diff --git a/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/cfd_para.hypara b/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/cfd_para.hypara new file mode 100644 index 0000000..b17970c --- /dev/null +++ b/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/cfd_para.hypara @@ -0,0 +1,1220 @@ +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +// PPPPP H H EEEEE N N GGGGG L EEEEE III + +// P P H H E NN N G L E I + +// PPPPP HHHHH EEEEE N N N G GG L EEEEE I + +// P H H E N N N G G L E I + +// P H H EEEEE N N GGGGG LLLLL EEEEE III + +//------------------------------------------------------------------------+ +// Platform for Hybrid Engineering Simulation of Flows + +// China Aerodynamics Research and Development Center + +// (C) Copyright, Since 2010 + +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +########################################################################### +# Default parameters for Grid conversion # +########################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// 2 -- Hybrid grid, include both of unstructured and structured grid. +// gridobj: Task type of grid treatment. +// 0 -- Grid generation of typical case, such as cylinder, flat plate, etc. +// 1 -- Grid conversion, from other grid data to PHenglEI, such as Fluent, CGNS. +// 2 -- Grid refinement. +// 3 -- Grid merging, merge two blocks into one block. +// 4 -- Grid deformation, achieve unstructured grid deformation. +// 5 -- Grid repairing, repair the original grid in order to remove the negative volume cells. +// 6 -- Grid mirroring, mirror a symmetry grid to whole grid. +// multiblock: Multi-block grid or not, only for structured grid conversion. +// 0 -- Not. +// 1 -- Yes. +// iadapt: Adaptation number for unstructure grid. +// SymmetryFaceVector: The vector of symmetry face. +// 0 -- X axis. +// 1 -- Y axis. +// 2 -- Z axis. +int gridtype = 0; +int gridobj = 1; +int multiblock = 0; +int iadapt = 0; +int SymmetryFaceVector = 1; + +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +int axisup = 1; + +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +int omit_no_bound_bc = 0; + +//----------------------------------------------------------------------- +# Grid data type # +//----------------------------------------------------------------------- +// from_gtype/to_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +// dumpOldGrid: If dump out the old grid file. +// 0 -- Not. (default) +// 1 -- Yes. +int from_gtype = 2; +int to_gtype = 1; +int dumpOldGrid = 0; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +int numberOfGridFile = 1; +string from_gfile = "./grid/rae2822_hybrid2d.cas"; +string from_gfile1= ""; + +string out_gfile = "./grid/flat_laminr_133_85_2d.fts"; + +// ----------------- some advanced choices ------------------------------ +// iunsteady: The Grid is for unsteady simulation or not. +int iunsteady = 0; +int codeOfAleModel = 0; + +// fileformat: Ustar Grid file format. +// 0 -- BINARY. +// 1 -- ASCII. +int fileformat = 0; + +// Parameters for hybrid solver. +// mixgrid_uns: path of unstructure grid file for hybrid solver, *.fts type. +// mixgrid_str: path of structure grid file for hybrid solver, *.fts type. +string mixgrid_uns = "./grid/rae2822_uns2d_4.fts"; +string mixgrid_str = "./grid/flat_laminr_133_85_2d.fts"; + +// Some parameters for structured overlapping grid. +int codeOfDigHoles = 1; +string holeBasicFileName = "./oversetGridView/holeBasicFile.inp"; +string holeFullFileName = "./oversetGridView/holeFullFile.dat"; +string linkFileName = "./oversetGridView/topology.dat"; +string zoneInverseFileName = "./oversetGridView/zoneInverseMapping.inp"; + +// ----------------- Adaptive Mesh Refine ------------------------------- +// In this file, the original_grid_file is used of the partition part. +// If use it dependently, abstract it here. +string adapt_grid_file = "./grid/sphere_mixed_adapt1.fts"; +string geometryFileName = "./grid/jsm.igs"; + +// geometryUnit: Geometry unit. +// 1 -- meter. +// 2 -- millimeter. +// 3 -- inch. +// exclusiveCase: Parallel projection exclusive case. +// 0 -- NON case. +// 1 -- JSM-C2-NPOFF case. +// 2 -- CHNT. +// projectOrgPoint: If the original wall points need to be projected or not. +int geometryUnit = 1; +int anisoRefine = 0; +int isProject = 0; +int readDist = 0; +int isDeform = 0; +int exclusiveCase = 0; // 0: NON case; 1: JSM-C2-NPOFF case; 2: CHNT. +int projectOrgPoint = 0; // if project original wall points. + + +// ----------------- Grid Deform Parameters ----------------------------- +// deformationMethod: Grid Deform. +// 1 -- SPRING. +// 2 -- RBF. +// stationalGridFile: Original grid file. +// visualFileName : The visualization file path of deform grid. +// nDeformStep : The max deform step. +// flapAngle : The max flap angle. +// rotatePostionZ : Rotate postion. +// rotatePostionY : Rotate postion. +// gridSlice : If dump slice grid. +// sliceAxis : Grid slice axis. +// slicePosition : Grid slice position. +int nDeformStep = 40; +double flapAngle = 10.0; +double rotatePostionZ = 4.00003; +double rotatePostionY = 3.05; + +int deformationMethod = 2; +string stationalGridFile = "./grid/Segment2Brid.fts"; +string visualFileName = "./results/deformedGrid.dat" + +int gridSlice = 1; +int sliceAxis = 1; +double slicePosition = 13; + +// ----------------- RBF Parameters ------------------------------------- +// numberOfReferenceCP : Number of reference Control Points. +// influencePara : The RBF influence radius parameter. +int numberOfReferenceCP = 40; +double influencePara = 25.0; + +// ----------------- Periodic Parameters -------------------------------- +// Notice: Rotational periodicity only support rotation along the X axis! +// periodicType: Which periodic boundary is used. +// 0 -- without Periodic Boundary. +// 1 -- Translational periodicity. +// 2 -- Rotational periodicity. +// translationLength[]: The relative distance between two periodic face + which only support one direction. +// rotationAngle: The relative angle between two periodic face. + which is recorded in degrees. + +int periodicType = 0; +double translationLength[] = [0.0,0.0,0.0]; +double rotationAngle = 0.0; + +######################################################################### +# Default parameters for Partition # +######################################################################### +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// 2 -- refine structured grid. +// maxproc: The number of partition zones that want to be divided into. +int pgridtype = 0; +int maxproc = 4; + +// traceMark: Trace mark or not, only for structured grid partition. +// 0 -- Not. +// 1 -- Yes. +// blockIndexOfMark: the block index of mark, only for structured grid partition. +// cellIndexOfMark: the cell index of mark, only for structured grid partition. +int traceMark = 0; +int blockIndexOfMark = 0; +int cellIndexOfMark[] = [185,30,1]; + +// parallel Strategy: +//! -# 0 : each zone is assigned to the one that defined in grid partition procedure. +//! -# 1 : random assigned for each zone or by some else ways. +int parallelStrategy = 1; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). +string original_grid_file = "./grid/sphere_mixed.fts"; +string partition_grid_file = "./grid/sphere_mixed__4.fts"; + +// ------------------ Sompe advanced parameters ------------------------- +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +// npartmethod: Method of interface reconstruction, default is 1. +// parallelPartitionMethod: Method of parallel partition, this is set only when execute parallel partition. It would be skipped when serial partition. +// 1 -- Using ParMetis for homogeneous MPI. +// 2 -- Using Metis for homogeneous MPI. +// 3 -- using METIS partition for homogeneous OpenMP. +// parmetisBalance: Used to specify the imbalance tolerance. +// 1 -- perfect balance. +// maxproc -- perfect imbalance. +// 1.05 -- recommended. + +int omit_no_bound_bc = 0; +int npartmethod = 1; +int parallelPartitionMethod = 2; +double parmetisBalance = 1.05; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level, ..., et al. +int numberOfMultigrid = 1; + +######################################################################### +# Default parameters for CFD simulation # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepSample: The step intervals for monitored probes variables file 'sample.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual file 'res.dat' saved. +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) + +int maxSimuStep = 20000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepSample = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; +int ifLowSpeedPrecon = 0; + +// compressible: +// 0 -- incompressible flow. +// 1 -- compressible flow. (default) +int compressible = 1; + +//----------------------------------------------------------------------- +# CFD Control Parameter # +//----------------------------------------------------------------------- +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// 4 -- the condition that the velocity, temperature and density are given. +// 5 -- the condition that the velocity, temperature and pressure are given. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. +// radiationCoef: The radiation coefficient on wall, it is used to compute the radiation heat flux on wall when the boundary +// condition is radiation equilibrium temperature, and 0.8 is the default value. +// refMolecularWeight : the reference molecular weight of gas used for perfect gas. The unit is g/mol. +// Generally, the gas is air. Sometimes, it is experiment gas, such as Nitrogen, Argon, and so on. + +double refMachNumber = 0.73; +double attackd = 2.79; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 6.5e6; +double refDimensionalTemperature = 288.15; +double freestream_vibration_temperature = 300.00; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +//int inflowParaType = 3; +//int nsubsonicInlet = 1; +//int nsubsonicOutlet = 1; +//string inLetFileName = "./bin/subsonicInlet.hypara"; +//string outLetFileName = "./bin/subsonicOutlet.hypara"; +//double refDimensionalTemperature = 288.144; +//double refDimensionalPressure = 1.01313E05; + +//The velocity, temperature and density are fixed. +//int inflowParaType = 4; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalDensity = 1.0e3; + +//The velocity, temperature and pressure are fixed. +//int inflowParaType = 5; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalPressure = 1.0e5; + +//The MachNumber, temperature and pressure are fixed. +//int inflowParaType = 6; +//double refDimensionalTemperature = 293; +//double refDimensionalPressure = 8886.06; + +double wallTemperature = -1.0; + +double radiationCoef = 0.8; +double gridScaleFactor = 1.0; + +int numberOfAerodynamicForceComponents = 1; +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. +double refMolecularWeight = 28.9644; // unit of g/mol. + +//----------------------------------------------------------------------- +# Spatial Discretisation # +//----------------------------------------------------------------------- +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "hlle", "lax_f". +// -- "roe", "modified_roe". +// -- "ausm+", "ausm+w", "ausm+up", "ausmdv", "ausmpw", "ausmpw+". +// str_limiter_name: Limiter of struct grid. +// -- "vanalbada", "vanleer", "minmod", "smooth", "minvan", "3rdsmooth", "3rd_minmod_smooth". +// -- "nolim", no limiter. +// -- "vanalbada_clz", clz supersonic version. +string inviscidSchemeName = "roe"; +string str_limiter_name = "vanalbada"; + +#******************************************************************* +# UnStruct Solver or Common * +#******************************************************************* +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 2 -- Algebraic. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "0eq-bl". +// -- "1eq-sa". +// -- "2eq-kw-menter-sst". +// -- "2eq-kw-menter-bsl". +// -- "2eq-kw-wilcox-1988". +// -- "2eq-kw-wilcox-1998". +// -- "2eq-kw-kok-tnt". +// -- "2eq-kw-wilcox-2006". +// -- "easm-kw-2003". +// -- "easm-kw-2005". +// DESType: Type of DES. +// 0 -- RANS. (default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpw+". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "barth", "vencat", "vanleer", "minmod". +// -- "vanalbada", "smooth", "nnd", "lpz", "1st". +// -- "nolim", no limiter. +// uns_vis_name: Discretisation method of viscous term. +// -- "std", "test", "aver", "new1", "new2". +// gradientName: Gradient reconstruction method. +// -- "default", "ggcell", "ggnode", "lsq". +// ivencat: Variation of vencat limiter. +// 0 -- org method, it is independent of grid scale. +// 1 -- new method, it is dependent of grid scale. +// 4 -- Ustar limiter model, without grid size unitary. +// 7 -- default used. +// venkatCoeff: Cofficient of vencat, when using vencat limter. +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. +// skewnessAngle: The skewness angle of grid cells. +// roeEntropyFixMethod: Entropy fix (correction) method. +// 1 -- direct fix, which limits the minimum eigenvalue directly. +// 2 -- multi-dimensional fix, which is derived from structured solver and now is only valid for struct solver. +// 3 -- Harten type, which is default used. +// roeEntropyScale: Entropy fix (correction) coefficient scale, default is 1.0. +// It is used to scale the default Roe entropy fix coefficients. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +string uns_scheme_name = "roe"; +string uns_limiter_name = "vencat"; +string uns_vis_name = "test"; +string gradientName = "ggnode"; + +int ivencat = 7; +double venkatCoeff = 5.0; +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; +double skewnessAngle = 60.0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; + +//----------------------------------------------------------------------- +# Temporal Discretisation # +//----------------------------------------------------------------------- +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// physicalTimeStep: The nondimensional physical time step. +// ifStartFromSteadyResults: The unsteady simulation is start from steady flowfield or not, 0 is for no and else is for yes. +// ifStaticsFlowField: Statistical variables for unsteady simulation. +// ifStaticsReynoldsStress: Statistical Reynolds stress for unsteady simulation. +// startStatisticStep: Outer step when start statistics. +// when the value is larger than "maxSimuStep", it is useless. +// statisticalTimePeriod: Used as time period of statistic analysis. +// when the value is negative, time period is treated as infinite. +// statisticMethod: Statistic reynolds stress method. + 0 --tau = - ^2 + 1 --tau = +// min_sub_iter: The min sub iteration of unsteady simulation. +// max_sub_iter: The max sub iteration of unsteady simulation. +// tol_sub_iter: The tolerance of sub iteration of unsteady simulation. +// tscheme: Temporal Discretisation method. +// 1 -- Runge-Kutta Multi-State. +// 2 -- Point implicit. +// 3 -- Full implicit. +// 4 -- LU-SGS. +// 5 -- Block LU-SGS. +// 6 -- Jacobian iteration. +// 7 -- Lower G-S iteration. +// 8 -- Upper G-S iteration. +// 9 -- Lower/Upper G-S iteration. +// iSimplifyViscousTerm: Simplify the computation of viscous term in the Block LU-SGS method. The default value assigns 1 that could speed up the computation. +// Otherwise, the viscous Jacobian matrix Mv should be computed that will increase the memory and time in iteration of the BLUSGS method. +// CFLStart: Started cfl number. +// CFLEnd: End cfl number. +// CFLVaryStep: The number of step when cfl increase from CFLStart to CFLEnd. +// ktmax: Dtratio. dt[i] = MIN(dt[i], ktmax * dtmin / vol[i]) +// swapDq: Communication dq between forward/backward sweep of LUSGS or not, default is 0. +// nLUSGSSweeps: Sub iteration of LU-SGS or Block LU-SGS. +// LUSGSTolerance: Sub iter tolerance of LU-SGS or Block LU-SGS. +// ifLocalTimeStep: Time step method. +// 0 --Local. +// 1 --Global. +// visl_min: Minimum value of laminar viscosity coefficient. +// turbCFLScale: Turbulence model cfl number factor. +// codeOfAleModel: Arbitrary Lagrangian-Eulerian method. +// 0 -- no ALE method. +// 1 -- ALE method for non-moving grids. +// 2 -- ALE method for moving grids. +// 3 -- ALE method for deforming grids. +// wallFunctionType: The type of wall function to implement. +// 0 -- no wall function. (default) +// 1 -- standard wall function. +// 2 -- Pab3D wall function. +// RKStage: The number of Runge-Kutta step. +// lamda: Cofficient of Runge-Kutta step. + +int iunsteady = 0; +double physicalTimeStep = 0.01; +int ifStartFromSteadyResults = 0; +int ifStaticsFlowField = 0; +int ifStaticsReynoldsStress = 0; +int startStatisticStep = 800000; +double statisticalTimePeriod = -1.0; +int statisticMethod = 0; +int linearTwoStepMethods = 1; // 1--BDF1; 2--C-N; 3--BDF2; + +int methodOfDualTime = 3; +int min_sub_iter = 50; +int max_sub_iter = 50; +double tol_sub_iter = 0.01; + +int tscheme = 4; +int iSimplifyViscousTerm = 1; +int ifLocalTimeStep = 0; +double CFLStart = 0.01; +double CFLEnd = 10.0; +int CFLVaryStep = 500; + +double ktmax = 1.0e10; + +int swapDq = 1; + +int nLUSGSSweeps = 1; +double LUSGSTolerance = 0.01; +int order = 2; + +double visl_min = 0.01; +double turbCFLScale = 1.0; +double csrv = 2.0; +double timemax = 1.0e10; +double dtsave = -1.0; +int maxale = 10; +double dtau = 0.001; + +int wallFunctionType = 0; + +int RKStage = 2; +double lamda[] = 0.5, 1.0; + +//int RKStage = 1; +//double lamda[] = 1.0; + +//int RKStage = 4; +//double lamda[] = [0.25, 0.33333333333, 0.5, 1.0]; + +//----------------------------------------------------------------------- +# File In or Out # +//----------------------------------------------------------------------- +// numberOfGridGroups: The number of grid groups. +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the field results to visulization. +// walldistMethod: The method to compute wall distance. +// 0 -- accurate but not fast enough. +// 1 -- fast but not accurate enough. +// 2 -- super fast but more non-accurate! +// resSaveFile: The file path to save the residual convergence process, write data for every default (intervalStepRes) steps. +// turbresfile: The file path to save the residual convergence process of turbulence, write data for every default (intervalStepRes) steps. +// aircoeffile: The file path to save the aerodynamic force coefficients convergence process, write data for every default (intervalStepForce) steps. +// restartNSFile: The file path to write restart flowfield variables, write data for every default (intervalStepFlow) steps. +// turbfile: The file path to write restart flowfield variables of turbulence , write data for every default(intervalStepFlow) steps. +// visualfile: The visualization file path of flowfield , write data for every default (intervalStepPlot) steps. +// wall_aircoefile: The file path to save flowfield variables of wall, write data for every default steps. +// nDumpSurfaceInfo = 0 the "wall_varfile" write the informations including heat flux. +// nDumpSurfaceInfo = 1 the "wall_varfile" write the informations without heat flux. + +int numberOfGridGroups = 1; +string gridfile = "./grid/rae2822_hybrid2d__4.fts"; +string wallTemperaturefile= ""; + +int walldistMethod = 1; + +string resSaveFile = "results/res.dat"; +string turbresfile = "results/turbres.dat"; +string aircoeffile = "results/aircoef.dat"; + +string restartNSFile = "results/flow.dat"; +string turbfile = "results/turb.dat"; + +string visualfile = "results/tecflow.plt"; +string wall_aircoefile = "results/wall_aircoef.dat"; +string samplefile = "results/sample.dat"; + +int nDumpSurfaceInfo = 0; +string wall_varfile = ""; + +string jetDefineFile = "bin/jet.hypara"; + +string sixDofFileName = "results/sixDofInfo.dat"; +string derivativeFileName = "results/identify.dat"; +string hysteresisFileName = "results/force_beta.plt"; + +int plotFieldType = 0; + +// visualfileType: The file type of visualfile. +// 0 -- Tecplot binary. +// 1 -- Tecplot ASCII. + +int visualfileType = 1; + +// samplefileMode: The dump mode of sample file. +// 0 -- dump out every probe/line/surface data for all step intervals. +// 1 -- dump out all probe/line/surface data for every step intervals. +int samplefileMode = 0; + +// visualSlice: The slice of tecflow. +// 0 -- Do not save slice data. +// 1 -- comput and save it to sliceFile. +// sliceAxis: Normal vector of slice. +// 1 -- X_DIR. +// 2 -- Y_DIR. +// 3 -- Z_DIR. +// slicePostion: Coordinate of slice. + +int visualSlice = 0; +int sliceAxis = 1; +double slicePostion = -0.5; +string sliceFile = "results/Slice.plt"; +int dumpWallFaceCenter = 0; + +// min-max box of the visual block. +double lowerPlotFieldBox[] = [0.0 0.0 0.0]; +double upperPlotFieldBox[] = [1.0 1.0 1.0]; + +//-----------the optional parameters list for the flow field output---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40), +// -- gradientUx(41), gradientUy(42), gradientVx(43), gradientVy(44), iblank(81). +// -- specific heat ratio(gama, 56) +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. +//-----------the optional parameters list for the wall boundary condition---------------- +// nVisualWallVariables: The number of visual variables on wall. +// visualWallVariables : dumped variable types, listed as following: +// -coefficient of pressure(cp, 0), -coefficient of friction(cf, 1), yplus(2), -non-dimensional heat flux(Q_NonDim, 3), -dimensional heat flux(Q_Dim, 4), +// -pressure on wall(pw, 5), -temperature on wall(Tw, 6), -density on wall(rhow, 7), -heat flux of translational-rotational temperature term(Qtr, 8), +// -heat flux of species diffusion term(Qs, 9), -heat flux of vibrational temperature term(Qv, 10), -heat flux of electron temperature term(Qe, 11), +// -species mass fractions(Ns, 12), -x component of wall velocity(Vx, 13), -y component of wall velocity(Vy, 14), -z component of wall velocity(Vz, 15) +// -slip translational-rotational temperature(Tts, 16), -slip vibrational temperature(Tvs, 17), -slip electron temperature(Tes, 18), -absolute wall velocity(Vs, 19) +// -Stanton number(St, 20), -coefficient of heat rate(Ch, 21), -temperature jump(deltaT, 22), -transition gamaeff(gamaeff, 48), +// -transition intermittency(intermittency, 51), -transition momentum thickness reynolds(MomentumThicknessReynolds, 52), +// -overlap iblank(iblank, 81) + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +int nVisualWallVariables = 9; +int visualWallVariables[] = [0, 1, 2, 3, 4, 5, 9, 10, 11]; + +// dumpStandardModel: Dump many standard model data. +// 1 -- Turbulent flat plate. +int dumpStandardModel = 0; + +// ifSetDataMonitor: Whether to set the data monitor. +// 0 -- No. +// 1 -- Yes. +// dataMonitorType: The type of data Monitor. +// 0 -- Probes data monitor. +// 1 -- Lines data monitor. +// 2 -- Surfaces data monitor. +// probesDefineFile: Probes location information file. +// nLines: The number of lines need to be monitored. +// linesDefineFile: Lines location information file. +// nSurfaces: The number of surfaces need to be monitored. +// surfacesDefineFile: Surfaces location information file. +// searchCellsMethod: method to search the cell of each probe. +// 0 -- Nearest cell to the probe. +// 1 -- Real cell where the probe is located. +// nProbeVariables: Number of variables want to be dumped for probes monitered. +// probeVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5). +// Important Warning: Array size of probeVariables MUST be equal to nProbeVariables!!! +// probeVariables order must from small to big. +// probeVariablesInterpolationMethod: Interpolation method used to compute the probe variables. +// 0 -- Take the value of probe's cell as probe real value. +// 1 -- Interpolation from probe's and neighbouring cell to probe. +// 2 -- Interpolation from probe's cell nodes to probe. +int ifSetDataMonitor = 0; + +int dataMonitorType = 0; +string probesDefineFile = "bin/probes_XYZ.dat"; + +//int dataMonitorType = 1; +//int nLines = 1; +//string linesDefineFile = "bin/lines_XYZ.dat"; + +//int dataMonitorType = 2; +//int nSurfaces = 4; +//string surfacesDefineFile = "bin/surfaces_XYZ.dat"; + +int searchCellsMethod = 0; + +int nProbeVariables = 6; +int probeVariables[] = [0, 1, 2, 3, 4, 5]; +int probeVariablesInterpolationMethod = 0; +//----------------------------------------------------------------------- +# Turbulence Parameter # +//----------------------------------------------------------------------- +// turbInterval: Iteration number of turbulence. +// kindOfTurbSource: Kinds of turbulent source. +// 0 -- Original. +// 1 -- Edwards. +// 2 -- new. +// mod_turb_res: If modify the residuals for the cells next to the wall or not, default is 0. + +int turbInterval = 1; +int turbOrderStruct = 2; +int kindOfTurbSource = 0; +int mod_turb_res = 0; +double turb_relax = 1.0; +double freeStreamViscosity = 1.0e-3; +double muoo = 3.0; +double kwoo = 5.0; +int transitionType = 0; +double turbIntensity = -1.0; +int freeturbIntensitySRModify = 0; +double freeDecayXLocation = 0.0; +int compressibleCorrection = 0; +int transitionMaFix = 1; + +# maximum eddy viscosity (myt/my) max. +double eddyViscosityLimit = 1.0e10; +int monitor_vistmax = 0; + +//----------------------------------------------------------------------- +# LES Parameter # +//----------------------------------------------------------------------- +// iLES: Create LESSolver or not. +// == 1 - Create LESSolver; +// != 1 - not. +// amplitudeofDisturb: Amplitude of adding disturb. +// disturbstep: Unsteady time step or steady iteration of adding random disturb. +// iterdisturb: Add random disturb in every sub-iter or only first sub-iter. +// = 0 - in only first sub-iter; +// != 0 - in every sub-iter. +// ipraddisturb: Add density and pressure disturb or not. +// ibodyforce: Add body force in source flux of NS equations or not. +// = 0 - not; +// != 0 - Add body force. +// bodyforce: Body force in source flux of NS equations or not. +// utau: friction velocity, using in DNSDisturb. +// sgsmodel: subgrid scale model. +// = "smagorinsky"; +// = "dsmCom"; +// = "wale"; +// = "sigma". +// deltaFunctionType: = 1 - MAX(deltai, deltaj, deltak); +// = 2 - pow(deltai * deltaj *deltak, 1/3); +// = 3 - Devloped by Scotti. +// wallDampingFunctionType: = 0 - no wall function; +// = 1 - van Driest; +// = 2 - developed by Dr. Deng Xiaobing; +// = 3 - developed by Piomelli. +// turbViscousCutType: turbulent viscosity cut type. +// = 0 - mu_total = mut + mul; +// = 1 - mu_total = max(mut-mul,0)+ mul; +// = 2 - mu_total = max(mut ,0)+ mul. +// smagConstant: constant of smagorinsky model. +// waleConstant: constant of wale model. +// filterDirection[3]: filter variables in i, j, k direction or not. +// averageDirection[3]: average variables in i, j, k direction or not. +// isotropicConstant: constant of isotropic part of SGS stress. + +int iLES = 0; +string sgsmodel = "smagorinsky"; +int deltaFunctionType = 2; +int wallDampingFunctionType = 1; +int turbViscousCutType = 2; +double smagConstant = 0.1; +double isotropicConstant = 0.0; +double waleConstant = 0.6; +double sigmaConstant = 1.35; +int filterDirection[] = [1, 1, 0]; +int averageDirection[] = [0, 0, 0]; +double testFilterScale = 2.0; +int averageWidth = 1; +int monitorNegativeConstant = 0; + +//----------------------------------------------------------------------- +# Other Parameters for Hypersonic Non-equilibrium Gas # +//----------------------------------------------------------------------- +// dg_high_order: +// 0 -- generic order accuracy. +// 1 -- high order accuracy. +// iapplication: +// 0 -- gas model is fixed in the codes. +// 1 -- gas model is imported from library files. +// iCodeBranch: +// 0 -- The old code version is used for Navier-Stokes. +// 1 -- A new code version is active for Navier-Stokes solver. +// nm: Equation number of the physics, but is out of commision now. +// 4 -- for 2D. +// 5 -- for 3D. +// nGasModel: The type of gas. less than and equal to 1 represents the mixture gas. +// Otherwise, the pure gas with one component is used for perfect gas. +// 0 -- Earth gas. +// 1 -- Mars gas. +// 2 -- Argon. +// 3 -- Nitrogen. +// nEnergyRecycle: The type of EnergyModel Recycle. +// 0 -- not used . +// 1 -- used. +// nDensityModify: The type of densitymodify. + +// 0 -- not used. +// 1 -- used. +// nchem: +// 0 -- without chemical reaction flow. +// 1 -- the chemical reaction flow is considered. +// nEquilibriumGas: the variable is valid when the condition of nchem=0 is satisfied. +// 0 -- perfect gas. +// 5, 7, 11 -- equilibrium gas, meanwhile, its value denotes the number of gas component. +// nPCWCycleStep: the maximum step number of iteration in the module of computing species mass fractions with the partial catalytic wall(PCW) condition. +// the value equals to or is greater than 1, and 3 is for default value. +// nRETCycleStep: the maximum step number of iteration in the module of computing radiation equilibrium temperature on wall. +// the value equals to or is greater than 1, and 3 is for default value. +// nSLIPCycleStep:the maximum step number of iteration in the module of computing slip temperature, slip velocity and slip species mass fraction. +// the value equals to or is greater than 1, and 3 is for default value. +// nSlipBCModel : The computational model of slip boundary conditions. + +// 0 -- no slip. +// 1 -- the conventional Maxwell slip conditions. +// 2 -- the Gokcen slip conditions. +// 3 -- the Knudsen-layer correction of the standard slip conditions proposed by Lockerby, et al. +// 4 -- the Kogan simplified slip conditions. +// nMeanFreePathType : the method to the mean free-path for the slip conditions. For the mixture, 0 is suggested. +// 0 -- the equivalent mean free-path is calculated by the simple hard sphere model(HS). +// 1 -- calculated by the definition that includes the variables of the number density and the molecule diameter. +// 2 -- the equivalent mean free-path is calculated by the variable hard sphere model(VHS). +// nchemsrc: +// 0 -- the source terms are not computed. +// 1 -- the source terms are computed. +// nchemrad: +// 0 -- compute the spectrum radius without considering chemical reaction flow. +// 1 -- compute the spectrum radius that need to count the contribution from chemical reaction flow. +// ntmodel: The thermodynamic temperature model. +// 1 -- One-temperature model. +// 2 -- Two-temperature model. +// 3 -- Three-temperature model. +// nTEnergyModel: the method to computing temperature energy model. +// 0 -- the energy term is computed using the conventional method. +// 1 -- the energy term is computed using the curve fitting method. +// parkVDPower: the power of translational-rotational temperature in the Park V-D(vibration-dissociation) coupling model. +// The value is in range of [0.0, 1.0], DPLR suggests 0.5, LAURA suggests 0.7, while 0.6 is given as default value. +// catalyticCoef: +// 0.0 -- full non-catalytic wall boundary condition. +// 1.0 -- full catalytic wall boundary condition. +// in range of (0.0, 1.0) -- partial catalytic condition, the value indicates the catalytic coefficient. +// nIsSuperCatalytic : the super catalytic condition for the fully catalytic wall, and assigned with the value of 1. +// 0 -- equilibrium condition for the fully catalytic wall where the mass fractions are assigned with the values of the free stream. +// 1 -- super catalytic condition for the fully catalytic wall where all the atomic components combine into molecular components. +// nTemperatureJump : the method to calculate the temperature jump. +// 0 -- calculated by the variables of heat conductivity and constant volume specific heat for each energy mode. +// 1 -- the general method where the iteration is calculated with the translation-rotation temperature. +// sigmaVelocity: the coordination coefficient of tangential momentum for computation of slip velocity. The value is in range of (0.0, 2.0]. +// sigmaTemperature: the heat coordination coefficient for computation of slip temperature. The value is in range of (0.0, 2.0]. +// sigmaMassFraction: the species coordination coefficient for computation of slip mass fractions. The value is in range of (0.0, 2.0]. +// velocitySlipCorrectConstant: the correction constant to the velocity slip condition. For the diffuse reflection, 1.0 is used. +// 1.0 -- proposed by Maxwell. +// sqrt(2/PI)~0.8 -- used for "micro-slip", namely the actual velocity slip at the wall. +// 1.146 -- proposed for an additional "fictitious" velocity slip. + +// chemicalRelaxCorf: The value is in range of [0.001, 1.0]. +// chemicalSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// viscousSpectrumRadiusCoef : The value is in range of [1.0, 3.0]. +// inviscidSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// staticPressureRelaxCorf: The value is in range of [0.1, 1.0]. +// nIsChemicalFreeze : the flag to freeze the chemical reactions. +// 0 -- not freeze, the chemical reaction sources will be calculated. +// 1 -- freezes the chemical reactions, the chemical reaction sources will not be calculated.// veTemperatureMin: The minimum of Tv and Te +// nDebug: cout the Wrong place and abort +// 0 -- not used. +// 1 -- used. +// nSpeciesLimit: limitter of gas species +// 0 -- not used. +// 1 -- used. +// nTurblenceForChemical: the coupled mode of Turblence and Chemical reaction +// 0 -- method 0. +// 1 -- method 1. +// nViscosityFluxSublevelModified: Modified for ViscosityFlux on Sublevel grid +// 0 -- not used. +// 1 -- used. +// nChemcalSourceModified: Modified on ChemcalSource +// 0 -- not used. +// 1 -- used. +// nAblation: +// 0 -- The wall ablation is not computed. +// 1 -- The wall ablation is computed. +// isInjection: +// 0 -- The injection velocity of ablation wall is not computed. +// 1 -- The injection velocity of ablation wall is computed. +// nViscosityModel: + +// 0 -- Blottner fitting method. +// 1 -- Gupta fitting method. +// nSutherland: +// 0 -- stands for selecting the Blotter curve fits mode. +// 1 -- stands for Sutherland relation. +// gasfile: Indicates the gas model, 9 models are provided, namely "Gu5", "Gu7", "Gu11", "Pa5", "Pa7", "Pa11", "DK5", "DK7", "DK11". +// "Gu" -- indicates the Gupta Model, three-Type Models are embeded in the library, namely, the 5-species-6-reactions, the 7-species-9-reactions, the 11-species-20-reactions. +// "Pa" -- indicates the Park Model, three-Type Models are embeded in the library, namely, the 5-species-17-reactions, the 7-species-22-reactions, the 11-species-48-reactions. +// "DK" -- indicates the Dunn-Kang Model, three-Type Models are embeded in the library, namely, the 5-species-11-reactions, the 7-species-15-reactions, the 11-species-26-reactions. +// "Mars-Pa8" is for Park model of Mars gas, "Mars-Mc8" for McKenzie model of Mars gas. +// "Combustion-12" -- indicates the Combustion Chamber Gas Model which includes 12-species-20-reactions. +// "Gas-Mixture" -- indicates the process of mixing two species without reacting. +// For self-definition model, the gasfile is used to indicate the file path of the new gas model. +// speciesName: Used to list the names of each species, while each species name is separated by the symbol of comma. +// initMassFraction: Used to list the initial mass fractions of species in accordance with the sequence of names in the parameter speciesName. +// ifStartFromPerfectGasResults: The chemical reaction simulation is start from perfect gas flowfield or not, 0 is for no and else is for yes. + +int dg_high_order = 0; +int iapplication = 0; +int iCodeBranch = 0; +int nm = 5; +int nEquilibriumGas = 0; +int nPCWCycleStep = 3; +int nRETCycleStep = 3; +int nSLIPCycleStep= 3; + +double refGama = 1.4; +double prl = 0.72; +double prt = 0.90; +double sc_l = 0.5; +double sc_t = 0.5; + +int nGasModel = 0; +int nchem = 0; +int nchemsrc = 1; +int nchemrad = 1; +int ntmodel = 1; + +int nEnergyRecycle = 0; +int nSlipBCModel = 0; +int nDensityModify = 1; +int nTEnergyModel = 0; +int nMeanFreePathType = 0; +int nIsChemicalFreeze = 0; +int nIsSuperCatalytic = 1; +int nTemperatureJump = 0; + +double parkVDPower = 0.6; +double catalyticCoef = 0.0; +double sigmaVelocity = 1.0; +double sigmaTemperature = 1.0; +double sigmaMassFraction = 1.0; +double velocitySlipCorrectConstant = 1.0; + +double chemicalRelaxCorf = 1.0; +double chemicalSpectrumRadiusCoef = 1.0; +double viscousSpectrumRadiusCoef = 1.0; +double inviscidSpectrumRadiusCoef = 1.0; +double staticPressureRelaxCorf = 1.0; + +double veTemperatureMin = 30.0; +int nDebug = 0; +int nSpeciesLimit = 0; +int nTurblenceForChemical = 0; +int nViscosityFluxSublevelModified = 0 ; +int nChemcalSourceModified = 0; + +int nAblation = 0; +int isInjection = 0; +int nViscosityModel = 0; +int nMarsModel = 0; +string gasfile = "DK5"; +//string gasfile = "./chemical/Dunn-Kang_air5s11r.dat"; +string speciesName = "O, O2, NO, N, N2"; +string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.767"; + +//string speciesName = "O, O2, NO, N, NO+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string speciesName = "O, O2, NO, N, O+, O2+, NO+, N+, N2+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Mars-Pa8"; +//string speciesName = "O, O2, NO, N, N2, C, CO, CO2"; +//string initMassFraction = "0.0015, 0.0429, 0.0, 0.0, 0.0, 0.0, 0.0777, 0.8779"; + +//string gasfile = "DK7"; +//string speciesName = "O, O2, NO, N, NO+, C, C2, CO, CO2, CN, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Combustion-12"; +//string speciesName = "O, O2, NO, N, C, CO, CO2, H, H2, OH, H2O, N2"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767"; + +//string gasfile = "Gas-Mixture"; +//string speciesName ="SpeciesA, SpeciesB"; +//string initMassFraction = "1.0, 0.0"; +int nSutherland = 0; +double gamaSpeciesA = 1.4; +double gamaSpeciesB = 1.3; +double molecularWeightSpeciesA = 29.0; +double molecularWeightSpeciesB = 30.0; + +int nChemicalFlowStep = 0; +int ifStartFromPerfectGasResults = 0; + +######################################################################### +// Multi-Grid parameters. +// nMGLevel: The number of level of Multi-Grid. +// <= 1 -- Single-level. +// > 1 -- multi-level. +// MGPreIteration: For each grid, the number of pre-smoothing steps. +// n_post: For each grid, the number of post-smoothing steps. +// MGCoarsestIteration: For the coarest grid the number of smoothing steps. +// MGFasType: V-multi cycle or W-multi cycle. +// 1 -- V-multi cycle. +// 2 -- W-multi cycle. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. +// mgCFLScale: CFL number enlarge times for coarse grid. +// mprol: Multi-grid interpolation method, interpolation from coarse cell to fine grid. +// 1 -- zero order. +// 2 -- first-order. (default) +// mgCorrectionLimit: Multi-grid correction limit. + +int nMGLevel = 1; +int MGCoarsestIteration = 1; +int MGPreIteration = 1; +int MGFasType = 1; +int n_post = 0; +int flowInitStep = 100; +int mprol = 2; +double mgCFLScale = 1.0; +double mgCorrectionLimit = 0.01; + +//--------------- Some parameter for turbulent model -------------------- +// neasm: The variation of kw turbulent model. +// ismooth_turb: Residual smooth for turb or not. +// SSTProductType: The type of product term based on vorticity for SST. +// SAProductType: The type of product term based on vorticity for SA. +int neasm = -3; +int SSTProductType = 0; +int ismooth_turb = 0; +int SAProductType = 2; + +// ----------------- Overset Grid parameter ----------------------------- +int codeOfDigHoles = 1; +int codeOfTurbulentModel = 0; +string masterFileName = "./grid/searchFile.inp"; +string holeBasicFileName = "./grid/holeBasicFile.inp"; +string holeFullFileName = "./grid/holeFullFile.dat"; +string linkFileName = "./grid/topology.dat"; +string zoneInverseFileName = "./grid/zoneInverseMapping.inp"; + +######################################################################### +# High Order Struct Solver # +######################################################################### +// isFVMOrFDM: +// 0 -- NSSolverStruct using Finite Volume Method. +// 1 -- NSSolverStruct using Finite Differ Method. +// SolverStructOrder: Spatial discretisation order of NS equations with struct grid. +// <= 2 -- finite volume method. +// >= 3 -- finite difference order. (to be completed) +// 0 -- default. +// str_highorder_interpolation_epsilon: Epsilon in weighted interpolation, bigger epsilon, better convergence, +// smaller epsilon, robuster for shock-detecting. +// str_highorder_interpolation_type: +// -- "classical", "test". +// str_highorder_flux_name: +// -- "roe", "steger". +// structhighordergradient: +// -- "conservation", "chain_rule". +int isFVMOrFDM = 0; +string str_highorder_solver = "WCNS"; +int SolverStructOrder = 0; +double str_highorder_interpolation_epsilon = 1.0e-6; +string str_highorder_interpolation_type = "test"; +string str_highorder_flux_name = "steger"; +string structhighordergradient = "conservation"; +double coefofstrflux = 0.5; +double limitcoefofinterface = 0.0; + +// ----------------- Advanced choices ----------------------------------- +// outtimesc: Time stepping scheme for the outer loop. +// MUSCLCoefXk: The parameter of MUSCL interpolations, belongs to [-1, 1]. +// -1 -- seconde-order fully-upwind differencing. +// 0 -- seconde-order upwind-biased differencing. +// 0.333333 -- third-order upwind-biased differencing. +// 1 -- seconde-order central differencing. +// MUSCLCoefXb: The limiter parameter. +// 0 -- the effect of the limiter is cancelled, means the first-order interpolations. +// allReduceStep: Iteration intervals for MPI AllReduce operation, default is 1. +string outtimesc = "impbd2"; +double MUSCLCoefXk = -1; +double MUSCLCoefXb = 1.0; +int allReduceStep = 1; + +// ----------------- overlap configuration ------------------------------ +// codeOfOversetGrid: Overlapping(overset) grid or not. +// 0 -- NON-overlapping grid. +// 1 -- Overlapping grid. +// oversetInterpolationMethod: the method of overset interpolation while field simulation +// 0 -- set the acceptor cell value by donor cell value. +// 1 -- set the acceptor cell value by distance weight of donor cell value. + +int codeOfOversetGrid = 0; +int oversetInterpolationMethod = 0; +int readOversetFileOrNot = 0; +int symetryOrNot = 0; +int readInAuxiliaryInnerGrid = 1; +int readInAuxiliaryOuterGrid = 0; +int readInSklFileOrNot = 0; +string auxiliaryInnerGrid0 = "./grid/aux-upper.fts"; +string auxiliaryInnerGrid1 = "./grid/aux-lower.fts"; +string auxiliaryInnerGrid2 = ""; +string oversetGridFileName = "./grid/iblank.ovs"; +double walldistMainZone = 1.0 +double toleranceForOversetSearch = 1.0e-3; +double toleranceForOversetBox = 1.0e-3; +int twoOrderInterpolationOrNot = 0; +int keyEnlargeOfActiveNodes = 0; +int outTecplotOverset = 0; + +int numberOfMovingBodies = 2; + +// ----------------- ALE configuration ------------------------------ +int codeOfAleModel = 1; +int aleStartStrategy = -1; + +int strategyForFaceNormalVelocity = 0; //0-By Sweeping volume; 1-By face center 1st; 2-By face center 2nd; +int strategyForGCLSource = 0; //0-present; 1-Ahn; + +//0:1st-Admas-Bashforth; 1:2nd-Admas-Bashforth; 2:1st-Implicit-Euler; 3:2nd-Implicit Euler; 4:2nd-Adams-Moulton; 5:3rd-Adams-Moulton +int methodForKineticEquation = 0; +double relaxParameterOfKinetic = 1.0; + +######################################################################### +# motive information # +######################################################################### +int numberOfMovingBodies = 1; + +############################## body0 ############################## +//mass of parts +double mass_0 = 1.0; +//mass matrix of parts Ixx Iyy Izz Ixy Ixz Iyz +double massMatrix_0[] = 1e-7, 1e-6, 1e-6, 0.0, 0.0, 0.0; +//initial six DOF position information of parts. xc yc zc +double massCenter_0[] = 0.0 , 0.0, 0.0; +//initial six DOF position information of parts. angleX angleY angleZ +double attitudeAngle_0[] = 0.0 , 0.0, 0.0; +//initial six DOF move information of parts. vc vy vz +double massCenterVelocity_0[] = 0.0, 0.0, 0.0; +//initial six DOF move information of parts. omigX omigY omigZ +double angularVelocity_0[] = 0.0, 0.0, 0.0; +//the object that the parts belong to. +int fartherIndex_0 = -1; +//the assembly position of the parts. xc yc zc angleX angleY angleZ +double configPamameter_0[] = 0.0 ,0.0 ,0.0 ,0.0 ,0.0 ,0.0; +//the move pattern of the parts. +// -1 given motion partten. +// 0 still. +// 1 six DOF motion. +// 2 three DOF motion. +// 11 X-axis forced motion. +// 12 Y-axis forced motion. +// 13 Z-axis forced motion. +// 14 forced pitch motion. +// 15 forced yaw motion. +// 16 forced roll motion. +int RBDMethod_0 = 0; +double amplitude_0 = 0.0; +double reduceFrequency_0 = 0.0; +//string uDFSixDofFileName_0 = "./Bin/UDFSixDof.Parameter"; +//additional force (system axis) fX fY fZ +double addedForce_0[] = 0.0 ,0.0 ,0.0 ; +//additional moment of Force (system axis) mX mY mZ +double addedMoment_0[] = 0.0 ,0.0 ,0.0 ; +//the deformation method of the parts. +int morphing_0 = 0; + +// post indentify +int integralOrder = 4; + + +// ---------------- ATP read -------------------------------------------- +//@int inflowParaType = 0; +//@double refReNumber = 6.5e6; +//@double refDimensionalTemperature = 288.15; +//@double freestream_vibration_temperature = 300.00; +//@double refDimensionalPressure = 0; +//@double height = 0; +//@int nsubsonicInlet = 0; +//@int nsubsonicOutlet = 0; +//@string inLetFileName = "./bin/subsonicInlet.hypara"; +//@string outLetFileName = "./bin/subsonicOutlet.hypara"; +//@double refDimensionalVelocity = 0; +//@double refDimensionalDensity = 0; + +######################################################################### +# Old Parameter # +######################################################################### +int isPlotVolumeField = 0; + diff --git a/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/cfd_para_subsonic.hypara b/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/cfd_para_subsonic.hypara new file mode 100644 index 0000000..49457cc --- /dev/null +++ b/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/cfd_para_subsonic.hypara @@ -0,0 +1,195 @@ +######################################################################### +# General Control Parameter # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual 'res.dat' saved. + +int maxSimuStep = 80000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; + +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) +int ifLowSpeedPrecon = 0; + +######################################################################### +# Inflow Parameter # +######################################################################### +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. + +double refMachNumber = 0.185; +double attackd = 6.00; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 2.51e6; +double refDimensionalTemperature = 288.15; + +//int inflowParaType = 1; +//double height = 0.001; + +double gridScaleFactor = 1.0; + +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. + +######################################################################### +# Physical models # +######################################################################### +// viscousType : Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "1eq-sa", when viscousType = 3. +// -- "2eq-kw-menter-sst", when viscousType = 4. +// DESType: Type of DES. +// 0 -- RANS.(default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +//int viscousType = 3; +//string viscousName = "1eq-sa"; + +int viscousType = 4; +string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +int roeEntropyFixMethod = 2; +double roeEntropyScale = 1.0; +######################################################################### +# Spatial Discretisation # +######################################################################### +#******************************************************************* +# Struct Solver * +#******************************************************************* +// str_limiter_name: Limiter of struct grid. +// -- "3rdsmooth", "smooth". +// -- "nolim", no limiter. + +string str_limiter_name = "smooth"; + +#******************************************************************* +# UnStruct Solver * +#******************************************************************* +// uns_limiter_name: Limiter of Unstruct grid. +// -- "vencat". +// -- "1st", meaning accuracy of first-order. +// -- "nolim", no limiter. +// venkatCoeff: Coefficient of vencat limiter, when uns_limiter_name = 'vencat'. +// The smaller the value, the more robust it is. + +string uns_limiter_name = "vencat"; +double venkatCoeff = 50.0; + +######################################################################### +# Temporal Discretisation # +######################################################################### +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// CFLEnd: The CFL number, [0.1, 100]. +// The bigger the value, the convergence faster but lower robustness. +// nLUSGSSweeps: Number of Sub-iteration of LU-SGS. +// 1 -- is recommended for structured solver. +// 1-3 -- is recommended for unstructured solver. + +int iunsteady = 0; + +double CFLEnd = 10.0; + +int nLUSGSSweeps = 1; + +######################################################################### +# Multi-Grid parameters # +######################################################################### +// nMGLevel: The number of Multi-Grid level. +// = 1 -- single-level. +// > 1 -- multi-level. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. + +int nMGLevel = 1; +int flowInitStep = 100; + +######################################################################### +# File In or Out # +######################################################################### +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// Please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the whole field results to tecplot or not, 0 / 1. + +string gridfile = "./grid/2D_NLR7301_Str.fts"; +int plotFieldType = 0; + +// ----------------- Advanced Parameters, DO NOT care it ---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables: Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21). +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. + +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; diff --git a/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/grid_para.hypara b/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/grid_para.hypara new file mode 100644 index 0000000..a51e384 --- /dev/null +++ b/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/grid_para.hypara @@ -0,0 +1,30 @@ +######################################################################### +# Grid data type # +######################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +// from_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +int gridtype = 1; +int axisup = 1; +int from_gtype = 3; + +######################################################################### +# File path # +######################################################################### +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +string from_gfile = "./grid/2D_NLR7301_Str.grd"; +string out_gfile = "./grid/2D_NLR7301_Str.fts"; diff --git a/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/key.hypara b/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/key.hypara new file mode 100644 index 0000000..78c5988 --- /dev/null +++ b/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/key.hypara @@ -0,0 +1,59 @@ +string title = "PHengLEI Main Parameter Control File"; + +// IMPORTANT NOTICE: DON NOT MODIFY THE FOWLLOWING LINE. +string defaultParaFile = "./bin/cfd_para.hypara"; + +// ndim: Dimensional of the grid, 2 or 3. +// nparafile: the number of parameter files. +// nsimutask: simulation task type. +// 0 -- CFD Solver of NS or Turbulation. +// 1 -- Grid generation: for special typical cases, such as cylinder, flat plate, etc. +// Grid conversion: from other format to PHengLEI format (.fts). +// Grid reconstruction: such as grid adaptation. +// Grid merging: merge two blocks into one block. +// Grid repairing: repair the original grid in order to remove the negative volume cells. +// 2 -- Wall distance computation for turb-solver. +// 3 -- Grid partition. +// 4 -- Knowledge repository / examples of PHengLEI-API. +int ndim = 2; +int nparafile = 1; + +int nsimutask = 0; +string parafilename = "./bin/cfd_para_subsonic.hypara"; +//string parafilename = "./bin/cfd_para_transonic.hypara"; +//string parafilename = "./bin/cfd_para_supersonic.hypara"; +//string parafilename = "./bin/cfd_para_hypersonic.hypara"; +//string parafilename = "./bin/incompressible.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_para.hypara"; + +//int nsimutask = 2; +//string parafilename = "./bin/cfd_para.hypara"; + +//int nsimutask = 3; +//string parafilename = "./bin/partition.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_deform_para.hypara"; + +//int nsimutask = 4; +//string parafilename = "./bin/repository.hypara"; + +//int nsimutask = 5; +//string parafilename = "./bin/overset_grid_view.hypara"; + +//int nsimutask = 13; +//string parafilename = "./bin/lbm_para.hypara"; + +//int nsimutask = 14; +//string parafilename = "./bin/integrative_solver.hypara"; + +//int nsimutask = 99; +//string parafilename = "./bin/post_processing.hypara"; + +// ---------------- Advanced Parameters, DO NOT care it ---------------- +int numberOfGridProcessor = 0; +// ATP read +//@string parafilename1 = "" +//@string parafilename2 = ""; diff --git a/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/partition.hypara b/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/partition.hypara new file mode 100644 index 0000000..161b4b4 --- /dev/null +++ b/A16-TwoD_NLR7301_SST_Struct_4CPU/bin/partition.hypara @@ -0,0 +1,21 @@ +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// maxproc: The number of partition zones that want to be divided into, +// which is equal to the number of CPU processors you want. +// Usually, 50~100 thousands structured cells per CPU-Core is suggested. +// 30~70 thousands unstructured cells per CPU-Core is suggested. +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). + +int pgridtype = 1; +int maxproc = 1; + +string original_grid_file = "./grid/2D_NLR7301_Str.fts"; +string partition_grid_file = "./grid/2D_NLR7301_Str.fts"; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level,..., et al. +int numberOfMultigrid = 1; diff --git a/A16-TwoD_NLR7301_SST_Struct_4CPU/grid/2D_NLR7301_Str.grd b/A16-TwoD_NLR7301_SST_Struct_4CPU/grid/2D_NLR7301_Str.grd new file mode 100644 index 0000000..2468de6 Binary files /dev/null and b/A16-TwoD_NLR7301_SST_Struct_4CPU/grid/2D_NLR7301_Str.grd differ diff --git a/A16-TwoD_NLR7301_SST_Struct_4CPU/grid/2D_NLR7301_Str.inp b/A16-TwoD_NLR7301_SST_Struct_4CPU/grid/2D_NLR7301_Str.inp new file mode 100644 index 0000000..10659c9 --- /dev/null +++ b/A16-TwoD_NLR7301_SST_Struct_4CPU/grid/2D_NLR7301_Str.inp @@ -0,0 +1,58 @@ + 1 + 5 + 377 145 +A + 5 + 1 377 1 1 2 + 377 377 1 145 -1 + 89 89 145 1 2 + 1 377 145 145 4 + 1 1 81 145 -1 + 81 81 73 137 3 + 1 1 1 81 -1 + 49 49 1 81 5 + 89 329 +B + 6 + 89 1 329 329 2 + 1 1 329 1 -1 + 1 1 169 497 4 + 89 1 1 1 4 + 89 89 145 1 -1 + 377 377 1 145 1 + 89 89 177 145 2 + 89 89 177 329 -1 + 1 1 1 153 5 + 81 137 +C + 5 + 1 81 1 1 2 + 81 81 1 73 -1 + 49 49 153 81 5 + 81 81 73 137 -1 + 1 1 81 145 1 + 1 81 137 137 4 + 1 1 1 137 -1 + 1 1 137 1 4 + 89 497 +D + 6 + 1 89 1 1 4 + 89 89 1 497 4 + 1 89 497 497 4 + 1 1 169 497 -1 + 1 1 329 1 2 + 1 1 137 169 2 + 1 1 137 1 -1 + 1 1 1 137 3 + 49 153 +E + 5 + 1 49 1 1 2 + 49 49 1 81 -1 + 1 1 1 81 1 + 49 49 153 81 -1 + 81 81 1 73 3 + 1 49 153 153 2 + 1 1 1 153 -1 + 89 89 177 329 2 diff --git a/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/boundary_condition.hypara b/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/boundary_condition.hypara new file mode 100644 index 0000000..0592952 --- /dev/null +++ b/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/boundary_condition.hypara @@ -0,0 +1,53 @@ +# nBoundaryConditons : number of global boundary conditions. +# bcName : Boundary Condition Name. +# bcType(in PHengLEI): Boundary Condition Type. + +# Account of how to set boundaryconditon. +# string bcName = "Farfield"; +# { +# int bcType = 4; +# int inflowParaType = 1; +# double attackd = 0; +# double refReNumber = 6.5e6; +# double refMachNumber = 3.5; +# double angleSlide = 0; +# } + +int nBoundaryConditons = 5; +string bcName = "wall"; +{ + string bodyName = "body"; + int bcType = 2; +} +string bcName = "sym"; +{ + int bcType = 3; +} +string bcName = "in"; +{ + int bcType = 4; +} +string bcName = "up"; +{ + int bcType = 4; +} +string bcName = "out"; +{ + int bcType = 6; +} + +# 'bcType' is defined as following: +# 99: PERIODIC +# -2: WAKE +# -1: INTERFACE +# 0 : NO_BOUNDARY_CONDITION +# 1 : EXTRAPOLATION +# 2 : SOLID_SURFACE +# 3 : SYMMETRY +# 4 : FARFIELD +# 5 : INFLOW +# 6 : OUTFLOW +# 52: PRESSURE_INLET +# 62: PRESSURE_OUTLET +# 61: OUTFLOW_CONFINED +# 7 : POLE diff --git a/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/cfd_para.hypara b/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/cfd_para.hypara new file mode 100644 index 0000000..b17970c --- /dev/null +++ b/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/cfd_para.hypara @@ -0,0 +1,1220 @@ +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +// PPPPP H H EEEEE N N GGGGG L EEEEE III + +// P P H H E NN N G L E I + +// PPPPP HHHHH EEEEE N N N G GG L EEEEE I + +// P H H E N N N G G L E I + +// P H H EEEEE N N GGGGG LLLLL EEEEE III + +//------------------------------------------------------------------------+ +// Platform for Hybrid Engineering Simulation of Flows + +// China Aerodynamics Research and Development Center + +// (C) Copyright, Since 2010 + +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +########################################################################### +# Default parameters for Grid conversion # +########################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// 2 -- Hybrid grid, include both of unstructured and structured grid. +// gridobj: Task type of grid treatment. +// 0 -- Grid generation of typical case, such as cylinder, flat plate, etc. +// 1 -- Grid conversion, from other grid data to PHenglEI, such as Fluent, CGNS. +// 2 -- Grid refinement. +// 3 -- Grid merging, merge two blocks into one block. +// 4 -- Grid deformation, achieve unstructured grid deformation. +// 5 -- Grid repairing, repair the original grid in order to remove the negative volume cells. +// 6 -- Grid mirroring, mirror a symmetry grid to whole grid. +// multiblock: Multi-block grid or not, only for structured grid conversion. +// 0 -- Not. +// 1 -- Yes. +// iadapt: Adaptation number for unstructure grid. +// SymmetryFaceVector: The vector of symmetry face. +// 0 -- X axis. +// 1 -- Y axis. +// 2 -- Z axis. +int gridtype = 0; +int gridobj = 1; +int multiblock = 0; +int iadapt = 0; +int SymmetryFaceVector = 1; + +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +int axisup = 1; + +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +int omit_no_bound_bc = 0; + +//----------------------------------------------------------------------- +# Grid data type # +//----------------------------------------------------------------------- +// from_gtype/to_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +// dumpOldGrid: If dump out the old grid file. +// 0 -- Not. (default) +// 1 -- Yes. +int from_gtype = 2; +int to_gtype = 1; +int dumpOldGrid = 0; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +int numberOfGridFile = 1; +string from_gfile = "./grid/rae2822_hybrid2d.cas"; +string from_gfile1= ""; + +string out_gfile = "./grid/flat_laminr_133_85_2d.fts"; + +// ----------------- some advanced choices ------------------------------ +// iunsteady: The Grid is for unsteady simulation or not. +int iunsteady = 0; +int codeOfAleModel = 0; + +// fileformat: Ustar Grid file format. +// 0 -- BINARY. +// 1 -- ASCII. +int fileformat = 0; + +// Parameters for hybrid solver. +// mixgrid_uns: path of unstructure grid file for hybrid solver, *.fts type. +// mixgrid_str: path of structure grid file for hybrid solver, *.fts type. +string mixgrid_uns = "./grid/rae2822_uns2d_4.fts"; +string mixgrid_str = "./grid/flat_laminr_133_85_2d.fts"; + +// Some parameters for structured overlapping grid. +int codeOfDigHoles = 1; +string holeBasicFileName = "./oversetGridView/holeBasicFile.inp"; +string holeFullFileName = "./oversetGridView/holeFullFile.dat"; +string linkFileName = "./oversetGridView/topology.dat"; +string zoneInverseFileName = "./oversetGridView/zoneInverseMapping.inp"; + +// ----------------- Adaptive Mesh Refine ------------------------------- +// In this file, the original_grid_file is used of the partition part. +// If use it dependently, abstract it here. +string adapt_grid_file = "./grid/sphere_mixed_adapt1.fts"; +string geometryFileName = "./grid/jsm.igs"; + +// geometryUnit: Geometry unit. +// 1 -- meter. +// 2 -- millimeter. +// 3 -- inch. +// exclusiveCase: Parallel projection exclusive case. +// 0 -- NON case. +// 1 -- JSM-C2-NPOFF case. +// 2 -- CHNT. +// projectOrgPoint: If the original wall points need to be projected or not. +int geometryUnit = 1; +int anisoRefine = 0; +int isProject = 0; +int readDist = 0; +int isDeform = 0; +int exclusiveCase = 0; // 0: NON case; 1: JSM-C2-NPOFF case; 2: CHNT. +int projectOrgPoint = 0; // if project original wall points. + + +// ----------------- Grid Deform Parameters ----------------------------- +// deformationMethod: Grid Deform. +// 1 -- SPRING. +// 2 -- RBF. +// stationalGridFile: Original grid file. +// visualFileName : The visualization file path of deform grid. +// nDeformStep : The max deform step. +// flapAngle : The max flap angle. +// rotatePostionZ : Rotate postion. +// rotatePostionY : Rotate postion. +// gridSlice : If dump slice grid. +// sliceAxis : Grid slice axis. +// slicePosition : Grid slice position. +int nDeformStep = 40; +double flapAngle = 10.0; +double rotatePostionZ = 4.00003; +double rotatePostionY = 3.05; + +int deformationMethod = 2; +string stationalGridFile = "./grid/Segment2Brid.fts"; +string visualFileName = "./results/deformedGrid.dat" + +int gridSlice = 1; +int sliceAxis = 1; +double slicePosition = 13; + +// ----------------- RBF Parameters ------------------------------------- +// numberOfReferenceCP : Number of reference Control Points. +// influencePara : The RBF influence radius parameter. +int numberOfReferenceCP = 40; +double influencePara = 25.0; + +// ----------------- Periodic Parameters -------------------------------- +// Notice: Rotational periodicity only support rotation along the X axis! +// periodicType: Which periodic boundary is used. +// 0 -- without Periodic Boundary. +// 1 -- Translational periodicity. +// 2 -- Rotational periodicity. +// translationLength[]: The relative distance between two periodic face + which only support one direction. +// rotationAngle: The relative angle between two periodic face. + which is recorded in degrees. + +int periodicType = 0; +double translationLength[] = [0.0,0.0,0.0]; +double rotationAngle = 0.0; + +######################################################################### +# Default parameters for Partition # +######################################################################### +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// 2 -- refine structured grid. +// maxproc: The number of partition zones that want to be divided into. +int pgridtype = 0; +int maxproc = 4; + +// traceMark: Trace mark or not, only for structured grid partition. +// 0 -- Not. +// 1 -- Yes. +// blockIndexOfMark: the block index of mark, only for structured grid partition. +// cellIndexOfMark: the cell index of mark, only for structured grid partition. +int traceMark = 0; +int blockIndexOfMark = 0; +int cellIndexOfMark[] = [185,30,1]; + +// parallel Strategy: +//! -# 0 : each zone is assigned to the one that defined in grid partition procedure. +//! -# 1 : random assigned for each zone or by some else ways. +int parallelStrategy = 1; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). +string original_grid_file = "./grid/sphere_mixed.fts"; +string partition_grid_file = "./grid/sphere_mixed__4.fts"; + +// ------------------ Sompe advanced parameters ------------------------- +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +// npartmethod: Method of interface reconstruction, default is 1. +// parallelPartitionMethod: Method of parallel partition, this is set only when execute parallel partition. It would be skipped when serial partition. +// 1 -- Using ParMetis for homogeneous MPI. +// 2 -- Using Metis for homogeneous MPI. +// 3 -- using METIS partition for homogeneous OpenMP. +// parmetisBalance: Used to specify the imbalance tolerance. +// 1 -- perfect balance. +// maxproc -- perfect imbalance. +// 1.05 -- recommended. + +int omit_no_bound_bc = 0; +int npartmethod = 1; +int parallelPartitionMethod = 2; +double parmetisBalance = 1.05; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level, ..., et al. +int numberOfMultigrid = 1; + +######################################################################### +# Default parameters for CFD simulation # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepSample: The step intervals for monitored probes variables file 'sample.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual file 'res.dat' saved. +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) + +int maxSimuStep = 20000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepSample = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; +int ifLowSpeedPrecon = 0; + +// compressible: +// 0 -- incompressible flow. +// 1 -- compressible flow. (default) +int compressible = 1; + +//----------------------------------------------------------------------- +# CFD Control Parameter # +//----------------------------------------------------------------------- +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// 4 -- the condition that the velocity, temperature and density are given. +// 5 -- the condition that the velocity, temperature and pressure are given. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. +// radiationCoef: The radiation coefficient on wall, it is used to compute the radiation heat flux on wall when the boundary +// condition is radiation equilibrium temperature, and 0.8 is the default value. +// refMolecularWeight : the reference molecular weight of gas used for perfect gas. The unit is g/mol. +// Generally, the gas is air. Sometimes, it is experiment gas, such as Nitrogen, Argon, and so on. + +double refMachNumber = 0.73; +double attackd = 2.79; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 6.5e6; +double refDimensionalTemperature = 288.15; +double freestream_vibration_temperature = 300.00; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +//int inflowParaType = 3; +//int nsubsonicInlet = 1; +//int nsubsonicOutlet = 1; +//string inLetFileName = "./bin/subsonicInlet.hypara"; +//string outLetFileName = "./bin/subsonicOutlet.hypara"; +//double refDimensionalTemperature = 288.144; +//double refDimensionalPressure = 1.01313E05; + +//The velocity, temperature and density are fixed. +//int inflowParaType = 4; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalDensity = 1.0e3; + +//The velocity, temperature and pressure are fixed. +//int inflowParaType = 5; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalPressure = 1.0e5; + +//The MachNumber, temperature and pressure are fixed. +//int inflowParaType = 6; +//double refDimensionalTemperature = 293; +//double refDimensionalPressure = 8886.06; + +double wallTemperature = -1.0; + +double radiationCoef = 0.8; +double gridScaleFactor = 1.0; + +int numberOfAerodynamicForceComponents = 1; +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. +double refMolecularWeight = 28.9644; // unit of g/mol. + +//----------------------------------------------------------------------- +# Spatial Discretisation # +//----------------------------------------------------------------------- +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "hlle", "lax_f". +// -- "roe", "modified_roe". +// -- "ausm+", "ausm+w", "ausm+up", "ausmdv", "ausmpw", "ausmpw+". +// str_limiter_name: Limiter of struct grid. +// -- "vanalbada", "vanleer", "minmod", "smooth", "minvan", "3rdsmooth", "3rd_minmod_smooth". +// -- "nolim", no limiter. +// -- "vanalbada_clz", clz supersonic version. +string inviscidSchemeName = "roe"; +string str_limiter_name = "vanalbada"; + +#******************************************************************* +# UnStruct Solver or Common * +#******************************************************************* +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 2 -- Algebraic. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "0eq-bl". +// -- "1eq-sa". +// -- "2eq-kw-menter-sst". +// -- "2eq-kw-menter-bsl". +// -- "2eq-kw-wilcox-1988". +// -- "2eq-kw-wilcox-1998". +// -- "2eq-kw-kok-tnt". +// -- "2eq-kw-wilcox-2006". +// -- "easm-kw-2003". +// -- "easm-kw-2005". +// DESType: Type of DES. +// 0 -- RANS. (default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpw+". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "barth", "vencat", "vanleer", "minmod". +// -- "vanalbada", "smooth", "nnd", "lpz", "1st". +// -- "nolim", no limiter. +// uns_vis_name: Discretisation method of viscous term. +// -- "std", "test", "aver", "new1", "new2". +// gradientName: Gradient reconstruction method. +// -- "default", "ggcell", "ggnode", "lsq". +// ivencat: Variation of vencat limiter. +// 0 -- org method, it is independent of grid scale. +// 1 -- new method, it is dependent of grid scale. +// 4 -- Ustar limiter model, without grid size unitary. +// 7 -- default used. +// venkatCoeff: Cofficient of vencat, when using vencat limter. +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. +// skewnessAngle: The skewness angle of grid cells. +// roeEntropyFixMethod: Entropy fix (correction) method. +// 1 -- direct fix, which limits the minimum eigenvalue directly. +// 2 -- multi-dimensional fix, which is derived from structured solver and now is only valid for struct solver. +// 3 -- Harten type, which is default used. +// roeEntropyScale: Entropy fix (correction) coefficient scale, default is 1.0. +// It is used to scale the default Roe entropy fix coefficients. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +string uns_scheme_name = "roe"; +string uns_limiter_name = "vencat"; +string uns_vis_name = "test"; +string gradientName = "ggnode"; + +int ivencat = 7; +double venkatCoeff = 5.0; +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; +double skewnessAngle = 60.0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; + +//----------------------------------------------------------------------- +# Temporal Discretisation # +//----------------------------------------------------------------------- +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// physicalTimeStep: The nondimensional physical time step. +// ifStartFromSteadyResults: The unsteady simulation is start from steady flowfield or not, 0 is for no and else is for yes. +// ifStaticsFlowField: Statistical variables for unsteady simulation. +// ifStaticsReynoldsStress: Statistical Reynolds stress for unsteady simulation. +// startStatisticStep: Outer step when start statistics. +// when the value is larger than "maxSimuStep", it is useless. +// statisticalTimePeriod: Used as time period of statistic analysis. +// when the value is negative, time period is treated as infinite. +// statisticMethod: Statistic reynolds stress method. + 0 --tau = - ^2 + 1 --tau = +// min_sub_iter: The min sub iteration of unsteady simulation. +// max_sub_iter: The max sub iteration of unsteady simulation. +// tol_sub_iter: The tolerance of sub iteration of unsteady simulation. +// tscheme: Temporal Discretisation method. +// 1 -- Runge-Kutta Multi-State. +// 2 -- Point implicit. +// 3 -- Full implicit. +// 4 -- LU-SGS. +// 5 -- Block LU-SGS. +// 6 -- Jacobian iteration. +// 7 -- Lower G-S iteration. +// 8 -- Upper G-S iteration. +// 9 -- Lower/Upper G-S iteration. +// iSimplifyViscousTerm: Simplify the computation of viscous term in the Block LU-SGS method. The default value assigns 1 that could speed up the computation. +// Otherwise, the viscous Jacobian matrix Mv should be computed that will increase the memory and time in iteration of the BLUSGS method. +// CFLStart: Started cfl number. +// CFLEnd: End cfl number. +// CFLVaryStep: The number of step when cfl increase from CFLStart to CFLEnd. +// ktmax: Dtratio. dt[i] = MIN(dt[i], ktmax * dtmin / vol[i]) +// swapDq: Communication dq between forward/backward sweep of LUSGS or not, default is 0. +// nLUSGSSweeps: Sub iteration of LU-SGS or Block LU-SGS. +// LUSGSTolerance: Sub iter tolerance of LU-SGS or Block LU-SGS. +// ifLocalTimeStep: Time step method. +// 0 --Local. +// 1 --Global. +// visl_min: Minimum value of laminar viscosity coefficient. +// turbCFLScale: Turbulence model cfl number factor. +// codeOfAleModel: Arbitrary Lagrangian-Eulerian method. +// 0 -- no ALE method. +// 1 -- ALE method for non-moving grids. +// 2 -- ALE method for moving grids. +// 3 -- ALE method for deforming grids. +// wallFunctionType: The type of wall function to implement. +// 0 -- no wall function. (default) +// 1 -- standard wall function. +// 2 -- Pab3D wall function. +// RKStage: The number of Runge-Kutta step. +// lamda: Cofficient of Runge-Kutta step. + +int iunsteady = 0; +double physicalTimeStep = 0.01; +int ifStartFromSteadyResults = 0; +int ifStaticsFlowField = 0; +int ifStaticsReynoldsStress = 0; +int startStatisticStep = 800000; +double statisticalTimePeriod = -1.0; +int statisticMethod = 0; +int linearTwoStepMethods = 1; // 1--BDF1; 2--C-N; 3--BDF2; + +int methodOfDualTime = 3; +int min_sub_iter = 50; +int max_sub_iter = 50; +double tol_sub_iter = 0.01; + +int tscheme = 4; +int iSimplifyViscousTerm = 1; +int ifLocalTimeStep = 0; +double CFLStart = 0.01; +double CFLEnd = 10.0; +int CFLVaryStep = 500; + +double ktmax = 1.0e10; + +int swapDq = 1; + +int nLUSGSSweeps = 1; +double LUSGSTolerance = 0.01; +int order = 2; + +double visl_min = 0.01; +double turbCFLScale = 1.0; +double csrv = 2.0; +double timemax = 1.0e10; +double dtsave = -1.0; +int maxale = 10; +double dtau = 0.001; + +int wallFunctionType = 0; + +int RKStage = 2; +double lamda[] = 0.5, 1.0; + +//int RKStage = 1; +//double lamda[] = 1.0; + +//int RKStage = 4; +//double lamda[] = [0.25, 0.33333333333, 0.5, 1.0]; + +//----------------------------------------------------------------------- +# File In or Out # +//----------------------------------------------------------------------- +// numberOfGridGroups: The number of grid groups. +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the field results to visulization. +// walldistMethod: The method to compute wall distance. +// 0 -- accurate but not fast enough. +// 1 -- fast but not accurate enough. +// 2 -- super fast but more non-accurate! +// resSaveFile: The file path to save the residual convergence process, write data for every default (intervalStepRes) steps. +// turbresfile: The file path to save the residual convergence process of turbulence, write data for every default (intervalStepRes) steps. +// aircoeffile: The file path to save the aerodynamic force coefficients convergence process, write data for every default (intervalStepForce) steps. +// restartNSFile: The file path to write restart flowfield variables, write data for every default (intervalStepFlow) steps. +// turbfile: The file path to write restart flowfield variables of turbulence , write data for every default(intervalStepFlow) steps. +// visualfile: The visualization file path of flowfield , write data for every default (intervalStepPlot) steps. +// wall_aircoefile: The file path to save flowfield variables of wall, write data for every default steps. +// nDumpSurfaceInfo = 0 the "wall_varfile" write the informations including heat flux. +// nDumpSurfaceInfo = 1 the "wall_varfile" write the informations without heat flux. + +int numberOfGridGroups = 1; +string gridfile = "./grid/rae2822_hybrid2d__4.fts"; +string wallTemperaturefile= ""; + +int walldistMethod = 1; + +string resSaveFile = "results/res.dat"; +string turbresfile = "results/turbres.dat"; +string aircoeffile = "results/aircoef.dat"; + +string restartNSFile = "results/flow.dat"; +string turbfile = "results/turb.dat"; + +string visualfile = "results/tecflow.plt"; +string wall_aircoefile = "results/wall_aircoef.dat"; +string samplefile = "results/sample.dat"; + +int nDumpSurfaceInfo = 0; +string wall_varfile = ""; + +string jetDefineFile = "bin/jet.hypara"; + +string sixDofFileName = "results/sixDofInfo.dat"; +string derivativeFileName = "results/identify.dat"; +string hysteresisFileName = "results/force_beta.plt"; + +int plotFieldType = 0; + +// visualfileType: The file type of visualfile. +// 0 -- Tecplot binary. +// 1 -- Tecplot ASCII. + +int visualfileType = 1; + +// samplefileMode: The dump mode of sample file. +// 0 -- dump out every probe/line/surface data for all step intervals. +// 1 -- dump out all probe/line/surface data for every step intervals. +int samplefileMode = 0; + +// visualSlice: The slice of tecflow. +// 0 -- Do not save slice data. +// 1 -- comput and save it to sliceFile. +// sliceAxis: Normal vector of slice. +// 1 -- X_DIR. +// 2 -- Y_DIR. +// 3 -- Z_DIR. +// slicePostion: Coordinate of slice. + +int visualSlice = 0; +int sliceAxis = 1; +double slicePostion = -0.5; +string sliceFile = "results/Slice.plt"; +int dumpWallFaceCenter = 0; + +// min-max box of the visual block. +double lowerPlotFieldBox[] = [0.0 0.0 0.0]; +double upperPlotFieldBox[] = [1.0 1.0 1.0]; + +//-----------the optional parameters list for the flow field output---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40), +// -- gradientUx(41), gradientUy(42), gradientVx(43), gradientVy(44), iblank(81). +// -- specific heat ratio(gama, 56) +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. +//-----------the optional parameters list for the wall boundary condition---------------- +// nVisualWallVariables: The number of visual variables on wall. +// visualWallVariables : dumped variable types, listed as following: +// -coefficient of pressure(cp, 0), -coefficient of friction(cf, 1), yplus(2), -non-dimensional heat flux(Q_NonDim, 3), -dimensional heat flux(Q_Dim, 4), +// -pressure on wall(pw, 5), -temperature on wall(Tw, 6), -density on wall(rhow, 7), -heat flux of translational-rotational temperature term(Qtr, 8), +// -heat flux of species diffusion term(Qs, 9), -heat flux of vibrational temperature term(Qv, 10), -heat flux of electron temperature term(Qe, 11), +// -species mass fractions(Ns, 12), -x component of wall velocity(Vx, 13), -y component of wall velocity(Vy, 14), -z component of wall velocity(Vz, 15) +// -slip translational-rotational temperature(Tts, 16), -slip vibrational temperature(Tvs, 17), -slip electron temperature(Tes, 18), -absolute wall velocity(Vs, 19) +// -Stanton number(St, 20), -coefficient of heat rate(Ch, 21), -temperature jump(deltaT, 22), -transition gamaeff(gamaeff, 48), +// -transition intermittency(intermittency, 51), -transition momentum thickness reynolds(MomentumThicknessReynolds, 52), +// -overlap iblank(iblank, 81) + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +int nVisualWallVariables = 9; +int visualWallVariables[] = [0, 1, 2, 3, 4, 5, 9, 10, 11]; + +// dumpStandardModel: Dump many standard model data. +// 1 -- Turbulent flat plate. +int dumpStandardModel = 0; + +// ifSetDataMonitor: Whether to set the data monitor. +// 0 -- No. +// 1 -- Yes. +// dataMonitorType: The type of data Monitor. +// 0 -- Probes data monitor. +// 1 -- Lines data monitor. +// 2 -- Surfaces data monitor. +// probesDefineFile: Probes location information file. +// nLines: The number of lines need to be monitored. +// linesDefineFile: Lines location information file. +// nSurfaces: The number of surfaces need to be monitored. +// surfacesDefineFile: Surfaces location information file. +// searchCellsMethod: method to search the cell of each probe. +// 0 -- Nearest cell to the probe. +// 1 -- Real cell where the probe is located. +// nProbeVariables: Number of variables want to be dumped for probes monitered. +// probeVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5). +// Important Warning: Array size of probeVariables MUST be equal to nProbeVariables!!! +// probeVariables order must from small to big. +// probeVariablesInterpolationMethod: Interpolation method used to compute the probe variables. +// 0 -- Take the value of probe's cell as probe real value. +// 1 -- Interpolation from probe's and neighbouring cell to probe. +// 2 -- Interpolation from probe's cell nodes to probe. +int ifSetDataMonitor = 0; + +int dataMonitorType = 0; +string probesDefineFile = "bin/probes_XYZ.dat"; + +//int dataMonitorType = 1; +//int nLines = 1; +//string linesDefineFile = "bin/lines_XYZ.dat"; + +//int dataMonitorType = 2; +//int nSurfaces = 4; +//string surfacesDefineFile = "bin/surfaces_XYZ.dat"; + +int searchCellsMethod = 0; + +int nProbeVariables = 6; +int probeVariables[] = [0, 1, 2, 3, 4, 5]; +int probeVariablesInterpolationMethod = 0; +//----------------------------------------------------------------------- +# Turbulence Parameter # +//----------------------------------------------------------------------- +// turbInterval: Iteration number of turbulence. +// kindOfTurbSource: Kinds of turbulent source. +// 0 -- Original. +// 1 -- Edwards. +// 2 -- new. +// mod_turb_res: If modify the residuals for the cells next to the wall or not, default is 0. + +int turbInterval = 1; +int turbOrderStruct = 2; +int kindOfTurbSource = 0; +int mod_turb_res = 0; +double turb_relax = 1.0; +double freeStreamViscosity = 1.0e-3; +double muoo = 3.0; +double kwoo = 5.0; +int transitionType = 0; +double turbIntensity = -1.0; +int freeturbIntensitySRModify = 0; +double freeDecayXLocation = 0.0; +int compressibleCorrection = 0; +int transitionMaFix = 1; + +# maximum eddy viscosity (myt/my) max. +double eddyViscosityLimit = 1.0e10; +int monitor_vistmax = 0; + +//----------------------------------------------------------------------- +# LES Parameter # +//----------------------------------------------------------------------- +// iLES: Create LESSolver or not. +// == 1 - Create LESSolver; +// != 1 - not. +// amplitudeofDisturb: Amplitude of adding disturb. +// disturbstep: Unsteady time step or steady iteration of adding random disturb. +// iterdisturb: Add random disturb in every sub-iter or only first sub-iter. +// = 0 - in only first sub-iter; +// != 0 - in every sub-iter. +// ipraddisturb: Add density and pressure disturb or not. +// ibodyforce: Add body force in source flux of NS equations or not. +// = 0 - not; +// != 0 - Add body force. +// bodyforce: Body force in source flux of NS equations or not. +// utau: friction velocity, using in DNSDisturb. +// sgsmodel: subgrid scale model. +// = "smagorinsky"; +// = "dsmCom"; +// = "wale"; +// = "sigma". +// deltaFunctionType: = 1 - MAX(deltai, deltaj, deltak); +// = 2 - pow(deltai * deltaj *deltak, 1/3); +// = 3 - Devloped by Scotti. +// wallDampingFunctionType: = 0 - no wall function; +// = 1 - van Driest; +// = 2 - developed by Dr. Deng Xiaobing; +// = 3 - developed by Piomelli. +// turbViscousCutType: turbulent viscosity cut type. +// = 0 - mu_total = mut + mul; +// = 1 - mu_total = max(mut-mul,0)+ mul; +// = 2 - mu_total = max(mut ,0)+ mul. +// smagConstant: constant of smagorinsky model. +// waleConstant: constant of wale model. +// filterDirection[3]: filter variables in i, j, k direction or not. +// averageDirection[3]: average variables in i, j, k direction or not. +// isotropicConstant: constant of isotropic part of SGS stress. + +int iLES = 0; +string sgsmodel = "smagorinsky"; +int deltaFunctionType = 2; +int wallDampingFunctionType = 1; +int turbViscousCutType = 2; +double smagConstant = 0.1; +double isotropicConstant = 0.0; +double waleConstant = 0.6; +double sigmaConstant = 1.35; +int filterDirection[] = [1, 1, 0]; +int averageDirection[] = [0, 0, 0]; +double testFilterScale = 2.0; +int averageWidth = 1; +int monitorNegativeConstant = 0; + +//----------------------------------------------------------------------- +# Other Parameters for Hypersonic Non-equilibrium Gas # +//----------------------------------------------------------------------- +// dg_high_order: +// 0 -- generic order accuracy. +// 1 -- high order accuracy. +// iapplication: +// 0 -- gas model is fixed in the codes. +// 1 -- gas model is imported from library files. +// iCodeBranch: +// 0 -- The old code version is used for Navier-Stokes. +// 1 -- A new code version is active for Navier-Stokes solver. +// nm: Equation number of the physics, but is out of commision now. +// 4 -- for 2D. +// 5 -- for 3D. +// nGasModel: The type of gas. less than and equal to 1 represents the mixture gas. +// Otherwise, the pure gas with one component is used for perfect gas. +// 0 -- Earth gas. +// 1 -- Mars gas. +// 2 -- Argon. +// 3 -- Nitrogen. +// nEnergyRecycle: The type of EnergyModel Recycle. +// 0 -- not used . +// 1 -- used. +// nDensityModify: The type of densitymodify. + +// 0 -- not used. +// 1 -- used. +// nchem: +// 0 -- without chemical reaction flow. +// 1 -- the chemical reaction flow is considered. +// nEquilibriumGas: the variable is valid when the condition of nchem=0 is satisfied. +// 0 -- perfect gas. +// 5, 7, 11 -- equilibrium gas, meanwhile, its value denotes the number of gas component. +// nPCWCycleStep: the maximum step number of iteration in the module of computing species mass fractions with the partial catalytic wall(PCW) condition. +// the value equals to or is greater than 1, and 3 is for default value. +// nRETCycleStep: the maximum step number of iteration in the module of computing radiation equilibrium temperature on wall. +// the value equals to or is greater than 1, and 3 is for default value. +// nSLIPCycleStep:the maximum step number of iteration in the module of computing slip temperature, slip velocity and slip species mass fraction. +// the value equals to or is greater than 1, and 3 is for default value. +// nSlipBCModel : The computational model of slip boundary conditions. + +// 0 -- no slip. +// 1 -- the conventional Maxwell slip conditions. +// 2 -- the Gokcen slip conditions. +// 3 -- the Knudsen-layer correction of the standard slip conditions proposed by Lockerby, et al. +// 4 -- the Kogan simplified slip conditions. +// nMeanFreePathType : the method to the mean free-path for the slip conditions. For the mixture, 0 is suggested. +// 0 -- the equivalent mean free-path is calculated by the simple hard sphere model(HS). +// 1 -- calculated by the definition that includes the variables of the number density and the molecule diameter. +// 2 -- the equivalent mean free-path is calculated by the variable hard sphere model(VHS). +// nchemsrc: +// 0 -- the source terms are not computed. +// 1 -- the source terms are computed. +// nchemrad: +// 0 -- compute the spectrum radius without considering chemical reaction flow. +// 1 -- compute the spectrum radius that need to count the contribution from chemical reaction flow. +// ntmodel: The thermodynamic temperature model. +// 1 -- One-temperature model. +// 2 -- Two-temperature model. +// 3 -- Three-temperature model. +// nTEnergyModel: the method to computing temperature energy model. +// 0 -- the energy term is computed using the conventional method. +// 1 -- the energy term is computed using the curve fitting method. +// parkVDPower: the power of translational-rotational temperature in the Park V-D(vibration-dissociation) coupling model. +// The value is in range of [0.0, 1.0], DPLR suggests 0.5, LAURA suggests 0.7, while 0.6 is given as default value. +// catalyticCoef: +// 0.0 -- full non-catalytic wall boundary condition. +// 1.0 -- full catalytic wall boundary condition. +// in range of (0.0, 1.0) -- partial catalytic condition, the value indicates the catalytic coefficient. +// nIsSuperCatalytic : the super catalytic condition for the fully catalytic wall, and assigned with the value of 1. +// 0 -- equilibrium condition for the fully catalytic wall where the mass fractions are assigned with the values of the free stream. +// 1 -- super catalytic condition for the fully catalytic wall where all the atomic components combine into molecular components. +// nTemperatureJump : the method to calculate the temperature jump. +// 0 -- calculated by the variables of heat conductivity and constant volume specific heat for each energy mode. +// 1 -- the general method where the iteration is calculated with the translation-rotation temperature. +// sigmaVelocity: the coordination coefficient of tangential momentum for computation of slip velocity. The value is in range of (0.0, 2.0]. +// sigmaTemperature: the heat coordination coefficient for computation of slip temperature. The value is in range of (0.0, 2.0]. +// sigmaMassFraction: the species coordination coefficient for computation of slip mass fractions. The value is in range of (0.0, 2.0]. +// velocitySlipCorrectConstant: the correction constant to the velocity slip condition. For the diffuse reflection, 1.0 is used. +// 1.0 -- proposed by Maxwell. +// sqrt(2/PI)~0.8 -- used for "micro-slip", namely the actual velocity slip at the wall. +// 1.146 -- proposed for an additional "fictitious" velocity slip. + +// chemicalRelaxCorf: The value is in range of [0.001, 1.0]. +// chemicalSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// viscousSpectrumRadiusCoef : The value is in range of [1.0, 3.0]. +// inviscidSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// staticPressureRelaxCorf: The value is in range of [0.1, 1.0]. +// nIsChemicalFreeze : the flag to freeze the chemical reactions. +// 0 -- not freeze, the chemical reaction sources will be calculated. +// 1 -- freezes the chemical reactions, the chemical reaction sources will not be calculated.// veTemperatureMin: The minimum of Tv and Te +// nDebug: cout the Wrong place and abort +// 0 -- not used. +// 1 -- used. +// nSpeciesLimit: limitter of gas species +// 0 -- not used. +// 1 -- used. +// nTurblenceForChemical: the coupled mode of Turblence and Chemical reaction +// 0 -- method 0. +// 1 -- method 1. +// nViscosityFluxSublevelModified: Modified for ViscosityFlux on Sublevel grid +// 0 -- not used. +// 1 -- used. +// nChemcalSourceModified: Modified on ChemcalSource +// 0 -- not used. +// 1 -- used. +// nAblation: +// 0 -- The wall ablation is not computed. +// 1 -- The wall ablation is computed. +// isInjection: +// 0 -- The injection velocity of ablation wall is not computed. +// 1 -- The injection velocity of ablation wall is computed. +// nViscosityModel: + +// 0 -- Blottner fitting method. +// 1 -- Gupta fitting method. +// nSutherland: +// 0 -- stands for selecting the Blotter curve fits mode. +// 1 -- stands for Sutherland relation. +// gasfile: Indicates the gas model, 9 models are provided, namely "Gu5", "Gu7", "Gu11", "Pa5", "Pa7", "Pa11", "DK5", "DK7", "DK11". +// "Gu" -- indicates the Gupta Model, three-Type Models are embeded in the library, namely, the 5-species-6-reactions, the 7-species-9-reactions, the 11-species-20-reactions. +// "Pa" -- indicates the Park Model, three-Type Models are embeded in the library, namely, the 5-species-17-reactions, the 7-species-22-reactions, the 11-species-48-reactions. +// "DK" -- indicates the Dunn-Kang Model, three-Type Models are embeded in the library, namely, the 5-species-11-reactions, the 7-species-15-reactions, the 11-species-26-reactions. +// "Mars-Pa8" is for Park model of Mars gas, "Mars-Mc8" for McKenzie model of Mars gas. +// "Combustion-12" -- indicates the Combustion Chamber Gas Model which includes 12-species-20-reactions. +// "Gas-Mixture" -- indicates the process of mixing two species without reacting. +// For self-definition model, the gasfile is used to indicate the file path of the new gas model. +// speciesName: Used to list the names of each species, while each species name is separated by the symbol of comma. +// initMassFraction: Used to list the initial mass fractions of species in accordance with the sequence of names in the parameter speciesName. +// ifStartFromPerfectGasResults: The chemical reaction simulation is start from perfect gas flowfield or not, 0 is for no and else is for yes. + +int dg_high_order = 0; +int iapplication = 0; +int iCodeBranch = 0; +int nm = 5; +int nEquilibriumGas = 0; +int nPCWCycleStep = 3; +int nRETCycleStep = 3; +int nSLIPCycleStep= 3; + +double refGama = 1.4; +double prl = 0.72; +double prt = 0.90; +double sc_l = 0.5; +double sc_t = 0.5; + +int nGasModel = 0; +int nchem = 0; +int nchemsrc = 1; +int nchemrad = 1; +int ntmodel = 1; + +int nEnergyRecycle = 0; +int nSlipBCModel = 0; +int nDensityModify = 1; +int nTEnergyModel = 0; +int nMeanFreePathType = 0; +int nIsChemicalFreeze = 0; +int nIsSuperCatalytic = 1; +int nTemperatureJump = 0; + +double parkVDPower = 0.6; +double catalyticCoef = 0.0; +double sigmaVelocity = 1.0; +double sigmaTemperature = 1.0; +double sigmaMassFraction = 1.0; +double velocitySlipCorrectConstant = 1.0; + +double chemicalRelaxCorf = 1.0; +double chemicalSpectrumRadiusCoef = 1.0; +double viscousSpectrumRadiusCoef = 1.0; +double inviscidSpectrumRadiusCoef = 1.0; +double staticPressureRelaxCorf = 1.0; + +double veTemperatureMin = 30.0; +int nDebug = 0; +int nSpeciesLimit = 0; +int nTurblenceForChemical = 0; +int nViscosityFluxSublevelModified = 0 ; +int nChemcalSourceModified = 0; + +int nAblation = 0; +int isInjection = 0; +int nViscosityModel = 0; +int nMarsModel = 0; +string gasfile = "DK5"; +//string gasfile = "./chemical/Dunn-Kang_air5s11r.dat"; +string speciesName = "O, O2, NO, N, N2"; +string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.767"; + +//string speciesName = "O, O2, NO, N, NO+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string speciesName = "O, O2, NO, N, O+, O2+, NO+, N+, N2+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Mars-Pa8"; +//string speciesName = "O, O2, NO, N, N2, C, CO, CO2"; +//string initMassFraction = "0.0015, 0.0429, 0.0, 0.0, 0.0, 0.0, 0.0777, 0.8779"; + +//string gasfile = "DK7"; +//string speciesName = "O, O2, NO, N, NO+, C, C2, CO, CO2, CN, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Combustion-12"; +//string speciesName = "O, O2, NO, N, C, CO, CO2, H, H2, OH, H2O, N2"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767"; + +//string gasfile = "Gas-Mixture"; +//string speciesName ="SpeciesA, SpeciesB"; +//string initMassFraction = "1.0, 0.0"; +int nSutherland = 0; +double gamaSpeciesA = 1.4; +double gamaSpeciesB = 1.3; +double molecularWeightSpeciesA = 29.0; +double molecularWeightSpeciesB = 30.0; + +int nChemicalFlowStep = 0; +int ifStartFromPerfectGasResults = 0; + +######################################################################### +// Multi-Grid parameters. +// nMGLevel: The number of level of Multi-Grid. +// <= 1 -- Single-level. +// > 1 -- multi-level. +// MGPreIteration: For each grid, the number of pre-smoothing steps. +// n_post: For each grid, the number of post-smoothing steps. +// MGCoarsestIteration: For the coarest grid the number of smoothing steps. +// MGFasType: V-multi cycle or W-multi cycle. +// 1 -- V-multi cycle. +// 2 -- W-multi cycle. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. +// mgCFLScale: CFL number enlarge times for coarse grid. +// mprol: Multi-grid interpolation method, interpolation from coarse cell to fine grid. +// 1 -- zero order. +// 2 -- first-order. (default) +// mgCorrectionLimit: Multi-grid correction limit. + +int nMGLevel = 1; +int MGCoarsestIteration = 1; +int MGPreIteration = 1; +int MGFasType = 1; +int n_post = 0; +int flowInitStep = 100; +int mprol = 2; +double mgCFLScale = 1.0; +double mgCorrectionLimit = 0.01; + +//--------------- Some parameter for turbulent model -------------------- +// neasm: The variation of kw turbulent model. +// ismooth_turb: Residual smooth for turb or not. +// SSTProductType: The type of product term based on vorticity for SST. +// SAProductType: The type of product term based on vorticity for SA. +int neasm = -3; +int SSTProductType = 0; +int ismooth_turb = 0; +int SAProductType = 2; + +// ----------------- Overset Grid parameter ----------------------------- +int codeOfDigHoles = 1; +int codeOfTurbulentModel = 0; +string masterFileName = "./grid/searchFile.inp"; +string holeBasicFileName = "./grid/holeBasicFile.inp"; +string holeFullFileName = "./grid/holeFullFile.dat"; +string linkFileName = "./grid/topology.dat"; +string zoneInverseFileName = "./grid/zoneInverseMapping.inp"; + +######################################################################### +# High Order Struct Solver # +######################################################################### +// isFVMOrFDM: +// 0 -- NSSolverStruct using Finite Volume Method. +// 1 -- NSSolverStruct using Finite Differ Method. +// SolverStructOrder: Spatial discretisation order of NS equations with struct grid. +// <= 2 -- finite volume method. +// >= 3 -- finite difference order. (to be completed) +// 0 -- default. +// str_highorder_interpolation_epsilon: Epsilon in weighted interpolation, bigger epsilon, better convergence, +// smaller epsilon, robuster for shock-detecting. +// str_highorder_interpolation_type: +// -- "classical", "test". +// str_highorder_flux_name: +// -- "roe", "steger". +// structhighordergradient: +// -- "conservation", "chain_rule". +int isFVMOrFDM = 0; +string str_highorder_solver = "WCNS"; +int SolverStructOrder = 0; +double str_highorder_interpolation_epsilon = 1.0e-6; +string str_highorder_interpolation_type = "test"; +string str_highorder_flux_name = "steger"; +string structhighordergradient = "conservation"; +double coefofstrflux = 0.5; +double limitcoefofinterface = 0.0; + +// ----------------- Advanced choices ----------------------------------- +// outtimesc: Time stepping scheme for the outer loop. +// MUSCLCoefXk: The parameter of MUSCL interpolations, belongs to [-1, 1]. +// -1 -- seconde-order fully-upwind differencing. +// 0 -- seconde-order upwind-biased differencing. +// 0.333333 -- third-order upwind-biased differencing. +// 1 -- seconde-order central differencing. +// MUSCLCoefXb: The limiter parameter. +// 0 -- the effect of the limiter is cancelled, means the first-order interpolations. +// allReduceStep: Iteration intervals for MPI AllReduce operation, default is 1. +string outtimesc = "impbd2"; +double MUSCLCoefXk = -1; +double MUSCLCoefXb = 1.0; +int allReduceStep = 1; + +// ----------------- overlap configuration ------------------------------ +// codeOfOversetGrid: Overlapping(overset) grid or not. +// 0 -- NON-overlapping grid. +// 1 -- Overlapping grid. +// oversetInterpolationMethod: the method of overset interpolation while field simulation +// 0 -- set the acceptor cell value by donor cell value. +// 1 -- set the acceptor cell value by distance weight of donor cell value. + +int codeOfOversetGrid = 0; +int oversetInterpolationMethod = 0; +int readOversetFileOrNot = 0; +int symetryOrNot = 0; +int readInAuxiliaryInnerGrid = 1; +int readInAuxiliaryOuterGrid = 0; +int readInSklFileOrNot = 0; +string auxiliaryInnerGrid0 = "./grid/aux-upper.fts"; +string auxiliaryInnerGrid1 = "./grid/aux-lower.fts"; +string auxiliaryInnerGrid2 = ""; +string oversetGridFileName = "./grid/iblank.ovs"; +double walldistMainZone = 1.0 +double toleranceForOversetSearch = 1.0e-3; +double toleranceForOversetBox = 1.0e-3; +int twoOrderInterpolationOrNot = 0; +int keyEnlargeOfActiveNodes = 0; +int outTecplotOverset = 0; + +int numberOfMovingBodies = 2; + +// ----------------- ALE configuration ------------------------------ +int codeOfAleModel = 1; +int aleStartStrategy = -1; + +int strategyForFaceNormalVelocity = 0; //0-By Sweeping volume; 1-By face center 1st; 2-By face center 2nd; +int strategyForGCLSource = 0; //0-present; 1-Ahn; + +//0:1st-Admas-Bashforth; 1:2nd-Admas-Bashforth; 2:1st-Implicit-Euler; 3:2nd-Implicit Euler; 4:2nd-Adams-Moulton; 5:3rd-Adams-Moulton +int methodForKineticEquation = 0; +double relaxParameterOfKinetic = 1.0; + +######################################################################### +# motive information # +######################################################################### +int numberOfMovingBodies = 1; + +############################## body0 ############################## +//mass of parts +double mass_0 = 1.0; +//mass matrix of parts Ixx Iyy Izz Ixy Ixz Iyz +double massMatrix_0[] = 1e-7, 1e-6, 1e-6, 0.0, 0.0, 0.0; +//initial six DOF position information of parts. xc yc zc +double massCenter_0[] = 0.0 , 0.0, 0.0; +//initial six DOF position information of parts. angleX angleY angleZ +double attitudeAngle_0[] = 0.0 , 0.0, 0.0; +//initial six DOF move information of parts. vc vy vz +double massCenterVelocity_0[] = 0.0, 0.0, 0.0; +//initial six DOF move information of parts. omigX omigY omigZ +double angularVelocity_0[] = 0.0, 0.0, 0.0; +//the object that the parts belong to. +int fartherIndex_0 = -1; +//the assembly position of the parts. xc yc zc angleX angleY angleZ +double configPamameter_0[] = 0.0 ,0.0 ,0.0 ,0.0 ,0.0 ,0.0; +//the move pattern of the parts. +// -1 given motion partten. +// 0 still. +// 1 six DOF motion. +// 2 three DOF motion. +// 11 X-axis forced motion. +// 12 Y-axis forced motion. +// 13 Z-axis forced motion. +// 14 forced pitch motion. +// 15 forced yaw motion. +// 16 forced roll motion. +int RBDMethod_0 = 0; +double amplitude_0 = 0.0; +double reduceFrequency_0 = 0.0; +//string uDFSixDofFileName_0 = "./Bin/UDFSixDof.Parameter"; +//additional force (system axis) fX fY fZ +double addedForce_0[] = 0.0 ,0.0 ,0.0 ; +//additional moment of Force (system axis) mX mY mZ +double addedMoment_0[] = 0.0 ,0.0 ,0.0 ; +//the deformation method of the parts. +int morphing_0 = 0; + +// post indentify +int integralOrder = 4; + + +// ---------------- ATP read -------------------------------------------- +//@int inflowParaType = 0; +//@double refReNumber = 6.5e6; +//@double refDimensionalTemperature = 288.15; +//@double freestream_vibration_temperature = 300.00; +//@double refDimensionalPressure = 0; +//@double height = 0; +//@int nsubsonicInlet = 0; +//@int nsubsonicOutlet = 0; +//@string inLetFileName = "./bin/subsonicInlet.hypara"; +//@string outLetFileName = "./bin/subsonicOutlet.hypara"; +//@double refDimensionalVelocity = 0; +//@double refDimensionalDensity = 0; + +######################################################################### +# Old Parameter # +######################################################################### +int isPlotVolumeField = 0; + diff --git a/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/cfd_para_supersonic.hypara b/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/cfd_para_supersonic.hypara new file mode 100644 index 0000000..ce2aa86 --- /dev/null +++ b/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/cfd_para_supersonic.hypara @@ -0,0 +1,191 @@ +######################################################################### +# General Control Parameter # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual 'res.dat' saved. + +int maxSimuStep = 20000; + +int intervalStepFlow = 2000; +int intervalStepPlot = 2000; +int intervalStepForce = 100; +int intervalStepRes = 10; + +######################################################################### +# Inflow Parameter # +######################################################################### +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceRefenenceLength, forceRefenenceLengthSpanWise, forceRefenenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. + +double refMachNumber = 2.85; +double attackd = 0.00; +double angleSlide = 0.00; + +double wallTemperature = -1.0; + +int inflowParaType = 0; +double refReNumber = 6.567e7; +double refDimensionalTemperature = 102.1; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +double gridScaleFactor = 1.0; + +double forceReferenceLengthSpanWise = 0.026; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. + +######################################################################### +# Physical models # +######################################################################### +// viscousType : Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "1eq-sa", when viscousType = 3. +// -- "2eq-kw-menter-sst", when viscousType = 4. +// DESType: Type of DES. +// 0 -- RANS.(default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +int roeEntropyFixMethod = 2; +double roeEntropyScale = 1.0; +######################################################################### +# Spatial Discretisation # +######################################################################### +#******************************************************************* +# Struct Solver * +#************************************************* +****************** +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "ausmpw". +// str_limiter_name: Limiter of struct grid. +// -- "minmod", "3rd_minmod_smooth". + +string inviscidSchemeName = "vanleer"; +string str_limiter_name = "minmod"; + +#******************************************************************* +# UnStruct Solver * +#******************************************************************* +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpwplus". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "vencat", "barth". +// -- "1st", meaning accuracy of first-order. +// -- "nolim", no limiter. +// venkatCoeff: Coefficient of vencat limiter, when uns_limiter_name = 'vencat'. +// The smaller the value, the more robust it is. + +string uns_scheme_name = "vanleer"; +string uns_limiter_name = "vencat"; +double venkatCoeff = 0.5; + +######################################################################### +# Temporal Discretisation # +######################################################################### +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// CFLEnd: The CFL number, [0.1, 100]. +// The bigger the value, the convergence faster but lower robustness. +// ktmax: The lower the value, the more robustness, 1.0e5 - 1.0e10. + +int iunsteady = 0; + +double CFLEnd = 1.0; + +double ktmax = 1.0e10; + +######################################################################### +# File In or Out # +######################################################################### +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// Please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the whole field results to tecplot or not, 0 / 1. + +string gridfile = "./grid/3d_16ramp_str.fts"; +int plotFieldType = 0; + +// ----------------- Advanced Parameters, DO NOT care it ---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables: Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21). +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. + +int reconmeth = 0; +int limitVariables = 0; +int limitVector = 1; diff --git a/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/grid_para.hypara b/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/grid_para.hypara new file mode 100644 index 0000000..7a7a6cf --- /dev/null +++ b/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/grid_para.hypara @@ -0,0 +1,30 @@ +######################################################################### +# Grid data type # +######################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +// from_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +int gridtype = 1; +int axisup = 2; +int from_gtype = 2; + +######################################################################### +# File path # +######################################################################### +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +string from_gfile = "./grid/3d_16ramp_str.cgns"; +string out_gfile = "./grid/3d_16ramp_str.fts"; diff --git a/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/key.hypara b/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/key.hypara new file mode 100644 index 0000000..1f6a6c5 --- /dev/null +++ b/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/key.hypara @@ -0,0 +1,56 @@ +string title = "PHengLEI Main Parameter Control File"; + +// IMPORTANT NOTICE: DON NOT MODIFY THE FOWLLOWING LINE. +string defaultParaFile = "./bin/cfd_para.hypara"; + +// ndim: Dimensional of the grid, 2 or 3. +// nparafile: the number of parameter files. +// nsimutask: simulation task type. +// 0 -- CFD Solver of NS or Turbulation. +// 1 -- Grid generation: for special typical cases, such as cylinder, flat plate, etc. +// Grid conversion: from other format to PHengLEI format (.fts). +// Grid reconstruction: such as grid adaptation. +// Grid merging: merge two blocks into one block. +// Grid repairing: repair the original grid in order to remove the negative volume cells. +// 2 -- Wall distance computation for turb-solver. +// 3 -- Grid partition. +// 4 -- Knowledge repository / examples of PHengLEI-API. +int ndim = 3; +int nparafile = 1; + +int nsimutask = 0; +//string parafilename = "./bin/cfd_para_subsonic.hypara"; +//string parafilename = "./bin/cfd_para_transonic.hypara"; +string parafilename = "./bin/cfd_para_supersonic.hypara"; +//string parafilename = "./bin/cfd_para_hypersonic.hypara"; +//string parafilename = "./bin/incompressible.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_para.hypara"; + +//int nsimutask = 2; +//string parafilename = "./bin/cfd_para.hypara"; + +//int nsimutask = 3; +//string parafilename = "./bin/partition.hypara"; + +//int nsimutask = 4; +//string parafilename = "./bin/repository.hypara"; + +//int nsimutask = 5; +//string parafilename = "./bin/overset_grid_view.hypara"; + +//int nsimutask = 13; +//string parafilename = "./bin/lbm_para.hypara"; + +//int nsimutask = 14; +//string parafilename = "./bin/integrative_solver.hypara"; + +//int nsimutask = 99; +//string parafilename = "./bin/post_processing.hypara"; + +// ---------------- Advanced Parameters, DO NOT care it ---------------- +int numberOfGridProcessor = 0; +// ATP read +//@string parafilename1 = "" +//@string parafilename2 = ""; diff --git a/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/partition.hypara b/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/partition.hypara new file mode 100644 index 0000000..4e95633 --- /dev/null +++ b/A17-ThreeD_Compression_Ramp-16_SA_Struct/bin/partition.hypara @@ -0,0 +1,21 @@ +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// maxproc: The number of partition zones that want to be divided into, +// which is equal to the number of CPU processors you want. +// Usually, 50~100 thousands structured cells per CPU-Core is suggested. +// 30~70 thousands unstructured cells per CPU-Core is suggested. +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). + +int pgridtype = 0; +int maxproc = 1; + +string original_grid_file = "./grid/3d_16ramp_str.fts"; +string partition_grid_file = "./grid/3d_16ramp_str.fts"; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level,..., et al. +int numberOfMultigrid = 1; diff --git a/A17-ThreeD_Compression_Ramp-16_SA_Struct/grid/3d_16ramp_str.cgns b/A17-ThreeD_Compression_Ramp-16_SA_Struct/grid/3d_16ramp_str.cgns new file mode 100644 index 0000000..a0f1811 Binary files /dev/null and b/A17-ThreeD_Compression_Ramp-16_SA_Struct/grid/3d_16ramp_str.cgns differ diff --git a/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/boundary_condition.hypara b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/boundary_condition.hypara new file mode 100644 index 0000000..15112a8 --- /dev/null +++ b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/boundary_condition.hypara @@ -0,0 +1,49 @@ +# nBoundaryConditons : number of global boundary conditions. +# bcName : Boundary Condition Name. +# bcType(in PHengLEI): Boundary Condition Type. + +# Account of how to set boundaryconditon. +# string bcName = "Farfield"; +# { +# int bcType = 4; +# int inflowParaType = 1; +# double attackd = 0; +# double refReNumber = 6.5e6; +# double refMachNumber = 3.5; +# double angleSlide = 0; +# } + +int nBoundaryConditons = 4; +string bcName = "wall"; +{ + string bodyName = "body"; + int bcType = 2; +} +string bcName = "sym"; +{ + int bcType = 3; +} +string bcName = "in"; +{ + int bcType = 5; +} +string bcName = "out"; +{ + int bcType = 6; +} + +# 'bcType' is defined as following: +# 99: PERIODIC +# -2: WAKE +# -1: INTERFACE +# 0 : NO_BOUNDARY_CONDITION +# 1 : EXTRAPOLATION +# 2 : SOLID_SURFACE +# 3 : SYMMETRY +# 4 : FARFIELD +# 5 : INFLOW +# 6 : OUTFLOW +# 52: PRESSURE_INLET +# 62: PRESSURE_OUTLET +# 61: OUTFLOW_CONFINED +# 7 : POLE diff --git a/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/cfd_para.hypara b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/cfd_para.hypara new file mode 100644 index 0000000..b17970c --- /dev/null +++ b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/cfd_para.hypara @@ -0,0 +1,1220 @@ +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +// PPPPP H H EEEEE N N GGGGG L EEEEE III + +// P P H H E NN N G L E I + +// PPPPP HHHHH EEEEE N N N G GG L EEEEE I + +// P H H E N N N G G L E I + +// P H H EEEEE N N GGGGG LLLLL EEEEE III + +//------------------------------------------------------------------------+ +// Platform for Hybrid Engineering Simulation of Flows + +// China Aerodynamics Research and Development Center + +// (C) Copyright, Since 2010 + +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +########################################################################### +# Default parameters for Grid conversion # +########################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// 2 -- Hybrid grid, include both of unstructured and structured grid. +// gridobj: Task type of grid treatment. +// 0 -- Grid generation of typical case, such as cylinder, flat plate, etc. +// 1 -- Grid conversion, from other grid data to PHenglEI, such as Fluent, CGNS. +// 2 -- Grid refinement. +// 3 -- Grid merging, merge two blocks into one block. +// 4 -- Grid deformation, achieve unstructured grid deformation. +// 5 -- Grid repairing, repair the original grid in order to remove the negative volume cells. +// 6 -- Grid mirroring, mirror a symmetry grid to whole grid. +// multiblock: Multi-block grid or not, only for structured grid conversion. +// 0 -- Not. +// 1 -- Yes. +// iadapt: Adaptation number for unstructure grid. +// SymmetryFaceVector: The vector of symmetry face. +// 0 -- X axis. +// 1 -- Y axis. +// 2 -- Z axis. +int gridtype = 0; +int gridobj = 1; +int multiblock = 0; +int iadapt = 0; +int SymmetryFaceVector = 1; + +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +int axisup = 1; + +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +int omit_no_bound_bc = 0; + +//----------------------------------------------------------------------- +# Grid data type # +//----------------------------------------------------------------------- +// from_gtype/to_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +// dumpOldGrid: If dump out the old grid file. +// 0 -- Not. (default) +// 1 -- Yes. +int from_gtype = 2; +int to_gtype = 1; +int dumpOldGrid = 0; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +int numberOfGridFile = 1; +string from_gfile = "./grid/rae2822_hybrid2d.cas"; +string from_gfile1= ""; + +string out_gfile = "./grid/flat_laminr_133_85_2d.fts"; + +// ----------------- some advanced choices ------------------------------ +// iunsteady: The Grid is for unsteady simulation or not. +int iunsteady = 0; +int codeOfAleModel = 0; + +// fileformat: Ustar Grid file format. +// 0 -- BINARY. +// 1 -- ASCII. +int fileformat = 0; + +// Parameters for hybrid solver. +// mixgrid_uns: path of unstructure grid file for hybrid solver, *.fts type. +// mixgrid_str: path of structure grid file for hybrid solver, *.fts type. +string mixgrid_uns = "./grid/rae2822_uns2d_4.fts"; +string mixgrid_str = "./grid/flat_laminr_133_85_2d.fts"; + +// Some parameters for structured overlapping grid. +int codeOfDigHoles = 1; +string holeBasicFileName = "./oversetGridView/holeBasicFile.inp"; +string holeFullFileName = "./oversetGridView/holeFullFile.dat"; +string linkFileName = "./oversetGridView/topology.dat"; +string zoneInverseFileName = "./oversetGridView/zoneInverseMapping.inp"; + +// ----------------- Adaptive Mesh Refine ------------------------------- +// In this file, the original_grid_file is used of the partition part. +// If use it dependently, abstract it here. +string adapt_grid_file = "./grid/sphere_mixed_adapt1.fts"; +string geometryFileName = "./grid/jsm.igs"; + +// geometryUnit: Geometry unit. +// 1 -- meter. +// 2 -- millimeter. +// 3 -- inch. +// exclusiveCase: Parallel projection exclusive case. +// 0 -- NON case. +// 1 -- JSM-C2-NPOFF case. +// 2 -- CHNT. +// projectOrgPoint: If the original wall points need to be projected or not. +int geometryUnit = 1; +int anisoRefine = 0; +int isProject = 0; +int readDist = 0; +int isDeform = 0; +int exclusiveCase = 0; // 0: NON case; 1: JSM-C2-NPOFF case; 2: CHNT. +int projectOrgPoint = 0; // if project original wall points. + + +// ----------------- Grid Deform Parameters ----------------------------- +// deformationMethod: Grid Deform. +// 1 -- SPRING. +// 2 -- RBF. +// stationalGridFile: Original grid file. +// visualFileName : The visualization file path of deform grid. +// nDeformStep : The max deform step. +// flapAngle : The max flap angle. +// rotatePostionZ : Rotate postion. +// rotatePostionY : Rotate postion. +// gridSlice : If dump slice grid. +// sliceAxis : Grid slice axis. +// slicePosition : Grid slice position. +int nDeformStep = 40; +double flapAngle = 10.0; +double rotatePostionZ = 4.00003; +double rotatePostionY = 3.05; + +int deformationMethod = 2; +string stationalGridFile = "./grid/Segment2Brid.fts"; +string visualFileName = "./results/deformedGrid.dat" + +int gridSlice = 1; +int sliceAxis = 1; +double slicePosition = 13; + +// ----------------- RBF Parameters ------------------------------------- +// numberOfReferenceCP : Number of reference Control Points. +// influencePara : The RBF influence radius parameter. +int numberOfReferenceCP = 40; +double influencePara = 25.0; + +// ----------------- Periodic Parameters -------------------------------- +// Notice: Rotational periodicity only support rotation along the X axis! +// periodicType: Which periodic boundary is used. +// 0 -- without Periodic Boundary. +// 1 -- Translational periodicity. +// 2 -- Rotational periodicity. +// translationLength[]: The relative distance between two periodic face + which only support one direction. +// rotationAngle: The relative angle between two periodic face. + which is recorded in degrees. + +int periodicType = 0; +double translationLength[] = [0.0,0.0,0.0]; +double rotationAngle = 0.0; + +######################################################################### +# Default parameters for Partition # +######################################################################### +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// 2 -- refine structured grid. +// maxproc: The number of partition zones that want to be divided into. +int pgridtype = 0; +int maxproc = 4; + +// traceMark: Trace mark or not, only for structured grid partition. +// 0 -- Not. +// 1 -- Yes. +// blockIndexOfMark: the block index of mark, only for structured grid partition. +// cellIndexOfMark: the cell index of mark, only for structured grid partition. +int traceMark = 0; +int blockIndexOfMark = 0; +int cellIndexOfMark[] = [185,30,1]; + +// parallel Strategy: +//! -# 0 : each zone is assigned to the one that defined in grid partition procedure. +//! -# 1 : random assigned for each zone or by some else ways. +int parallelStrategy = 1; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). +string original_grid_file = "./grid/sphere_mixed.fts"; +string partition_grid_file = "./grid/sphere_mixed__4.fts"; + +// ------------------ Sompe advanced parameters ------------------------- +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +// npartmethod: Method of interface reconstruction, default is 1. +// parallelPartitionMethod: Method of parallel partition, this is set only when execute parallel partition. It would be skipped when serial partition. +// 1 -- Using ParMetis for homogeneous MPI. +// 2 -- Using Metis for homogeneous MPI. +// 3 -- using METIS partition for homogeneous OpenMP. +// parmetisBalance: Used to specify the imbalance tolerance. +// 1 -- perfect balance. +// maxproc -- perfect imbalance. +// 1.05 -- recommended. + +int omit_no_bound_bc = 0; +int npartmethod = 1; +int parallelPartitionMethod = 2; +double parmetisBalance = 1.05; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level, ..., et al. +int numberOfMultigrid = 1; + +######################################################################### +# Default parameters for CFD simulation # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepSample: The step intervals for monitored probes variables file 'sample.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual file 'res.dat' saved. +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) + +int maxSimuStep = 20000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepSample = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; +int ifLowSpeedPrecon = 0; + +// compressible: +// 0 -- incompressible flow. +// 1 -- compressible flow. (default) +int compressible = 1; + +//----------------------------------------------------------------------- +# CFD Control Parameter # +//----------------------------------------------------------------------- +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// 4 -- the condition that the velocity, temperature and density are given. +// 5 -- the condition that the velocity, temperature and pressure are given. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. +// radiationCoef: The radiation coefficient on wall, it is used to compute the radiation heat flux on wall when the boundary +// condition is radiation equilibrium temperature, and 0.8 is the default value. +// refMolecularWeight : the reference molecular weight of gas used for perfect gas. The unit is g/mol. +// Generally, the gas is air. Sometimes, it is experiment gas, such as Nitrogen, Argon, and so on. + +double refMachNumber = 0.73; +double attackd = 2.79; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 6.5e6; +double refDimensionalTemperature = 288.15; +double freestream_vibration_temperature = 300.00; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +//int inflowParaType = 3; +//int nsubsonicInlet = 1; +//int nsubsonicOutlet = 1; +//string inLetFileName = "./bin/subsonicInlet.hypara"; +//string outLetFileName = "./bin/subsonicOutlet.hypara"; +//double refDimensionalTemperature = 288.144; +//double refDimensionalPressure = 1.01313E05; + +//The velocity, temperature and density are fixed. +//int inflowParaType = 4; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalDensity = 1.0e3; + +//The velocity, temperature and pressure are fixed. +//int inflowParaType = 5; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalPressure = 1.0e5; + +//The MachNumber, temperature and pressure are fixed. +//int inflowParaType = 6; +//double refDimensionalTemperature = 293; +//double refDimensionalPressure = 8886.06; + +double wallTemperature = -1.0; + +double radiationCoef = 0.8; +double gridScaleFactor = 1.0; + +int numberOfAerodynamicForceComponents = 1; +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. +double refMolecularWeight = 28.9644; // unit of g/mol. + +//----------------------------------------------------------------------- +# Spatial Discretisation # +//----------------------------------------------------------------------- +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "hlle", "lax_f". +// -- "roe", "modified_roe". +// -- "ausm+", "ausm+w", "ausm+up", "ausmdv", "ausmpw", "ausmpw+". +// str_limiter_name: Limiter of struct grid. +// -- "vanalbada", "vanleer", "minmod", "smooth", "minvan", "3rdsmooth", "3rd_minmod_smooth". +// -- "nolim", no limiter. +// -- "vanalbada_clz", clz supersonic version. +string inviscidSchemeName = "roe"; +string str_limiter_name = "vanalbada"; + +#******************************************************************* +# UnStruct Solver or Common * +#******************************************************************* +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 2 -- Algebraic. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "0eq-bl". +// -- "1eq-sa". +// -- "2eq-kw-menter-sst". +// -- "2eq-kw-menter-bsl". +// -- "2eq-kw-wilcox-1988". +// -- "2eq-kw-wilcox-1998". +// -- "2eq-kw-kok-tnt". +// -- "2eq-kw-wilcox-2006". +// -- "easm-kw-2003". +// -- "easm-kw-2005". +// DESType: Type of DES. +// 0 -- RANS. (default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpw+". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "barth", "vencat", "vanleer", "minmod". +// -- "vanalbada", "smooth", "nnd", "lpz", "1st". +// -- "nolim", no limiter. +// uns_vis_name: Discretisation method of viscous term. +// -- "std", "test", "aver", "new1", "new2". +// gradientName: Gradient reconstruction method. +// -- "default", "ggcell", "ggnode", "lsq". +// ivencat: Variation of vencat limiter. +// 0 -- org method, it is independent of grid scale. +// 1 -- new method, it is dependent of grid scale. +// 4 -- Ustar limiter model, without grid size unitary. +// 7 -- default used. +// venkatCoeff: Cofficient of vencat, when using vencat limter. +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. +// skewnessAngle: The skewness angle of grid cells. +// roeEntropyFixMethod: Entropy fix (correction) method. +// 1 -- direct fix, which limits the minimum eigenvalue directly. +// 2 -- multi-dimensional fix, which is derived from structured solver and now is only valid for struct solver. +// 3 -- Harten type, which is default used. +// roeEntropyScale: Entropy fix (correction) coefficient scale, default is 1.0. +// It is used to scale the default Roe entropy fix coefficients. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +string uns_scheme_name = "roe"; +string uns_limiter_name = "vencat"; +string uns_vis_name = "test"; +string gradientName = "ggnode"; + +int ivencat = 7; +double venkatCoeff = 5.0; +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; +double skewnessAngle = 60.0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; + +//----------------------------------------------------------------------- +# Temporal Discretisation # +//----------------------------------------------------------------------- +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// physicalTimeStep: The nondimensional physical time step. +// ifStartFromSteadyResults: The unsteady simulation is start from steady flowfield or not, 0 is for no and else is for yes. +// ifStaticsFlowField: Statistical variables for unsteady simulation. +// ifStaticsReynoldsStress: Statistical Reynolds stress for unsteady simulation. +// startStatisticStep: Outer step when start statistics. +// when the value is larger than "maxSimuStep", it is useless. +// statisticalTimePeriod: Used as time period of statistic analysis. +// when the value is negative, time period is treated as infinite. +// statisticMethod: Statistic reynolds stress method. + 0 --tau = - ^2 + 1 --tau = +// min_sub_iter: The min sub iteration of unsteady simulation. +// max_sub_iter: The max sub iteration of unsteady simulation. +// tol_sub_iter: The tolerance of sub iteration of unsteady simulation. +// tscheme: Temporal Discretisation method. +// 1 -- Runge-Kutta Multi-State. +// 2 -- Point implicit. +// 3 -- Full implicit. +// 4 -- LU-SGS. +// 5 -- Block LU-SGS. +// 6 -- Jacobian iteration. +// 7 -- Lower G-S iteration. +// 8 -- Upper G-S iteration. +// 9 -- Lower/Upper G-S iteration. +// iSimplifyViscousTerm: Simplify the computation of viscous term in the Block LU-SGS method. The default value assigns 1 that could speed up the computation. +// Otherwise, the viscous Jacobian matrix Mv should be computed that will increase the memory and time in iteration of the BLUSGS method. +// CFLStart: Started cfl number. +// CFLEnd: End cfl number. +// CFLVaryStep: The number of step when cfl increase from CFLStart to CFLEnd. +// ktmax: Dtratio. dt[i] = MIN(dt[i], ktmax * dtmin / vol[i]) +// swapDq: Communication dq between forward/backward sweep of LUSGS or not, default is 0. +// nLUSGSSweeps: Sub iteration of LU-SGS or Block LU-SGS. +// LUSGSTolerance: Sub iter tolerance of LU-SGS or Block LU-SGS. +// ifLocalTimeStep: Time step method. +// 0 --Local. +// 1 --Global. +// visl_min: Minimum value of laminar viscosity coefficient. +// turbCFLScale: Turbulence model cfl number factor. +// codeOfAleModel: Arbitrary Lagrangian-Eulerian method. +// 0 -- no ALE method. +// 1 -- ALE method for non-moving grids. +// 2 -- ALE method for moving grids. +// 3 -- ALE method for deforming grids. +// wallFunctionType: The type of wall function to implement. +// 0 -- no wall function. (default) +// 1 -- standard wall function. +// 2 -- Pab3D wall function. +// RKStage: The number of Runge-Kutta step. +// lamda: Cofficient of Runge-Kutta step. + +int iunsteady = 0; +double physicalTimeStep = 0.01; +int ifStartFromSteadyResults = 0; +int ifStaticsFlowField = 0; +int ifStaticsReynoldsStress = 0; +int startStatisticStep = 800000; +double statisticalTimePeriod = -1.0; +int statisticMethod = 0; +int linearTwoStepMethods = 1; // 1--BDF1; 2--C-N; 3--BDF2; + +int methodOfDualTime = 3; +int min_sub_iter = 50; +int max_sub_iter = 50; +double tol_sub_iter = 0.01; + +int tscheme = 4; +int iSimplifyViscousTerm = 1; +int ifLocalTimeStep = 0; +double CFLStart = 0.01; +double CFLEnd = 10.0; +int CFLVaryStep = 500; + +double ktmax = 1.0e10; + +int swapDq = 1; + +int nLUSGSSweeps = 1; +double LUSGSTolerance = 0.01; +int order = 2; + +double visl_min = 0.01; +double turbCFLScale = 1.0; +double csrv = 2.0; +double timemax = 1.0e10; +double dtsave = -1.0; +int maxale = 10; +double dtau = 0.001; + +int wallFunctionType = 0; + +int RKStage = 2; +double lamda[] = 0.5, 1.0; + +//int RKStage = 1; +//double lamda[] = 1.0; + +//int RKStage = 4; +//double lamda[] = [0.25, 0.33333333333, 0.5, 1.0]; + +//----------------------------------------------------------------------- +# File In or Out # +//----------------------------------------------------------------------- +// numberOfGridGroups: The number of grid groups. +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the field results to visulization. +// walldistMethod: The method to compute wall distance. +// 0 -- accurate but not fast enough. +// 1 -- fast but not accurate enough. +// 2 -- super fast but more non-accurate! +// resSaveFile: The file path to save the residual convergence process, write data for every default (intervalStepRes) steps. +// turbresfile: The file path to save the residual convergence process of turbulence, write data for every default (intervalStepRes) steps. +// aircoeffile: The file path to save the aerodynamic force coefficients convergence process, write data for every default (intervalStepForce) steps. +// restartNSFile: The file path to write restart flowfield variables, write data for every default (intervalStepFlow) steps. +// turbfile: The file path to write restart flowfield variables of turbulence , write data for every default(intervalStepFlow) steps. +// visualfile: The visualization file path of flowfield , write data for every default (intervalStepPlot) steps. +// wall_aircoefile: The file path to save flowfield variables of wall, write data for every default steps. +// nDumpSurfaceInfo = 0 the "wall_varfile" write the informations including heat flux. +// nDumpSurfaceInfo = 1 the "wall_varfile" write the informations without heat flux. + +int numberOfGridGroups = 1; +string gridfile = "./grid/rae2822_hybrid2d__4.fts"; +string wallTemperaturefile= ""; + +int walldistMethod = 1; + +string resSaveFile = "results/res.dat"; +string turbresfile = "results/turbres.dat"; +string aircoeffile = "results/aircoef.dat"; + +string restartNSFile = "results/flow.dat"; +string turbfile = "results/turb.dat"; + +string visualfile = "results/tecflow.plt"; +string wall_aircoefile = "results/wall_aircoef.dat"; +string samplefile = "results/sample.dat"; + +int nDumpSurfaceInfo = 0; +string wall_varfile = ""; + +string jetDefineFile = "bin/jet.hypara"; + +string sixDofFileName = "results/sixDofInfo.dat"; +string derivativeFileName = "results/identify.dat"; +string hysteresisFileName = "results/force_beta.plt"; + +int plotFieldType = 0; + +// visualfileType: The file type of visualfile. +// 0 -- Tecplot binary. +// 1 -- Tecplot ASCII. + +int visualfileType = 1; + +// samplefileMode: The dump mode of sample file. +// 0 -- dump out every probe/line/surface data for all step intervals. +// 1 -- dump out all probe/line/surface data for every step intervals. +int samplefileMode = 0; + +// visualSlice: The slice of tecflow. +// 0 -- Do not save slice data. +// 1 -- comput and save it to sliceFile. +// sliceAxis: Normal vector of slice. +// 1 -- X_DIR. +// 2 -- Y_DIR. +// 3 -- Z_DIR. +// slicePostion: Coordinate of slice. + +int visualSlice = 0; +int sliceAxis = 1; +double slicePostion = -0.5; +string sliceFile = "results/Slice.plt"; +int dumpWallFaceCenter = 0; + +// min-max box of the visual block. +double lowerPlotFieldBox[] = [0.0 0.0 0.0]; +double upperPlotFieldBox[] = [1.0 1.0 1.0]; + +//-----------the optional parameters list for the flow field output---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40), +// -- gradientUx(41), gradientUy(42), gradientVx(43), gradientVy(44), iblank(81). +// -- specific heat ratio(gama, 56) +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. +//-----------the optional parameters list for the wall boundary condition---------------- +// nVisualWallVariables: The number of visual variables on wall. +// visualWallVariables : dumped variable types, listed as following: +// -coefficient of pressure(cp, 0), -coefficient of friction(cf, 1), yplus(2), -non-dimensional heat flux(Q_NonDim, 3), -dimensional heat flux(Q_Dim, 4), +// -pressure on wall(pw, 5), -temperature on wall(Tw, 6), -density on wall(rhow, 7), -heat flux of translational-rotational temperature term(Qtr, 8), +// -heat flux of species diffusion term(Qs, 9), -heat flux of vibrational temperature term(Qv, 10), -heat flux of electron temperature term(Qe, 11), +// -species mass fractions(Ns, 12), -x component of wall velocity(Vx, 13), -y component of wall velocity(Vy, 14), -z component of wall velocity(Vz, 15) +// -slip translational-rotational temperature(Tts, 16), -slip vibrational temperature(Tvs, 17), -slip electron temperature(Tes, 18), -absolute wall velocity(Vs, 19) +// -Stanton number(St, 20), -coefficient of heat rate(Ch, 21), -temperature jump(deltaT, 22), -transition gamaeff(gamaeff, 48), +// -transition intermittency(intermittency, 51), -transition momentum thickness reynolds(MomentumThicknessReynolds, 52), +// -overlap iblank(iblank, 81) + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +int nVisualWallVariables = 9; +int visualWallVariables[] = [0, 1, 2, 3, 4, 5, 9, 10, 11]; + +// dumpStandardModel: Dump many standard model data. +// 1 -- Turbulent flat plate. +int dumpStandardModel = 0; + +// ifSetDataMonitor: Whether to set the data monitor. +// 0 -- No. +// 1 -- Yes. +// dataMonitorType: The type of data Monitor. +// 0 -- Probes data monitor. +// 1 -- Lines data monitor. +// 2 -- Surfaces data monitor. +// probesDefineFile: Probes location information file. +// nLines: The number of lines need to be monitored. +// linesDefineFile: Lines location information file. +// nSurfaces: The number of surfaces need to be monitored. +// surfacesDefineFile: Surfaces location information file. +// searchCellsMethod: method to search the cell of each probe. +// 0 -- Nearest cell to the probe. +// 1 -- Real cell where the probe is located. +// nProbeVariables: Number of variables want to be dumped for probes monitered. +// probeVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5). +// Important Warning: Array size of probeVariables MUST be equal to nProbeVariables!!! +// probeVariables order must from small to big. +// probeVariablesInterpolationMethod: Interpolation method used to compute the probe variables. +// 0 -- Take the value of probe's cell as probe real value. +// 1 -- Interpolation from probe's and neighbouring cell to probe. +// 2 -- Interpolation from probe's cell nodes to probe. +int ifSetDataMonitor = 0; + +int dataMonitorType = 0; +string probesDefineFile = "bin/probes_XYZ.dat"; + +//int dataMonitorType = 1; +//int nLines = 1; +//string linesDefineFile = "bin/lines_XYZ.dat"; + +//int dataMonitorType = 2; +//int nSurfaces = 4; +//string surfacesDefineFile = "bin/surfaces_XYZ.dat"; + +int searchCellsMethod = 0; + +int nProbeVariables = 6; +int probeVariables[] = [0, 1, 2, 3, 4, 5]; +int probeVariablesInterpolationMethod = 0; +//----------------------------------------------------------------------- +# Turbulence Parameter # +//----------------------------------------------------------------------- +// turbInterval: Iteration number of turbulence. +// kindOfTurbSource: Kinds of turbulent source. +// 0 -- Original. +// 1 -- Edwards. +// 2 -- new. +// mod_turb_res: If modify the residuals for the cells next to the wall or not, default is 0. + +int turbInterval = 1; +int turbOrderStruct = 2; +int kindOfTurbSource = 0; +int mod_turb_res = 0; +double turb_relax = 1.0; +double freeStreamViscosity = 1.0e-3; +double muoo = 3.0; +double kwoo = 5.0; +int transitionType = 0; +double turbIntensity = -1.0; +int freeturbIntensitySRModify = 0; +double freeDecayXLocation = 0.0; +int compressibleCorrection = 0; +int transitionMaFix = 1; + +# maximum eddy viscosity (myt/my) max. +double eddyViscosityLimit = 1.0e10; +int monitor_vistmax = 0; + +//----------------------------------------------------------------------- +# LES Parameter # +//----------------------------------------------------------------------- +// iLES: Create LESSolver or not. +// == 1 - Create LESSolver; +// != 1 - not. +// amplitudeofDisturb: Amplitude of adding disturb. +// disturbstep: Unsteady time step or steady iteration of adding random disturb. +// iterdisturb: Add random disturb in every sub-iter or only first sub-iter. +// = 0 - in only first sub-iter; +// != 0 - in every sub-iter. +// ipraddisturb: Add density and pressure disturb or not. +// ibodyforce: Add body force in source flux of NS equations or not. +// = 0 - not; +// != 0 - Add body force. +// bodyforce: Body force in source flux of NS equations or not. +// utau: friction velocity, using in DNSDisturb. +// sgsmodel: subgrid scale model. +// = "smagorinsky"; +// = "dsmCom"; +// = "wale"; +// = "sigma". +// deltaFunctionType: = 1 - MAX(deltai, deltaj, deltak); +// = 2 - pow(deltai * deltaj *deltak, 1/3); +// = 3 - Devloped by Scotti. +// wallDampingFunctionType: = 0 - no wall function; +// = 1 - van Driest; +// = 2 - developed by Dr. Deng Xiaobing; +// = 3 - developed by Piomelli. +// turbViscousCutType: turbulent viscosity cut type. +// = 0 - mu_total = mut + mul; +// = 1 - mu_total = max(mut-mul,0)+ mul; +// = 2 - mu_total = max(mut ,0)+ mul. +// smagConstant: constant of smagorinsky model. +// waleConstant: constant of wale model. +// filterDirection[3]: filter variables in i, j, k direction or not. +// averageDirection[3]: average variables in i, j, k direction or not. +// isotropicConstant: constant of isotropic part of SGS stress. + +int iLES = 0; +string sgsmodel = "smagorinsky"; +int deltaFunctionType = 2; +int wallDampingFunctionType = 1; +int turbViscousCutType = 2; +double smagConstant = 0.1; +double isotropicConstant = 0.0; +double waleConstant = 0.6; +double sigmaConstant = 1.35; +int filterDirection[] = [1, 1, 0]; +int averageDirection[] = [0, 0, 0]; +double testFilterScale = 2.0; +int averageWidth = 1; +int monitorNegativeConstant = 0; + +//----------------------------------------------------------------------- +# Other Parameters for Hypersonic Non-equilibrium Gas # +//----------------------------------------------------------------------- +// dg_high_order: +// 0 -- generic order accuracy. +// 1 -- high order accuracy. +// iapplication: +// 0 -- gas model is fixed in the codes. +// 1 -- gas model is imported from library files. +// iCodeBranch: +// 0 -- The old code version is used for Navier-Stokes. +// 1 -- A new code version is active for Navier-Stokes solver. +// nm: Equation number of the physics, but is out of commision now. +// 4 -- for 2D. +// 5 -- for 3D. +// nGasModel: The type of gas. less than and equal to 1 represents the mixture gas. +// Otherwise, the pure gas with one component is used for perfect gas. +// 0 -- Earth gas. +// 1 -- Mars gas. +// 2 -- Argon. +// 3 -- Nitrogen. +// nEnergyRecycle: The type of EnergyModel Recycle. +// 0 -- not used . +// 1 -- used. +// nDensityModify: The type of densitymodify. + +// 0 -- not used. +// 1 -- used. +// nchem: +// 0 -- without chemical reaction flow. +// 1 -- the chemical reaction flow is considered. +// nEquilibriumGas: the variable is valid when the condition of nchem=0 is satisfied. +// 0 -- perfect gas. +// 5, 7, 11 -- equilibrium gas, meanwhile, its value denotes the number of gas component. +// nPCWCycleStep: the maximum step number of iteration in the module of computing species mass fractions with the partial catalytic wall(PCW) condition. +// the value equals to or is greater than 1, and 3 is for default value. +// nRETCycleStep: the maximum step number of iteration in the module of computing radiation equilibrium temperature on wall. +// the value equals to or is greater than 1, and 3 is for default value. +// nSLIPCycleStep:the maximum step number of iteration in the module of computing slip temperature, slip velocity and slip species mass fraction. +// the value equals to or is greater than 1, and 3 is for default value. +// nSlipBCModel : The computational model of slip boundary conditions. + +// 0 -- no slip. +// 1 -- the conventional Maxwell slip conditions. +// 2 -- the Gokcen slip conditions. +// 3 -- the Knudsen-layer correction of the standard slip conditions proposed by Lockerby, et al. +// 4 -- the Kogan simplified slip conditions. +// nMeanFreePathType : the method to the mean free-path for the slip conditions. For the mixture, 0 is suggested. +// 0 -- the equivalent mean free-path is calculated by the simple hard sphere model(HS). +// 1 -- calculated by the definition that includes the variables of the number density and the molecule diameter. +// 2 -- the equivalent mean free-path is calculated by the variable hard sphere model(VHS). +// nchemsrc: +// 0 -- the source terms are not computed. +// 1 -- the source terms are computed. +// nchemrad: +// 0 -- compute the spectrum radius without considering chemical reaction flow. +// 1 -- compute the spectrum radius that need to count the contribution from chemical reaction flow. +// ntmodel: The thermodynamic temperature model. +// 1 -- One-temperature model. +// 2 -- Two-temperature model. +// 3 -- Three-temperature model. +// nTEnergyModel: the method to computing temperature energy model. +// 0 -- the energy term is computed using the conventional method. +// 1 -- the energy term is computed using the curve fitting method. +// parkVDPower: the power of translational-rotational temperature in the Park V-D(vibration-dissociation) coupling model. +// The value is in range of [0.0, 1.0], DPLR suggests 0.5, LAURA suggests 0.7, while 0.6 is given as default value. +// catalyticCoef: +// 0.0 -- full non-catalytic wall boundary condition. +// 1.0 -- full catalytic wall boundary condition. +// in range of (0.0, 1.0) -- partial catalytic condition, the value indicates the catalytic coefficient. +// nIsSuperCatalytic : the super catalytic condition for the fully catalytic wall, and assigned with the value of 1. +// 0 -- equilibrium condition for the fully catalytic wall where the mass fractions are assigned with the values of the free stream. +// 1 -- super catalytic condition for the fully catalytic wall where all the atomic components combine into molecular components. +// nTemperatureJump : the method to calculate the temperature jump. +// 0 -- calculated by the variables of heat conductivity and constant volume specific heat for each energy mode. +// 1 -- the general method where the iteration is calculated with the translation-rotation temperature. +// sigmaVelocity: the coordination coefficient of tangential momentum for computation of slip velocity. The value is in range of (0.0, 2.0]. +// sigmaTemperature: the heat coordination coefficient for computation of slip temperature. The value is in range of (0.0, 2.0]. +// sigmaMassFraction: the species coordination coefficient for computation of slip mass fractions. The value is in range of (0.0, 2.0]. +// velocitySlipCorrectConstant: the correction constant to the velocity slip condition. For the diffuse reflection, 1.0 is used. +// 1.0 -- proposed by Maxwell. +// sqrt(2/PI)~0.8 -- used for "micro-slip", namely the actual velocity slip at the wall. +// 1.146 -- proposed for an additional "fictitious" velocity slip. + +// chemicalRelaxCorf: The value is in range of [0.001, 1.0]. +// chemicalSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// viscousSpectrumRadiusCoef : The value is in range of [1.0, 3.0]. +// inviscidSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// staticPressureRelaxCorf: The value is in range of [0.1, 1.0]. +// nIsChemicalFreeze : the flag to freeze the chemical reactions. +// 0 -- not freeze, the chemical reaction sources will be calculated. +// 1 -- freezes the chemical reactions, the chemical reaction sources will not be calculated.// veTemperatureMin: The minimum of Tv and Te +// nDebug: cout the Wrong place and abort +// 0 -- not used. +// 1 -- used. +// nSpeciesLimit: limitter of gas species +// 0 -- not used. +// 1 -- used. +// nTurblenceForChemical: the coupled mode of Turblence and Chemical reaction +// 0 -- method 0. +// 1 -- method 1. +// nViscosityFluxSublevelModified: Modified for ViscosityFlux on Sublevel grid +// 0 -- not used. +// 1 -- used. +// nChemcalSourceModified: Modified on ChemcalSource +// 0 -- not used. +// 1 -- used. +// nAblation: +// 0 -- The wall ablation is not computed. +// 1 -- The wall ablation is computed. +// isInjection: +// 0 -- The injection velocity of ablation wall is not computed. +// 1 -- The injection velocity of ablation wall is computed. +// nViscosityModel: + +// 0 -- Blottner fitting method. +// 1 -- Gupta fitting method. +// nSutherland: +// 0 -- stands for selecting the Blotter curve fits mode. +// 1 -- stands for Sutherland relation. +// gasfile: Indicates the gas model, 9 models are provided, namely "Gu5", "Gu7", "Gu11", "Pa5", "Pa7", "Pa11", "DK5", "DK7", "DK11". +// "Gu" -- indicates the Gupta Model, three-Type Models are embeded in the library, namely, the 5-species-6-reactions, the 7-species-9-reactions, the 11-species-20-reactions. +// "Pa" -- indicates the Park Model, three-Type Models are embeded in the library, namely, the 5-species-17-reactions, the 7-species-22-reactions, the 11-species-48-reactions. +// "DK" -- indicates the Dunn-Kang Model, three-Type Models are embeded in the library, namely, the 5-species-11-reactions, the 7-species-15-reactions, the 11-species-26-reactions. +// "Mars-Pa8" is for Park model of Mars gas, "Mars-Mc8" for McKenzie model of Mars gas. +// "Combustion-12" -- indicates the Combustion Chamber Gas Model which includes 12-species-20-reactions. +// "Gas-Mixture" -- indicates the process of mixing two species without reacting. +// For self-definition model, the gasfile is used to indicate the file path of the new gas model. +// speciesName: Used to list the names of each species, while each species name is separated by the symbol of comma. +// initMassFraction: Used to list the initial mass fractions of species in accordance with the sequence of names in the parameter speciesName. +// ifStartFromPerfectGasResults: The chemical reaction simulation is start from perfect gas flowfield or not, 0 is for no and else is for yes. + +int dg_high_order = 0; +int iapplication = 0; +int iCodeBranch = 0; +int nm = 5; +int nEquilibriumGas = 0; +int nPCWCycleStep = 3; +int nRETCycleStep = 3; +int nSLIPCycleStep= 3; + +double refGama = 1.4; +double prl = 0.72; +double prt = 0.90; +double sc_l = 0.5; +double sc_t = 0.5; + +int nGasModel = 0; +int nchem = 0; +int nchemsrc = 1; +int nchemrad = 1; +int ntmodel = 1; + +int nEnergyRecycle = 0; +int nSlipBCModel = 0; +int nDensityModify = 1; +int nTEnergyModel = 0; +int nMeanFreePathType = 0; +int nIsChemicalFreeze = 0; +int nIsSuperCatalytic = 1; +int nTemperatureJump = 0; + +double parkVDPower = 0.6; +double catalyticCoef = 0.0; +double sigmaVelocity = 1.0; +double sigmaTemperature = 1.0; +double sigmaMassFraction = 1.0; +double velocitySlipCorrectConstant = 1.0; + +double chemicalRelaxCorf = 1.0; +double chemicalSpectrumRadiusCoef = 1.0; +double viscousSpectrumRadiusCoef = 1.0; +double inviscidSpectrumRadiusCoef = 1.0; +double staticPressureRelaxCorf = 1.0; + +double veTemperatureMin = 30.0; +int nDebug = 0; +int nSpeciesLimit = 0; +int nTurblenceForChemical = 0; +int nViscosityFluxSublevelModified = 0 ; +int nChemcalSourceModified = 0; + +int nAblation = 0; +int isInjection = 0; +int nViscosityModel = 0; +int nMarsModel = 0; +string gasfile = "DK5"; +//string gasfile = "./chemical/Dunn-Kang_air5s11r.dat"; +string speciesName = "O, O2, NO, N, N2"; +string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.767"; + +//string speciesName = "O, O2, NO, N, NO+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string speciesName = "O, O2, NO, N, O+, O2+, NO+, N+, N2+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Mars-Pa8"; +//string speciesName = "O, O2, NO, N, N2, C, CO, CO2"; +//string initMassFraction = "0.0015, 0.0429, 0.0, 0.0, 0.0, 0.0, 0.0777, 0.8779"; + +//string gasfile = "DK7"; +//string speciesName = "O, O2, NO, N, NO+, C, C2, CO, CO2, CN, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Combustion-12"; +//string speciesName = "O, O2, NO, N, C, CO, CO2, H, H2, OH, H2O, N2"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767"; + +//string gasfile = "Gas-Mixture"; +//string speciesName ="SpeciesA, SpeciesB"; +//string initMassFraction = "1.0, 0.0"; +int nSutherland = 0; +double gamaSpeciesA = 1.4; +double gamaSpeciesB = 1.3; +double molecularWeightSpeciesA = 29.0; +double molecularWeightSpeciesB = 30.0; + +int nChemicalFlowStep = 0; +int ifStartFromPerfectGasResults = 0; + +######################################################################### +// Multi-Grid parameters. +// nMGLevel: The number of level of Multi-Grid. +// <= 1 -- Single-level. +// > 1 -- multi-level. +// MGPreIteration: For each grid, the number of pre-smoothing steps. +// n_post: For each grid, the number of post-smoothing steps. +// MGCoarsestIteration: For the coarest grid the number of smoothing steps. +// MGFasType: V-multi cycle or W-multi cycle. +// 1 -- V-multi cycle. +// 2 -- W-multi cycle. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. +// mgCFLScale: CFL number enlarge times for coarse grid. +// mprol: Multi-grid interpolation method, interpolation from coarse cell to fine grid. +// 1 -- zero order. +// 2 -- first-order. (default) +// mgCorrectionLimit: Multi-grid correction limit. + +int nMGLevel = 1; +int MGCoarsestIteration = 1; +int MGPreIteration = 1; +int MGFasType = 1; +int n_post = 0; +int flowInitStep = 100; +int mprol = 2; +double mgCFLScale = 1.0; +double mgCorrectionLimit = 0.01; + +//--------------- Some parameter for turbulent model -------------------- +// neasm: The variation of kw turbulent model. +// ismooth_turb: Residual smooth for turb or not. +// SSTProductType: The type of product term based on vorticity for SST. +// SAProductType: The type of product term based on vorticity for SA. +int neasm = -3; +int SSTProductType = 0; +int ismooth_turb = 0; +int SAProductType = 2; + +// ----------------- Overset Grid parameter ----------------------------- +int codeOfDigHoles = 1; +int codeOfTurbulentModel = 0; +string masterFileName = "./grid/searchFile.inp"; +string holeBasicFileName = "./grid/holeBasicFile.inp"; +string holeFullFileName = "./grid/holeFullFile.dat"; +string linkFileName = "./grid/topology.dat"; +string zoneInverseFileName = "./grid/zoneInverseMapping.inp"; + +######################################################################### +# High Order Struct Solver # +######################################################################### +// isFVMOrFDM: +// 0 -- NSSolverStruct using Finite Volume Method. +// 1 -- NSSolverStruct using Finite Differ Method. +// SolverStructOrder: Spatial discretisation order of NS equations with struct grid. +// <= 2 -- finite volume method. +// >= 3 -- finite difference order. (to be completed) +// 0 -- default. +// str_highorder_interpolation_epsilon: Epsilon in weighted interpolation, bigger epsilon, better convergence, +// smaller epsilon, robuster for shock-detecting. +// str_highorder_interpolation_type: +// -- "classical", "test". +// str_highorder_flux_name: +// -- "roe", "steger". +// structhighordergradient: +// -- "conservation", "chain_rule". +int isFVMOrFDM = 0; +string str_highorder_solver = "WCNS"; +int SolverStructOrder = 0; +double str_highorder_interpolation_epsilon = 1.0e-6; +string str_highorder_interpolation_type = "test"; +string str_highorder_flux_name = "steger"; +string structhighordergradient = "conservation"; +double coefofstrflux = 0.5; +double limitcoefofinterface = 0.0; + +// ----------------- Advanced choices ----------------------------------- +// outtimesc: Time stepping scheme for the outer loop. +// MUSCLCoefXk: The parameter of MUSCL interpolations, belongs to [-1, 1]. +// -1 -- seconde-order fully-upwind differencing. +// 0 -- seconde-order upwind-biased differencing. +// 0.333333 -- third-order upwind-biased differencing. +// 1 -- seconde-order central differencing. +// MUSCLCoefXb: The limiter parameter. +// 0 -- the effect of the limiter is cancelled, means the first-order interpolations. +// allReduceStep: Iteration intervals for MPI AllReduce operation, default is 1. +string outtimesc = "impbd2"; +double MUSCLCoefXk = -1; +double MUSCLCoefXb = 1.0; +int allReduceStep = 1; + +// ----------------- overlap configuration ------------------------------ +// codeOfOversetGrid: Overlapping(overset) grid or not. +// 0 -- NON-overlapping grid. +// 1 -- Overlapping grid. +// oversetInterpolationMethod: the method of overset interpolation while field simulation +// 0 -- set the acceptor cell value by donor cell value. +// 1 -- set the acceptor cell value by distance weight of donor cell value. + +int codeOfOversetGrid = 0; +int oversetInterpolationMethod = 0; +int readOversetFileOrNot = 0; +int symetryOrNot = 0; +int readInAuxiliaryInnerGrid = 1; +int readInAuxiliaryOuterGrid = 0; +int readInSklFileOrNot = 0; +string auxiliaryInnerGrid0 = "./grid/aux-upper.fts"; +string auxiliaryInnerGrid1 = "./grid/aux-lower.fts"; +string auxiliaryInnerGrid2 = ""; +string oversetGridFileName = "./grid/iblank.ovs"; +double walldistMainZone = 1.0 +double toleranceForOversetSearch = 1.0e-3; +double toleranceForOversetBox = 1.0e-3; +int twoOrderInterpolationOrNot = 0; +int keyEnlargeOfActiveNodes = 0; +int outTecplotOverset = 0; + +int numberOfMovingBodies = 2; + +// ----------------- ALE configuration ------------------------------ +int codeOfAleModel = 1; +int aleStartStrategy = -1; + +int strategyForFaceNormalVelocity = 0; //0-By Sweeping volume; 1-By face center 1st; 2-By face center 2nd; +int strategyForGCLSource = 0; //0-present; 1-Ahn; + +//0:1st-Admas-Bashforth; 1:2nd-Admas-Bashforth; 2:1st-Implicit-Euler; 3:2nd-Implicit Euler; 4:2nd-Adams-Moulton; 5:3rd-Adams-Moulton +int methodForKineticEquation = 0; +double relaxParameterOfKinetic = 1.0; + +######################################################################### +# motive information # +######################################################################### +int numberOfMovingBodies = 1; + +############################## body0 ############################## +//mass of parts +double mass_0 = 1.0; +//mass matrix of parts Ixx Iyy Izz Ixy Ixz Iyz +double massMatrix_0[] = 1e-7, 1e-6, 1e-6, 0.0, 0.0, 0.0; +//initial six DOF position information of parts. xc yc zc +double massCenter_0[] = 0.0 , 0.0, 0.0; +//initial six DOF position information of parts. angleX angleY angleZ +double attitudeAngle_0[] = 0.0 , 0.0, 0.0; +//initial six DOF move information of parts. vc vy vz +double massCenterVelocity_0[] = 0.0, 0.0, 0.0; +//initial six DOF move information of parts. omigX omigY omigZ +double angularVelocity_0[] = 0.0, 0.0, 0.0; +//the object that the parts belong to. +int fartherIndex_0 = -1; +//the assembly position of the parts. xc yc zc angleX angleY angleZ +double configPamameter_0[] = 0.0 ,0.0 ,0.0 ,0.0 ,0.0 ,0.0; +//the move pattern of the parts. +// -1 given motion partten. +// 0 still. +// 1 six DOF motion. +// 2 three DOF motion. +// 11 X-axis forced motion. +// 12 Y-axis forced motion. +// 13 Z-axis forced motion. +// 14 forced pitch motion. +// 15 forced yaw motion. +// 16 forced roll motion. +int RBDMethod_0 = 0; +double amplitude_0 = 0.0; +double reduceFrequency_0 = 0.0; +//string uDFSixDofFileName_0 = "./Bin/UDFSixDof.Parameter"; +//additional force (system axis) fX fY fZ +double addedForce_0[] = 0.0 ,0.0 ,0.0 ; +//additional moment of Force (system axis) mX mY mZ +double addedMoment_0[] = 0.0 ,0.0 ,0.0 ; +//the deformation method of the parts. +int morphing_0 = 0; + +// post indentify +int integralOrder = 4; + + +// ---------------- ATP read -------------------------------------------- +//@int inflowParaType = 0; +//@double refReNumber = 6.5e6; +//@double refDimensionalTemperature = 288.15; +//@double freestream_vibration_temperature = 300.00; +//@double refDimensionalPressure = 0; +//@double height = 0; +//@int nsubsonicInlet = 0; +//@int nsubsonicOutlet = 0; +//@string inLetFileName = "./bin/subsonicInlet.hypara"; +//@string outLetFileName = "./bin/subsonicOutlet.hypara"; +//@double refDimensionalVelocity = 0; +//@double refDimensionalDensity = 0; + +######################################################################### +# Old Parameter # +######################################################################### +int isPlotVolumeField = 0; + diff --git a/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/cfd_para_hypersonic.hypara b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/cfd_para_hypersonic.hypara new file mode 100644 index 0000000..b88ca8a --- /dev/null +++ b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/cfd_para_hypersonic.hypara @@ -0,0 +1,238 @@ +######################################################################### +# General Control Parameter # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual 'res.dat' saved. + +int maxSimuStep = 50000; + +int intervalStepFlow = 2000; +int intervalStepPlot = 2000; +int intervalStepForce = 100; +int intervalStepRes = 10; + +######################################################################### +# Inflow Parameter # +######################################################################### +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. + +double refMachNumber = 9.91; +double attackd = 0.00; +double angleSlide = 0.00; + +double wallTemperature = 293; + +int inflowParaType = 0; +double refReNumber = 1.86e5; +double refDimensionalTemperature = 51; +double freestream_vibration_temperature = 10000.0; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +double gridScaleFactor = 0.001; + +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 0.1017; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. + +######################################################################### +# Physical models # +######################################################################### +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "1eq-sa", when viscousType = 3. +// -- "2eq-kw-menter-sst", when viscousType = 4. +// DESType: Type of DES. +// 0 -- RANS.(default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. + +//int viscousType = 0; +//string viscousName = "Euler"; + +int viscousType = 1; +string viscousName = "laminar"; + +//int viscousType = 3; +//string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +int roeEntropyFixMethod = 2; +double roeEntropyScale = 1.0; +######################################################################### +# Spatial Discretisation # +######################################################################### +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "ausmpw". +// str_limiter_name: Limiter of struct grid. +// -- "minmod", "3rd_minmod_smooth". + +string inviscidSchemeName = "steger"; +string str_limiter_name = "minmod"; + +#******************************************************************* +# UnStruct Solver * +#******************************************************************* +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpwplus". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "vencat", "barth". +// -- "1st", meaning accuracy of first-order. +// -- "nolim", no limiter. +// venkatCoeff: Coefficient of vencat limiter, when uns_limiter_name = 'vencat'. +// The smaller the value, the more robust it is. + +string uns_scheme_name = "vanleer"; +string uns_limiter_name = "vencat"; +double venkatCoeff = 0.5; + +######################################################################### +# Temporal Discretisation # +######################################################################### +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// CFLEnd: The CFL number, [0.1, 100]. +// The bigger the value, the convergence faster but lower robustness. +// ktmax: The lower the value, the more robustness, 1.0e5 - 1.0e10. + +int iunsteady = 0; + +double CFLEnd = 3.0; + +double ktmax = 1.0e10; + +######################################################################### +# File In or Out # +######################################################################### +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// Please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the whole field results to tecplot or not, 0 / 1. + +string gridfile = "./grid/3d_HCFlare_str__16.fts"; +int plotFieldType = 0; + +// ----------------- Advanced Parameters, DO NOT care it ---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables: Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40). +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. + +int reconmeth = 0; +int limitVariables = 0; +int limitVector = 1; + +######################################################################### +# Non-equilibrium gas # +######################################################################### +// nGasModel: The type of gas. +// 0 -- Earth gas. +// 1 -- Mars gas. +// nchem: +// 0 -- without chemical reaction flow. +// 1 -- the chemical reaction flow is considered. +// nchemsrc: +// 0 -- the source terms are not computed. +// 1 -- the source terms are computed. +// nchemrad: +// 0 -- compute the spectrum radius without considering chemical reaction flow. +// 1 -- compute the spectrum radius that need to count the contribution from chemical reaction flow. +// ntmodel: The thermodynamic temperature model. +// 1 -- One-temperature model. +// 2 -- Two-temperature model. +// 3 -- Three-temperature model. +// catalyticCoef: +// 0.0 -- full non-catalytic wall boundary condition. +// 1.0 -- full catalytic wall boundary condition. +// in range of (0.0, 1.0) -- partial catalytic condition, the value indicates the catalytic coefficient. +// gasfile: Indicates the gas model, 9 models are provided, namely "Gu5", "Gu7", "Gu11", "Pa5", "Pa7", "Pa11", "DK5", "DK7", "DK11". +// "Gu" -- indicates the Gupta Model, three-Type Models are embeded in the library, namely, the 5-species-6-reactions, the 7-species-9-reactions, the 11-species-20-reactions. +// "Pa" -- indicates the Park Model, three-Type Models are embeded in the library, namely, the 5-species-17-reactions, the 7-species-22-reactions, the 11-species-48-reactions. +// "DK" -- indicates the Dunn-Kang Model, three-Type Models are embeded in the library, namely, the 5-species-11-reactions, the 7-species-15-reactions, the 11-species-26-reactions. +// "Mars-Pa8" is for Park model of Mars gas, "Mars-Mc8" for McKenzie model of Mars gas. +// For self-definition model, the gasfile is used to indicate the file path of the new gas model. +// speciesName: Used to list the names of each species, while each species name is separated by the symbol of comma. +// initMassFraction: Used to list the initial mass fractions of species in accordance with the sequence of names in the parameter speciesName. +// ifStartFromPerfectGasResults: The chemical reaction simulation is start from perfect gas flowfield or not, 0 is for no and else is for yes. + +int nGasModel = 0; +int nchem = 0; +int ntmodel = 1; +int nchemsrc = 1; +int nchemrad = 1; +double catalyticCoef = 1.0; +string gasfile = "DK5"; +string speciesName = "O, O2, NO, N, N2"; +string initMassFraction = "0.07955, 0.134, 0.0509, 1.0e-9, 0.73555"; +int ifStartFromPerfectGasResults = 0; diff --git a/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/grid_para.hypara b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/grid_para.hypara new file mode 100644 index 0000000..a6ac477 --- /dev/null +++ b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/grid_para.hypara @@ -0,0 +1,30 @@ +######################################################################### +# Grid data type # +######################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +// from_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +int gridtype = 1; +int axisup = 2; +int from_gtype = 2; + +######################################################################### +# File path # +######################################################################### +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +string from_gfile = "./grid/3d_HCFlare_str.cgns"; +string out_gfile = "./grid/3d_HCFlare_str.fts"; diff --git a/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/key.hypara b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/key.hypara new file mode 100644 index 0000000..a0b0913 --- /dev/null +++ b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/key.hypara @@ -0,0 +1,56 @@ +string title = "PHengLEI Main Parameter Control File"; + +// IMPORTANT NOTICE: DON NOT MODIFY THE FOWLLOWING LINE. +string defaultParaFile = "./bin/cfd_para.hypara"; + +// ndim: Dimensional of the grid, 2 or 3. +// nparafile: the number of parameter files. +// nsimutask: simulation task type. +// 0 -- CFD Solver of NS or Turbulation. +// 1 -- Grid generation: for special typical cases, such as cylinder, flat plate, etc. +// Grid conversion: from other format to PHengLEI format (.fts). +// Grid reconstruction: such as grid adaptation. +// Grid merging: merge two blocks into one block. +// Grid repairing: repair the original grid in order to remove the negative volume cells. +// 2 -- Wall distance computation for turb-solver. +// 3 -- Grid partition. +// 4 -- Knowledge repository / examples of PHengLEI-API. +int ndim = 3; +int nparafile = 1; + +int nsimutask = 0; +//string parafilename = "./bin/cfd_para_subsonic.hypara"; +//string parafilename = "./bin/cfd_para_transonic.hypara"; +//string parafilename = "./bin/cfd_para_supersonic.hypara"; +string parafilename = "./bin/cfd_para_hypersonic.hypara"; +//string parafilename = "./bin/incompressible.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_para.hypara"; + +//int nsimutask = 2; +//string parafilename = "./bin/cfd_para.hypara"; + +//int nsimutask = 3; +//string parafilename = "./bin/partition.hypara"; + +//int nsimutask = 4; +//string parafilename = "./bin/repository.hypara"; + +//int nsimutask = 5; +//string parafilename = "./bin/overset_grid_view.hypara"; + +//int nsimutask = 13; +//string parafilename = "./bin/lbm_para.hypara"; + +//int nsimutask = 14; +//string parafilename = "./bin/integrative_solver.hypara"; + +//int nsimutask = 99; +//string parafilename = "./bin/post_processing.hypara"; + +// ---------------- Advanced Parameters, DO NOT care it ---------------- +int numberOfGridProcessor = 0; +// ATP read +//@string parafilename1 = "" +//@string parafilename2 = ""; diff --git a/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/partition.hypara b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/partition.hypara new file mode 100644 index 0000000..a043bcd --- /dev/null +++ b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/bin/partition.hypara @@ -0,0 +1,21 @@ +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// maxproc: The number of partition zones that want to be divided into, +// which is equal to the number of CPU processors you want. +// Usually, 50~100 thousands structured cells per CPU-Core is suggested. +// 30~70 thousands unstructured cells per CPU-Core is suggested. +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). + +int pgridtype = 1; +int maxproc = 16; + +string original_grid_file = "./grid/3d_HCFlare_str.fts"; +string partition_grid_file = "./grid/3d_HCFlare_str__16.fts"; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level,..., et al. +int numberOfMultigrid = 1; diff --git a/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/grid/3d_HCFlare_str.cgns b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/grid/3d_HCFlare_str.cgns new file mode 100644 index 0000000..4de6b1a Binary files /dev/null and b/A18-ThreeD_Hollow_Cylinder_Flare_Laminar_Struct_16CPU/grid/3d_HCFlare_str.cgns differ diff --git a/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/boundary_condition.hypara b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/boundary_condition.hypara new file mode 100644 index 0000000..1410388 --- /dev/null +++ b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/boundary_condition.hypara @@ -0,0 +1,65 @@ +# nBoundaryConditons : Number of global boundary conditions. +# bcName : Boundary condition name. +# bcType(in PHengLEI): Boundary condition type. + +# How to set boundary condition, for example: +# string bcName = "Wall"; +# { +# int bcType = 2; +# int viscousType = 1; +# double wallTemperature = -1.0; +# double uWall = 0.0; +# double vWall = 0.0; +# double wWall = 0.0; +# } +# string bcName = "Inflow"; +# { +# int bcType = 5; +# int inflowParaType = 0; +# double refMachNumber = 0.73; +# double attackd = 2.79; +# double angleSlide = 0.0; +# double refReNumber = 6.5e6; +# double refDimensionalTemperature = 288.15; +# } + +# For more information, see examples/bin/boundary_condition.hypara file!!! + +int nBoundaryConditons = 5; +string bcName = "SOLID_SURFACE"; +{ + string bodyName = "body"; + int bcType = 2; +} +string bcName = "SYMMETRY"; +{ + int bcType = 3; +} +string bcName = "INFLOW"; +{ + int bcType = 5; +} +string bcName = "OUTFLOW"; +{ + int bcType = 6; +} +string bcName = "POLE3"; +{ + int bcType = 73; +} + +# 'bcType' is defined as following: +# 99: PERIODIC +# -2: WAKE +# -1: INTERFACE +# 0 : NO_BOUNDARY_CONDITION +# 1 : EXTRAPOLATION +# 2 : SOLID_SURFACE +# 3 : SYMMETRY +# 4 : FARFIELD +# 5 : INFLOW +# 6 : OUTFLOW +# 52: PRESSURE_INLET +# 62: PRESSURE_OUTLET +# 61: OUTFLOW_CONFINED +# 7 : POLE diff --git a/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/cfd_para.hypara b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/cfd_para.hypara new file mode 100644 index 0000000..b17970c --- /dev/null +++ b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/cfd_para.hypara @@ -0,0 +1,1220 @@ +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +// PPPPP H H EEEEE N N GGGGG L EEEEE III + +// P P H H E NN N G L E I + +// PPPPP HHHHH EEEEE N N N G GG L EEEEE I + +// P H H E N N N G G L E I + +// P H H EEEEE N N GGGGG LLLLL EEEEE III + +//------------------------------------------------------------------------+ +// Platform for Hybrid Engineering Simulation of Flows + +// China Aerodynamics Research and Development Center + +// (C) Copyright, Since 2010 + +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +########################################################################### +# Default parameters for Grid conversion # +########################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// 2 -- Hybrid grid, include both of unstructured and structured grid. +// gridobj: Task type of grid treatment. +// 0 -- Grid generation of typical case, such as cylinder, flat plate, etc. +// 1 -- Grid conversion, from other grid data to PHenglEI, such as Fluent, CGNS. +// 2 -- Grid refinement. +// 3 -- Grid merging, merge two blocks into one block. +// 4 -- Grid deformation, achieve unstructured grid deformation. +// 5 -- Grid repairing, repair the original grid in order to remove the negative volume cells. +// 6 -- Grid mirroring, mirror a symmetry grid to whole grid. +// multiblock: Multi-block grid or not, only for structured grid conversion. +// 0 -- Not. +// 1 -- Yes. +// iadapt: Adaptation number for unstructure grid. +// SymmetryFaceVector: The vector of symmetry face. +// 0 -- X axis. +// 1 -- Y axis. +// 2 -- Z axis. +int gridtype = 0; +int gridobj = 1; +int multiblock = 0; +int iadapt = 0; +int SymmetryFaceVector = 1; + +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +int axisup = 1; + +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +int omit_no_bound_bc = 0; + +//----------------------------------------------------------------------- +# Grid data type # +//----------------------------------------------------------------------- +// from_gtype/to_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +// dumpOldGrid: If dump out the old grid file. +// 0 -- Not. (default) +// 1 -- Yes. +int from_gtype = 2; +int to_gtype = 1; +int dumpOldGrid = 0; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +int numberOfGridFile = 1; +string from_gfile = "./grid/rae2822_hybrid2d.cas"; +string from_gfile1= ""; + +string out_gfile = "./grid/flat_laminr_133_85_2d.fts"; + +// ----------------- some advanced choices ------------------------------ +// iunsteady: The Grid is for unsteady simulation or not. +int iunsteady = 0; +int codeOfAleModel = 0; + +// fileformat: Ustar Grid file format. +// 0 -- BINARY. +// 1 -- ASCII. +int fileformat = 0; + +// Parameters for hybrid solver. +// mixgrid_uns: path of unstructure grid file for hybrid solver, *.fts type. +// mixgrid_str: path of structure grid file for hybrid solver, *.fts type. +string mixgrid_uns = "./grid/rae2822_uns2d_4.fts"; +string mixgrid_str = "./grid/flat_laminr_133_85_2d.fts"; + +// Some parameters for structured overlapping grid. +int codeOfDigHoles = 1; +string holeBasicFileName = "./oversetGridView/holeBasicFile.inp"; +string holeFullFileName = "./oversetGridView/holeFullFile.dat"; +string linkFileName = "./oversetGridView/topology.dat"; +string zoneInverseFileName = "./oversetGridView/zoneInverseMapping.inp"; + +// ----------------- Adaptive Mesh Refine ------------------------------- +// In this file, the original_grid_file is used of the partition part. +// If use it dependently, abstract it here. +string adapt_grid_file = "./grid/sphere_mixed_adapt1.fts"; +string geometryFileName = "./grid/jsm.igs"; + +// geometryUnit: Geometry unit. +// 1 -- meter. +// 2 -- millimeter. +// 3 -- inch. +// exclusiveCase: Parallel projection exclusive case. +// 0 -- NON case. +// 1 -- JSM-C2-NPOFF case. +// 2 -- CHNT. +// projectOrgPoint: If the original wall points need to be projected or not. +int geometryUnit = 1; +int anisoRefine = 0; +int isProject = 0; +int readDist = 0; +int isDeform = 0; +int exclusiveCase = 0; // 0: NON case; 1: JSM-C2-NPOFF case; 2: CHNT. +int projectOrgPoint = 0; // if project original wall points. + + +// ----------------- Grid Deform Parameters ----------------------------- +// deformationMethod: Grid Deform. +// 1 -- SPRING. +// 2 -- RBF. +// stationalGridFile: Original grid file. +// visualFileName : The visualization file path of deform grid. +// nDeformStep : The max deform step. +// flapAngle : The max flap angle. +// rotatePostionZ : Rotate postion. +// rotatePostionY : Rotate postion. +// gridSlice : If dump slice grid. +// sliceAxis : Grid slice axis. +// slicePosition : Grid slice position. +int nDeformStep = 40; +double flapAngle = 10.0; +double rotatePostionZ = 4.00003; +double rotatePostionY = 3.05; + +int deformationMethod = 2; +string stationalGridFile = "./grid/Segment2Brid.fts"; +string visualFileName = "./results/deformedGrid.dat" + +int gridSlice = 1; +int sliceAxis = 1; +double slicePosition = 13; + +// ----------------- RBF Parameters ------------------------------------- +// numberOfReferenceCP : Number of reference Control Points. +// influencePara : The RBF influence radius parameter. +int numberOfReferenceCP = 40; +double influencePara = 25.0; + +// ----------------- Periodic Parameters -------------------------------- +// Notice: Rotational periodicity only support rotation along the X axis! +// periodicType: Which periodic boundary is used. +// 0 -- without Periodic Boundary. +// 1 -- Translational periodicity. +// 2 -- Rotational periodicity. +// translationLength[]: The relative distance between two periodic face + which only support one direction. +// rotationAngle: The relative angle between two periodic face. + which is recorded in degrees. + +int periodicType = 0; +double translationLength[] = [0.0,0.0,0.0]; +double rotationAngle = 0.0; + +######################################################################### +# Default parameters for Partition # +######################################################################### +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// 2 -- refine structured grid. +// maxproc: The number of partition zones that want to be divided into. +int pgridtype = 0; +int maxproc = 4; + +// traceMark: Trace mark or not, only for structured grid partition. +// 0 -- Not. +// 1 -- Yes. +// blockIndexOfMark: the block index of mark, only for structured grid partition. +// cellIndexOfMark: the cell index of mark, only for structured grid partition. +int traceMark = 0; +int blockIndexOfMark = 0; +int cellIndexOfMark[] = [185,30,1]; + +// parallel Strategy: +//! -# 0 : each zone is assigned to the one that defined in grid partition procedure. +//! -# 1 : random assigned for each zone or by some else ways. +int parallelStrategy = 1; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). +string original_grid_file = "./grid/sphere_mixed.fts"; +string partition_grid_file = "./grid/sphere_mixed__4.fts"; + +// ------------------ Sompe advanced parameters ------------------------- +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +// npartmethod: Method of interface reconstruction, default is 1. +// parallelPartitionMethod: Method of parallel partition, this is set only when execute parallel partition. It would be skipped when serial partition. +// 1 -- Using ParMetis for homogeneous MPI. +// 2 -- Using Metis for homogeneous MPI. +// 3 -- using METIS partition for homogeneous OpenMP. +// parmetisBalance: Used to specify the imbalance tolerance. +// 1 -- perfect balance. +// maxproc -- perfect imbalance. +// 1.05 -- recommended. + +int omit_no_bound_bc = 0; +int npartmethod = 1; +int parallelPartitionMethod = 2; +double parmetisBalance = 1.05; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level, ..., et al. +int numberOfMultigrid = 1; + +######################################################################### +# Default parameters for CFD simulation # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepSample: The step intervals for monitored probes variables file 'sample.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual file 'res.dat' saved. +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) + +int maxSimuStep = 20000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepSample = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; +int ifLowSpeedPrecon = 0; + +// compressible: +// 0 -- incompressible flow. +// 1 -- compressible flow. (default) +int compressible = 1; + +//----------------------------------------------------------------------- +# CFD Control Parameter # +//----------------------------------------------------------------------- +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// 4 -- the condition that the velocity, temperature and density are given. +// 5 -- the condition that the velocity, temperature and pressure are given. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. +// radiationCoef: The radiation coefficient on wall, it is used to compute the radiation heat flux on wall when the boundary +// condition is radiation equilibrium temperature, and 0.8 is the default value. +// refMolecularWeight : the reference molecular weight of gas used for perfect gas. The unit is g/mol. +// Generally, the gas is air. Sometimes, it is experiment gas, such as Nitrogen, Argon, and so on. + +double refMachNumber = 0.73; +double attackd = 2.79; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 6.5e6; +double refDimensionalTemperature = 288.15; +double freestream_vibration_temperature = 300.00; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +//int inflowParaType = 3; +//int nsubsonicInlet = 1; +//int nsubsonicOutlet = 1; +//string inLetFileName = "./bin/subsonicInlet.hypara"; +//string outLetFileName = "./bin/subsonicOutlet.hypara"; +//double refDimensionalTemperature = 288.144; +//double refDimensionalPressure = 1.01313E05; + +//The velocity, temperature and density are fixed. +//int inflowParaType = 4; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalDensity = 1.0e3; + +//The velocity, temperature and pressure are fixed. +//int inflowParaType = 5; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalPressure = 1.0e5; + +//The MachNumber, temperature and pressure are fixed. +//int inflowParaType = 6; +//double refDimensionalTemperature = 293; +//double refDimensionalPressure = 8886.06; + +double wallTemperature = -1.0; + +double radiationCoef = 0.8; +double gridScaleFactor = 1.0; + +int numberOfAerodynamicForceComponents = 1; +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. +double refMolecularWeight = 28.9644; // unit of g/mol. + +//----------------------------------------------------------------------- +# Spatial Discretisation # +//----------------------------------------------------------------------- +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "hlle", "lax_f". +// -- "roe", "modified_roe". +// -- "ausm+", "ausm+w", "ausm+up", "ausmdv", "ausmpw", "ausmpw+". +// str_limiter_name: Limiter of struct grid. +// -- "vanalbada", "vanleer", "minmod", "smooth", "minvan", "3rdsmooth", "3rd_minmod_smooth". +// -- "nolim", no limiter. +// -- "vanalbada_clz", clz supersonic version. +string inviscidSchemeName = "roe"; +string str_limiter_name = "vanalbada"; + +#******************************************************************* +# UnStruct Solver or Common * +#******************************************************************* +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 2 -- Algebraic. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "0eq-bl". +// -- "1eq-sa". +// -- "2eq-kw-menter-sst". +// -- "2eq-kw-menter-bsl". +// -- "2eq-kw-wilcox-1988". +// -- "2eq-kw-wilcox-1998". +// -- "2eq-kw-kok-tnt". +// -- "2eq-kw-wilcox-2006". +// -- "easm-kw-2003". +// -- "easm-kw-2005". +// DESType: Type of DES. +// 0 -- RANS. (default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpw+". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "barth", "vencat", "vanleer", "minmod". +// -- "vanalbada", "smooth", "nnd", "lpz", "1st". +// -- "nolim", no limiter. +// uns_vis_name: Discretisation method of viscous term. +// -- "std", "test", "aver", "new1", "new2". +// gradientName: Gradient reconstruction method. +// -- "default", "ggcell", "ggnode", "lsq". +// ivencat: Variation of vencat limiter. +// 0 -- org method, it is independent of grid scale. +// 1 -- new method, it is dependent of grid scale. +// 4 -- Ustar limiter model, without grid size unitary. +// 7 -- default used. +// venkatCoeff: Cofficient of vencat, when using vencat limter. +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. +// skewnessAngle: The skewness angle of grid cells. +// roeEntropyFixMethod: Entropy fix (correction) method. +// 1 -- direct fix, which limits the minimum eigenvalue directly. +// 2 -- multi-dimensional fix, which is derived from structured solver and now is only valid for struct solver. +// 3 -- Harten type, which is default used. +// roeEntropyScale: Entropy fix (correction) coefficient scale, default is 1.0. +// It is used to scale the default Roe entropy fix coefficients. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +string uns_scheme_name = "roe"; +string uns_limiter_name = "vencat"; +string uns_vis_name = "test"; +string gradientName = "ggnode"; + +int ivencat = 7; +double venkatCoeff = 5.0; +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; +double skewnessAngle = 60.0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; + +//----------------------------------------------------------------------- +# Temporal Discretisation # +//----------------------------------------------------------------------- +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// physicalTimeStep: The nondimensional physical time step. +// ifStartFromSteadyResults: The unsteady simulation is start from steady flowfield or not, 0 is for no and else is for yes. +// ifStaticsFlowField: Statistical variables for unsteady simulation. +// ifStaticsReynoldsStress: Statistical Reynolds stress for unsteady simulation. +// startStatisticStep: Outer step when start statistics. +// when the value is larger than "maxSimuStep", it is useless. +// statisticalTimePeriod: Used as time period of statistic analysis. +// when the value is negative, time period is treated as infinite. +// statisticMethod: Statistic reynolds stress method. + 0 --tau = - ^2 + 1 --tau = +// min_sub_iter: The min sub iteration of unsteady simulation. +// max_sub_iter: The max sub iteration of unsteady simulation. +// tol_sub_iter: The tolerance of sub iteration of unsteady simulation. +// tscheme: Temporal Discretisation method. +// 1 -- Runge-Kutta Multi-State. +// 2 -- Point implicit. +// 3 -- Full implicit. +// 4 -- LU-SGS. +// 5 -- Block LU-SGS. +// 6 -- Jacobian iteration. +// 7 -- Lower G-S iteration. +// 8 -- Upper G-S iteration. +// 9 -- Lower/Upper G-S iteration. +// iSimplifyViscousTerm: Simplify the computation of viscous term in the Block LU-SGS method. The default value assigns 1 that could speed up the computation. +// Otherwise, the viscous Jacobian matrix Mv should be computed that will increase the memory and time in iteration of the BLUSGS method. +// CFLStart: Started cfl number. +// CFLEnd: End cfl number. +// CFLVaryStep: The number of step when cfl increase from CFLStart to CFLEnd. +// ktmax: Dtratio. dt[i] = MIN(dt[i], ktmax * dtmin / vol[i]) +// swapDq: Communication dq between forward/backward sweep of LUSGS or not, default is 0. +// nLUSGSSweeps: Sub iteration of LU-SGS or Block LU-SGS. +// LUSGSTolerance: Sub iter tolerance of LU-SGS or Block LU-SGS. +// ifLocalTimeStep: Time step method. +// 0 --Local. +// 1 --Global. +// visl_min: Minimum value of laminar viscosity coefficient. +// turbCFLScale: Turbulence model cfl number factor. +// codeOfAleModel: Arbitrary Lagrangian-Eulerian method. +// 0 -- no ALE method. +// 1 -- ALE method for non-moving grids. +// 2 -- ALE method for moving grids. +// 3 -- ALE method for deforming grids. +// wallFunctionType: The type of wall function to implement. +// 0 -- no wall function. (default) +// 1 -- standard wall function. +// 2 -- Pab3D wall function. +// RKStage: The number of Runge-Kutta step. +// lamda: Cofficient of Runge-Kutta step. + +int iunsteady = 0; +double physicalTimeStep = 0.01; +int ifStartFromSteadyResults = 0; +int ifStaticsFlowField = 0; +int ifStaticsReynoldsStress = 0; +int startStatisticStep = 800000; +double statisticalTimePeriod = -1.0; +int statisticMethod = 0; +int linearTwoStepMethods = 1; // 1--BDF1; 2--C-N; 3--BDF2; + +int methodOfDualTime = 3; +int min_sub_iter = 50; +int max_sub_iter = 50; +double tol_sub_iter = 0.01; + +int tscheme = 4; +int iSimplifyViscousTerm = 1; +int ifLocalTimeStep = 0; +double CFLStart = 0.01; +double CFLEnd = 10.0; +int CFLVaryStep = 500; + +double ktmax = 1.0e10; + +int swapDq = 1; + +int nLUSGSSweeps = 1; +double LUSGSTolerance = 0.01; +int order = 2; + +double visl_min = 0.01; +double turbCFLScale = 1.0; +double csrv = 2.0; +double timemax = 1.0e10; +double dtsave = -1.0; +int maxale = 10; +double dtau = 0.001; + +int wallFunctionType = 0; + +int RKStage = 2; +double lamda[] = 0.5, 1.0; + +//int RKStage = 1; +//double lamda[] = 1.0; + +//int RKStage = 4; +//double lamda[] = [0.25, 0.33333333333, 0.5, 1.0]; + +//----------------------------------------------------------------------- +# File In or Out # +//----------------------------------------------------------------------- +// numberOfGridGroups: The number of grid groups. +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the field results to visulization. +// walldistMethod: The method to compute wall distance. +// 0 -- accurate but not fast enough. +// 1 -- fast but not accurate enough. +// 2 -- super fast but more non-accurate! +// resSaveFile: The file path to save the residual convergence process, write data for every default (intervalStepRes) steps. +// turbresfile: The file path to save the residual convergence process of turbulence, write data for every default (intervalStepRes) steps. +// aircoeffile: The file path to save the aerodynamic force coefficients convergence process, write data for every default (intervalStepForce) steps. +// restartNSFile: The file path to write restart flowfield variables, write data for every default (intervalStepFlow) steps. +// turbfile: The file path to write restart flowfield variables of turbulence , write data for every default(intervalStepFlow) steps. +// visualfile: The visualization file path of flowfield , write data for every default (intervalStepPlot) steps. +// wall_aircoefile: The file path to save flowfield variables of wall, write data for every default steps. +// nDumpSurfaceInfo = 0 the "wall_varfile" write the informations including heat flux. +// nDumpSurfaceInfo = 1 the "wall_varfile" write the informations without heat flux. + +int numberOfGridGroups = 1; +string gridfile = "./grid/rae2822_hybrid2d__4.fts"; +string wallTemperaturefile= ""; + +int walldistMethod = 1; + +string resSaveFile = "results/res.dat"; +string turbresfile = "results/turbres.dat"; +string aircoeffile = "results/aircoef.dat"; + +string restartNSFile = "results/flow.dat"; +string turbfile = "results/turb.dat"; + +string visualfile = "results/tecflow.plt"; +string wall_aircoefile = "results/wall_aircoef.dat"; +string samplefile = "results/sample.dat"; + +int nDumpSurfaceInfo = 0; +string wall_varfile = ""; + +string jetDefineFile = "bin/jet.hypara"; + +string sixDofFileName = "results/sixDofInfo.dat"; +string derivativeFileName = "results/identify.dat"; +string hysteresisFileName = "results/force_beta.plt"; + +int plotFieldType = 0; + +// visualfileType: The file type of visualfile. +// 0 -- Tecplot binary. +// 1 -- Tecplot ASCII. + +int visualfileType = 1; + +// samplefileMode: The dump mode of sample file. +// 0 -- dump out every probe/line/surface data for all step intervals. +// 1 -- dump out all probe/line/surface data for every step intervals. +int samplefileMode = 0; + +// visualSlice: The slice of tecflow. +// 0 -- Do not save slice data. +// 1 -- comput and save it to sliceFile. +// sliceAxis: Normal vector of slice. +// 1 -- X_DIR. +// 2 -- Y_DIR. +// 3 -- Z_DIR. +// slicePostion: Coordinate of slice. + +int visualSlice = 0; +int sliceAxis = 1; +double slicePostion = -0.5; +string sliceFile = "results/Slice.plt"; +int dumpWallFaceCenter = 0; + +// min-max box of the visual block. +double lowerPlotFieldBox[] = [0.0 0.0 0.0]; +double upperPlotFieldBox[] = [1.0 1.0 1.0]; + +//-----------the optional parameters list for the flow field output---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40), +// -- gradientUx(41), gradientUy(42), gradientVx(43), gradientVy(44), iblank(81). +// -- specific heat ratio(gama, 56) +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. +//-----------the optional parameters list for the wall boundary condition---------------- +// nVisualWallVariables: The number of visual variables on wall. +// visualWallVariables : dumped variable types, listed as following: +// -coefficient of pressure(cp, 0), -coefficient of friction(cf, 1), yplus(2), -non-dimensional heat flux(Q_NonDim, 3), -dimensional heat flux(Q_Dim, 4), +// -pressure on wall(pw, 5), -temperature on wall(Tw, 6), -density on wall(rhow, 7), -heat flux of translational-rotational temperature term(Qtr, 8), +// -heat flux of species diffusion term(Qs, 9), -heat flux of vibrational temperature term(Qv, 10), -heat flux of electron temperature term(Qe, 11), +// -species mass fractions(Ns, 12), -x component of wall velocity(Vx, 13), -y component of wall velocity(Vy, 14), -z component of wall velocity(Vz, 15) +// -slip translational-rotational temperature(Tts, 16), -slip vibrational temperature(Tvs, 17), -slip electron temperature(Tes, 18), -absolute wall velocity(Vs, 19) +// -Stanton number(St, 20), -coefficient of heat rate(Ch, 21), -temperature jump(deltaT, 22), -transition gamaeff(gamaeff, 48), +// -transition intermittency(intermittency, 51), -transition momentum thickness reynolds(MomentumThicknessReynolds, 52), +// -overlap iblank(iblank, 81) + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +int nVisualWallVariables = 9; +int visualWallVariables[] = [0, 1, 2, 3, 4, 5, 9, 10, 11]; + +// dumpStandardModel: Dump many standard model data. +// 1 -- Turbulent flat plate. +int dumpStandardModel = 0; + +// ifSetDataMonitor: Whether to set the data monitor. +// 0 -- No. +// 1 -- Yes. +// dataMonitorType: The type of data Monitor. +// 0 -- Probes data monitor. +// 1 -- Lines data monitor. +// 2 -- Surfaces data monitor. +// probesDefineFile: Probes location information file. +// nLines: The number of lines need to be monitored. +// linesDefineFile: Lines location information file. +// nSurfaces: The number of surfaces need to be monitored. +// surfacesDefineFile: Surfaces location information file. +// searchCellsMethod: method to search the cell of each probe. +// 0 -- Nearest cell to the probe. +// 1 -- Real cell where the probe is located. +// nProbeVariables: Number of variables want to be dumped for probes monitered. +// probeVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5). +// Important Warning: Array size of probeVariables MUST be equal to nProbeVariables!!! +// probeVariables order must from small to big. +// probeVariablesInterpolationMethod: Interpolation method used to compute the probe variables. +// 0 -- Take the value of probe's cell as probe real value. +// 1 -- Interpolation from probe's and neighbouring cell to probe. +// 2 -- Interpolation from probe's cell nodes to probe. +int ifSetDataMonitor = 0; + +int dataMonitorType = 0; +string probesDefineFile = "bin/probes_XYZ.dat"; + +//int dataMonitorType = 1; +//int nLines = 1; +//string linesDefineFile = "bin/lines_XYZ.dat"; + +//int dataMonitorType = 2; +//int nSurfaces = 4; +//string surfacesDefineFile = "bin/surfaces_XYZ.dat"; + +int searchCellsMethod = 0; + +int nProbeVariables = 6; +int probeVariables[] = [0, 1, 2, 3, 4, 5]; +int probeVariablesInterpolationMethod = 0; +//----------------------------------------------------------------------- +# Turbulence Parameter # +//----------------------------------------------------------------------- +// turbInterval: Iteration number of turbulence. +// kindOfTurbSource: Kinds of turbulent source. +// 0 -- Original. +// 1 -- Edwards. +// 2 -- new. +// mod_turb_res: If modify the residuals for the cells next to the wall or not, default is 0. + +int turbInterval = 1; +int turbOrderStruct = 2; +int kindOfTurbSource = 0; +int mod_turb_res = 0; +double turb_relax = 1.0; +double freeStreamViscosity = 1.0e-3; +double muoo = 3.0; +double kwoo = 5.0; +int transitionType = 0; +double turbIntensity = -1.0; +int freeturbIntensitySRModify = 0; +double freeDecayXLocation = 0.0; +int compressibleCorrection = 0; +int transitionMaFix = 1; + +# maximum eddy viscosity (myt/my) max. +double eddyViscosityLimit = 1.0e10; +int monitor_vistmax = 0; + +//----------------------------------------------------------------------- +# LES Parameter # +//----------------------------------------------------------------------- +// iLES: Create LESSolver or not. +// == 1 - Create LESSolver; +// != 1 - not. +// amplitudeofDisturb: Amplitude of adding disturb. +// disturbstep: Unsteady time step or steady iteration of adding random disturb. +// iterdisturb: Add random disturb in every sub-iter or only first sub-iter. +// = 0 - in only first sub-iter; +// != 0 - in every sub-iter. +// ipraddisturb: Add density and pressure disturb or not. +// ibodyforce: Add body force in source flux of NS equations or not. +// = 0 - not; +// != 0 - Add body force. +// bodyforce: Body force in source flux of NS equations or not. +// utau: friction velocity, using in DNSDisturb. +// sgsmodel: subgrid scale model. +// = "smagorinsky"; +// = "dsmCom"; +// = "wale"; +// = "sigma". +// deltaFunctionType: = 1 - MAX(deltai, deltaj, deltak); +// = 2 - pow(deltai * deltaj *deltak, 1/3); +// = 3 - Devloped by Scotti. +// wallDampingFunctionType: = 0 - no wall function; +// = 1 - van Driest; +// = 2 - developed by Dr. Deng Xiaobing; +// = 3 - developed by Piomelli. +// turbViscousCutType: turbulent viscosity cut type. +// = 0 - mu_total = mut + mul; +// = 1 - mu_total = max(mut-mul,0)+ mul; +// = 2 - mu_total = max(mut ,0)+ mul. +// smagConstant: constant of smagorinsky model. +// waleConstant: constant of wale model. +// filterDirection[3]: filter variables in i, j, k direction or not. +// averageDirection[3]: average variables in i, j, k direction or not. +// isotropicConstant: constant of isotropic part of SGS stress. + +int iLES = 0; +string sgsmodel = "smagorinsky"; +int deltaFunctionType = 2; +int wallDampingFunctionType = 1; +int turbViscousCutType = 2; +double smagConstant = 0.1; +double isotropicConstant = 0.0; +double waleConstant = 0.6; +double sigmaConstant = 1.35; +int filterDirection[] = [1, 1, 0]; +int averageDirection[] = [0, 0, 0]; +double testFilterScale = 2.0; +int averageWidth = 1; +int monitorNegativeConstant = 0; + +//----------------------------------------------------------------------- +# Other Parameters for Hypersonic Non-equilibrium Gas # +//----------------------------------------------------------------------- +// dg_high_order: +// 0 -- generic order accuracy. +// 1 -- high order accuracy. +// iapplication: +// 0 -- gas model is fixed in the codes. +// 1 -- gas model is imported from library files. +// iCodeBranch: +// 0 -- The old code version is used for Navier-Stokes. +// 1 -- A new code version is active for Navier-Stokes solver. +// nm: Equation number of the physics, but is out of commision now. +// 4 -- for 2D. +// 5 -- for 3D. +// nGasModel: The type of gas. less than and equal to 1 represents the mixture gas. +// Otherwise, the pure gas with one component is used for perfect gas. +// 0 -- Earth gas. +// 1 -- Mars gas. +// 2 -- Argon. +// 3 -- Nitrogen. +// nEnergyRecycle: The type of EnergyModel Recycle. +// 0 -- not used . +// 1 -- used. +// nDensityModify: The type of densitymodify. + +// 0 -- not used. +// 1 -- used. +// nchem: +// 0 -- without chemical reaction flow. +// 1 -- the chemical reaction flow is considered. +// nEquilibriumGas: the variable is valid when the condition of nchem=0 is satisfied. +// 0 -- perfect gas. +// 5, 7, 11 -- equilibrium gas, meanwhile, its value denotes the number of gas component. +// nPCWCycleStep: the maximum step number of iteration in the module of computing species mass fractions with the partial catalytic wall(PCW) condition. +// the value equals to or is greater than 1, and 3 is for default value. +// nRETCycleStep: the maximum step number of iteration in the module of computing radiation equilibrium temperature on wall. +// the value equals to or is greater than 1, and 3 is for default value. +// nSLIPCycleStep:the maximum step number of iteration in the module of computing slip temperature, slip velocity and slip species mass fraction. +// the value equals to or is greater than 1, and 3 is for default value. +// nSlipBCModel : The computational model of slip boundary conditions. + +// 0 -- no slip. +// 1 -- the conventional Maxwell slip conditions. +// 2 -- the Gokcen slip conditions. +// 3 -- the Knudsen-layer correction of the standard slip conditions proposed by Lockerby, et al. +// 4 -- the Kogan simplified slip conditions. +// nMeanFreePathType : the method to the mean free-path for the slip conditions. For the mixture, 0 is suggested. +// 0 -- the equivalent mean free-path is calculated by the simple hard sphere model(HS). +// 1 -- calculated by the definition that includes the variables of the number density and the molecule diameter. +// 2 -- the equivalent mean free-path is calculated by the variable hard sphere model(VHS). +// nchemsrc: +// 0 -- the source terms are not computed. +// 1 -- the source terms are computed. +// nchemrad: +// 0 -- compute the spectrum radius without considering chemical reaction flow. +// 1 -- compute the spectrum radius that need to count the contribution from chemical reaction flow. +// ntmodel: The thermodynamic temperature model. +// 1 -- One-temperature model. +// 2 -- Two-temperature model. +// 3 -- Three-temperature model. +// nTEnergyModel: the method to computing temperature energy model. +// 0 -- the energy term is computed using the conventional method. +// 1 -- the energy term is computed using the curve fitting method. +// parkVDPower: the power of translational-rotational temperature in the Park V-D(vibration-dissociation) coupling model. +// The value is in range of [0.0, 1.0], DPLR suggests 0.5, LAURA suggests 0.7, while 0.6 is given as default value. +// catalyticCoef: +// 0.0 -- full non-catalytic wall boundary condition. +// 1.0 -- full catalytic wall boundary condition. +// in range of (0.0, 1.0) -- partial catalytic condition, the value indicates the catalytic coefficient. +// nIsSuperCatalytic : the super catalytic condition for the fully catalytic wall, and assigned with the value of 1. +// 0 -- equilibrium condition for the fully catalytic wall where the mass fractions are assigned with the values of the free stream. +// 1 -- super catalytic condition for the fully catalytic wall where all the atomic components combine into molecular components. +// nTemperatureJump : the method to calculate the temperature jump. +// 0 -- calculated by the variables of heat conductivity and constant volume specific heat for each energy mode. +// 1 -- the general method where the iteration is calculated with the translation-rotation temperature. +// sigmaVelocity: the coordination coefficient of tangential momentum for computation of slip velocity. The value is in range of (0.0, 2.0]. +// sigmaTemperature: the heat coordination coefficient for computation of slip temperature. The value is in range of (0.0, 2.0]. +// sigmaMassFraction: the species coordination coefficient for computation of slip mass fractions. The value is in range of (0.0, 2.0]. +// velocitySlipCorrectConstant: the correction constant to the velocity slip condition. For the diffuse reflection, 1.0 is used. +// 1.0 -- proposed by Maxwell. +// sqrt(2/PI)~0.8 -- used for "micro-slip", namely the actual velocity slip at the wall. +// 1.146 -- proposed for an additional "fictitious" velocity slip. + +// chemicalRelaxCorf: The value is in range of [0.001, 1.0]. +// chemicalSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// viscousSpectrumRadiusCoef : The value is in range of [1.0, 3.0]. +// inviscidSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// staticPressureRelaxCorf: The value is in range of [0.1, 1.0]. +// nIsChemicalFreeze : the flag to freeze the chemical reactions. +// 0 -- not freeze, the chemical reaction sources will be calculated. +// 1 -- freezes the chemical reactions, the chemical reaction sources will not be calculated.// veTemperatureMin: The minimum of Tv and Te +// nDebug: cout the Wrong place and abort +// 0 -- not used. +// 1 -- used. +// nSpeciesLimit: limitter of gas species +// 0 -- not used. +// 1 -- used. +// nTurblenceForChemical: the coupled mode of Turblence and Chemical reaction +// 0 -- method 0. +// 1 -- method 1. +// nViscosityFluxSublevelModified: Modified for ViscosityFlux on Sublevel grid +// 0 -- not used. +// 1 -- used. +// nChemcalSourceModified: Modified on ChemcalSource +// 0 -- not used. +// 1 -- used. +// nAblation: +// 0 -- The wall ablation is not computed. +// 1 -- The wall ablation is computed. +// isInjection: +// 0 -- The injection velocity of ablation wall is not computed. +// 1 -- The injection velocity of ablation wall is computed. +// nViscosityModel: + +// 0 -- Blottner fitting method. +// 1 -- Gupta fitting method. +// nSutherland: +// 0 -- stands for selecting the Blotter curve fits mode. +// 1 -- stands for Sutherland relation. +// gasfile: Indicates the gas model, 9 models are provided, namely "Gu5", "Gu7", "Gu11", "Pa5", "Pa7", "Pa11", "DK5", "DK7", "DK11". +// "Gu" -- indicates the Gupta Model, three-Type Models are embeded in the library, namely, the 5-species-6-reactions, the 7-species-9-reactions, the 11-species-20-reactions. +// "Pa" -- indicates the Park Model, three-Type Models are embeded in the library, namely, the 5-species-17-reactions, the 7-species-22-reactions, the 11-species-48-reactions. +// "DK" -- indicates the Dunn-Kang Model, three-Type Models are embeded in the library, namely, the 5-species-11-reactions, the 7-species-15-reactions, the 11-species-26-reactions. +// "Mars-Pa8" is for Park model of Mars gas, "Mars-Mc8" for McKenzie model of Mars gas. +// "Combustion-12" -- indicates the Combustion Chamber Gas Model which includes 12-species-20-reactions. +// "Gas-Mixture" -- indicates the process of mixing two species without reacting. +// For self-definition model, the gasfile is used to indicate the file path of the new gas model. +// speciesName: Used to list the names of each species, while each species name is separated by the symbol of comma. +// initMassFraction: Used to list the initial mass fractions of species in accordance with the sequence of names in the parameter speciesName. +// ifStartFromPerfectGasResults: The chemical reaction simulation is start from perfect gas flowfield or not, 0 is for no and else is for yes. + +int dg_high_order = 0; +int iapplication = 0; +int iCodeBranch = 0; +int nm = 5; +int nEquilibriumGas = 0; +int nPCWCycleStep = 3; +int nRETCycleStep = 3; +int nSLIPCycleStep= 3; + +double refGama = 1.4; +double prl = 0.72; +double prt = 0.90; +double sc_l = 0.5; +double sc_t = 0.5; + +int nGasModel = 0; +int nchem = 0; +int nchemsrc = 1; +int nchemrad = 1; +int ntmodel = 1; + +int nEnergyRecycle = 0; +int nSlipBCModel = 0; +int nDensityModify = 1; +int nTEnergyModel = 0; +int nMeanFreePathType = 0; +int nIsChemicalFreeze = 0; +int nIsSuperCatalytic = 1; +int nTemperatureJump = 0; + +double parkVDPower = 0.6; +double catalyticCoef = 0.0; +double sigmaVelocity = 1.0; +double sigmaTemperature = 1.0; +double sigmaMassFraction = 1.0; +double velocitySlipCorrectConstant = 1.0; + +double chemicalRelaxCorf = 1.0; +double chemicalSpectrumRadiusCoef = 1.0; +double viscousSpectrumRadiusCoef = 1.0; +double inviscidSpectrumRadiusCoef = 1.0; +double staticPressureRelaxCorf = 1.0; + +double veTemperatureMin = 30.0; +int nDebug = 0; +int nSpeciesLimit = 0; +int nTurblenceForChemical = 0; +int nViscosityFluxSublevelModified = 0 ; +int nChemcalSourceModified = 0; + +int nAblation = 0; +int isInjection = 0; +int nViscosityModel = 0; +int nMarsModel = 0; +string gasfile = "DK5"; +//string gasfile = "./chemical/Dunn-Kang_air5s11r.dat"; +string speciesName = "O, O2, NO, N, N2"; +string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.767"; + +//string speciesName = "O, O2, NO, N, NO+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string speciesName = "O, O2, NO, N, O+, O2+, NO+, N+, N2+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Mars-Pa8"; +//string speciesName = "O, O2, NO, N, N2, C, CO, CO2"; +//string initMassFraction = "0.0015, 0.0429, 0.0, 0.0, 0.0, 0.0, 0.0777, 0.8779"; + +//string gasfile = "DK7"; +//string speciesName = "O, O2, NO, N, NO+, C, C2, CO, CO2, CN, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Combustion-12"; +//string speciesName = "O, O2, NO, N, C, CO, CO2, H, H2, OH, H2O, N2"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767"; + +//string gasfile = "Gas-Mixture"; +//string speciesName ="SpeciesA, SpeciesB"; +//string initMassFraction = "1.0, 0.0"; +int nSutherland = 0; +double gamaSpeciesA = 1.4; +double gamaSpeciesB = 1.3; +double molecularWeightSpeciesA = 29.0; +double molecularWeightSpeciesB = 30.0; + +int nChemicalFlowStep = 0; +int ifStartFromPerfectGasResults = 0; + +######################################################################### +// Multi-Grid parameters. +// nMGLevel: The number of level of Multi-Grid. +// <= 1 -- Single-level. +// > 1 -- multi-level. +// MGPreIteration: For each grid, the number of pre-smoothing steps. +// n_post: For each grid, the number of post-smoothing steps. +// MGCoarsestIteration: For the coarest grid the number of smoothing steps. +// MGFasType: V-multi cycle or W-multi cycle. +// 1 -- V-multi cycle. +// 2 -- W-multi cycle. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. +// mgCFLScale: CFL number enlarge times for coarse grid. +// mprol: Multi-grid interpolation method, interpolation from coarse cell to fine grid. +// 1 -- zero order. +// 2 -- first-order. (default) +// mgCorrectionLimit: Multi-grid correction limit. + +int nMGLevel = 1; +int MGCoarsestIteration = 1; +int MGPreIteration = 1; +int MGFasType = 1; +int n_post = 0; +int flowInitStep = 100; +int mprol = 2; +double mgCFLScale = 1.0; +double mgCorrectionLimit = 0.01; + +//--------------- Some parameter for turbulent model -------------------- +// neasm: The variation of kw turbulent model. +// ismooth_turb: Residual smooth for turb or not. +// SSTProductType: The type of product term based on vorticity for SST. +// SAProductType: The type of product term based on vorticity for SA. +int neasm = -3; +int SSTProductType = 0; +int ismooth_turb = 0; +int SAProductType = 2; + +// ----------------- Overset Grid parameter ----------------------------- +int codeOfDigHoles = 1; +int codeOfTurbulentModel = 0; +string masterFileName = "./grid/searchFile.inp"; +string holeBasicFileName = "./grid/holeBasicFile.inp"; +string holeFullFileName = "./grid/holeFullFile.dat"; +string linkFileName = "./grid/topology.dat"; +string zoneInverseFileName = "./grid/zoneInverseMapping.inp"; + +######################################################################### +# High Order Struct Solver # +######################################################################### +// isFVMOrFDM: +// 0 -- NSSolverStruct using Finite Volume Method. +// 1 -- NSSolverStruct using Finite Differ Method. +// SolverStructOrder: Spatial discretisation order of NS equations with struct grid. +// <= 2 -- finite volume method. +// >= 3 -- finite difference order. (to be completed) +// 0 -- default. +// str_highorder_interpolation_epsilon: Epsilon in weighted interpolation, bigger epsilon, better convergence, +// smaller epsilon, robuster for shock-detecting. +// str_highorder_interpolation_type: +// -- "classical", "test". +// str_highorder_flux_name: +// -- "roe", "steger". +// structhighordergradient: +// -- "conservation", "chain_rule". +int isFVMOrFDM = 0; +string str_highorder_solver = "WCNS"; +int SolverStructOrder = 0; +double str_highorder_interpolation_epsilon = 1.0e-6; +string str_highorder_interpolation_type = "test"; +string str_highorder_flux_name = "steger"; +string structhighordergradient = "conservation"; +double coefofstrflux = 0.5; +double limitcoefofinterface = 0.0; + +// ----------------- Advanced choices ----------------------------------- +// outtimesc: Time stepping scheme for the outer loop. +// MUSCLCoefXk: The parameter of MUSCL interpolations, belongs to [-1, 1]. +// -1 -- seconde-order fully-upwind differencing. +// 0 -- seconde-order upwind-biased differencing. +// 0.333333 -- third-order upwind-biased differencing. +// 1 -- seconde-order central differencing. +// MUSCLCoefXb: The limiter parameter. +// 0 -- the effect of the limiter is cancelled, means the first-order interpolations. +// allReduceStep: Iteration intervals for MPI AllReduce operation, default is 1. +string outtimesc = "impbd2"; +double MUSCLCoefXk = -1; +double MUSCLCoefXb = 1.0; +int allReduceStep = 1; + +// ----------------- overlap configuration ------------------------------ +// codeOfOversetGrid: Overlapping(overset) grid or not. +// 0 -- NON-overlapping grid. +// 1 -- Overlapping grid. +// oversetInterpolationMethod: the method of overset interpolation while field simulation +// 0 -- set the acceptor cell value by donor cell value. +// 1 -- set the acceptor cell value by distance weight of donor cell value. + +int codeOfOversetGrid = 0; +int oversetInterpolationMethod = 0; +int readOversetFileOrNot = 0; +int symetryOrNot = 0; +int readInAuxiliaryInnerGrid = 1; +int readInAuxiliaryOuterGrid = 0; +int readInSklFileOrNot = 0; +string auxiliaryInnerGrid0 = "./grid/aux-upper.fts"; +string auxiliaryInnerGrid1 = "./grid/aux-lower.fts"; +string auxiliaryInnerGrid2 = ""; +string oversetGridFileName = "./grid/iblank.ovs"; +double walldistMainZone = 1.0 +double toleranceForOversetSearch = 1.0e-3; +double toleranceForOversetBox = 1.0e-3; +int twoOrderInterpolationOrNot = 0; +int keyEnlargeOfActiveNodes = 0; +int outTecplotOverset = 0; + +int numberOfMovingBodies = 2; + +// ----------------- ALE configuration ------------------------------ +int codeOfAleModel = 1; +int aleStartStrategy = -1; + +int strategyForFaceNormalVelocity = 0; //0-By Sweeping volume; 1-By face center 1st; 2-By face center 2nd; +int strategyForGCLSource = 0; //0-present; 1-Ahn; + +//0:1st-Admas-Bashforth; 1:2nd-Admas-Bashforth; 2:1st-Implicit-Euler; 3:2nd-Implicit Euler; 4:2nd-Adams-Moulton; 5:3rd-Adams-Moulton +int methodForKineticEquation = 0; +double relaxParameterOfKinetic = 1.0; + +######################################################################### +# motive information # +######################################################################### +int numberOfMovingBodies = 1; + +############################## body0 ############################## +//mass of parts +double mass_0 = 1.0; +//mass matrix of parts Ixx Iyy Izz Ixy Ixz Iyz +double massMatrix_0[] = 1e-7, 1e-6, 1e-6, 0.0, 0.0, 0.0; +//initial six DOF position information of parts. xc yc zc +double massCenter_0[] = 0.0 , 0.0, 0.0; +//initial six DOF position information of parts. angleX angleY angleZ +double attitudeAngle_0[] = 0.0 , 0.0, 0.0; +//initial six DOF move information of parts. vc vy vz +double massCenterVelocity_0[] = 0.0, 0.0, 0.0; +//initial six DOF move information of parts. omigX omigY omigZ +double angularVelocity_0[] = 0.0, 0.0, 0.0; +//the object that the parts belong to. +int fartherIndex_0 = -1; +//the assembly position of the parts. xc yc zc angleX angleY angleZ +double configPamameter_0[] = 0.0 ,0.0 ,0.0 ,0.0 ,0.0 ,0.0; +//the move pattern of the parts. +// -1 given motion partten. +// 0 still. +// 1 six DOF motion. +// 2 three DOF motion. +// 11 X-axis forced motion. +// 12 Y-axis forced motion. +// 13 Z-axis forced motion. +// 14 forced pitch motion. +// 15 forced yaw motion. +// 16 forced roll motion. +int RBDMethod_0 = 0; +double amplitude_0 = 0.0; +double reduceFrequency_0 = 0.0; +//string uDFSixDofFileName_0 = "./Bin/UDFSixDof.Parameter"; +//additional force (system axis) fX fY fZ +double addedForce_0[] = 0.0 ,0.0 ,0.0 ; +//additional moment of Force (system axis) mX mY mZ +double addedMoment_0[] = 0.0 ,0.0 ,0.0 ; +//the deformation method of the parts. +int morphing_0 = 0; + +// post indentify +int integralOrder = 4; + + +// ---------------- ATP read -------------------------------------------- +//@int inflowParaType = 0; +//@double refReNumber = 6.5e6; +//@double refDimensionalTemperature = 288.15; +//@double freestream_vibration_temperature = 300.00; +//@double refDimensionalPressure = 0; +//@double height = 0; +//@int nsubsonicInlet = 0; +//@int nsubsonicOutlet = 0; +//@string inLetFileName = "./bin/subsonicInlet.hypara"; +//@string outLetFileName = "./bin/subsonicOutlet.hypara"; +//@double refDimensionalVelocity = 0; +//@double refDimensionalDensity = 0; + +######################################################################### +# Old Parameter # +######################################################################### +int isPlotVolumeField = 0; + diff --git a/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/cfd_para_hypersonic.hypara b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/cfd_para_hypersonic.hypara new file mode 100644 index 0000000..e9960b5 --- /dev/null +++ b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/cfd_para_hypersonic.hypara @@ -0,0 +1,206 @@ +######################################################################### +# General Control Parameter # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual 'res.dat' saved. + +int maxSimuStep = 50000; + +int intervalStepFlow = 2000; +int intervalStepPlot = 2000; +int intervalStepForce = 100; +int intervalStepRes = 10; + +######################################################################### +# Inflow Parameter # +######################################################################### +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// 4 -- the condition that the velocity, temperature and density are given. +// 5 -- the condition that the velocity, temperature and pressure are given. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. + +double refMachNumber = 10.6; +double attackd = 20.00; +double angleSlide = 0.00; + +double wallTemperature = 294.44; + +int inflowParaType = 0; +double refReNumber = 3.937e6; +double refDimensionalTemperature = 47.3; +double freestream_vibration_temperature = 10000.0; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +//The velocity, temperature and density are fixed. +//int inflowParaType = 4; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalDensity = 1.0e3; + +//The velocity, temperature and pressure are fixed. +//int inflowParaType = 5; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalPressure = 1.0e5; + +double gridScaleFactor = 1.0; + +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 0.02794; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. + +######################################################################### +# Physical models # +######################################################################### +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "1eq-sa", when viscousType = 3. +// -- "2eq-kw-menter-sst", when viscousType = 4. +// DESType: Type of DES. +// 0 -- RANS.(default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. + +//int viscousType = 0; +//string viscousName = "Euler"; + +int viscousType = 1; +string viscousName = "laminar"; + +//int viscousType = 3; +//string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; +######################################################################### +# Spatial Discretisation # +######################################################################### +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "ausmpw", "ausmpw+". +// str_limiter_name: Limiter of struct grid. +// -- "minmod", "3rd_minmod_smooth". + +string inviscidSchemeName = "steger"; +string str_limiter_name = "minmod"; + +#******************************************************************* +# UnStruct Solver * +#******************************************************************* +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpwplus". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "vencat", "barth". +// -- "1st", meaning accuracy of first-order. +// -- "nolim", no limiter. +// venkatCoeff: Coefficient of vencat limiter, when uns_limiter_name = 'vencat'. +// The smaller the value, the more robust it is. + +string uns_scheme_name = "vanleer"; +string uns_limiter_name = "vencat"; +double venkatCoeff = 0.5; + +######################################################################### +# Temporal Discretisation # +######################################################################### +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// CFLEnd: The CFL number, [0.1, 100]. +// The bigger the value, the convergence faster but lower robustness. +// ktmax: The lower the value, the more robustness, 1.0e5 - 1.0e10. + +int iunsteady = 0; + +double CFLEnd = 1.0; +int CFLVaryStep = 1000; +double ktmax = 1.0e10; + +######################################################################### +# File In or Out # +######################################################################### +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// Please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the whole field results to tecplot or not, 0 / 1. + +string gridfile = "./grid/3D_bluntcone_str__64.fts"; +int plotFieldType = 0; + +// ----------------- Advanced Parameters, DO NOT care it ---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables: Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40). +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. + +int reconmeth = 0; +int limitVariables = 0; +int limitVector = 1; diff --git a/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/grid_para.hypara b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/grid_para.hypara new file mode 100644 index 0000000..c40a936 --- /dev/null +++ b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/grid_para.hypara @@ -0,0 +1,30 @@ +######################################################################### +# Grid data type # +######################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +// from_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +int gridtype = 1; +int axisup = 1; +int from_gtype = 3; + +######################################################################### +# File path # +######################################################################### +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +string from_gfile = "./grid/3D_bluntcone_str.grd"; +string out_gfile = "./grid/3D_bluntcone_str.fts"; diff --git a/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/key.hypara b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/key.hypara new file mode 100644 index 0000000..04a16e4 --- /dev/null +++ b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/key.hypara @@ -0,0 +1,59 @@ +string title = "PHengLEI Main Parameter Control File"; + +// IMPORTANT NOTICE: DON NOT MODIFY THE FOWLLOWING LINE. +string defaultParaFile = "./bin/cfd_para.hypara"; + +// ndim: Dimensional of the grid, 2 or 3. +// nparafile: the number of parameter files. +// nsimutask: simulation task type. +// 0 -- CFD Solver of NS or Turbulation. +// 1 -- Grid generation: for special typical cases, such as cylinder, flat plate, etc. +// Grid conversion: from other format to PHengLEI format (.fts). +// Grid reconstruction: such as grid adaptation. +// Grid merging: merge two blocks into one block. +// Grid repairing: repair the original grid in order to remove the negative volume cells. +// 2 -- Wall distance computation for turb-solver. +// 3 -- Grid partition. +// 4 -- Knowledge repository / examples of PHengLEI-API. +int ndim = 3; +int nparafile = 1; + +//int nsimutask = 0; +//string parafilename = "./bin/cfd_para_subsonic.hypara"; +//string parafilename = "./bin/cfd_para_transonic.hypara"; +//string parafilename = "./bin/cfd_para_supersonic.hypara"; +//string parafilename = "./bin/cfd_para_hypersonic.hypara"; +//string parafilename = "./bin/incompressible.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_para.hypara"; + +//int nsimutask = 2; +//string parafilename = "./bin/cfd_para.hypara"; + +int nsimutask = 3; +string parafilename = "./bin/partition.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_deform_para.hypara"; + +//int nsimutask = 4; +//string parafilename = "./bin/repository.hypara"; + +//int nsimutask = 5; +//string parafilename = "./bin/overset_grid_view.hypara"; + +//int nsimutask = 13; +//string parafilename = "./bin/lbm_para.hypara"; + +//int nsimutask = 14; +//string parafilename = "./bin/integrative_solver.hypara"; + +//int nsimutask = 99; +//string parafilename = "./bin/post_processing.hypara"; + +// ---------------- Advanced Parameters, DO NOT care it ---------------- +int numberOfGridProcessor = 0; +// ATP read +//@string parafilename1 = "" +//@string parafilename2 = ""; diff --git a/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/partition.hypara b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/partition.hypara new file mode 100644 index 0000000..95acdb9 --- /dev/null +++ b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/bin/partition.hypara @@ -0,0 +1,21 @@ +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// maxproc: The number of partition zones that want to be divided into, +// which is equal to the number of CPU processors you want. +// Usually, 50~100 thousands structured cells per CPU-Core is suggested. +// 30~70 thousands unstructured cells per CPU-Core is suggested. +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). + +int pgridtype = 1; +int maxproc = 64; + +string original_grid_file = "./grid/3D_bluntcone_str.fts"; +string partition_grid_file = "./grid/3D_bluntcone_str__64.fts"; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level,..., et al. +int numberOfMultigrid = 1; diff --git a/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/grid/3D_bluntcone_str.grd b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/grid/3D_bluntcone_str.grd new file mode 100644 index 0000000..1bd720d Binary files /dev/null and b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/grid/3D_bluntcone_str.grd differ diff --git a/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/grid/3D_bluntcone_str.inp b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/grid/3D_bluntcone_str.inp new file mode 100644 index 0000000..b81eaae --- /dev/null +++ b/A19-ThreeD_BluntCone_Ma10d6_Laminar_Struct_64CPU/grid/3D_bluntcone_str.inp @@ -0,0 +1,11 @@ + 1 + 1 + 181 201 121 +A + 6 + 1 181 1 201 1 1 3 + 1 181 1 201 121 121 3 + 1 1 1 201 1 121 6 + 181 181 1 201 1 121 73 + 1 181 1 1 1 121 5 + 1 181 201 201 1 121 2 diff --git a/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/cfd_para.hypara b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/cfd_para.hypara new file mode 100644 index 0000000..b17970c --- /dev/null +++ b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/cfd_para.hypara @@ -0,0 +1,1220 @@ +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +// PPPPP H H EEEEE N N GGGGG L EEEEE III + +// P P H H E NN N G L E I + +// PPPPP HHHHH EEEEE N N N G GG L EEEEE I + +// P H H E N N N G G L E I + +// P H H EEEEE N N GGGGG LLLLL EEEEE III + +//------------------------------------------------------------------------+ +// Platform for Hybrid Engineering Simulation of Flows + +// China Aerodynamics Research and Development Center + +// (C) Copyright, Since 2010 + +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +########################################################################### +# Default parameters for Grid conversion # +########################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// 2 -- Hybrid grid, include both of unstructured and structured grid. +// gridobj: Task type of grid treatment. +// 0 -- Grid generation of typical case, such as cylinder, flat plate, etc. +// 1 -- Grid conversion, from other grid data to PHenglEI, such as Fluent, CGNS. +// 2 -- Grid refinement. +// 3 -- Grid merging, merge two blocks into one block. +// 4 -- Grid deformation, achieve unstructured grid deformation. +// 5 -- Grid repairing, repair the original grid in order to remove the negative volume cells. +// 6 -- Grid mirroring, mirror a symmetry grid to whole grid. +// multiblock: Multi-block grid or not, only for structured grid conversion. +// 0 -- Not. +// 1 -- Yes. +// iadapt: Adaptation number for unstructure grid. +// SymmetryFaceVector: The vector of symmetry face. +// 0 -- X axis. +// 1 -- Y axis. +// 2 -- Z axis. +int gridtype = 0; +int gridobj = 1; +int multiblock = 0; +int iadapt = 0; +int SymmetryFaceVector = 1; + +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +int axisup = 1; + +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +int omit_no_bound_bc = 0; + +//----------------------------------------------------------------------- +# Grid data type # +//----------------------------------------------------------------------- +// from_gtype/to_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +// dumpOldGrid: If dump out the old grid file. +// 0 -- Not. (default) +// 1 -- Yes. +int from_gtype = 2; +int to_gtype = 1; +int dumpOldGrid = 0; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +int numberOfGridFile = 1; +string from_gfile = "./grid/rae2822_hybrid2d.cas"; +string from_gfile1= ""; + +string out_gfile = "./grid/flat_laminr_133_85_2d.fts"; + +// ----------------- some advanced choices ------------------------------ +// iunsteady: The Grid is for unsteady simulation or not. +int iunsteady = 0; +int codeOfAleModel = 0; + +// fileformat: Ustar Grid file format. +// 0 -- BINARY. +// 1 -- ASCII. +int fileformat = 0; + +// Parameters for hybrid solver. +// mixgrid_uns: path of unstructure grid file for hybrid solver, *.fts type. +// mixgrid_str: path of structure grid file for hybrid solver, *.fts type. +string mixgrid_uns = "./grid/rae2822_uns2d_4.fts"; +string mixgrid_str = "./grid/flat_laminr_133_85_2d.fts"; + +// Some parameters for structured overlapping grid. +int codeOfDigHoles = 1; +string holeBasicFileName = "./oversetGridView/holeBasicFile.inp"; +string holeFullFileName = "./oversetGridView/holeFullFile.dat"; +string linkFileName = "./oversetGridView/topology.dat"; +string zoneInverseFileName = "./oversetGridView/zoneInverseMapping.inp"; + +// ----------------- Adaptive Mesh Refine ------------------------------- +// In this file, the original_grid_file is used of the partition part. +// If use it dependently, abstract it here. +string adapt_grid_file = "./grid/sphere_mixed_adapt1.fts"; +string geometryFileName = "./grid/jsm.igs"; + +// geometryUnit: Geometry unit. +// 1 -- meter. +// 2 -- millimeter. +// 3 -- inch. +// exclusiveCase: Parallel projection exclusive case. +// 0 -- NON case. +// 1 -- JSM-C2-NPOFF case. +// 2 -- CHNT. +// projectOrgPoint: If the original wall points need to be projected or not. +int geometryUnit = 1; +int anisoRefine = 0; +int isProject = 0; +int readDist = 0; +int isDeform = 0; +int exclusiveCase = 0; // 0: NON case; 1: JSM-C2-NPOFF case; 2: CHNT. +int projectOrgPoint = 0; // if project original wall points. + + +// ----------------- Grid Deform Parameters ----------------------------- +// deformationMethod: Grid Deform. +// 1 -- SPRING. +// 2 -- RBF. +// stationalGridFile: Original grid file. +// visualFileName : The visualization file path of deform grid. +// nDeformStep : The max deform step. +// flapAngle : The max flap angle. +// rotatePostionZ : Rotate postion. +// rotatePostionY : Rotate postion. +// gridSlice : If dump slice grid. +// sliceAxis : Grid slice axis. +// slicePosition : Grid slice position. +int nDeformStep = 40; +double flapAngle = 10.0; +double rotatePostionZ = 4.00003; +double rotatePostionY = 3.05; + +int deformationMethod = 2; +string stationalGridFile = "./grid/Segment2Brid.fts"; +string visualFileName = "./results/deformedGrid.dat" + +int gridSlice = 1; +int sliceAxis = 1; +double slicePosition = 13; + +// ----------------- RBF Parameters ------------------------------------- +// numberOfReferenceCP : Number of reference Control Points. +// influencePara : The RBF influence radius parameter. +int numberOfReferenceCP = 40; +double influencePara = 25.0; + +// ----------------- Periodic Parameters -------------------------------- +// Notice: Rotational periodicity only support rotation along the X axis! +// periodicType: Which periodic boundary is used. +// 0 -- without Periodic Boundary. +// 1 -- Translational periodicity. +// 2 -- Rotational periodicity. +// translationLength[]: The relative distance between two periodic face + which only support one direction. +// rotationAngle: The relative angle between two periodic face. + which is recorded in degrees. + +int periodicType = 0; +double translationLength[] = [0.0,0.0,0.0]; +double rotationAngle = 0.0; + +######################################################################### +# Default parameters for Partition # +######################################################################### +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// 2 -- refine structured grid. +// maxproc: The number of partition zones that want to be divided into. +int pgridtype = 0; +int maxproc = 4; + +// traceMark: Trace mark or not, only for structured grid partition. +// 0 -- Not. +// 1 -- Yes. +// blockIndexOfMark: the block index of mark, only for structured grid partition. +// cellIndexOfMark: the cell index of mark, only for structured grid partition. +int traceMark = 0; +int blockIndexOfMark = 0; +int cellIndexOfMark[] = [185,30,1]; + +// parallel Strategy: +//! -# 0 : each zone is assigned to the one that defined in grid partition procedure. +//! -# 1 : random assigned for each zone or by some else ways. +int parallelStrategy = 1; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). +string original_grid_file = "./grid/sphere_mixed.fts"; +string partition_grid_file = "./grid/sphere_mixed__4.fts"; + +// ------------------ Sompe advanced parameters ------------------------- +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +// npartmethod: Method of interface reconstruction, default is 1. +// parallelPartitionMethod: Method of parallel partition, this is set only when execute parallel partition. It would be skipped when serial partition. +// 1 -- Using ParMetis for homogeneous MPI. +// 2 -- Using Metis for homogeneous MPI. +// 3 -- using METIS partition for homogeneous OpenMP. +// parmetisBalance: Used to specify the imbalance tolerance. +// 1 -- perfect balance. +// maxproc -- perfect imbalance. +// 1.05 -- recommended. + +int omit_no_bound_bc = 0; +int npartmethod = 1; +int parallelPartitionMethod = 2; +double parmetisBalance = 1.05; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level, ..., et al. +int numberOfMultigrid = 1; + +######################################################################### +# Default parameters for CFD simulation # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepSample: The step intervals for monitored probes variables file 'sample.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual file 'res.dat' saved. +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) + +int maxSimuStep = 20000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepSample = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; +int ifLowSpeedPrecon = 0; + +// compressible: +// 0 -- incompressible flow. +// 1 -- compressible flow. (default) +int compressible = 1; + +//----------------------------------------------------------------------- +# CFD Control Parameter # +//----------------------------------------------------------------------- +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// 4 -- the condition that the velocity, temperature and density are given. +// 5 -- the condition that the velocity, temperature and pressure are given. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. +// radiationCoef: The radiation coefficient on wall, it is used to compute the radiation heat flux on wall when the boundary +// condition is radiation equilibrium temperature, and 0.8 is the default value. +// refMolecularWeight : the reference molecular weight of gas used for perfect gas. The unit is g/mol. +// Generally, the gas is air. Sometimes, it is experiment gas, such as Nitrogen, Argon, and so on. + +double refMachNumber = 0.73; +double attackd = 2.79; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 6.5e6; +double refDimensionalTemperature = 288.15; +double freestream_vibration_temperature = 300.00; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +//int inflowParaType = 3; +//int nsubsonicInlet = 1; +//int nsubsonicOutlet = 1; +//string inLetFileName = "./bin/subsonicInlet.hypara"; +//string outLetFileName = "./bin/subsonicOutlet.hypara"; +//double refDimensionalTemperature = 288.144; +//double refDimensionalPressure = 1.01313E05; + +//The velocity, temperature and density are fixed. +//int inflowParaType = 4; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalDensity = 1.0e3; + +//The velocity, temperature and pressure are fixed. +//int inflowParaType = 5; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalPressure = 1.0e5; + +//The MachNumber, temperature and pressure are fixed. +//int inflowParaType = 6; +//double refDimensionalTemperature = 293; +//double refDimensionalPressure = 8886.06; + +double wallTemperature = -1.0; + +double radiationCoef = 0.8; +double gridScaleFactor = 1.0; + +int numberOfAerodynamicForceComponents = 1; +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. +double refMolecularWeight = 28.9644; // unit of g/mol. + +//----------------------------------------------------------------------- +# Spatial Discretisation # +//----------------------------------------------------------------------- +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "hlle", "lax_f". +// -- "roe", "modified_roe". +// -- "ausm+", "ausm+w", "ausm+up", "ausmdv", "ausmpw", "ausmpw+". +// str_limiter_name: Limiter of struct grid. +// -- "vanalbada", "vanleer", "minmod", "smooth", "minvan", "3rdsmooth", "3rd_minmod_smooth". +// -- "nolim", no limiter. +// -- "vanalbada_clz", clz supersonic version. +string inviscidSchemeName = "roe"; +string str_limiter_name = "vanalbada"; + +#******************************************************************* +# UnStruct Solver or Common * +#******************************************************************* +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 2 -- Algebraic. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "0eq-bl". +// -- "1eq-sa". +// -- "2eq-kw-menter-sst". +// -- "2eq-kw-menter-bsl". +// -- "2eq-kw-wilcox-1988". +// -- "2eq-kw-wilcox-1998". +// -- "2eq-kw-kok-tnt". +// -- "2eq-kw-wilcox-2006". +// -- "easm-kw-2003". +// -- "easm-kw-2005". +// DESType: Type of DES. +// 0 -- RANS. (default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpw+". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "barth", "vencat", "vanleer", "minmod". +// -- "vanalbada", "smooth", "nnd", "lpz", "1st". +// -- "nolim", no limiter. +// uns_vis_name: Discretisation method of viscous term. +// -- "std", "test", "aver", "new1", "new2". +// gradientName: Gradient reconstruction method. +// -- "default", "ggcell", "ggnode", "lsq". +// ivencat: Variation of vencat limiter. +// 0 -- org method, it is independent of grid scale. +// 1 -- new method, it is dependent of grid scale. +// 4 -- Ustar limiter model, without grid size unitary. +// 7 -- default used. +// venkatCoeff: Cofficient of vencat, when using vencat limter. +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. +// skewnessAngle: The skewness angle of grid cells. +// roeEntropyFixMethod: Entropy fix (correction) method. +// 1 -- direct fix, which limits the minimum eigenvalue directly. +// 2 -- multi-dimensional fix, which is derived from structured solver and now is only valid for struct solver. +// 3 -- Harten type, which is default used. +// roeEntropyScale: Entropy fix (correction) coefficient scale, default is 1.0. +// It is used to scale the default Roe entropy fix coefficients. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +string uns_scheme_name = "roe"; +string uns_limiter_name = "vencat"; +string uns_vis_name = "test"; +string gradientName = "ggnode"; + +int ivencat = 7; +double venkatCoeff = 5.0; +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; +double skewnessAngle = 60.0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; + +//----------------------------------------------------------------------- +# Temporal Discretisation # +//----------------------------------------------------------------------- +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// physicalTimeStep: The nondimensional physical time step. +// ifStartFromSteadyResults: The unsteady simulation is start from steady flowfield or not, 0 is for no and else is for yes. +// ifStaticsFlowField: Statistical variables for unsteady simulation. +// ifStaticsReynoldsStress: Statistical Reynolds stress for unsteady simulation. +// startStatisticStep: Outer step when start statistics. +// when the value is larger than "maxSimuStep", it is useless. +// statisticalTimePeriod: Used as time period of statistic analysis. +// when the value is negative, time period is treated as infinite. +// statisticMethod: Statistic reynolds stress method. + 0 --tau = - ^2 + 1 --tau = +// min_sub_iter: The min sub iteration of unsteady simulation. +// max_sub_iter: The max sub iteration of unsteady simulation. +// tol_sub_iter: The tolerance of sub iteration of unsteady simulation. +// tscheme: Temporal Discretisation method. +// 1 -- Runge-Kutta Multi-State. +// 2 -- Point implicit. +// 3 -- Full implicit. +// 4 -- LU-SGS. +// 5 -- Block LU-SGS. +// 6 -- Jacobian iteration. +// 7 -- Lower G-S iteration. +// 8 -- Upper G-S iteration. +// 9 -- Lower/Upper G-S iteration. +// iSimplifyViscousTerm: Simplify the computation of viscous term in the Block LU-SGS method. The default value assigns 1 that could speed up the computation. +// Otherwise, the viscous Jacobian matrix Mv should be computed that will increase the memory and time in iteration of the BLUSGS method. +// CFLStart: Started cfl number. +// CFLEnd: End cfl number. +// CFLVaryStep: The number of step when cfl increase from CFLStart to CFLEnd. +// ktmax: Dtratio. dt[i] = MIN(dt[i], ktmax * dtmin / vol[i]) +// swapDq: Communication dq between forward/backward sweep of LUSGS or not, default is 0. +// nLUSGSSweeps: Sub iteration of LU-SGS or Block LU-SGS. +// LUSGSTolerance: Sub iter tolerance of LU-SGS or Block LU-SGS. +// ifLocalTimeStep: Time step method. +// 0 --Local. +// 1 --Global. +// visl_min: Minimum value of laminar viscosity coefficient. +// turbCFLScale: Turbulence model cfl number factor. +// codeOfAleModel: Arbitrary Lagrangian-Eulerian method. +// 0 -- no ALE method. +// 1 -- ALE method for non-moving grids. +// 2 -- ALE method for moving grids. +// 3 -- ALE method for deforming grids. +// wallFunctionType: The type of wall function to implement. +// 0 -- no wall function. (default) +// 1 -- standard wall function. +// 2 -- Pab3D wall function. +// RKStage: The number of Runge-Kutta step. +// lamda: Cofficient of Runge-Kutta step. + +int iunsteady = 0; +double physicalTimeStep = 0.01; +int ifStartFromSteadyResults = 0; +int ifStaticsFlowField = 0; +int ifStaticsReynoldsStress = 0; +int startStatisticStep = 800000; +double statisticalTimePeriod = -1.0; +int statisticMethod = 0; +int linearTwoStepMethods = 1; // 1--BDF1; 2--C-N; 3--BDF2; + +int methodOfDualTime = 3; +int min_sub_iter = 50; +int max_sub_iter = 50; +double tol_sub_iter = 0.01; + +int tscheme = 4; +int iSimplifyViscousTerm = 1; +int ifLocalTimeStep = 0; +double CFLStart = 0.01; +double CFLEnd = 10.0; +int CFLVaryStep = 500; + +double ktmax = 1.0e10; + +int swapDq = 1; + +int nLUSGSSweeps = 1; +double LUSGSTolerance = 0.01; +int order = 2; + +double visl_min = 0.01; +double turbCFLScale = 1.0; +double csrv = 2.0; +double timemax = 1.0e10; +double dtsave = -1.0; +int maxale = 10; +double dtau = 0.001; + +int wallFunctionType = 0; + +int RKStage = 2; +double lamda[] = 0.5, 1.0; + +//int RKStage = 1; +//double lamda[] = 1.0; + +//int RKStage = 4; +//double lamda[] = [0.25, 0.33333333333, 0.5, 1.0]; + +//----------------------------------------------------------------------- +# File In or Out # +//----------------------------------------------------------------------- +// numberOfGridGroups: The number of grid groups. +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the field results to visulization. +// walldistMethod: The method to compute wall distance. +// 0 -- accurate but not fast enough. +// 1 -- fast but not accurate enough. +// 2 -- super fast but more non-accurate! +// resSaveFile: The file path to save the residual convergence process, write data for every default (intervalStepRes) steps. +// turbresfile: The file path to save the residual convergence process of turbulence, write data for every default (intervalStepRes) steps. +// aircoeffile: The file path to save the aerodynamic force coefficients convergence process, write data for every default (intervalStepForce) steps. +// restartNSFile: The file path to write restart flowfield variables, write data for every default (intervalStepFlow) steps. +// turbfile: The file path to write restart flowfield variables of turbulence , write data for every default(intervalStepFlow) steps. +// visualfile: The visualization file path of flowfield , write data for every default (intervalStepPlot) steps. +// wall_aircoefile: The file path to save flowfield variables of wall, write data for every default steps. +// nDumpSurfaceInfo = 0 the "wall_varfile" write the informations including heat flux. +// nDumpSurfaceInfo = 1 the "wall_varfile" write the informations without heat flux. + +int numberOfGridGroups = 1; +string gridfile = "./grid/rae2822_hybrid2d__4.fts"; +string wallTemperaturefile= ""; + +int walldistMethod = 1; + +string resSaveFile = "results/res.dat"; +string turbresfile = "results/turbres.dat"; +string aircoeffile = "results/aircoef.dat"; + +string restartNSFile = "results/flow.dat"; +string turbfile = "results/turb.dat"; + +string visualfile = "results/tecflow.plt"; +string wall_aircoefile = "results/wall_aircoef.dat"; +string samplefile = "results/sample.dat"; + +int nDumpSurfaceInfo = 0; +string wall_varfile = ""; + +string jetDefineFile = "bin/jet.hypara"; + +string sixDofFileName = "results/sixDofInfo.dat"; +string derivativeFileName = "results/identify.dat"; +string hysteresisFileName = "results/force_beta.plt"; + +int plotFieldType = 0; + +// visualfileType: The file type of visualfile. +// 0 -- Tecplot binary. +// 1 -- Tecplot ASCII. + +int visualfileType = 1; + +// samplefileMode: The dump mode of sample file. +// 0 -- dump out every probe/line/surface data for all step intervals. +// 1 -- dump out all probe/line/surface data for every step intervals. +int samplefileMode = 0; + +// visualSlice: The slice of tecflow. +// 0 -- Do not save slice data. +// 1 -- comput and save it to sliceFile. +// sliceAxis: Normal vector of slice. +// 1 -- X_DIR. +// 2 -- Y_DIR. +// 3 -- Z_DIR. +// slicePostion: Coordinate of slice. + +int visualSlice = 0; +int sliceAxis = 1; +double slicePostion = -0.5; +string sliceFile = "results/Slice.plt"; +int dumpWallFaceCenter = 0; + +// min-max box of the visual block. +double lowerPlotFieldBox[] = [0.0 0.0 0.0]; +double upperPlotFieldBox[] = [1.0 1.0 1.0]; + +//-----------the optional parameters list for the flow field output---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40), +// -- gradientUx(41), gradientUy(42), gradientVx(43), gradientVy(44), iblank(81). +// -- specific heat ratio(gama, 56) +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. +//-----------the optional parameters list for the wall boundary condition---------------- +// nVisualWallVariables: The number of visual variables on wall. +// visualWallVariables : dumped variable types, listed as following: +// -coefficient of pressure(cp, 0), -coefficient of friction(cf, 1), yplus(2), -non-dimensional heat flux(Q_NonDim, 3), -dimensional heat flux(Q_Dim, 4), +// -pressure on wall(pw, 5), -temperature on wall(Tw, 6), -density on wall(rhow, 7), -heat flux of translational-rotational temperature term(Qtr, 8), +// -heat flux of species diffusion term(Qs, 9), -heat flux of vibrational temperature term(Qv, 10), -heat flux of electron temperature term(Qe, 11), +// -species mass fractions(Ns, 12), -x component of wall velocity(Vx, 13), -y component of wall velocity(Vy, 14), -z component of wall velocity(Vz, 15) +// -slip translational-rotational temperature(Tts, 16), -slip vibrational temperature(Tvs, 17), -slip electron temperature(Tes, 18), -absolute wall velocity(Vs, 19) +// -Stanton number(St, 20), -coefficient of heat rate(Ch, 21), -temperature jump(deltaT, 22), -transition gamaeff(gamaeff, 48), +// -transition intermittency(intermittency, 51), -transition momentum thickness reynolds(MomentumThicknessReynolds, 52), +// -overlap iblank(iblank, 81) + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +int nVisualWallVariables = 9; +int visualWallVariables[] = [0, 1, 2, 3, 4, 5, 9, 10, 11]; + +// dumpStandardModel: Dump many standard model data. +// 1 -- Turbulent flat plate. +int dumpStandardModel = 0; + +// ifSetDataMonitor: Whether to set the data monitor. +// 0 -- No. +// 1 -- Yes. +// dataMonitorType: The type of data Monitor. +// 0 -- Probes data monitor. +// 1 -- Lines data monitor. +// 2 -- Surfaces data monitor. +// probesDefineFile: Probes location information file. +// nLines: The number of lines need to be monitored. +// linesDefineFile: Lines location information file. +// nSurfaces: The number of surfaces need to be monitored. +// surfacesDefineFile: Surfaces location information file. +// searchCellsMethod: method to search the cell of each probe. +// 0 -- Nearest cell to the probe. +// 1 -- Real cell where the probe is located. +// nProbeVariables: Number of variables want to be dumped for probes monitered. +// probeVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5). +// Important Warning: Array size of probeVariables MUST be equal to nProbeVariables!!! +// probeVariables order must from small to big. +// probeVariablesInterpolationMethod: Interpolation method used to compute the probe variables. +// 0 -- Take the value of probe's cell as probe real value. +// 1 -- Interpolation from probe's and neighbouring cell to probe. +// 2 -- Interpolation from probe's cell nodes to probe. +int ifSetDataMonitor = 0; + +int dataMonitorType = 0; +string probesDefineFile = "bin/probes_XYZ.dat"; + +//int dataMonitorType = 1; +//int nLines = 1; +//string linesDefineFile = "bin/lines_XYZ.dat"; + +//int dataMonitorType = 2; +//int nSurfaces = 4; +//string surfacesDefineFile = "bin/surfaces_XYZ.dat"; + +int searchCellsMethod = 0; + +int nProbeVariables = 6; +int probeVariables[] = [0, 1, 2, 3, 4, 5]; +int probeVariablesInterpolationMethod = 0; +//----------------------------------------------------------------------- +# Turbulence Parameter # +//----------------------------------------------------------------------- +// turbInterval: Iteration number of turbulence. +// kindOfTurbSource: Kinds of turbulent source. +// 0 -- Original. +// 1 -- Edwards. +// 2 -- new. +// mod_turb_res: If modify the residuals for the cells next to the wall or not, default is 0. + +int turbInterval = 1; +int turbOrderStruct = 2; +int kindOfTurbSource = 0; +int mod_turb_res = 0; +double turb_relax = 1.0; +double freeStreamViscosity = 1.0e-3; +double muoo = 3.0; +double kwoo = 5.0; +int transitionType = 0; +double turbIntensity = -1.0; +int freeturbIntensitySRModify = 0; +double freeDecayXLocation = 0.0; +int compressibleCorrection = 0; +int transitionMaFix = 1; + +# maximum eddy viscosity (myt/my) max. +double eddyViscosityLimit = 1.0e10; +int monitor_vistmax = 0; + +//----------------------------------------------------------------------- +# LES Parameter # +//----------------------------------------------------------------------- +// iLES: Create LESSolver or not. +// == 1 - Create LESSolver; +// != 1 - not. +// amplitudeofDisturb: Amplitude of adding disturb. +// disturbstep: Unsteady time step or steady iteration of adding random disturb. +// iterdisturb: Add random disturb in every sub-iter or only first sub-iter. +// = 0 - in only first sub-iter; +// != 0 - in every sub-iter. +// ipraddisturb: Add density and pressure disturb or not. +// ibodyforce: Add body force in source flux of NS equations or not. +// = 0 - not; +// != 0 - Add body force. +// bodyforce: Body force in source flux of NS equations or not. +// utau: friction velocity, using in DNSDisturb. +// sgsmodel: subgrid scale model. +// = "smagorinsky"; +// = "dsmCom"; +// = "wale"; +// = "sigma". +// deltaFunctionType: = 1 - MAX(deltai, deltaj, deltak); +// = 2 - pow(deltai * deltaj *deltak, 1/3); +// = 3 - Devloped by Scotti. +// wallDampingFunctionType: = 0 - no wall function; +// = 1 - van Driest; +// = 2 - developed by Dr. Deng Xiaobing; +// = 3 - developed by Piomelli. +// turbViscousCutType: turbulent viscosity cut type. +// = 0 - mu_total = mut + mul; +// = 1 - mu_total = max(mut-mul,0)+ mul; +// = 2 - mu_total = max(mut ,0)+ mul. +// smagConstant: constant of smagorinsky model. +// waleConstant: constant of wale model. +// filterDirection[3]: filter variables in i, j, k direction or not. +// averageDirection[3]: average variables in i, j, k direction or not. +// isotropicConstant: constant of isotropic part of SGS stress. + +int iLES = 0; +string sgsmodel = "smagorinsky"; +int deltaFunctionType = 2; +int wallDampingFunctionType = 1; +int turbViscousCutType = 2; +double smagConstant = 0.1; +double isotropicConstant = 0.0; +double waleConstant = 0.6; +double sigmaConstant = 1.35; +int filterDirection[] = [1, 1, 0]; +int averageDirection[] = [0, 0, 0]; +double testFilterScale = 2.0; +int averageWidth = 1; +int monitorNegativeConstant = 0; + +//----------------------------------------------------------------------- +# Other Parameters for Hypersonic Non-equilibrium Gas # +//----------------------------------------------------------------------- +// dg_high_order: +// 0 -- generic order accuracy. +// 1 -- high order accuracy. +// iapplication: +// 0 -- gas model is fixed in the codes. +// 1 -- gas model is imported from library files. +// iCodeBranch: +// 0 -- The old code version is used for Navier-Stokes. +// 1 -- A new code version is active for Navier-Stokes solver. +// nm: Equation number of the physics, but is out of commision now. +// 4 -- for 2D. +// 5 -- for 3D. +// nGasModel: The type of gas. less than and equal to 1 represents the mixture gas. +// Otherwise, the pure gas with one component is used for perfect gas. +// 0 -- Earth gas. +// 1 -- Mars gas. +// 2 -- Argon. +// 3 -- Nitrogen. +// nEnergyRecycle: The type of EnergyModel Recycle. +// 0 -- not used . +// 1 -- used. +// nDensityModify: The type of densitymodify. + +// 0 -- not used. +// 1 -- used. +// nchem: +// 0 -- without chemical reaction flow. +// 1 -- the chemical reaction flow is considered. +// nEquilibriumGas: the variable is valid when the condition of nchem=0 is satisfied. +// 0 -- perfect gas. +// 5, 7, 11 -- equilibrium gas, meanwhile, its value denotes the number of gas component. +// nPCWCycleStep: the maximum step number of iteration in the module of computing species mass fractions with the partial catalytic wall(PCW) condition. +// the value equals to or is greater than 1, and 3 is for default value. +// nRETCycleStep: the maximum step number of iteration in the module of computing radiation equilibrium temperature on wall. +// the value equals to or is greater than 1, and 3 is for default value. +// nSLIPCycleStep:the maximum step number of iteration in the module of computing slip temperature, slip velocity and slip species mass fraction. +// the value equals to or is greater than 1, and 3 is for default value. +// nSlipBCModel : The computational model of slip boundary conditions. + +// 0 -- no slip. +// 1 -- the conventional Maxwell slip conditions. +// 2 -- the Gokcen slip conditions. +// 3 -- the Knudsen-layer correction of the standard slip conditions proposed by Lockerby, et al. +// 4 -- the Kogan simplified slip conditions. +// nMeanFreePathType : the method to the mean free-path for the slip conditions. For the mixture, 0 is suggested. +// 0 -- the equivalent mean free-path is calculated by the simple hard sphere model(HS). +// 1 -- calculated by the definition that includes the variables of the number density and the molecule diameter. +// 2 -- the equivalent mean free-path is calculated by the variable hard sphere model(VHS). +// nchemsrc: +// 0 -- the source terms are not computed. +// 1 -- the source terms are computed. +// nchemrad: +// 0 -- compute the spectrum radius without considering chemical reaction flow. +// 1 -- compute the spectrum radius that need to count the contribution from chemical reaction flow. +// ntmodel: The thermodynamic temperature model. +// 1 -- One-temperature model. +// 2 -- Two-temperature model. +// 3 -- Three-temperature model. +// nTEnergyModel: the method to computing temperature energy model. +// 0 -- the energy term is computed using the conventional method. +// 1 -- the energy term is computed using the curve fitting method. +// parkVDPower: the power of translational-rotational temperature in the Park V-D(vibration-dissociation) coupling model. +// The value is in range of [0.0, 1.0], DPLR suggests 0.5, LAURA suggests 0.7, while 0.6 is given as default value. +// catalyticCoef: +// 0.0 -- full non-catalytic wall boundary condition. +// 1.0 -- full catalytic wall boundary condition. +// in range of (0.0, 1.0) -- partial catalytic condition, the value indicates the catalytic coefficient. +// nIsSuperCatalytic : the super catalytic condition for the fully catalytic wall, and assigned with the value of 1. +// 0 -- equilibrium condition for the fully catalytic wall where the mass fractions are assigned with the values of the free stream. +// 1 -- super catalytic condition for the fully catalytic wall where all the atomic components combine into molecular components. +// nTemperatureJump : the method to calculate the temperature jump. +// 0 -- calculated by the variables of heat conductivity and constant volume specific heat for each energy mode. +// 1 -- the general method where the iteration is calculated with the translation-rotation temperature. +// sigmaVelocity: the coordination coefficient of tangential momentum for computation of slip velocity. The value is in range of (0.0, 2.0]. +// sigmaTemperature: the heat coordination coefficient for computation of slip temperature. The value is in range of (0.0, 2.0]. +// sigmaMassFraction: the species coordination coefficient for computation of slip mass fractions. The value is in range of (0.0, 2.0]. +// velocitySlipCorrectConstant: the correction constant to the velocity slip condition. For the diffuse reflection, 1.0 is used. +// 1.0 -- proposed by Maxwell. +// sqrt(2/PI)~0.8 -- used for "micro-slip", namely the actual velocity slip at the wall. +// 1.146 -- proposed for an additional "fictitious" velocity slip. + +// chemicalRelaxCorf: The value is in range of [0.001, 1.0]. +// chemicalSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// viscousSpectrumRadiusCoef : The value is in range of [1.0, 3.0]. +// inviscidSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// staticPressureRelaxCorf: The value is in range of [0.1, 1.0]. +// nIsChemicalFreeze : the flag to freeze the chemical reactions. +// 0 -- not freeze, the chemical reaction sources will be calculated. +// 1 -- freezes the chemical reactions, the chemical reaction sources will not be calculated.// veTemperatureMin: The minimum of Tv and Te +// nDebug: cout the Wrong place and abort +// 0 -- not used. +// 1 -- used. +// nSpeciesLimit: limitter of gas species +// 0 -- not used. +// 1 -- used. +// nTurblenceForChemical: the coupled mode of Turblence and Chemical reaction +// 0 -- method 0. +// 1 -- method 1. +// nViscosityFluxSublevelModified: Modified for ViscosityFlux on Sublevel grid +// 0 -- not used. +// 1 -- used. +// nChemcalSourceModified: Modified on ChemcalSource +// 0 -- not used. +// 1 -- used. +// nAblation: +// 0 -- The wall ablation is not computed. +// 1 -- The wall ablation is computed. +// isInjection: +// 0 -- The injection velocity of ablation wall is not computed. +// 1 -- The injection velocity of ablation wall is computed. +// nViscosityModel: + +// 0 -- Blottner fitting method. +// 1 -- Gupta fitting method. +// nSutherland: +// 0 -- stands for selecting the Blotter curve fits mode. +// 1 -- stands for Sutherland relation. +// gasfile: Indicates the gas model, 9 models are provided, namely "Gu5", "Gu7", "Gu11", "Pa5", "Pa7", "Pa11", "DK5", "DK7", "DK11". +// "Gu" -- indicates the Gupta Model, three-Type Models are embeded in the library, namely, the 5-species-6-reactions, the 7-species-9-reactions, the 11-species-20-reactions. +// "Pa" -- indicates the Park Model, three-Type Models are embeded in the library, namely, the 5-species-17-reactions, the 7-species-22-reactions, the 11-species-48-reactions. +// "DK" -- indicates the Dunn-Kang Model, three-Type Models are embeded in the library, namely, the 5-species-11-reactions, the 7-species-15-reactions, the 11-species-26-reactions. +// "Mars-Pa8" is for Park model of Mars gas, "Mars-Mc8" for McKenzie model of Mars gas. +// "Combustion-12" -- indicates the Combustion Chamber Gas Model which includes 12-species-20-reactions. +// "Gas-Mixture" -- indicates the process of mixing two species without reacting. +// For self-definition model, the gasfile is used to indicate the file path of the new gas model. +// speciesName: Used to list the names of each species, while each species name is separated by the symbol of comma. +// initMassFraction: Used to list the initial mass fractions of species in accordance with the sequence of names in the parameter speciesName. +// ifStartFromPerfectGasResults: The chemical reaction simulation is start from perfect gas flowfield or not, 0 is for no and else is for yes. + +int dg_high_order = 0; +int iapplication = 0; +int iCodeBranch = 0; +int nm = 5; +int nEquilibriumGas = 0; +int nPCWCycleStep = 3; +int nRETCycleStep = 3; +int nSLIPCycleStep= 3; + +double refGama = 1.4; +double prl = 0.72; +double prt = 0.90; +double sc_l = 0.5; +double sc_t = 0.5; + +int nGasModel = 0; +int nchem = 0; +int nchemsrc = 1; +int nchemrad = 1; +int ntmodel = 1; + +int nEnergyRecycle = 0; +int nSlipBCModel = 0; +int nDensityModify = 1; +int nTEnergyModel = 0; +int nMeanFreePathType = 0; +int nIsChemicalFreeze = 0; +int nIsSuperCatalytic = 1; +int nTemperatureJump = 0; + +double parkVDPower = 0.6; +double catalyticCoef = 0.0; +double sigmaVelocity = 1.0; +double sigmaTemperature = 1.0; +double sigmaMassFraction = 1.0; +double velocitySlipCorrectConstant = 1.0; + +double chemicalRelaxCorf = 1.0; +double chemicalSpectrumRadiusCoef = 1.0; +double viscousSpectrumRadiusCoef = 1.0; +double inviscidSpectrumRadiusCoef = 1.0; +double staticPressureRelaxCorf = 1.0; + +double veTemperatureMin = 30.0; +int nDebug = 0; +int nSpeciesLimit = 0; +int nTurblenceForChemical = 0; +int nViscosityFluxSublevelModified = 0 ; +int nChemcalSourceModified = 0; + +int nAblation = 0; +int isInjection = 0; +int nViscosityModel = 0; +int nMarsModel = 0; +string gasfile = "DK5"; +//string gasfile = "./chemical/Dunn-Kang_air5s11r.dat"; +string speciesName = "O, O2, NO, N, N2"; +string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.767"; + +//string speciesName = "O, O2, NO, N, NO+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string speciesName = "O, O2, NO, N, O+, O2+, NO+, N+, N2+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Mars-Pa8"; +//string speciesName = "O, O2, NO, N, N2, C, CO, CO2"; +//string initMassFraction = "0.0015, 0.0429, 0.0, 0.0, 0.0, 0.0, 0.0777, 0.8779"; + +//string gasfile = "DK7"; +//string speciesName = "O, O2, NO, N, NO+, C, C2, CO, CO2, CN, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Combustion-12"; +//string speciesName = "O, O2, NO, N, C, CO, CO2, H, H2, OH, H2O, N2"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767"; + +//string gasfile = "Gas-Mixture"; +//string speciesName ="SpeciesA, SpeciesB"; +//string initMassFraction = "1.0, 0.0"; +int nSutherland = 0; +double gamaSpeciesA = 1.4; +double gamaSpeciesB = 1.3; +double molecularWeightSpeciesA = 29.0; +double molecularWeightSpeciesB = 30.0; + +int nChemicalFlowStep = 0; +int ifStartFromPerfectGasResults = 0; + +######################################################################### +// Multi-Grid parameters. +// nMGLevel: The number of level of Multi-Grid. +// <= 1 -- Single-level. +// > 1 -- multi-level. +// MGPreIteration: For each grid, the number of pre-smoothing steps. +// n_post: For each grid, the number of post-smoothing steps. +// MGCoarsestIteration: For the coarest grid the number of smoothing steps. +// MGFasType: V-multi cycle or W-multi cycle. +// 1 -- V-multi cycle. +// 2 -- W-multi cycle. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. +// mgCFLScale: CFL number enlarge times for coarse grid. +// mprol: Multi-grid interpolation method, interpolation from coarse cell to fine grid. +// 1 -- zero order. +// 2 -- first-order. (default) +// mgCorrectionLimit: Multi-grid correction limit. + +int nMGLevel = 1; +int MGCoarsestIteration = 1; +int MGPreIteration = 1; +int MGFasType = 1; +int n_post = 0; +int flowInitStep = 100; +int mprol = 2; +double mgCFLScale = 1.0; +double mgCorrectionLimit = 0.01; + +//--------------- Some parameter for turbulent model -------------------- +// neasm: The variation of kw turbulent model. +// ismooth_turb: Residual smooth for turb or not. +// SSTProductType: The type of product term based on vorticity for SST. +// SAProductType: The type of product term based on vorticity for SA. +int neasm = -3; +int SSTProductType = 0; +int ismooth_turb = 0; +int SAProductType = 2; + +// ----------------- Overset Grid parameter ----------------------------- +int codeOfDigHoles = 1; +int codeOfTurbulentModel = 0; +string masterFileName = "./grid/searchFile.inp"; +string holeBasicFileName = "./grid/holeBasicFile.inp"; +string holeFullFileName = "./grid/holeFullFile.dat"; +string linkFileName = "./grid/topology.dat"; +string zoneInverseFileName = "./grid/zoneInverseMapping.inp"; + +######################################################################### +# High Order Struct Solver # +######################################################################### +// isFVMOrFDM: +// 0 -- NSSolverStruct using Finite Volume Method. +// 1 -- NSSolverStruct using Finite Differ Method. +// SolverStructOrder: Spatial discretisation order of NS equations with struct grid. +// <= 2 -- finite volume method. +// >= 3 -- finite difference order. (to be completed) +// 0 -- default. +// str_highorder_interpolation_epsilon: Epsilon in weighted interpolation, bigger epsilon, better convergence, +// smaller epsilon, robuster for shock-detecting. +// str_highorder_interpolation_type: +// -- "classical", "test". +// str_highorder_flux_name: +// -- "roe", "steger". +// structhighordergradient: +// -- "conservation", "chain_rule". +int isFVMOrFDM = 0; +string str_highorder_solver = "WCNS"; +int SolverStructOrder = 0; +double str_highorder_interpolation_epsilon = 1.0e-6; +string str_highorder_interpolation_type = "test"; +string str_highorder_flux_name = "steger"; +string structhighordergradient = "conservation"; +double coefofstrflux = 0.5; +double limitcoefofinterface = 0.0; + +// ----------------- Advanced choices ----------------------------------- +// outtimesc: Time stepping scheme for the outer loop. +// MUSCLCoefXk: The parameter of MUSCL interpolations, belongs to [-1, 1]. +// -1 -- seconde-order fully-upwind differencing. +// 0 -- seconde-order upwind-biased differencing. +// 0.333333 -- third-order upwind-biased differencing. +// 1 -- seconde-order central differencing. +// MUSCLCoefXb: The limiter parameter. +// 0 -- the effect of the limiter is cancelled, means the first-order interpolations. +// allReduceStep: Iteration intervals for MPI AllReduce operation, default is 1. +string outtimesc = "impbd2"; +double MUSCLCoefXk = -1; +double MUSCLCoefXb = 1.0; +int allReduceStep = 1; + +// ----------------- overlap configuration ------------------------------ +// codeOfOversetGrid: Overlapping(overset) grid or not. +// 0 -- NON-overlapping grid. +// 1 -- Overlapping grid. +// oversetInterpolationMethod: the method of overset interpolation while field simulation +// 0 -- set the acceptor cell value by donor cell value. +// 1 -- set the acceptor cell value by distance weight of donor cell value. + +int codeOfOversetGrid = 0; +int oversetInterpolationMethod = 0; +int readOversetFileOrNot = 0; +int symetryOrNot = 0; +int readInAuxiliaryInnerGrid = 1; +int readInAuxiliaryOuterGrid = 0; +int readInSklFileOrNot = 0; +string auxiliaryInnerGrid0 = "./grid/aux-upper.fts"; +string auxiliaryInnerGrid1 = "./grid/aux-lower.fts"; +string auxiliaryInnerGrid2 = ""; +string oversetGridFileName = "./grid/iblank.ovs"; +double walldistMainZone = 1.0 +double toleranceForOversetSearch = 1.0e-3; +double toleranceForOversetBox = 1.0e-3; +int twoOrderInterpolationOrNot = 0; +int keyEnlargeOfActiveNodes = 0; +int outTecplotOverset = 0; + +int numberOfMovingBodies = 2; + +// ----------------- ALE configuration ------------------------------ +int codeOfAleModel = 1; +int aleStartStrategy = -1; + +int strategyForFaceNormalVelocity = 0; //0-By Sweeping volume; 1-By face center 1st; 2-By face center 2nd; +int strategyForGCLSource = 0; //0-present; 1-Ahn; + +//0:1st-Admas-Bashforth; 1:2nd-Admas-Bashforth; 2:1st-Implicit-Euler; 3:2nd-Implicit Euler; 4:2nd-Adams-Moulton; 5:3rd-Adams-Moulton +int methodForKineticEquation = 0; +double relaxParameterOfKinetic = 1.0; + +######################################################################### +# motive information # +######################################################################### +int numberOfMovingBodies = 1; + +############################## body0 ############################## +//mass of parts +double mass_0 = 1.0; +//mass matrix of parts Ixx Iyy Izz Ixy Ixz Iyz +double massMatrix_0[] = 1e-7, 1e-6, 1e-6, 0.0, 0.0, 0.0; +//initial six DOF position information of parts. xc yc zc +double massCenter_0[] = 0.0 , 0.0, 0.0; +//initial six DOF position information of parts. angleX angleY angleZ +double attitudeAngle_0[] = 0.0 , 0.0, 0.0; +//initial six DOF move information of parts. vc vy vz +double massCenterVelocity_0[] = 0.0, 0.0, 0.0; +//initial six DOF move information of parts. omigX omigY omigZ +double angularVelocity_0[] = 0.0, 0.0, 0.0; +//the object that the parts belong to. +int fartherIndex_0 = -1; +//the assembly position of the parts. xc yc zc angleX angleY angleZ +double configPamameter_0[] = 0.0 ,0.0 ,0.0 ,0.0 ,0.0 ,0.0; +//the move pattern of the parts. +// -1 given motion partten. +// 0 still. +// 1 six DOF motion. +// 2 three DOF motion. +// 11 X-axis forced motion. +// 12 Y-axis forced motion. +// 13 Z-axis forced motion. +// 14 forced pitch motion. +// 15 forced yaw motion. +// 16 forced roll motion. +int RBDMethod_0 = 0; +double amplitude_0 = 0.0; +double reduceFrequency_0 = 0.0; +//string uDFSixDofFileName_0 = "./Bin/UDFSixDof.Parameter"; +//additional force (system axis) fX fY fZ +double addedForce_0[] = 0.0 ,0.0 ,0.0 ; +//additional moment of Force (system axis) mX mY mZ +double addedMoment_0[] = 0.0 ,0.0 ,0.0 ; +//the deformation method of the parts. +int morphing_0 = 0; + +// post indentify +int integralOrder = 4; + + +// ---------------- ATP read -------------------------------------------- +//@int inflowParaType = 0; +//@double refReNumber = 6.5e6; +//@double refDimensionalTemperature = 288.15; +//@double freestream_vibration_temperature = 300.00; +//@double refDimensionalPressure = 0; +//@double height = 0; +//@int nsubsonicInlet = 0; +//@int nsubsonicOutlet = 0; +//@string inLetFileName = "./bin/subsonicInlet.hypara"; +//@string outLetFileName = "./bin/subsonicOutlet.hypara"; +//@double refDimensionalVelocity = 0; +//@double refDimensionalDensity = 0; + +######################################################################### +# Old Parameter # +######################################################################### +int isPlotVolumeField = 0; + diff --git a/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/cfd_para_hypersonic.hypara b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/cfd_para_hypersonic.hypara new file mode 100644 index 0000000..0230051 --- /dev/null +++ b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/cfd_para_hypersonic.hypara @@ -0,0 +1,206 @@ +######################################################################### +# General Control Parameter # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual 'res.dat' saved. + +int maxSimuStep = 50000; + +int intervalStepFlow = 2000; +int intervalStepPlot = 2000; +int intervalStepForce = 100; +int intervalStepRes = 20; + +######################################################################### +# Inflow Parameter # +######################################################################### +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// 4 -- the condition that the velocity, temperature and density are given. +// 5 -- the condition that the velocity, temperature and pressure are given. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. + +double refMachNumber = 20.00; +double attackd = 20.00; +double angleSlide = 0.00; + +double wallTemperature = 1500.0; + +//int inflowParaType = 0; +//double refReNumber = 1.0e5; +//double refDimensionalTemperature = 288.15; +//double freestream_vibration_temperature = 300.0; + +int inflowParaType = 1; +double height = 50.0; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +//The velocity, temperature and density are fixed. +//int inflowParaType = 4; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalDensity = 1.0e3; + +//The velocity, temperature and pressure are fixed. +//int inflowParaType = 5; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalPressure = 1.0e5; + +double gridScaleFactor = 0.001; + +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. + +######################################################################### +# Physical models # +######################################################################### +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "1eq-sa", when viscousType = 3. +// -- "2eq-kw-menter-sst", when viscousType = 4. +// DESType: Type of DES. +// 0 -- RANS.(default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. + +//int viscousType = 0; +//string viscousName = "Euler"; + +int viscousType = 1; +string viscousName = "laminar"; + +//int viscousType = 3; +//string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +int roeEntropyFixMethod = 2; +double roeEntropyScale = 1.0; +######################################################################### +# Spatial Discretisation # +######################################################################### +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "ausmpw", "ausmpw+". +// str_limiter_name: Limiter of struct grid. +// -- "minmod", "3rd_minmod_smooth". + +string inviscidSchemeName = "steger"; +string str_limiter_name = "minmod"; + +#******************************************************************* +# UnStruct Solver * +#******************************************************************* +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpwplus". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "vencat", "barth". +// -- "1st", meaning accuracy of first-order. +// -- "nolim", no limiter. +// venkatCoeff: Coefficient of vencat limiter, when uns_limiter_name = 'vencat'. +// The smaller the value, the more robust it is. + +string uns_scheme_name = "vanleer"; +string uns_limiter_name = "vencat"; +double venkatCoeff = 0.5; + +######################################################################### +# Temporal Discretisation # +######################################################################### +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// CFLEnd: The CFL number, [0.1, 100]. +// The bigger the value, the convergence faster but lower robustness. +// ktmax: The lower the value, the more robustness, 1.0e5 - 1.0e10. + +int iunsteady = 0; + +double CFLEnd = 2.0; +int CFLVaryStep = 1000; +double ktmax = 1.0e10; + +######################################################################### +# File In or Out # +######################################################################### +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// Please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the whole field results to tecplot or not, 0 / 1. + +string gridfile = "./grid/OV102__24.fts"; +int plotFieldType = 0; + +// ----------------- Advanced Parameters, DO NOT care it ---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables: Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40). +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. + +int reconmeth = 0; +int limitVariables = 0; +int limitVector = 1; \ No newline at end of file diff --git a/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/grid_para.hypara b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/grid_para.hypara new file mode 100644 index 0000000..307e4fe --- /dev/null +++ b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/grid_para.hypara @@ -0,0 +1,30 @@ +######################################################################### +# Grid data type # +######################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +// from_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +int gridtype = 1; +int axisup = 1; +int from_gtype = 3; + +######################################################################### +# File path # +######################################################################### +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +string from_gfile = "./grid/OV102.grd"; +string out_gfile = "./grid/OV102.fts"; diff --git a/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/key.hypara b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/key.hypara new file mode 100644 index 0000000..969b4ea --- /dev/null +++ b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/key.hypara @@ -0,0 +1,59 @@ +string title = "PHengLEI Main Parameter Control File"; + +// IMPORTANT NOTICE: DON NOT MODIFY THE FOWLLOWING LINE. +string defaultParaFile = "./bin/cfd_para.hypara"; + +// ndim: Dimensional of the grid, 2 or 3. +// nparafile: the number of parameter files. +// nsimutask: simulation task type. +// 0 -- CFD Solver of NS or Turbulation. +// 1 -- Grid generation: for special typical cases, such as cylinder, flat plate, etc. +// Grid conversion: from other format to PHengLEI format (.fts). +// Grid reconstruction: such as grid adaptation. +// Grid merging: merge two blocks into one block. +// Grid repairing: repair the original grid in order to remove the negative volume cells. +// 2 -- Wall distance computation for turb-solver. +// 3 -- Grid partition. +// 4 -- Knowledge repository / examples of PHengLEI-API. +int ndim = 2; +int nparafile = 1; + +int nsimutask = 0; +//string parafilename = "./bin/cfd_para_subsonic.hypara"; +//string parafilename = "./bin/cfd_para_transonic.hypara"; +//string parafilename = "./bin/cfd_para_supersonic.hypara"; +string parafilename = "./bin/cfd_para_hypersonic.hypara"; +//string parafilename = "./bin/incompressible.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_para.hypara"; + +//int nsimutask = 2; +//string parafilename = "./bin/cfd_para.hypara"; + +//int nsimutask = 3; +//string parafilename = "./bin/partition.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_deform_para.hypara"; + +//int nsimutask = 4; +//string parafilename = "./bin/repository.hypara"; + +//int nsimutask = 5; +//string parafilename = "./bin/overset_grid_view.hypara"; + +//int nsimutask = 13; +//string parafilename = "./bin/lbm_para.hypara"; + +//int nsimutask = 14; +//string parafilename = "./bin/integrative_solver.hypara"; + +//int nsimutask = 99; +//string parafilename = "./bin/post_processing.hypara"; + +// ---------------- Advanced Parameters, DO NOT care it ---------------- +int numberOfGridProcessor = 0; +// ATP read +//@string parafilename1 = "" +//@string parafilename2 = ""; diff --git a/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/partition.hypara b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/partition.hypara new file mode 100644 index 0000000..b27bf10 --- /dev/null +++ b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/bin/partition.hypara @@ -0,0 +1,21 @@ +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// maxproc: The number of partition zones that want to be divided into, +// which is equal to the number of CPU processors you want. +// Usually, 50~100 thousands structured cells per CPU-Core is suggested. +// 30~70 thousands unstructured cells per CPU-Core is suggested. +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). + +int pgridtype = 1; +int maxproc = 24; + +string original_grid_file = "./grid/OV102.fts"; +string partition_grid_file = "./grid/OV102__24.fts"; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level,..., et al. +int numberOfMultigrid = 1; diff --git a/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/grid/OV102.grd b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/grid/OV102.grd new file mode 100644 index 0000000..6644a11 Binary files /dev/null and b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/grid/OV102.grd differ diff --git a/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/grid/OV102.inp b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/grid/OV102.inp new file mode 100644 index 0000000..447a75f --- /dev/null +++ b/A20-ThreeD_OV102_Ma20_Laminar_H50_Struct_24CPU/grid/OV102.inp @@ -0,0 +1,213 @@ + 1 + 9 + 60 63 54 +D + 17 + 1 60 63 1 1 1 3 + 1 60 -1 -63 54 54 -1 + 1 60 38 38 -1 -63 2 + 1 1 -63 -1 1 54 -1 + 10 10 -63 -1 1 54 7 + 60 60 -63 -43 1 7 -1 + -1 -21 1 7 25 25 9 + 60 60 -43 -1 1 7 -1 + -21 -63 1 7 25 25 9 + 60 60 -63 -1 7 54 -1 + 1 1 1 48 -1 -63 3 + 60 54 1 1 1 28 2 + 60 54 1 1 28 54 2 + 54 48 1 1 1 54 2 + 48 42 1 1 1 54 2 + 42 35 1 1 1 54 2 + 35 29 1 1 1 54 2 + 29 22 1 1 1 54 2 + 22 20 1 1 1 54 2 + 20 15 1 1 1 54 2 + 15 1 1 1 1 54 2 + 60 1 63 63 1 54 4 + 77 38 63 +A + 16 + 68 60 38 1 1 1 2 + 68 76 26 12 1 1 2 + 76 68 38 26 1 1 2 + 77 68 1 12 1 1 2 + 77 76 -12 -38 1 1 -1 + 18 17 -22 -48 63 63 3 + 60 48 38 1 1 1 2 + 48 35 38 1 1 1 2 + 35 22 38 1 1 1 2 + 22 13 38 1 1 1 2 + 13 1 38 1 1 1 2 + 1 77 1 38 63 63 4 + 1 1 38 1 -63 -1 -1 + 10 10 -63 -1 54 91 7 + 77 77 -38 -1 1 63 -1 + -1 -38 15 15 63 1 5 + 1 77 1 1 1 63 3 + 60 77 38 38 -63 -1 -1 + 1 18 48 48 -1 -63 3 + 1 60 38 38 -1 -63 -1 + 1 60 -1 -63 54 54 1 + 18 48 63 +C + 22 + 1 18 1 48 1 1 4 + 1 5 22 1 63 63 2 + 5 9 22 1 63 63 2 + 1 9 48 22 63 63 2 + 9 13 22 1 63 63 2 + 9 13 48 22 63 63 2 + 13 15 22 1 63 63 2 + 15 17 22 1 63 63 2 + 13 15 48 22 63 63 2 + 15 17 48 22 63 63 2 + 17 18 22 1 63 63 2 + 18 17 -22 -48 63 63 -1 + 77 76 -12 -38 1 1 2 + 1 1 1 48 -1 -63 -1 + 60 60 -63 -1 7 54 1 + 18 18 -48 -1 63 1 -1 + 1 1 63 1 -1 -48 6 + 1 9 1 1 -1 -21 -1 + -1 -21 7 15 25 25 9 + 1 9 1 1 -21 -63 -1 + -21 -63 7 15 25 25 9 + 9 13 1 1 -1 -21 -1 + -1 -21 15 19 25 25 9 + 9 13 1 1 -21 -63 -1 + -21 -63 15 19 25 25 9 + 13 17 1 1 -21 -63 -1 + -21 -63 19 23 25 25 9 + 13 18 1 1 -1 -21 -1 + -1 -21 19 24 25 25 9 + 17 18 1 1 -21 -63 -1 + -21 -63 23 24 25 25 9 + 1 18 48 48 -1 -63 -1 + 60 77 38 38 -63 -1 2 + 15 11 20 +G + 8 + 15 1 -1 -11 1 1 -1 + -28 -38 1 15 63 63 5 + -1 -15 1 4 20 20 -1 + -1 -15 63 63 45 48 6 + 15 1 -4 -11 20 20 -1 + 15 1 63 63 -48 -55 6 + 1 1 11 1 20 1 2 + 15 15 11 1 20 1 6 + 15 1 1 1 -20 -2 -1 + 15 1 63 63 -45 -27 6 + 15 1 1 1 -1 -2 -1 + -28 -27 1 15 63 63 5 + 15 1 11 11 1 20 3 + 38 15 63 +E + 8 + 38 1 15 1 1 1 4 + -1 -27 1 15 63 63 -1 + 15 1 63 63 -1 -27 6 + -28 -27 1 15 63 63 -1 + 15 1 1 1 -1 -2 4 + -28 -38 1 15 63 63 -1 + 15 1 -1 -11 1 1 4 + 1 1 -1 -15 63 1 -1 + -15 -1 63 1 1 1 6 + 38 38 15 1 63 1 3 + 1 38 1 1 63 1 6 + -1 -38 15 15 63 1 -1 + 77 77 -38 -1 1 63 2 + 15 63 55 +F + 13 + -15 -1 63 1 1 1 -1 + 1 1 -1 -15 63 1 5 + 1 15 63 1 55 55 3 + 1 1 -1 -21 48 55 -1 + -1 -21 24 31 25 25 9 + 1 1 -21 -63 48 55 -1 + -21 -63 24 31 25 25 9 + 1 1 63 1 -1 -48 -1 + 18 18 -48 -1 63 1 3 + 15 15 1 21 48 55 6 + 15 15 21 63 48 55 6 + 15 15 63 1 1 48 6 + 1 15 1 1 1 55 4 + -1 -15 63 63 45 48 -1 + -1 -15 1 4 20 20 4 + 15 1 63 63 -45 -27 -1 + 15 1 1 1 -20 -2 4 + 15 1 63 63 -48 -55 -1 + 15 1 -4 -11 20 20 4 + 15 1 63 63 -1 -27 -1 + -1 -27 1 15 63 63 5 + 10 63 91 +H + 9 + 1 10 63 1 1 1 3 + 10 1 63 1 91 91 3 + 1 1 -1 -63 1 25 -1 + -1 -63 1 1 1 25 8 + 1 1 -1 -63 25 67 -1 + -1 -63 1 43 25 25 8 + 1 1 -1 -63 67 91 -1 + -1 -63 43 43 25 1 8 + 10 10 -63 -1 1 54 -1 + 1 1 -63 -1 1 54 1 + 10 10 -63 -1 54 91 -1 + 1 1 38 1 -63 -1 2 + 1 10 1 1 1 91 2 + 1 10 63 63 1 91 4 + 63 43 25 +I + 6 + 63 1 1 43 1 1 3 + -1 -63 1 43 25 25 -1 + 1 1 -1 -63 25 67 7 + 1 1 1 43 1 25 2 + 63 63 1 43 1 25 4 + -1 -63 1 1 1 25 -1 + 1 1 -1 -63 1 25 7 + -1 -63 43 43 25 1 -1 + 1 1 -1 -63 67 91 7 + 63 31 25 +J + 27 + 1 21 1 31 1 1 3 + 21 24 31 1 1 1 2 + 24 36 19 1 1 1 2 + 24 36 30 19 1 1 2 + 24 36 31 30 1 1 2 + 36 38 31 1 1 1 2 + 38 41 28 1 1 1 2 + 38 41 31 28 1 1 2 + 41 63 31 28 1 1 2 + 63 41 1 28 1 1 2 + -21 -63 1 7 25 25 -1 + 60 60 -43 -1 1 7 1 + -1 -21 1 7 25 25 -1 + 60 60 -63 -43 1 7 1 + -21 -63 7 15 25 25 -1 + 1 9 1 1 -21 -63 3 + -21 -63 15 19 25 25 -1 + 9 13 1 1 -21 -63 3 + -1 -21 7 15 25 25 -1 + 1 9 1 1 -1 -21 3 + -1 -21 15 19 25 25 -1 + 9 13 1 1 -1 -21 3 + -21 -63 19 23 25 25 -1 + 13 17 1 1 -21 -63 3 + -21 -63 23 24 25 25 -1 + 17 18 1 1 -21 -63 3 + -1 -21 19 24 25 25 -1 + 13 18 1 1 -1 -21 3 + -21 -63 24 31 25 25 -1 + 1 1 -21 -63 48 55 6 + -1 -21 24 31 25 25 -1 + 1 1 -1 -21 48 55 6 + 1 1 1 31 1 25 4 + 63 63 1 31 1 25 2 + 21 63 1 1 25 1 3 + 1 21 1 1 25 1 3 + 63 21 31 31 25 1 3 + 21 1 31 31 25 1 3 diff --git a/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/boundary_condition_ref.hypara b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/boundary_condition_ref.hypara new file mode 100644 index 0000000..509bab9 --- /dev/null +++ b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/boundary_condition_ref.hypara @@ -0,0 +1,59 @@ +# nBoundaryConditons : number of global boundary conditions. +# bcName : Boundary Condition Name. +# bcType(in PHengLEI): Boundary Condition Type. + +# Account of how to set boundaryconditon. +# string bcName = "Farfield"; +# { +# int bcType = 4; +# int inflowParaType = 1; +# double attackd = 0; +# double refReNumber = 6.5e6; +# double refMachNumber = 3.5; +# double angleSlide = 0; +# } + +int nBoundaryConditons = 5; +string bcName = "Wall"; +{ + string bodyName = "body"; + int bcType = 2; +} +string bcName = "Symmetry"; +{ + int bcType = 3; +} +string bcName = "Inlet1"; +{ + int bcType = 5; + int inflowParaType = 9; + double primDensity = 1.129985; + double primU = 0.9666364; + double primV = -0.052199312; + double primW = 0; + double primPressure = 0.2119350; +} +string bcName = "Inlet2"; +{ + int bcType = 5; +} +string bcName = "Outlet"; +{ + int bcType = 6; +} + +# 'bcType' is defined as following: +# 99: PERIODIC +# -2: WAKE +# -1: INTERFACE +# 0 : NO_BOUNDARY_CONDITION +# 1 : EXTRAPOLATION +# 2 : SOLID_SURFACE +# 3 : SYMMETRY +# 4 : FARFIELD +# 5 : INFLOW +# 6 : OUTFLOW +# 52: PRESSURE_INLET +# 62: PRESSURE_OUTLET +# 61: OUTFLOW_CONFINED +# 7 : POLE diff --git a/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/cfd_para.hypara b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/cfd_para.hypara new file mode 100644 index 0000000..b17970c --- /dev/null +++ b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/cfd_para.hypara @@ -0,0 +1,1220 @@ +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +// PPPPP H H EEEEE N N GGGGG L EEEEE III + +// P P H H E NN N G L E I + +// PPPPP HHHHH EEEEE N N N G GG L EEEEE I + +// P H H E N N N G G L E I + +// P H H EEEEE N N GGGGG LLLLL EEEEE III + +//------------------------------------------------------------------------+ +// Platform for Hybrid Engineering Simulation of Flows + +// China Aerodynamics Research and Development Center + +// (C) Copyright, Since 2010 + +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +########################################################################### +# Default parameters for Grid conversion # +########################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// 2 -- Hybrid grid, include both of unstructured and structured grid. +// gridobj: Task type of grid treatment. +// 0 -- Grid generation of typical case, such as cylinder, flat plate, etc. +// 1 -- Grid conversion, from other grid data to PHenglEI, such as Fluent, CGNS. +// 2 -- Grid refinement. +// 3 -- Grid merging, merge two blocks into one block. +// 4 -- Grid deformation, achieve unstructured grid deformation. +// 5 -- Grid repairing, repair the original grid in order to remove the negative volume cells. +// 6 -- Grid mirroring, mirror a symmetry grid to whole grid. +// multiblock: Multi-block grid or not, only for structured grid conversion. +// 0 -- Not. +// 1 -- Yes. +// iadapt: Adaptation number for unstructure grid. +// SymmetryFaceVector: The vector of symmetry face. +// 0 -- X axis. +// 1 -- Y axis. +// 2 -- Z axis. +int gridtype = 0; +int gridobj = 1; +int multiblock = 0; +int iadapt = 0; +int SymmetryFaceVector = 1; + +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +int axisup = 1; + +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +int omit_no_bound_bc = 0; + +//----------------------------------------------------------------------- +# Grid data type # +//----------------------------------------------------------------------- +// from_gtype/to_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +// dumpOldGrid: If dump out the old grid file. +// 0 -- Not. (default) +// 1 -- Yes. +int from_gtype = 2; +int to_gtype = 1; +int dumpOldGrid = 0; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +int numberOfGridFile = 1; +string from_gfile = "./grid/rae2822_hybrid2d.cas"; +string from_gfile1= ""; + +string out_gfile = "./grid/flat_laminr_133_85_2d.fts"; + +// ----------------- some advanced choices ------------------------------ +// iunsteady: The Grid is for unsteady simulation or not. +int iunsteady = 0; +int codeOfAleModel = 0; + +// fileformat: Ustar Grid file format. +// 0 -- BINARY. +// 1 -- ASCII. +int fileformat = 0; + +// Parameters for hybrid solver. +// mixgrid_uns: path of unstructure grid file for hybrid solver, *.fts type. +// mixgrid_str: path of structure grid file for hybrid solver, *.fts type. +string mixgrid_uns = "./grid/rae2822_uns2d_4.fts"; +string mixgrid_str = "./grid/flat_laminr_133_85_2d.fts"; + +// Some parameters for structured overlapping grid. +int codeOfDigHoles = 1; +string holeBasicFileName = "./oversetGridView/holeBasicFile.inp"; +string holeFullFileName = "./oversetGridView/holeFullFile.dat"; +string linkFileName = "./oversetGridView/topology.dat"; +string zoneInverseFileName = "./oversetGridView/zoneInverseMapping.inp"; + +// ----------------- Adaptive Mesh Refine ------------------------------- +// In this file, the original_grid_file is used of the partition part. +// If use it dependently, abstract it here. +string adapt_grid_file = "./grid/sphere_mixed_adapt1.fts"; +string geometryFileName = "./grid/jsm.igs"; + +// geometryUnit: Geometry unit. +// 1 -- meter. +// 2 -- millimeter. +// 3 -- inch. +// exclusiveCase: Parallel projection exclusive case. +// 0 -- NON case. +// 1 -- JSM-C2-NPOFF case. +// 2 -- CHNT. +// projectOrgPoint: If the original wall points need to be projected or not. +int geometryUnit = 1; +int anisoRefine = 0; +int isProject = 0; +int readDist = 0; +int isDeform = 0; +int exclusiveCase = 0; // 0: NON case; 1: JSM-C2-NPOFF case; 2: CHNT. +int projectOrgPoint = 0; // if project original wall points. + + +// ----------------- Grid Deform Parameters ----------------------------- +// deformationMethod: Grid Deform. +// 1 -- SPRING. +// 2 -- RBF. +// stationalGridFile: Original grid file. +// visualFileName : The visualization file path of deform grid. +// nDeformStep : The max deform step. +// flapAngle : The max flap angle. +// rotatePostionZ : Rotate postion. +// rotatePostionY : Rotate postion. +// gridSlice : If dump slice grid. +// sliceAxis : Grid slice axis. +// slicePosition : Grid slice position. +int nDeformStep = 40; +double flapAngle = 10.0; +double rotatePostionZ = 4.00003; +double rotatePostionY = 3.05; + +int deformationMethod = 2; +string stationalGridFile = "./grid/Segment2Brid.fts"; +string visualFileName = "./results/deformedGrid.dat" + +int gridSlice = 1; +int sliceAxis = 1; +double slicePosition = 13; + +// ----------------- RBF Parameters ------------------------------------- +// numberOfReferenceCP : Number of reference Control Points. +// influencePara : The RBF influence radius parameter. +int numberOfReferenceCP = 40; +double influencePara = 25.0; + +// ----------------- Periodic Parameters -------------------------------- +// Notice: Rotational periodicity only support rotation along the X axis! +// periodicType: Which periodic boundary is used. +// 0 -- without Periodic Boundary. +// 1 -- Translational periodicity. +// 2 -- Rotational periodicity. +// translationLength[]: The relative distance between two periodic face + which only support one direction. +// rotationAngle: The relative angle between two periodic face. + which is recorded in degrees. + +int periodicType = 0; +double translationLength[] = [0.0,0.0,0.0]; +double rotationAngle = 0.0; + +######################################################################### +# Default parameters for Partition # +######################################################################### +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// 2 -- refine structured grid. +// maxproc: The number of partition zones that want to be divided into. +int pgridtype = 0; +int maxproc = 4; + +// traceMark: Trace mark or not, only for structured grid partition. +// 0 -- Not. +// 1 -- Yes. +// blockIndexOfMark: the block index of mark, only for structured grid partition. +// cellIndexOfMark: the cell index of mark, only for structured grid partition. +int traceMark = 0; +int blockIndexOfMark = 0; +int cellIndexOfMark[] = [185,30,1]; + +// parallel Strategy: +//! -# 0 : each zone is assigned to the one that defined in grid partition procedure. +//! -# 1 : random assigned for each zone or by some else ways. +int parallelStrategy = 1; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). +string original_grid_file = "./grid/sphere_mixed.fts"; +string partition_grid_file = "./grid/sphere_mixed__4.fts"; + +// ------------------ Sompe advanced parameters ------------------------- +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +// npartmethod: Method of interface reconstruction, default is 1. +// parallelPartitionMethod: Method of parallel partition, this is set only when execute parallel partition. It would be skipped when serial partition. +// 1 -- Using ParMetis for homogeneous MPI. +// 2 -- Using Metis for homogeneous MPI. +// 3 -- using METIS partition for homogeneous OpenMP. +// parmetisBalance: Used to specify the imbalance tolerance. +// 1 -- perfect balance. +// maxproc -- perfect imbalance. +// 1.05 -- recommended. + +int omit_no_bound_bc = 0; +int npartmethod = 1; +int parallelPartitionMethod = 2; +double parmetisBalance = 1.05; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level, ..., et al. +int numberOfMultigrid = 1; + +######################################################################### +# Default parameters for CFD simulation # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepSample: The step intervals for monitored probes variables file 'sample.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual file 'res.dat' saved. +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) + +int maxSimuStep = 20000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepSample = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; +int ifLowSpeedPrecon = 0; + +// compressible: +// 0 -- incompressible flow. +// 1 -- compressible flow. (default) +int compressible = 1; + +//----------------------------------------------------------------------- +# CFD Control Parameter # +//----------------------------------------------------------------------- +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// 4 -- the condition that the velocity, temperature and density are given. +// 5 -- the condition that the velocity, temperature and pressure are given. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. +// radiationCoef: The radiation coefficient on wall, it is used to compute the radiation heat flux on wall when the boundary +// condition is radiation equilibrium temperature, and 0.8 is the default value. +// refMolecularWeight : the reference molecular weight of gas used for perfect gas. The unit is g/mol. +// Generally, the gas is air. Sometimes, it is experiment gas, such as Nitrogen, Argon, and so on. + +double refMachNumber = 0.73; +double attackd = 2.79; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 6.5e6; +double refDimensionalTemperature = 288.15; +double freestream_vibration_temperature = 300.00; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +//int inflowParaType = 3; +//int nsubsonicInlet = 1; +//int nsubsonicOutlet = 1; +//string inLetFileName = "./bin/subsonicInlet.hypara"; +//string outLetFileName = "./bin/subsonicOutlet.hypara"; +//double refDimensionalTemperature = 288.144; +//double refDimensionalPressure = 1.01313E05; + +//The velocity, temperature and density are fixed. +//int inflowParaType = 4; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalDensity = 1.0e3; + +//The velocity, temperature and pressure are fixed. +//int inflowParaType = 5; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalPressure = 1.0e5; + +//The MachNumber, temperature and pressure are fixed. +//int inflowParaType = 6; +//double refDimensionalTemperature = 293; +//double refDimensionalPressure = 8886.06; + +double wallTemperature = -1.0; + +double radiationCoef = 0.8; +double gridScaleFactor = 1.0; + +int numberOfAerodynamicForceComponents = 1; +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. +double refMolecularWeight = 28.9644; // unit of g/mol. + +//----------------------------------------------------------------------- +# Spatial Discretisation # +//----------------------------------------------------------------------- +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "hlle", "lax_f". +// -- "roe", "modified_roe". +// -- "ausm+", "ausm+w", "ausm+up", "ausmdv", "ausmpw", "ausmpw+". +// str_limiter_name: Limiter of struct grid. +// -- "vanalbada", "vanleer", "minmod", "smooth", "minvan", "3rdsmooth", "3rd_minmod_smooth". +// -- "nolim", no limiter. +// -- "vanalbada_clz", clz supersonic version. +string inviscidSchemeName = "roe"; +string str_limiter_name = "vanalbada"; + +#******************************************************************* +# UnStruct Solver or Common * +#******************************************************************* +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 2 -- Algebraic. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "0eq-bl". +// -- "1eq-sa". +// -- "2eq-kw-menter-sst". +// -- "2eq-kw-menter-bsl". +// -- "2eq-kw-wilcox-1988". +// -- "2eq-kw-wilcox-1998". +// -- "2eq-kw-kok-tnt". +// -- "2eq-kw-wilcox-2006". +// -- "easm-kw-2003". +// -- "easm-kw-2005". +// DESType: Type of DES. +// 0 -- RANS. (default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpw+". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "barth", "vencat", "vanleer", "minmod". +// -- "vanalbada", "smooth", "nnd", "lpz", "1st". +// -- "nolim", no limiter. +// uns_vis_name: Discretisation method of viscous term. +// -- "std", "test", "aver", "new1", "new2". +// gradientName: Gradient reconstruction method. +// -- "default", "ggcell", "ggnode", "lsq". +// ivencat: Variation of vencat limiter. +// 0 -- org method, it is independent of grid scale. +// 1 -- new method, it is dependent of grid scale. +// 4 -- Ustar limiter model, without grid size unitary. +// 7 -- default used. +// venkatCoeff: Cofficient of vencat, when using vencat limter. +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. +// skewnessAngle: The skewness angle of grid cells. +// roeEntropyFixMethod: Entropy fix (correction) method. +// 1 -- direct fix, which limits the minimum eigenvalue directly. +// 2 -- multi-dimensional fix, which is derived from structured solver and now is only valid for struct solver. +// 3 -- Harten type, which is default used. +// roeEntropyScale: Entropy fix (correction) coefficient scale, default is 1.0. +// It is used to scale the default Roe entropy fix coefficients. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +string uns_scheme_name = "roe"; +string uns_limiter_name = "vencat"; +string uns_vis_name = "test"; +string gradientName = "ggnode"; + +int ivencat = 7; +double venkatCoeff = 5.0; +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; +double skewnessAngle = 60.0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; + +//----------------------------------------------------------------------- +# Temporal Discretisation # +//----------------------------------------------------------------------- +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// physicalTimeStep: The nondimensional physical time step. +// ifStartFromSteadyResults: The unsteady simulation is start from steady flowfield or not, 0 is for no and else is for yes. +// ifStaticsFlowField: Statistical variables for unsteady simulation. +// ifStaticsReynoldsStress: Statistical Reynolds stress for unsteady simulation. +// startStatisticStep: Outer step when start statistics. +// when the value is larger than "maxSimuStep", it is useless. +// statisticalTimePeriod: Used as time period of statistic analysis. +// when the value is negative, time period is treated as infinite. +// statisticMethod: Statistic reynolds stress method. + 0 --tau = - ^2 + 1 --tau = +// min_sub_iter: The min sub iteration of unsteady simulation. +// max_sub_iter: The max sub iteration of unsteady simulation. +// tol_sub_iter: The tolerance of sub iteration of unsteady simulation. +// tscheme: Temporal Discretisation method. +// 1 -- Runge-Kutta Multi-State. +// 2 -- Point implicit. +// 3 -- Full implicit. +// 4 -- LU-SGS. +// 5 -- Block LU-SGS. +// 6 -- Jacobian iteration. +// 7 -- Lower G-S iteration. +// 8 -- Upper G-S iteration. +// 9 -- Lower/Upper G-S iteration. +// iSimplifyViscousTerm: Simplify the computation of viscous term in the Block LU-SGS method. The default value assigns 1 that could speed up the computation. +// Otherwise, the viscous Jacobian matrix Mv should be computed that will increase the memory and time in iteration of the BLUSGS method. +// CFLStart: Started cfl number. +// CFLEnd: End cfl number. +// CFLVaryStep: The number of step when cfl increase from CFLStart to CFLEnd. +// ktmax: Dtratio. dt[i] = MIN(dt[i], ktmax * dtmin / vol[i]) +// swapDq: Communication dq between forward/backward sweep of LUSGS or not, default is 0. +// nLUSGSSweeps: Sub iteration of LU-SGS or Block LU-SGS. +// LUSGSTolerance: Sub iter tolerance of LU-SGS or Block LU-SGS. +// ifLocalTimeStep: Time step method. +// 0 --Local. +// 1 --Global. +// visl_min: Minimum value of laminar viscosity coefficient. +// turbCFLScale: Turbulence model cfl number factor. +// codeOfAleModel: Arbitrary Lagrangian-Eulerian method. +// 0 -- no ALE method. +// 1 -- ALE method for non-moving grids. +// 2 -- ALE method for moving grids. +// 3 -- ALE method for deforming grids. +// wallFunctionType: The type of wall function to implement. +// 0 -- no wall function. (default) +// 1 -- standard wall function. +// 2 -- Pab3D wall function. +// RKStage: The number of Runge-Kutta step. +// lamda: Cofficient of Runge-Kutta step. + +int iunsteady = 0; +double physicalTimeStep = 0.01; +int ifStartFromSteadyResults = 0; +int ifStaticsFlowField = 0; +int ifStaticsReynoldsStress = 0; +int startStatisticStep = 800000; +double statisticalTimePeriod = -1.0; +int statisticMethod = 0; +int linearTwoStepMethods = 1; // 1--BDF1; 2--C-N; 3--BDF2; + +int methodOfDualTime = 3; +int min_sub_iter = 50; +int max_sub_iter = 50; +double tol_sub_iter = 0.01; + +int tscheme = 4; +int iSimplifyViscousTerm = 1; +int ifLocalTimeStep = 0; +double CFLStart = 0.01; +double CFLEnd = 10.0; +int CFLVaryStep = 500; + +double ktmax = 1.0e10; + +int swapDq = 1; + +int nLUSGSSweeps = 1; +double LUSGSTolerance = 0.01; +int order = 2; + +double visl_min = 0.01; +double turbCFLScale = 1.0; +double csrv = 2.0; +double timemax = 1.0e10; +double dtsave = -1.0; +int maxale = 10; +double dtau = 0.001; + +int wallFunctionType = 0; + +int RKStage = 2; +double lamda[] = 0.5, 1.0; + +//int RKStage = 1; +//double lamda[] = 1.0; + +//int RKStage = 4; +//double lamda[] = [0.25, 0.33333333333, 0.5, 1.0]; + +//----------------------------------------------------------------------- +# File In or Out # +//----------------------------------------------------------------------- +// numberOfGridGroups: The number of grid groups. +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the field results to visulization. +// walldistMethod: The method to compute wall distance. +// 0 -- accurate but not fast enough. +// 1 -- fast but not accurate enough. +// 2 -- super fast but more non-accurate! +// resSaveFile: The file path to save the residual convergence process, write data for every default (intervalStepRes) steps. +// turbresfile: The file path to save the residual convergence process of turbulence, write data for every default (intervalStepRes) steps. +// aircoeffile: The file path to save the aerodynamic force coefficients convergence process, write data for every default (intervalStepForce) steps. +// restartNSFile: The file path to write restart flowfield variables, write data for every default (intervalStepFlow) steps. +// turbfile: The file path to write restart flowfield variables of turbulence , write data for every default(intervalStepFlow) steps. +// visualfile: The visualization file path of flowfield , write data for every default (intervalStepPlot) steps. +// wall_aircoefile: The file path to save flowfield variables of wall, write data for every default steps. +// nDumpSurfaceInfo = 0 the "wall_varfile" write the informations including heat flux. +// nDumpSurfaceInfo = 1 the "wall_varfile" write the informations without heat flux. + +int numberOfGridGroups = 1; +string gridfile = "./grid/rae2822_hybrid2d__4.fts"; +string wallTemperaturefile= ""; + +int walldistMethod = 1; + +string resSaveFile = "results/res.dat"; +string turbresfile = "results/turbres.dat"; +string aircoeffile = "results/aircoef.dat"; + +string restartNSFile = "results/flow.dat"; +string turbfile = "results/turb.dat"; + +string visualfile = "results/tecflow.plt"; +string wall_aircoefile = "results/wall_aircoef.dat"; +string samplefile = "results/sample.dat"; + +int nDumpSurfaceInfo = 0; +string wall_varfile = ""; + +string jetDefineFile = "bin/jet.hypara"; + +string sixDofFileName = "results/sixDofInfo.dat"; +string derivativeFileName = "results/identify.dat"; +string hysteresisFileName = "results/force_beta.plt"; + +int plotFieldType = 0; + +// visualfileType: The file type of visualfile. +// 0 -- Tecplot binary. +// 1 -- Tecplot ASCII. + +int visualfileType = 1; + +// samplefileMode: The dump mode of sample file. +// 0 -- dump out every probe/line/surface data for all step intervals. +// 1 -- dump out all probe/line/surface data for every step intervals. +int samplefileMode = 0; + +// visualSlice: The slice of tecflow. +// 0 -- Do not save slice data. +// 1 -- comput and save it to sliceFile. +// sliceAxis: Normal vector of slice. +// 1 -- X_DIR. +// 2 -- Y_DIR. +// 3 -- Z_DIR. +// slicePostion: Coordinate of slice. + +int visualSlice = 0; +int sliceAxis = 1; +double slicePostion = -0.5; +string sliceFile = "results/Slice.plt"; +int dumpWallFaceCenter = 0; + +// min-max box of the visual block. +double lowerPlotFieldBox[] = [0.0 0.0 0.0]; +double upperPlotFieldBox[] = [1.0 1.0 1.0]; + +//-----------the optional parameters list for the flow field output---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40), +// -- gradientUx(41), gradientUy(42), gradientVx(43), gradientVy(44), iblank(81). +// -- specific heat ratio(gama, 56) +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. +//-----------the optional parameters list for the wall boundary condition---------------- +// nVisualWallVariables: The number of visual variables on wall. +// visualWallVariables : dumped variable types, listed as following: +// -coefficient of pressure(cp, 0), -coefficient of friction(cf, 1), yplus(2), -non-dimensional heat flux(Q_NonDim, 3), -dimensional heat flux(Q_Dim, 4), +// -pressure on wall(pw, 5), -temperature on wall(Tw, 6), -density on wall(rhow, 7), -heat flux of translational-rotational temperature term(Qtr, 8), +// -heat flux of species diffusion term(Qs, 9), -heat flux of vibrational temperature term(Qv, 10), -heat flux of electron temperature term(Qe, 11), +// -species mass fractions(Ns, 12), -x component of wall velocity(Vx, 13), -y component of wall velocity(Vy, 14), -z component of wall velocity(Vz, 15) +// -slip translational-rotational temperature(Tts, 16), -slip vibrational temperature(Tvs, 17), -slip electron temperature(Tes, 18), -absolute wall velocity(Vs, 19) +// -Stanton number(St, 20), -coefficient of heat rate(Ch, 21), -temperature jump(deltaT, 22), -transition gamaeff(gamaeff, 48), +// -transition intermittency(intermittency, 51), -transition momentum thickness reynolds(MomentumThicknessReynolds, 52), +// -overlap iblank(iblank, 81) + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +int nVisualWallVariables = 9; +int visualWallVariables[] = [0, 1, 2, 3, 4, 5, 9, 10, 11]; + +// dumpStandardModel: Dump many standard model data. +// 1 -- Turbulent flat plate. +int dumpStandardModel = 0; + +// ifSetDataMonitor: Whether to set the data monitor. +// 0 -- No. +// 1 -- Yes. +// dataMonitorType: The type of data Monitor. +// 0 -- Probes data monitor. +// 1 -- Lines data monitor. +// 2 -- Surfaces data monitor. +// probesDefineFile: Probes location information file. +// nLines: The number of lines need to be monitored. +// linesDefineFile: Lines location information file. +// nSurfaces: The number of surfaces need to be monitored. +// surfacesDefineFile: Surfaces location information file. +// searchCellsMethod: method to search the cell of each probe. +// 0 -- Nearest cell to the probe. +// 1 -- Real cell where the probe is located. +// nProbeVariables: Number of variables want to be dumped for probes monitered. +// probeVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5). +// Important Warning: Array size of probeVariables MUST be equal to nProbeVariables!!! +// probeVariables order must from small to big. +// probeVariablesInterpolationMethod: Interpolation method used to compute the probe variables. +// 0 -- Take the value of probe's cell as probe real value. +// 1 -- Interpolation from probe's and neighbouring cell to probe. +// 2 -- Interpolation from probe's cell nodes to probe. +int ifSetDataMonitor = 0; + +int dataMonitorType = 0; +string probesDefineFile = "bin/probes_XYZ.dat"; + +//int dataMonitorType = 1; +//int nLines = 1; +//string linesDefineFile = "bin/lines_XYZ.dat"; + +//int dataMonitorType = 2; +//int nSurfaces = 4; +//string surfacesDefineFile = "bin/surfaces_XYZ.dat"; + +int searchCellsMethod = 0; + +int nProbeVariables = 6; +int probeVariables[] = [0, 1, 2, 3, 4, 5]; +int probeVariablesInterpolationMethod = 0; +//----------------------------------------------------------------------- +# Turbulence Parameter # +//----------------------------------------------------------------------- +// turbInterval: Iteration number of turbulence. +// kindOfTurbSource: Kinds of turbulent source. +// 0 -- Original. +// 1 -- Edwards. +// 2 -- new. +// mod_turb_res: If modify the residuals for the cells next to the wall or not, default is 0. + +int turbInterval = 1; +int turbOrderStruct = 2; +int kindOfTurbSource = 0; +int mod_turb_res = 0; +double turb_relax = 1.0; +double freeStreamViscosity = 1.0e-3; +double muoo = 3.0; +double kwoo = 5.0; +int transitionType = 0; +double turbIntensity = -1.0; +int freeturbIntensitySRModify = 0; +double freeDecayXLocation = 0.0; +int compressibleCorrection = 0; +int transitionMaFix = 1; + +# maximum eddy viscosity (myt/my) max. +double eddyViscosityLimit = 1.0e10; +int monitor_vistmax = 0; + +//----------------------------------------------------------------------- +# LES Parameter # +//----------------------------------------------------------------------- +// iLES: Create LESSolver or not. +// == 1 - Create LESSolver; +// != 1 - not. +// amplitudeofDisturb: Amplitude of adding disturb. +// disturbstep: Unsteady time step or steady iteration of adding random disturb. +// iterdisturb: Add random disturb in every sub-iter or only first sub-iter. +// = 0 - in only first sub-iter; +// != 0 - in every sub-iter. +// ipraddisturb: Add density and pressure disturb or not. +// ibodyforce: Add body force in source flux of NS equations or not. +// = 0 - not; +// != 0 - Add body force. +// bodyforce: Body force in source flux of NS equations or not. +// utau: friction velocity, using in DNSDisturb. +// sgsmodel: subgrid scale model. +// = "smagorinsky"; +// = "dsmCom"; +// = "wale"; +// = "sigma". +// deltaFunctionType: = 1 - MAX(deltai, deltaj, deltak); +// = 2 - pow(deltai * deltaj *deltak, 1/3); +// = 3 - Devloped by Scotti. +// wallDampingFunctionType: = 0 - no wall function; +// = 1 - van Driest; +// = 2 - developed by Dr. Deng Xiaobing; +// = 3 - developed by Piomelli. +// turbViscousCutType: turbulent viscosity cut type. +// = 0 - mu_total = mut + mul; +// = 1 - mu_total = max(mut-mul,0)+ mul; +// = 2 - mu_total = max(mut ,0)+ mul. +// smagConstant: constant of smagorinsky model. +// waleConstant: constant of wale model. +// filterDirection[3]: filter variables in i, j, k direction or not. +// averageDirection[3]: average variables in i, j, k direction or not. +// isotropicConstant: constant of isotropic part of SGS stress. + +int iLES = 0; +string sgsmodel = "smagorinsky"; +int deltaFunctionType = 2; +int wallDampingFunctionType = 1; +int turbViscousCutType = 2; +double smagConstant = 0.1; +double isotropicConstant = 0.0; +double waleConstant = 0.6; +double sigmaConstant = 1.35; +int filterDirection[] = [1, 1, 0]; +int averageDirection[] = [0, 0, 0]; +double testFilterScale = 2.0; +int averageWidth = 1; +int monitorNegativeConstant = 0; + +//----------------------------------------------------------------------- +# Other Parameters for Hypersonic Non-equilibrium Gas # +//----------------------------------------------------------------------- +// dg_high_order: +// 0 -- generic order accuracy. +// 1 -- high order accuracy. +// iapplication: +// 0 -- gas model is fixed in the codes. +// 1 -- gas model is imported from library files. +// iCodeBranch: +// 0 -- The old code version is used for Navier-Stokes. +// 1 -- A new code version is active for Navier-Stokes solver. +// nm: Equation number of the physics, but is out of commision now. +// 4 -- for 2D. +// 5 -- for 3D. +// nGasModel: The type of gas. less than and equal to 1 represents the mixture gas. +// Otherwise, the pure gas with one component is used for perfect gas. +// 0 -- Earth gas. +// 1 -- Mars gas. +// 2 -- Argon. +// 3 -- Nitrogen. +// nEnergyRecycle: The type of EnergyModel Recycle. +// 0 -- not used . +// 1 -- used. +// nDensityModify: The type of densitymodify. + +// 0 -- not used. +// 1 -- used. +// nchem: +// 0 -- without chemical reaction flow. +// 1 -- the chemical reaction flow is considered. +// nEquilibriumGas: the variable is valid when the condition of nchem=0 is satisfied. +// 0 -- perfect gas. +// 5, 7, 11 -- equilibrium gas, meanwhile, its value denotes the number of gas component. +// nPCWCycleStep: the maximum step number of iteration in the module of computing species mass fractions with the partial catalytic wall(PCW) condition. +// the value equals to or is greater than 1, and 3 is for default value. +// nRETCycleStep: the maximum step number of iteration in the module of computing radiation equilibrium temperature on wall. +// the value equals to or is greater than 1, and 3 is for default value. +// nSLIPCycleStep:the maximum step number of iteration in the module of computing slip temperature, slip velocity and slip species mass fraction. +// the value equals to or is greater than 1, and 3 is for default value. +// nSlipBCModel : The computational model of slip boundary conditions. + +// 0 -- no slip. +// 1 -- the conventional Maxwell slip conditions. +// 2 -- the Gokcen slip conditions. +// 3 -- the Knudsen-layer correction of the standard slip conditions proposed by Lockerby, et al. +// 4 -- the Kogan simplified slip conditions. +// nMeanFreePathType : the method to the mean free-path for the slip conditions. For the mixture, 0 is suggested. +// 0 -- the equivalent mean free-path is calculated by the simple hard sphere model(HS). +// 1 -- calculated by the definition that includes the variables of the number density and the molecule diameter. +// 2 -- the equivalent mean free-path is calculated by the variable hard sphere model(VHS). +// nchemsrc: +// 0 -- the source terms are not computed. +// 1 -- the source terms are computed. +// nchemrad: +// 0 -- compute the spectrum radius without considering chemical reaction flow. +// 1 -- compute the spectrum radius that need to count the contribution from chemical reaction flow. +// ntmodel: The thermodynamic temperature model. +// 1 -- One-temperature model. +// 2 -- Two-temperature model. +// 3 -- Three-temperature model. +// nTEnergyModel: the method to computing temperature energy model. +// 0 -- the energy term is computed using the conventional method. +// 1 -- the energy term is computed using the curve fitting method. +// parkVDPower: the power of translational-rotational temperature in the Park V-D(vibration-dissociation) coupling model. +// The value is in range of [0.0, 1.0], DPLR suggests 0.5, LAURA suggests 0.7, while 0.6 is given as default value. +// catalyticCoef: +// 0.0 -- full non-catalytic wall boundary condition. +// 1.0 -- full catalytic wall boundary condition. +// in range of (0.0, 1.0) -- partial catalytic condition, the value indicates the catalytic coefficient. +// nIsSuperCatalytic : the super catalytic condition for the fully catalytic wall, and assigned with the value of 1. +// 0 -- equilibrium condition for the fully catalytic wall where the mass fractions are assigned with the values of the free stream. +// 1 -- super catalytic condition for the fully catalytic wall where all the atomic components combine into molecular components. +// nTemperatureJump : the method to calculate the temperature jump. +// 0 -- calculated by the variables of heat conductivity and constant volume specific heat for each energy mode. +// 1 -- the general method where the iteration is calculated with the translation-rotation temperature. +// sigmaVelocity: the coordination coefficient of tangential momentum for computation of slip velocity. The value is in range of (0.0, 2.0]. +// sigmaTemperature: the heat coordination coefficient for computation of slip temperature. The value is in range of (0.0, 2.0]. +// sigmaMassFraction: the species coordination coefficient for computation of slip mass fractions. The value is in range of (0.0, 2.0]. +// velocitySlipCorrectConstant: the correction constant to the velocity slip condition. For the diffuse reflection, 1.0 is used. +// 1.0 -- proposed by Maxwell. +// sqrt(2/PI)~0.8 -- used for "micro-slip", namely the actual velocity slip at the wall. +// 1.146 -- proposed for an additional "fictitious" velocity slip. + +// chemicalRelaxCorf: The value is in range of [0.001, 1.0]. +// chemicalSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// viscousSpectrumRadiusCoef : The value is in range of [1.0, 3.0]. +// inviscidSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// staticPressureRelaxCorf: The value is in range of [0.1, 1.0]. +// nIsChemicalFreeze : the flag to freeze the chemical reactions. +// 0 -- not freeze, the chemical reaction sources will be calculated. +// 1 -- freezes the chemical reactions, the chemical reaction sources will not be calculated.// veTemperatureMin: The minimum of Tv and Te +// nDebug: cout the Wrong place and abort +// 0 -- not used. +// 1 -- used. +// nSpeciesLimit: limitter of gas species +// 0 -- not used. +// 1 -- used. +// nTurblenceForChemical: the coupled mode of Turblence and Chemical reaction +// 0 -- method 0. +// 1 -- method 1. +// nViscosityFluxSublevelModified: Modified for ViscosityFlux on Sublevel grid +// 0 -- not used. +// 1 -- used. +// nChemcalSourceModified: Modified on ChemcalSource +// 0 -- not used. +// 1 -- used. +// nAblation: +// 0 -- The wall ablation is not computed. +// 1 -- The wall ablation is computed. +// isInjection: +// 0 -- The injection velocity of ablation wall is not computed. +// 1 -- The injection velocity of ablation wall is computed. +// nViscosityModel: + +// 0 -- Blottner fitting method. +// 1 -- Gupta fitting method. +// nSutherland: +// 0 -- stands for selecting the Blotter curve fits mode. +// 1 -- stands for Sutherland relation. +// gasfile: Indicates the gas model, 9 models are provided, namely "Gu5", "Gu7", "Gu11", "Pa5", "Pa7", "Pa11", "DK5", "DK7", "DK11". +// "Gu" -- indicates the Gupta Model, three-Type Models are embeded in the library, namely, the 5-species-6-reactions, the 7-species-9-reactions, the 11-species-20-reactions. +// "Pa" -- indicates the Park Model, three-Type Models are embeded in the library, namely, the 5-species-17-reactions, the 7-species-22-reactions, the 11-species-48-reactions. +// "DK" -- indicates the Dunn-Kang Model, three-Type Models are embeded in the library, namely, the 5-species-11-reactions, the 7-species-15-reactions, the 11-species-26-reactions. +// "Mars-Pa8" is for Park model of Mars gas, "Mars-Mc8" for McKenzie model of Mars gas. +// "Combustion-12" -- indicates the Combustion Chamber Gas Model which includes 12-species-20-reactions. +// "Gas-Mixture" -- indicates the process of mixing two species without reacting. +// For self-definition model, the gasfile is used to indicate the file path of the new gas model. +// speciesName: Used to list the names of each species, while each species name is separated by the symbol of comma. +// initMassFraction: Used to list the initial mass fractions of species in accordance with the sequence of names in the parameter speciesName. +// ifStartFromPerfectGasResults: The chemical reaction simulation is start from perfect gas flowfield or not, 0 is for no and else is for yes. + +int dg_high_order = 0; +int iapplication = 0; +int iCodeBranch = 0; +int nm = 5; +int nEquilibriumGas = 0; +int nPCWCycleStep = 3; +int nRETCycleStep = 3; +int nSLIPCycleStep= 3; + +double refGama = 1.4; +double prl = 0.72; +double prt = 0.90; +double sc_l = 0.5; +double sc_t = 0.5; + +int nGasModel = 0; +int nchem = 0; +int nchemsrc = 1; +int nchemrad = 1; +int ntmodel = 1; + +int nEnergyRecycle = 0; +int nSlipBCModel = 0; +int nDensityModify = 1; +int nTEnergyModel = 0; +int nMeanFreePathType = 0; +int nIsChemicalFreeze = 0; +int nIsSuperCatalytic = 1; +int nTemperatureJump = 0; + +double parkVDPower = 0.6; +double catalyticCoef = 0.0; +double sigmaVelocity = 1.0; +double sigmaTemperature = 1.0; +double sigmaMassFraction = 1.0; +double velocitySlipCorrectConstant = 1.0; + +double chemicalRelaxCorf = 1.0; +double chemicalSpectrumRadiusCoef = 1.0; +double viscousSpectrumRadiusCoef = 1.0; +double inviscidSpectrumRadiusCoef = 1.0; +double staticPressureRelaxCorf = 1.0; + +double veTemperatureMin = 30.0; +int nDebug = 0; +int nSpeciesLimit = 0; +int nTurblenceForChemical = 0; +int nViscosityFluxSublevelModified = 0 ; +int nChemcalSourceModified = 0; + +int nAblation = 0; +int isInjection = 0; +int nViscosityModel = 0; +int nMarsModel = 0; +string gasfile = "DK5"; +//string gasfile = "./chemical/Dunn-Kang_air5s11r.dat"; +string speciesName = "O, O2, NO, N, N2"; +string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.767"; + +//string speciesName = "O, O2, NO, N, NO+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string speciesName = "O, O2, NO, N, O+, O2+, NO+, N+, N2+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Mars-Pa8"; +//string speciesName = "O, O2, NO, N, N2, C, CO, CO2"; +//string initMassFraction = "0.0015, 0.0429, 0.0, 0.0, 0.0, 0.0, 0.0777, 0.8779"; + +//string gasfile = "DK7"; +//string speciesName = "O, O2, NO, N, NO+, C, C2, CO, CO2, CN, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Combustion-12"; +//string speciesName = "O, O2, NO, N, C, CO, CO2, H, H2, OH, H2O, N2"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767"; + +//string gasfile = "Gas-Mixture"; +//string speciesName ="SpeciesA, SpeciesB"; +//string initMassFraction = "1.0, 0.0"; +int nSutherland = 0; +double gamaSpeciesA = 1.4; +double gamaSpeciesB = 1.3; +double molecularWeightSpeciesA = 29.0; +double molecularWeightSpeciesB = 30.0; + +int nChemicalFlowStep = 0; +int ifStartFromPerfectGasResults = 0; + +######################################################################### +// Multi-Grid parameters. +// nMGLevel: The number of level of Multi-Grid. +// <= 1 -- Single-level. +// > 1 -- multi-level. +// MGPreIteration: For each grid, the number of pre-smoothing steps. +// n_post: For each grid, the number of post-smoothing steps. +// MGCoarsestIteration: For the coarest grid the number of smoothing steps. +// MGFasType: V-multi cycle or W-multi cycle. +// 1 -- V-multi cycle. +// 2 -- W-multi cycle. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. +// mgCFLScale: CFL number enlarge times for coarse grid. +// mprol: Multi-grid interpolation method, interpolation from coarse cell to fine grid. +// 1 -- zero order. +// 2 -- first-order. (default) +// mgCorrectionLimit: Multi-grid correction limit. + +int nMGLevel = 1; +int MGCoarsestIteration = 1; +int MGPreIteration = 1; +int MGFasType = 1; +int n_post = 0; +int flowInitStep = 100; +int mprol = 2; +double mgCFLScale = 1.0; +double mgCorrectionLimit = 0.01; + +//--------------- Some parameter for turbulent model -------------------- +// neasm: The variation of kw turbulent model. +// ismooth_turb: Residual smooth for turb or not. +// SSTProductType: The type of product term based on vorticity for SST. +// SAProductType: The type of product term based on vorticity for SA. +int neasm = -3; +int SSTProductType = 0; +int ismooth_turb = 0; +int SAProductType = 2; + +// ----------------- Overset Grid parameter ----------------------------- +int codeOfDigHoles = 1; +int codeOfTurbulentModel = 0; +string masterFileName = "./grid/searchFile.inp"; +string holeBasicFileName = "./grid/holeBasicFile.inp"; +string holeFullFileName = "./grid/holeFullFile.dat"; +string linkFileName = "./grid/topology.dat"; +string zoneInverseFileName = "./grid/zoneInverseMapping.inp"; + +######################################################################### +# High Order Struct Solver # +######################################################################### +// isFVMOrFDM: +// 0 -- NSSolverStruct using Finite Volume Method. +// 1 -- NSSolverStruct using Finite Differ Method. +// SolverStructOrder: Spatial discretisation order of NS equations with struct grid. +// <= 2 -- finite volume method. +// >= 3 -- finite difference order. (to be completed) +// 0 -- default. +// str_highorder_interpolation_epsilon: Epsilon in weighted interpolation, bigger epsilon, better convergence, +// smaller epsilon, robuster for shock-detecting. +// str_highorder_interpolation_type: +// -- "classical", "test". +// str_highorder_flux_name: +// -- "roe", "steger". +// structhighordergradient: +// -- "conservation", "chain_rule". +int isFVMOrFDM = 0; +string str_highorder_solver = "WCNS"; +int SolverStructOrder = 0; +double str_highorder_interpolation_epsilon = 1.0e-6; +string str_highorder_interpolation_type = "test"; +string str_highorder_flux_name = "steger"; +string structhighordergradient = "conservation"; +double coefofstrflux = 0.5; +double limitcoefofinterface = 0.0; + +// ----------------- Advanced choices ----------------------------------- +// outtimesc: Time stepping scheme for the outer loop. +// MUSCLCoefXk: The parameter of MUSCL interpolations, belongs to [-1, 1]. +// -1 -- seconde-order fully-upwind differencing. +// 0 -- seconde-order upwind-biased differencing. +// 0.333333 -- third-order upwind-biased differencing. +// 1 -- seconde-order central differencing. +// MUSCLCoefXb: The limiter parameter. +// 0 -- the effect of the limiter is cancelled, means the first-order interpolations. +// allReduceStep: Iteration intervals for MPI AllReduce operation, default is 1. +string outtimesc = "impbd2"; +double MUSCLCoefXk = -1; +double MUSCLCoefXb = 1.0; +int allReduceStep = 1; + +// ----------------- overlap configuration ------------------------------ +// codeOfOversetGrid: Overlapping(overset) grid or not. +// 0 -- NON-overlapping grid. +// 1 -- Overlapping grid. +// oversetInterpolationMethod: the method of overset interpolation while field simulation +// 0 -- set the acceptor cell value by donor cell value. +// 1 -- set the acceptor cell value by distance weight of donor cell value. + +int codeOfOversetGrid = 0; +int oversetInterpolationMethod = 0; +int readOversetFileOrNot = 0; +int symetryOrNot = 0; +int readInAuxiliaryInnerGrid = 1; +int readInAuxiliaryOuterGrid = 0; +int readInSklFileOrNot = 0; +string auxiliaryInnerGrid0 = "./grid/aux-upper.fts"; +string auxiliaryInnerGrid1 = "./grid/aux-lower.fts"; +string auxiliaryInnerGrid2 = ""; +string oversetGridFileName = "./grid/iblank.ovs"; +double walldistMainZone = 1.0 +double toleranceForOversetSearch = 1.0e-3; +double toleranceForOversetBox = 1.0e-3; +int twoOrderInterpolationOrNot = 0; +int keyEnlargeOfActiveNodes = 0; +int outTecplotOverset = 0; + +int numberOfMovingBodies = 2; + +// ----------------- ALE configuration ------------------------------ +int codeOfAleModel = 1; +int aleStartStrategy = -1; + +int strategyForFaceNormalVelocity = 0; //0-By Sweeping volume; 1-By face center 1st; 2-By face center 2nd; +int strategyForGCLSource = 0; //0-present; 1-Ahn; + +//0:1st-Admas-Bashforth; 1:2nd-Admas-Bashforth; 2:1st-Implicit-Euler; 3:2nd-Implicit Euler; 4:2nd-Adams-Moulton; 5:3rd-Adams-Moulton +int methodForKineticEquation = 0; +double relaxParameterOfKinetic = 1.0; + +######################################################################### +# motive information # +######################################################################### +int numberOfMovingBodies = 1; + +############################## body0 ############################## +//mass of parts +double mass_0 = 1.0; +//mass matrix of parts Ixx Iyy Izz Ixy Ixz Iyz +double massMatrix_0[] = 1e-7, 1e-6, 1e-6, 0.0, 0.0, 0.0; +//initial six DOF position information of parts. xc yc zc +double massCenter_0[] = 0.0 , 0.0, 0.0; +//initial six DOF position information of parts. angleX angleY angleZ +double attitudeAngle_0[] = 0.0 , 0.0, 0.0; +//initial six DOF move information of parts. vc vy vz +double massCenterVelocity_0[] = 0.0, 0.0, 0.0; +//initial six DOF move information of parts. omigX omigY omigZ +double angularVelocity_0[] = 0.0, 0.0, 0.0; +//the object that the parts belong to. +int fartherIndex_0 = -1; +//the assembly position of the parts. xc yc zc angleX angleY angleZ +double configPamameter_0[] = 0.0 ,0.0 ,0.0 ,0.0 ,0.0 ,0.0; +//the move pattern of the parts. +// -1 given motion partten. +// 0 still. +// 1 six DOF motion. +// 2 three DOF motion. +// 11 X-axis forced motion. +// 12 Y-axis forced motion. +// 13 Z-axis forced motion. +// 14 forced pitch motion. +// 15 forced yaw motion. +// 16 forced roll motion. +int RBDMethod_0 = 0; +double amplitude_0 = 0.0; +double reduceFrequency_0 = 0.0; +//string uDFSixDofFileName_0 = "./Bin/UDFSixDof.Parameter"; +//additional force (system axis) fX fY fZ +double addedForce_0[] = 0.0 ,0.0 ,0.0 ; +//additional moment of Force (system axis) mX mY mZ +double addedMoment_0[] = 0.0 ,0.0 ,0.0 ; +//the deformation method of the parts. +int morphing_0 = 0; + +// post indentify +int integralOrder = 4; + + +// ---------------- ATP read -------------------------------------------- +//@int inflowParaType = 0; +//@double refReNumber = 6.5e6; +//@double refDimensionalTemperature = 288.15; +//@double freestream_vibration_temperature = 300.00; +//@double refDimensionalPressure = 0; +//@double height = 0; +//@int nsubsonicInlet = 0; +//@int nsubsonicOutlet = 0; +//@string inLetFileName = "./bin/subsonicInlet.hypara"; +//@string outLetFileName = "./bin/subsonicOutlet.hypara"; +//@double refDimensionalVelocity = 0; +//@double refDimensionalDensity = 0; + +######################################################################### +# Old Parameter # +######################################################################### +int isPlotVolumeField = 0; + diff --git a/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/cfd_para_supersonic.hypara b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/cfd_para_supersonic.hypara new file mode 100644 index 0000000..bff0440 --- /dev/null +++ b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/cfd_para_supersonic.hypara @@ -0,0 +1,190 @@ +######################################################################### +# General Control Parameter # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual 'res.dat' saved. + +int maxSimuStep = 10000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; + +######################################################################### +# Inflow Parameter # +######################################################################### +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceRefenenceLength, forceRefenenceLengthSpanWise, forceRefenenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. + +double refMachNumber = 2.00; +double attackd = 0.00; +double angleSlide = 0.00; + +double wallTemperature = -1.0; + +int inflowParaType = 0; +double refReNumber = 2.96e5; +double refDimensionalTemperature = 117; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +double gridScaleFactor = 1.0; + +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. + +######################################################################### +# Physical models # +######################################################################### +// viscousType : Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "1eq-sa", when viscousType = 3. +// -- "2eq-kw-menter-sst", when viscousType = 4. +// DESType: Type of DES. +// 0 -- RANS.(default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. + +//int viscousType = 0; +//string viscousName = "Euler"; + +int viscousType = 1; +string viscousName = "laminar"; + +//int viscousType = 3; +//string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +int roeEntropyFixMethod = 2; +double roeEntropyScale = 1.0; +######################################################################### +# Spatial Discretisation # +######################################################################### +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "ausmpw". +// str_limiter_name: Limiter of struct grid. +// -- "minmod", "3rd_minmod_smooth". + +string inviscidSchemeName = "roe"; +string str_limiter_name = "minvan"; + +#******************************************************************* +# UnStruct Solver * +#******************************************************************* +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpwplus". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "vencat", "barth". +// -- "1st", meaning accuracy of first-order. +// -- "nolim", no limiter. +// venkatCoeff: Coefficient of vencat limiter, when uns_limiter_name = 'vencat'. +// The smaller the value, the more robust it is. + +string uns_scheme_name = "vanleer"; +string uns_limiter_name = "vencat"; +double venkatCoeff = 0.5; + +######################################################################### +# Temporal Discretisation # +######################################################################### +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// CFLEnd: The CFL number, [0.1, 100]. +// The bigger the value, the convergence faster but lower robustness. +// ktmax: The lower the value, the more robustness, 1.0e5 - 1.0e10. + +int iunsteady = 0; + +double CFLEnd = 30.0; + +double ktmax = 1.0e10; + +######################################################################### +# File In or Out # +######################################################################### +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// Please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the whole field results to tecplot or not, 0 / 1. + +string gridfile = "./grid/3D_plate_UDB_str.fts"; +int plotFieldType = 0; + +// ----------------- Advanced Parameters, DO NOT care it ---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables: Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21). +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. + +int reconmeth = 0; +int limitVariables = 0; +int limitVector = 1; diff --git a/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/grid_para.hypara b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/grid_para.hypara new file mode 100644 index 0000000..136f90a --- /dev/null +++ b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/grid_para.hypara @@ -0,0 +1,30 @@ +######################################################################### +# Grid data type # +######################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +// from_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +int gridtype = 1; +int axisup = 1; +int from_gtype = 2; + +######################################################################### +# File path # +######################################################################### +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +string from_gfile = "./grid/3D_plate_UDB_str.cgns"; +string out_gfile = "./grid/3D_plate_UDB_str.fts"; diff --git a/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/key.hypara b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/key.hypara new file mode 100644 index 0000000..004f7fa --- /dev/null +++ b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/key.hypara @@ -0,0 +1,54 @@ +string title = "PHengLEI Main Parameter Control File"; + +// IMPORTANT NOTICE: DON NOT MODIFY THE FOWLLOWING LINE. +string defaultParaFile = "./bin/cfd_para.hypara"; + +// ndim: Dimensional of the grid, 2 or 3. +// nparafile: the number of parameter files. +// nsimutask: simulation task type. +// 0 -- CFD Solver of NS or Turbulation. +// 1 -- Grid generation: for special typical cases, such as cylinder, flat plate, etc. +// Grid conversion: from other format to PHengLEI format (.fts). +// Grid reconstruction: such as grid adaptation. +// Grid merging: merge two blocks into one block. +// Grid repairing: repair the original grid in order to remove the negative volume cells. +// 2 -- Wall distance computation for turb-solver. +// 3 -- Grid partition. +// 4 -- Knowledge repository / examples of PHengLEI-API. +int ndim = 3; +int nparafile = 1; + +int nsimutask = 0; +//string parafilename = "./bin/cfd_para_subsonic.hypara"; +//string parafilename = "./bin/cfd_para_transonic.hypara"; +string parafilename = "./bin/cfd_para_supersonic.hypara"; +//string parafilename = "./bin/cfd_para_hypersonic.hypara"; +//string parafilename = "./bin/incompressible.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_para.hypara"; + +//int nsimutask = 2; +//string parafilename = "./bin/cfd_para.hypara"; + +//int nsimutask = 3; +//string parafilename = "./bin/partition.hypara"; + +//int nsimutask = 4; +//string parafilename = "./bin/repository.hypara"; + +//int nsimutask = 5; +//string parafilename = "./bin/overset_grid_view.hypara"; + +//int nsimutask = 14; +//string parafilename = "./bin/integrative_solver.hypara"; + +//int nsimutask = 99; +//string parafilename = "./bin/post_processing.hypara"; + +// ---------------- Advanced Parameters, DO NOT care it ---------------- +int iovrlap = 0; +int numberOfGridProcessor = 0; +// ATP read +//@string parafilename1 = "" +//@string parafilename2 = ""; diff --git a/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/partition.hypara b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/partition.hypara new file mode 100644 index 0000000..141bd80 --- /dev/null +++ b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/bin/partition.hypara @@ -0,0 +1,21 @@ +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// maxproc: The number of partition zones that want to be divided into, +// which is equal to the number of CPU processors you want. +// Usually, 50~100 thousands structured cells per CPU-Core is suggested. +// 30~70 thousands unstructured cells per CPU-Core is suggested. +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). + +int pgridtype = 0; +int maxproc = 1; + +string original_grid_file = "./grid/3D_plate_UDB_str.fts"; +string partition_grid_file = "./grid/3D_plate_UDB_str.fts"; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level,..., et al. +int numberOfMultigrid = 1; diff --git a/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/grid/3D_plate_UDB_str.cgns b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/grid/3D_plate_UDB_str.cgns new file mode 100644 index 0000000..7285e6e Binary files /dev/null and b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/grid/3D_plate_UDB_str.cgns differ diff --git a/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/涓夌淮缁撴瀯婵娉㈠共鎵拌秴澹伴熷眰娴佸钩鏉縚绠椾緥璇存槑鏂囨。.pdf b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/涓夌淮缁撴瀯婵娉㈠共鎵拌秴澹伴熷眰娴佸钩鏉縚绠椾緥璇存槑鏂囨。.pdf new file mode 100644 index 0000000..2df6e21 Binary files /dev/null and b/A21-ThreeD_ShockwaveInteractionPlate_Ma2_Laminar_UDB_Struct_1CPU/涓夌淮缁撴瀯婵娉㈠共鎵拌秴澹伴熷眰娴佸钩鏉縚绠椾緥璇存槑鏂囨。.pdf differ diff --git a/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/cfd_para.hypara b/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/cfd_para.hypara new file mode 100644 index 0000000..b17970c --- /dev/null +++ b/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/cfd_para.hypara @@ -0,0 +1,1220 @@ +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +// PPPPP H H EEEEE N N GGGGG L EEEEE III + +// P P H H E NN N G L E I + +// PPPPP HHHHH EEEEE N N N G GG L EEEEE I + +// P H H E N N N G G L E I + +// P H H EEEEE N N GGGGG LLLLL EEEEE III + +//------------------------------------------------------------------------+ +// Platform for Hybrid Engineering Simulation of Flows + +// China Aerodynamics Research and Development Center + +// (C) Copyright, Since 2010 + +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +########################################################################### +# Default parameters for Grid conversion # +########################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// 2 -- Hybrid grid, include both of unstructured and structured grid. +// gridobj: Task type of grid treatment. +// 0 -- Grid generation of typical case, such as cylinder, flat plate, etc. +// 1 -- Grid conversion, from other grid data to PHenglEI, such as Fluent, CGNS. +// 2 -- Grid refinement. +// 3 -- Grid merging, merge two blocks into one block. +// 4 -- Grid deformation, achieve unstructured grid deformation. +// 5 -- Grid repairing, repair the original grid in order to remove the negative volume cells. +// 6 -- Grid mirroring, mirror a symmetry grid to whole grid. +// multiblock: Multi-block grid or not, only for structured grid conversion. +// 0 -- Not. +// 1 -- Yes. +// iadapt: Adaptation number for unstructure grid. +// SymmetryFaceVector: The vector of symmetry face. +// 0 -- X axis. +// 1 -- Y axis. +// 2 -- Z axis. +int gridtype = 0; +int gridobj = 1; +int multiblock = 0; +int iadapt = 0; +int SymmetryFaceVector = 1; + +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +int axisup = 1; + +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +int omit_no_bound_bc = 0; + +//----------------------------------------------------------------------- +# Grid data type # +//----------------------------------------------------------------------- +// from_gtype/to_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +// dumpOldGrid: If dump out the old grid file. +// 0 -- Not. (default) +// 1 -- Yes. +int from_gtype = 2; +int to_gtype = 1; +int dumpOldGrid = 0; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +int numberOfGridFile = 1; +string from_gfile = "./grid/rae2822_hybrid2d.cas"; +string from_gfile1= ""; + +string out_gfile = "./grid/flat_laminr_133_85_2d.fts"; + +// ----------------- some advanced choices ------------------------------ +// iunsteady: The Grid is for unsteady simulation or not. +int iunsteady = 0; +int codeOfAleModel = 0; + +// fileformat: Ustar Grid file format. +// 0 -- BINARY. +// 1 -- ASCII. +int fileformat = 0; + +// Parameters for hybrid solver. +// mixgrid_uns: path of unstructure grid file for hybrid solver, *.fts type. +// mixgrid_str: path of structure grid file for hybrid solver, *.fts type. +string mixgrid_uns = "./grid/rae2822_uns2d_4.fts"; +string mixgrid_str = "./grid/flat_laminr_133_85_2d.fts"; + +// Some parameters for structured overlapping grid. +int codeOfDigHoles = 1; +string holeBasicFileName = "./oversetGridView/holeBasicFile.inp"; +string holeFullFileName = "./oversetGridView/holeFullFile.dat"; +string linkFileName = "./oversetGridView/topology.dat"; +string zoneInverseFileName = "./oversetGridView/zoneInverseMapping.inp"; + +// ----------------- Adaptive Mesh Refine ------------------------------- +// In this file, the original_grid_file is used of the partition part. +// If use it dependently, abstract it here. +string adapt_grid_file = "./grid/sphere_mixed_adapt1.fts"; +string geometryFileName = "./grid/jsm.igs"; + +// geometryUnit: Geometry unit. +// 1 -- meter. +// 2 -- millimeter. +// 3 -- inch. +// exclusiveCase: Parallel projection exclusive case. +// 0 -- NON case. +// 1 -- JSM-C2-NPOFF case. +// 2 -- CHNT. +// projectOrgPoint: If the original wall points need to be projected or not. +int geometryUnit = 1; +int anisoRefine = 0; +int isProject = 0; +int readDist = 0; +int isDeform = 0; +int exclusiveCase = 0; // 0: NON case; 1: JSM-C2-NPOFF case; 2: CHNT. +int projectOrgPoint = 0; // if project original wall points. + + +// ----------------- Grid Deform Parameters ----------------------------- +// deformationMethod: Grid Deform. +// 1 -- SPRING. +// 2 -- RBF. +// stationalGridFile: Original grid file. +// visualFileName : The visualization file path of deform grid. +// nDeformStep : The max deform step. +// flapAngle : The max flap angle. +// rotatePostionZ : Rotate postion. +// rotatePostionY : Rotate postion. +// gridSlice : If dump slice grid. +// sliceAxis : Grid slice axis. +// slicePosition : Grid slice position. +int nDeformStep = 40; +double flapAngle = 10.0; +double rotatePostionZ = 4.00003; +double rotatePostionY = 3.05; + +int deformationMethod = 2; +string stationalGridFile = "./grid/Segment2Brid.fts"; +string visualFileName = "./results/deformedGrid.dat" + +int gridSlice = 1; +int sliceAxis = 1; +double slicePosition = 13; + +// ----------------- RBF Parameters ------------------------------------- +// numberOfReferenceCP : Number of reference Control Points. +// influencePara : The RBF influence radius parameter. +int numberOfReferenceCP = 40; +double influencePara = 25.0; + +// ----------------- Periodic Parameters -------------------------------- +// Notice: Rotational periodicity only support rotation along the X axis! +// periodicType: Which periodic boundary is used. +// 0 -- without Periodic Boundary. +// 1 -- Translational periodicity. +// 2 -- Rotational periodicity. +// translationLength[]: The relative distance between two periodic face + which only support one direction. +// rotationAngle: The relative angle between two periodic face. + which is recorded in degrees. + +int periodicType = 0; +double translationLength[] = [0.0,0.0,0.0]; +double rotationAngle = 0.0; + +######################################################################### +# Default parameters for Partition # +######################################################################### +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// 2 -- refine structured grid. +// maxproc: The number of partition zones that want to be divided into. +int pgridtype = 0; +int maxproc = 4; + +// traceMark: Trace mark or not, only for structured grid partition. +// 0 -- Not. +// 1 -- Yes. +// blockIndexOfMark: the block index of mark, only for structured grid partition. +// cellIndexOfMark: the cell index of mark, only for structured grid partition. +int traceMark = 0; +int blockIndexOfMark = 0; +int cellIndexOfMark[] = [185,30,1]; + +// parallel Strategy: +//! -# 0 : each zone is assigned to the one that defined in grid partition procedure. +//! -# 1 : random assigned for each zone or by some else ways. +int parallelStrategy = 1; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). +string original_grid_file = "./grid/sphere_mixed.fts"; +string partition_grid_file = "./grid/sphere_mixed__4.fts"; + +// ------------------ Sompe advanced parameters ------------------------- +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +// npartmethod: Method of interface reconstruction, default is 1. +// parallelPartitionMethod: Method of parallel partition, this is set only when execute parallel partition. It would be skipped when serial partition. +// 1 -- Using ParMetis for homogeneous MPI. +// 2 -- Using Metis for homogeneous MPI. +// 3 -- using METIS partition for homogeneous OpenMP. +// parmetisBalance: Used to specify the imbalance tolerance. +// 1 -- perfect balance. +// maxproc -- perfect imbalance. +// 1.05 -- recommended. + +int omit_no_bound_bc = 0; +int npartmethod = 1; +int parallelPartitionMethod = 2; +double parmetisBalance = 1.05; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level, ..., et al. +int numberOfMultigrid = 1; + +######################################################################### +# Default parameters for CFD simulation # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepSample: The step intervals for monitored probes variables file 'sample.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual file 'res.dat' saved. +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) + +int maxSimuStep = 20000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepSample = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; +int ifLowSpeedPrecon = 0; + +// compressible: +// 0 -- incompressible flow. +// 1 -- compressible flow. (default) +int compressible = 1; + +//----------------------------------------------------------------------- +# CFD Control Parameter # +//----------------------------------------------------------------------- +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// 4 -- the condition that the velocity, temperature and density are given. +// 5 -- the condition that the velocity, temperature and pressure are given. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. +// radiationCoef: The radiation coefficient on wall, it is used to compute the radiation heat flux on wall when the boundary +// condition is radiation equilibrium temperature, and 0.8 is the default value. +// refMolecularWeight : the reference molecular weight of gas used for perfect gas. The unit is g/mol. +// Generally, the gas is air. Sometimes, it is experiment gas, such as Nitrogen, Argon, and so on. + +double refMachNumber = 0.73; +double attackd = 2.79; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 6.5e6; +double refDimensionalTemperature = 288.15; +double freestream_vibration_temperature = 300.00; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +//int inflowParaType = 3; +//int nsubsonicInlet = 1; +//int nsubsonicOutlet = 1; +//string inLetFileName = "./bin/subsonicInlet.hypara"; +//string outLetFileName = "./bin/subsonicOutlet.hypara"; +//double refDimensionalTemperature = 288.144; +//double refDimensionalPressure = 1.01313E05; + +//The velocity, temperature and density are fixed. +//int inflowParaType = 4; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalDensity = 1.0e3; + +//The velocity, temperature and pressure are fixed. +//int inflowParaType = 5; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalPressure = 1.0e5; + +//The MachNumber, temperature and pressure are fixed. +//int inflowParaType = 6; +//double refDimensionalTemperature = 293; +//double refDimensionalPressure = 8886.06; + +double wallTemperature = -1.0; + +double radiationCoef = 0.8; +double gridScaleFactor = 1.0; + +int numberOfAerodynamicForceComponents = 1; +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. +double refMolecularWeight = 28.9644; // unit of g/mol. + +//----------------------------------------------------------------------- +# Spatial Discretisation # +//----------------------------------------------------------------------- +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "hlle", "lax_f". +// -- "roe", "modified_roe". +// -- "ausm+", "ausm+w", "ausm+up", "ausmdv", "ausmpw", "ausmpw+". +// str_limiter_name: Limiter of struct grid. +// -- "vanalbada", "vanleer", "minmod", "smooth", "minvan", "3rdsmooth", "3rd_minmod_smooth". +// -- "nolim", no limiter. +// -- "vanalbada_clz", clz supersonic version. +string inviscidSchemeName = "roe"; +string str_limiter_name = "vanalbada"; + +#******************************************************************* +# UnStruct Solver or Common * +#******************************************************************* +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 2 -- Algebraic. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "0eq-bl". +// -- "1eq-sa". +// -- "2eq-kw-menter-sst". +// -- "2eq-kw-menter-bsl". +// -- "2eq-kw-wilcox-1988". +// -- "2eq-kw-wilcox-1998". +// -- "2eq-kw-kok-tnt". +// -- "2eq-kw-wilcox-2006". +// -- "easm-kw-2003". +// -- "easm-kw-2005". +// DESType: Type of DES. +// 0 -- RANS. (default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpw+". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "barth", "vencat", "vanleer", "minmod". +// -- "vanalbada", "smooth", "nnd", "lpz", "1st". +// -- "nolim", no limiter. +// uns_vis_name: Discretisation method of viscous term. +// -- "std", "test", "aver", "new1", "new2". +// gradientName: Gradient reconstruction method. +// -- "default", "ggcell", "ggnode", "lsq". +// ivencat: Variation of vencat limiter. +// 0 -- org method, it is independent of grid scale. +// 1 -- new method, it is dependent of grid scale. +// 4 -- Ustar limiter model, without grid size unitary. +// 7 -- default used. +// venkatCoeff: Cofficient of vencat, when using vencat limter. +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. +// skewnessAngle: The skewness angle of grid cells. +// roeEntropyFixMethod: Entropy fix (correction) method. +// 1 -- direct fix, which limits the minimum eigenvalue directly. +// 2 -- multi-dimensional fix, which is derived from structured solver and now is only valid for struct solver. +// 3 -- Harten type, which is default used. +// roeEntropyScale: Entropy fix (correction) coefficient scale, default is 1.0. +// It is used to scale the default Roe entropy fix coefficients. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +string uns_scheme_name = "roe"; +string uns_limiter_name = "vencat"; +string uns_vis_name = "test"; +string gradientName = "ggnode"; + +int ivencat = 7; +double venkatCoeff = 5.0; +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; +double skewnessAngle = 60.0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; + +//----------------------------------------------------------------------- +# Temporal Discretisation # +//----------------------------------------------------------------------- +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// physicalTimeStep: The nondimensional physical time step. +// ifStartFromSteadyResults: The unsteady simulation is start from steady flowfield or not, 0 is for no and else is for yes. +// ifStaticsFlowField: Statistical variables for unsteady simulation. +// ifStaticsReynoldsStress: Statistical Reynolds stress for unsteady simulation. +// startStatisticStep: Outer step when start statistics. +// when the value is larger than "maxSimuStep", it is useless. +// statisticalTimePeriod: Used as time period of statistic analysis. +// when the value is negative, time period is treated as infinite. +// statisticMethod: Statistic reynolds stress method. + 0 --tau = - ^2 + 1 --tau = +// min_sub_iter: The min sub iteration of unsteady simulation. +// max_sub_iter: The max sub iteration of unsteady simulation. +// tol_sub_iter: The tolerance of sub iteration of unsteady simulation. +// tscheme: Temporal Discretisation method. +// 1 -- Runge-Kutta Multi-State. +// 2 -- Point implicit. +// 3 -- Full implicit. +// 4 -- LU-SGS. +// 5 -- Block LU-SGS. +// 6 -- Jacobian iteration. +// 7 -- Lower G-S iteration. +// 8 -- Upper G-S iteration. +// 9 -- Lower/Upper G-S iteration. +// iSimplifyViscousTerm: Simplify the computation of viscous term in the Block LU-SGS method. The default value assigns 1 that could speed up the computation. +// Otherwise, the viscous Jacobian matrix Mv should be computed that will increase the memory and time in iteration of the BLUSGS method. +// CFLStart: Started cfl number. +// CFLEnd: End cfl number. +// CFLVaryStep: The number of step when cfl increase from CFLStart to CFLEnd. +// ktmax: Dtratio. dt[i] = MIN(dt[i], ktmax * dtmin / vol[i]) +// swapDq: Communication dq between forward/backward sweep of LUSGS or not, default is 0. +// nLUSGSSweeps: Sub iteration of LU-SGS or Block LU-SGS. +// LUSGSTolerance: Sub iter tolerance of LU-SGS or Block LU-SGS. +// ifLocalTimeStep: Time step method. +// 0 --Local. +// 1 --Global. +// visl_min: Minimum value of laminar viscosity coefficient. +// turbCFLScale: Turbulence model cfl number factor. +// codeOfAleModel: Arbitrary Lagrangian-Eulerian method. +// 0 -- no ALE method. +// 1 -- ALE method for non-moving grids. +// 2 -- ALE method for moving grids. +// 3 -- ALE method for deforming grids. +// wallFunctionType: The type of wall function to implement. +// 0 -- no wall function. (default) +// 1 -- standard wall function. +// 2 -- Pab3D wall function. +// RKStage: The number of Runge-Kutta step. +// lamda: Cofficient of Runge-Kutta step. + +int iunsteady = 0; +double physicalTimeStep = 0.01; +int ifStartFromSteadyResults = 0; +int ifStaticsFlowField = 0; +int ifStaticsReynoldsStress = 0; +int startStatisticStep = 800000; +double statisticalTimePeriod = -1.0; +int statisticMethod = 0; +int linearTwoStepMethods = 1; // 1--BDF1; 2--C-N; 3--BDF2; + +int methodOfDualTime = 3; +int min_sub_iter = 50; +int max_sub_iter = 50; +double tol_sub_iter = 0.01; + +int tscheme = 4; +int iSimplifyViscousTerm = 1; +int ifLocalTimeStep = 0; +double CFLStart = 0.01; +double CFLEnd = 10.0; +int CFLVaryStep = 500; + +double ktmax = 1.0e10; + +int swapDq = 1; + +int nLUSGSSweeps = 1; +double LUSGSTolerance = 0.01; +int order = 2; + +double visl_min = 0.01; +double turbCFLScale = 1.0; +double csrv = 2.0; +double timemax = 1.0e10; +double dtsave = -1.0; +int maxale = 10; +double dtau = 0.001; + +int wallFunctionType = 0; + +int RKStage = 2; +double lamda[] = 0.5, 1.0; + +//int RKStage = 1; +//double lamda[] = 1.0; + +//int RKStage = 4; +//double lamda[] = [0.25, 0.33333333333, 0.5, 1.0]; + +//----------------------------------------------------------------------- +# File In or Out # +//----------------------------------------------------------------------- +// numberOfGridGroups: The number of grid groups. +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the field results to visulization. +// walldistMethod: The method to compute wall distance. +// 0 -- accurate but not fast enough. +// 1 -- fast but not accurate enough. +// 2 -- super fast but more non-accurate! +// resSaveFile: The file path to save the residual convergence process, write data for every default (intervalStepRes) steps. +// turbresfile: The file path to save the residual convergence process of turbulence, write data for every default (intervalStepRes) steps. +// aircoeffile: The file path to save the aerodynamic force coefficients convergence process, write data for every default (intervalStepForce) steps. +// restartNSFile: The file path to write restart flowfield variables, write data for every default (intervalStepFlow) steps. +// turbfile: The file path to write restart flowfield variables of turbulence , write data for every default(intervalStepFlow) steps. +// visualfile: The visualization file path of flowfield , write data for every default (intervalStepPlot) steps. +// wall_aircoefile: The file path to save flowfield variables of wall, write data for every default steps. +// nDumpSurfaceInfo = 0 the "wall_varfile" write the informations including heat flux. +// nDumpSurfaceInfo = 1 the "wall_varfile" write the informations without heat flux. + +int numberOfGridGroups = 1; +string gridfile = "./grid/rae2822_hybrid2d__4.fts"; +string wallTemperaturefile= ""; + +int walldistMethod = 1; + +string resSaveFile = "results/res.dat"; +string turbresfile = "results/turbres.dat"; +string aircoeffile = "results/aircoef.dat"; + +string restartNSFile = "results/flow.dat"; +string turbfile = "results/turb.dat"; + +string visualfile = "results/tecflow.plt"; +string wall_aircoefile = "results/wall_aircoef.dat"; +string samplefile = "results/sample.dat"; + +int nDumpSurfaceInfo = 0; +string wall_varfile = ""; + +string jetDefineFile = "bin/jet.hypara"; + +string sixDofFileName = "results/sixDofInfo.dat"; +string derivativeFileName = "results/identify.dat"; +string hysteresisFileName = "results/force_beta.plt"; + +int plotFieldType = 0; + +// visualfileType: The file type of visualfile. +// 0 -- Tecplot binary. +// 1 -- Tecplot ASCII. + +int visualfileType = 1; + +// samplefileMode: The dump mode of sample file. +// 0 -- dump out every probe/line/surface data for all step intervals. +// 1 -- dump out all probe/line/surface data for every step intervals. +int samplefileMode = 0; + +// visualSlice: The slice of tecflow. +// 0 -- Do not save slice data. +// 1 -- comput and save it to sliceFile. +// sliceAxis: Normal vector of slice. +// 1 -- X_DIR. +// 2 -- Y_DIR. +// 3 -- Z_DIR. +// slicePostion: Coordinate of slice. + +int visualSlice = 0; +int sliceAxis = 1; +double slicePostion = -0.5; +string sliceFile = "results/Slice.plt"; +int dumpWallFaceCenter = 0; + +// min-max box of the visual block. +double lowerPlotFieldBox[] = [0.0 0.0 0.0]; +double upperPlotFieldBox[] = [1.0 1.0 1.0]; + +//-----------the optional parameters list for the flow field output---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40), +// -- gradientUx(41), gradientUy(42), gradientVx(43), gradientVy(44), iblank(81). +// -- specific heat ratio(gama, 56) +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. +//-----------the optional parameters list for the wall boundary condition---------------- +// nVisualWallVariables: The number of visual variables on wall. +// visualWallVariables : dumped variable types, listed as following: +// -coefficient of pressure(cp, 0), -coefficient of friction(cf, 1), yplus(2), -non-dimensional heat flux(Q_NonDim, 3), -dimensional heat flux(Q_Dim, 4), +// -pressure on wall(pw, 5), -temperature on wall(Tw, 6), -density on wall(rhow, 7), -heat flux of translational-rotational temperature term(Qtr, 8), +// -heat flux of species diffusion term(Qs, 9), -heat flux of vibrational temperature term(Qv, 10), -heat flux of electron temperature term(Qe, 11), +// -species mass fractions(Ns, 12), -x component of wall velocity(Vx, 13), -y component of wall velocity(Vy, 14), -z component of wall velocity(Vz, 15) +// -slip translational-rotational temperature(Tts, 16), -slip vibrational temperature(Tvs, 17), -slip electron temperature(Tes, 18), -absolute wall velocity(Vs, 19) +// -Stanton number(St, 20), -coefficient of heat rate(Ch, 21), -temperature jump(deltaT, 22), -transition gamaeff(gamaeff, 48), +// -transition intermittency(intermittency, 51), -transition momentum thickness reynolds(MomentumThicknessReynolds, 52), +// -overlap iblank(iblank, 81) + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +int nVisualWallVariables = 9; +int visualWallVariables[] = [0, 1, 2, 3, 4, 5, 9, 10, 11]; + +// dumpStandardModel: Dump many standard model data. +// 1 -- Turbulent flat plate. +int dumpStandardModel = 0; + +// ifSetDataMonitor: Whether to set the data monitor. +// 0 -- No. +// 1 -- Yes. +// dataMonitorType: The type of data Monitor. +// 0 -- Probes data monitor. +// 1 -- Lines data monitor. +// 2 -- Surfaces data monitor. +// probesDefineFile: Probes location information file. +// nLines: The number of lines need to be monitored. +// linesDefineFile: Lines location information file. +// nSurfaces: The number of surfaces need to be monitored. +// surfacesDefineFile: Surfaces location information file. +// searchCellsMethod: method to search the cell of each probe. +// 0 -- Nearest cell to the probe. +// 1 -- Real cell where the probe is located. +// nProbeVariables: Number of variables want to be dumped for probes monitered. +// probeVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5). +// Important Warning: Array size of probeVariables MUST be equal to nProbeVariables!!! +// probeVariables order must from small to big. +// probeVariablesInterpolationMethod: Interpolation method used to compute the probe variables. +// 0 -- Take the value of probe's cell as probe real value. +// 1 -- Interpolation from probe's and neighbouring cell to probe. +// 2 -- Interpolation from probe's cell nodes to probe. +int ifSetDataMonitor = 0; + +int dataMonitorType = 0; +string probesDefineFile = "bin/probes_XYZ.dat"; + +//int dataMonitorType = 1; +//int nLines = 1; +//string linesDefineFile = "bin/lines_XYZ.dat"; + +//int dataMonitorType = 2; +//int nSurfaces = 4; +//string surfacesDefineFile = "bin/surfaces_XYZ.dat"; + +int searchCellsMethod = 0; + +int nProbeVariables = 6; +int probeVariables[] = [0, 1, 2, 3, 4, 5]; +int probeVariablesInterpolationMethod = 0; +//----------------------------------------------------------------------- +# Turbulence Parameter # +//----------------------------------------------------------------------- +// turbInterval: Iteration number of turbulence. +// kindOfTurbSource: Kinds of turbulent source. +// 0 -- Original. +// 1 -- Edwards. +// 2 -- new. +// mod_turb_res: If modify the residuals for the cells next to the wall or not, default is 0. + +int turbInterval = 1; +int turbOrderStruct = 2; +int kindOfTurbSource = 0; +int mod_turb_res = 0; +double turb_relax = 1.0; +double freeStreamViscosity = 1.0e-3; +double muoo = 3.0; +double kwoo = 5.0; +int transitionType = 0; +double turbIntensity = -1.0; +int freeturbIntensitySRModify = 0; +double freeDecayXLocation = 0.0; +int compressibleCorrection = 0; +int transitionMaFix = 1; + +# maximum eddy viscosity (myt/my) max. +double eddyViscosityLimit = 1.0e10; +int monitor_vistmax = 0; + +//----------------------------------------------------------------------- +# LES Parameter # +//----------------------------------------------------------------------- +// iLES: Create LESSolver or not. +// == 1 - Create LESSolver; +// != 1 - not. +// amplitudeofDisturb: Amplitude of adding disturb. +// disturbstep: Unsteady time step or steady iteration of adding random disturb. +// iterdisturb: Add random disturb in every sub-iter or only first sub-iter. +// = 0 - in only first sub-iter; +// != 0 - in every sub-iter. +// ipraddisturb: Add density and pressure disturb or not. +// ibodyforce: Add body force in source flux of NS equations or not. +// = 0 - not; +// != 0 - Add body force. +// bodyforce: Body force in source flux of NS equations or not. +// utau: friction velocity, using in DNSDisturb. +// sgsmodel: subgrid scale model. +// = "smagorinsky"; +// = "dsmCom"; +// = "wale"; +// = "sigma". +// deltaFunctionType: = 1 - MAX(deltai, deltaj, deltak); +// = 2 - pow(deltai * deltaj *deltak, 1/3); +// = 3 - Devloped by Scotti. +// wallDampingFunctionType: = 0 - no wall function; +// = 1 - van Driest; +// = 2 - developed by Dr. Deng Xiaobing; +// = 3 - developed by Piomelli. +// turbViscousCutType: turbulent viscosity cut type. +// = 0 - mu_total = mut + mul; +// = 1 - mu_total = max(mut-mul,0)+ mul; +// = 2 - mu_total = max(mut ,0)+ mul. +// smagConstant: constant of smagorinsky model. +// waleConstant: constant of wale model. +// filterDirection[3]: filter variables in i, j, k direction or not. +// averageDirection[3]: average variables in i, j, k direction or not. +// isotropicConstant: constant of isotropic part of SGS stress. + +int iLES = 0; +string sgsmodel = "smagorinsky"; +int deltaFunctionType = 2; +int wallDampingFunctionType = 1; +int turbViscousCutType = 2; +double smagConstant = 0.1; +double isotropicConstant = 0.0; +double waleConstant = 0.6; +double sigmaConstant = 1.35; +int filterDirection[] = [1, 1, 0]; +int averageDirection[] = [0, 0, 0]; +double testFilterScale = 2.0; +int averageWidth = 1; +int monitorNegativeConstant = 0; + +//----------------------------------------------------------------------- +# Other Parameters for Hypersonic Non-equilibrium Gas # +//----------------------------------------------------------------------- +// dg_high_order: +// 0 -- generic order accuracy. +// 1 -- high order accuracy. +// iapplication: +// 0 -- gas model is fixed in the codes. +// 1 -- gas model is imported from library files. +// iCodeBranch: +// 0 -- The old code version is used for Navier-Stokes. +// 1 -- A new code version is active for Navier-Stokes solver. +// nm: Equation number of the physics, but is out of commision now. +// 4 -- for 2D. +// 5 -- for 3D. +// nGasModel: The type of gas. less than and equal to 1 represents the mixture gas. +// Otherwise, the pure gas with one component is used for perfect gas. +// 0 -- Earth gas. +// 1 -- Mars gas. +// 2 -- Argon. +// 3 -- Nitrogen. +// nEnergyRecycle: The type of EnergyModel Recycle. +// 0 -- not used . +// 1 -- used. +// nDensityModify: The type of densitymodify. + +// 0 -- not used. +// 1 -- used. +// nchem: +// 0 -- without chemical reaction flow. +// 1 -- the chemical reaction flow is considered. +// nEquilibriumGas: the variable is valid when the condition of nchem=0 is satisfied. +// 0 -- perfect gas. +// 5, 7, 11 -- equilibrium gas, meanwhile, its value denotes the number of gas component. +// nPCWCycleStep: the maximum step number of iteration in the module of computing species mass fractions with the partial catalytic wall(PCW) condition. +// the value equals to or is greater than 1, and 3 is for default value. +// nRETCycleStep: the maximum step number of iteration in the module of computing radiation equilibrium temperature on wall. +// the value equals to or is greater than 1, and 3 is for default value. +// nSLIPCycleStep:the maximum step number of iteration in the module of computing slip temperature, slip velocity and slip species mass fraction. +// the value equals to or is greater than 1, and 3 is for default value. +// nSlipBCModel : The computational model of slip boundary conditions. + +// 0 -- no slip. +// 1 -- the conventional Maxwell slip conditions. +// 2 -- the Gokcen slip conditions. +// 3 -- the Knudsen-layer correction of the standard slip conditions proposed by Lockerby, et al. +// 4 -- the Kogan simplified slip conditions. +// nMeanFreePathType : the method to the mean free-path for the slip conditions. For the mixture, 0 is suggested. +// 0 -- the equivalent mean free-path is calculated by the simple hard sphere model(HS). +// 1 -- calculated by the definition that includes the variables of the number density and the molecule diameter. +// 2 -- the equivalent mean free-path is calculated by the variable hard sphere model(VHS). +// nchemsrc: +// 0 -- the source terms are not computed. +// 1 -- the source terms are computed. +// nchemrad: +// 0 -- compute the spectrum radius without considering chemical reaction flow. +// 1 -- compute the spectrum radius that need to count the contribution from chemical reaction flow. +// ntmodel: The thermodynamic temperature model. +// 1 -- One-temperature model. +// 2 -- Two-temperature model. +// 3 -- Three-temperature model. +// nTEnergyModel: the method to computing temperature energy model. +// 0 -- the energy term is computed using the conventional method. +// 1 -- the energy term is computed using the curve fitting method. +// parkVDPower: the power of translational-rotational temperature in the Park V-D(vibration-dissociation) coupling model. +// The value is in range of [0.0, 1.0], DPLR suggests 0.5, LAURA suggests 0.7, while 0.6 is given as default value. +// catalyticCoef: +// 0.0 -- full non-catalytic wall boundary condition. +// 1.0 -- full catalytic wall boundary condition. +// in range of (0.0, 1.0) -- partial catalytic condition, the value indicates the catalytic coefficient. +// nIsSuperCatalytic : the super catalytic condition for the fully catalytic wall, and assigned with the value of 1. +// 0 -- equilibrium condition for the fully catalytic wall where the mass fractions are assigned with the values of the free stream. +// 1 -- super catalytic condition for the fully catalytic wall where all the atomic components combine into molecular components. +// nTemperatureJump : the method to calculate the temperature jump. +// 0 -- calculated by the variables of heat conductivity and constant volume specific heat for each energy mode. +// 1 -- the general method where the iteration is calculated with the translation-rotation temperature. +// sigmaVelocity: the coordination coefficient of tangential momentum for computation of slip velocity. The value is in range of (0.0, 2.0]. +// sigmaTemperature: the heat coordination coefficient for computation of slip temperature. The value is in range of (0.0, 2.0]. +// sigmaMassFraction: the species coordination coefficient for computation of slip mass fractions. The value is in range of (0.0, 2.0]. +// velocitySlipCorrectConstant: the correction constant to the velocity slip condition. For the diffuse reflection, 1.0 is used. +// 1.0 -- proposed by Maxwell. +// sqrt(2/PI)~0.8 -- used for "micro-slip", namely the actual velocity slip at the wall. +// 1.146 -- proposed for an additional "fictitious" velocity slip. + +// chemicalRelaxCorf: The value is in range of [0.001, 1.0]. +// chemicalSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// viscousSpectrumRadiusCoef : The value is in range of [1.0, 3.0]. +// inviscidSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// staticPressureRelaxCorf: The value is in range of [0.1, 1.0]. +// nIsChemicalFreeze : the flag to freeze the chemical reactions. +// 0 -- not freeze, the chemical reaction sources will be calculated. +// 1 -- freezes the chemical reactions, the chemical reaction sources will not be calculated.// veTemperatureMin: The minimum of Tv and Te +// nDebug: cout the Wrong place and abort +// 0 -- not used. +// 1 -- used. +// nSpeciesLimit: limitter of gas species +// 0 -- not used. +// 1 -- used. +// nTurblenceForChemical: the coupled mode of Turblence and Chemical reaction +// 0 -- method 0. +// 1 -- method 1. +// nViscosityFluxSublevelModified: Modified for ViscosityFlux on Sublevel grid +// 0 -- not used. +// 1 -- used. +// nChemcalSourceModified: Modified on ChemcalSource +// 0 -- not used. +// 1 -- used. +// nAblation: +// 0 -- The wall ablation is not computed. +// 1 -- The wall ablation is computed. +// isInjection: +// 0 -- The injection velocity of ablation wall is not computed. +// 1 -- The injection velocity of ablation wall is computed. +// nViscosityModel: + +// 0 -- Blottner fitting method. +// 1 -- Gupta fitting method. +// nSutherland: +// 0 -- stands for selecting the Blotter curve fits mode. +// 1 -- stands for Sutherland relation. +// gasfile: Indicates the gas model, 9 models are provided, namely "Gu5", "Gu7", "Gu11", "Pa5", "Pa7", "Pa11", "DK5", "DK7", "DK11". +// "Gu" -- indicates the Gupta Model, three-Type Models are embeded in the library, namely, the 5-species-6-reactions, the 7-species-9-reactions, the 11-species-20-reactions. +// "Pa" -- indicates the Park Model, three-Type Models are embeded in the library, namely, the 5-species-17-reactions, the 7-species-22-reactions, the 11-species-48-reactions. +// "DK" -- indicates the Dunn-Kang Model, three-Type Models are embeded in the library, namely, the 5-species-11-reactions, the 7-species-15-reactions, the 11-species-26-reactions. +// "Mars-Pa8" is for Park model of Mars gas, "Mars-Mc8" for McKenzie model of Mars gas. +// "Combustion-12" -- indicates the Combustion Chamber Gas Model which includes 12-species-20-reactions. +// "Gas-Mixture" -- indicates the process of mixing two species without reacting. +// For self-definition model, the gasfile is used to indicate the file path of the new gas model. +// speciesName: Used to list the names of each species, while each species name is separated by the symbol of comma. +// initMassFraction: Used to list the initial mass fractions of species in accordance with the sequence of names in the parameter speciesName. +// ifStartFromPerfectGasResults: The chemical reaction simulation is start from perfect gas flowfield or not, 0 is for no and else is for yes. + +int dg_high_order = 0; +int iapplication = 0; +int iCodeBranch = 0; +int nm = 5; +int nEquilibriumGas = 0; +int nPCWCycleStep = 3; +int nRETCycleStep = 3; +int nSLIPCycleStep= 3; + +double refGama = 1.4; +double prl = 0.72; +double prt = 0.90; +double sc_l = 0.5; +double sc_t = 0.5; + +int nGasModel = 0; +int nchem = 0; +int nchemsrc = 1; +int nchemrad = 1; +int ntmodel = 1; + +int nEnergyRecycle = 0; +int nSlipBCModel = 0; +int nDensityModify = 1; +int nTEnergyModel = 0; +int nMeanFreePathType = 0; +int nIsChemicalFreeze = 0; +int nIsSuperCatalytic = 1; +int nTemperatureJump = 0; + +double parkVDPower = 0.6; +double catalyticCoef = 0.0; +double sigmaVelocity = 1.0; +double sigmaTemperature = 1.0; +double sigmaMassFraction = 1.0; +double velocitySlipCorrectConstant = 1.0; + +double chemicalRelaxCorf = 1.0; +double chemicalSpectrumRadiusCoef = 1.0; +double viscousSpectrumRadiusCoef = 1.0; +double inviscidSpectrumRadiusCoef = 1.0; +double staticPressureRelaxCorf = 1.0; + +double veTemperatureMin = 30.0; +int nDebug = 0; +int nSpeciesLimit = 0; +int nTurblenceForChemical = 0; +int nViscosityFluxSublevelModified = 0 ; +int nChemcalSourceModified = 0; + +int nAblation = 0; +int isInjection = 0; +int nViscosityModel = 0; +int nMarsModel = 0; +string gasfile = "DK5"; +//string gasfile = "./chemical/Dunn-Kang_air5s11r.dat"; +string speciesName = "O, O2, NO, N, N2"; +string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.767"; + +//string speciesName = "O, O2, NO, N, NO+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string speciesName = "O, O2, NO, N, O+, O2+, NO+, N+, N2+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Mars-Pa8"; +//string speciesName = "O, O2, NO, N, N2, C, CO, CO2"; +//string initMassFraction = "0.0015, 0.0429, 0.0, 0.0, 0.0, 0.0, 0.0777, 0.8779"; + +//string gasfile = "DK7"; +//string speciesName = "O, O2, NO, N, NO+, C, C2, CO, CO2, CN, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Combustion-12"; +//string speciesName = "O, O2, NO, N, C, CO, CO2, H, H2, OH, H2O, N2"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767"; + +//string gasfile = "Gas-Mixture"; +//string speciesName ="SpeciesA, SpeciesB"; +//string initMassFraction = "1.0, 0.0"; +int nSutherland = 0; +double gamaSpeciesA = 1.4; +double gamaSpeciesB = 1.3; +double molecularWeightSpeciesA = 29.0; +double molecularWeightSpeciesB = 30.0; + +int nChemicalFlowStep = 0; +int ifStartFromPerfectGasResults = 0; + +######################################################################### +// Multi-Grid parameters. +// nMGLevel: The number of level of Multi-Grid. +// <= 1 -- Single-level. +// > 1 -- multi-level. +// MGPreIteration: For each grid, the number of pre-smoothing steps. +// n_post: For each grid, the number of post-smoothing steps. +// MGCoarsestIteration: For the coarest grid the number of smoothing steps. +// MGFasType: V-multi cycle or W-multi cycle. +// 1 -- V-multi cycle. +// 2 -- W-multi cycle. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. +// mgCFLScale: CFL number enlarge times for coarse grid. +// mprol: Multi-grid interpolation method, interpolation from coarse cell to fine grid. +// 1 -- zero order. +// 2 -- first-order. (default) +// mgCorrectionLimit: Multi-grid correction limit. + +int nMGLevel = 1; +int MGCoarsestIteration = 1; +int MGPreIteration = 1; +int MGFasType = 1; +int n_post = 0; +int flowInitStep = 100; +int mprol = 2; +double mgCFLScale = 1.0; +double mgCorrectionLimit = 0.01; + +//--------------- Some parameter for turbulent model -------------------- +// neasm: The variation of kw turbulent model. +// ismooth_turb: Residual smooth for turb or not. +// SSTProductType: The type of product term based on vorticity for SST. +// SAProductType: The type of product term based on vorticity for SA. +int neasm = -3; +int SSTProductType = 0; +int ismooth_turb = 0; +int SAProductType = 2; + +// ----------------- Overset Grid parameter ----------------------------- +int codeOfDigHoles = 1; +int codeOfTurbulentModel = 0; +string masterFileName = "./grid/searchFile.inp"; +string holeBasicFileName = "./grid/holeBasicFile.inp"; +string holeFullFileName = "./grid/holeFullFile.dat"; +string linkFileName = "./grid/topology.dat"; +string zoneInverseFileName = "./grid/zoneInverseMapping.inp"; + +######################################################################### +# High Order Struct Solver # +######################################################################### +// isFVMOrFDM: +// 0 -- NSSolverStruct using Finite Volume Method. +// 1 -- NSSolverStruct using Finite Differ Method. +// SolverStructOrder: Spatial discretisation order of NS equations with struct grid. +// <= 2 -- finite volume method. +// >= 3 -- finite difference order. (to be completed) +// 0 -- default. +// str_highorder_interpolation_epsilon: Epsilon in weighted interpolation, bigger epsilon, better convergence, +// smaller epsilon, robuster for shock-detecting. +// str_highorder_interpolation_type: +// -- "classical", "test". +// str_highorder_flux_name: +// -- "roe", "steger". +// structhighordergradient: +// -- "conservation", "chain_rule". +int isFVMOrFDM = 0; +string str_highorder_solver = "WCNS"; +int SolverStructOrder = 0; +double str_highorder_interpolation_epsilon = 1.0e-6; +string str_highorder_interpolation_type = "test"; +string str_highorder_flux_name = "steger"; +string structhighordergradient = "conservation"; +double coefofstrflux = 0.5; +double limitcoefofinterface = 0.0; + +// ----------------- Advanced choices ----------------------------------- +// outtimesc: Time stepping scheme for the outer loop. +// MUSCLCoefXk: The parameter of MUSCL interpolations, belongs to [-1, 1]. +// -1 -- seconde-order fully-upwind differencing. +// 0 -- seconde-order upwind-biased differencing. +// 0.333333 -- third-order upwind-biased differencing. +// 1 -- seconde-order central differencing. +// MUSCLCoefXb: The limiter parameter. +// 0 -- the effect of the limiter is cancelled, means the first-order interpolations. +// allReduceStep: Iteration intervals for MPI AllReduce operation, default is 1. +string outtimesc = "impbd2"; +double MUSCLCoefXk = -1; +double MUSCLCoefXb = 1.0; +int allReduceStep = 1; + +// ----------------- overlap configuration ------------------------------ +// codeOfOversetGrid: Overlapping(overset) grid or not. +// 0 -- NON-overlapping grid. +// 1 -- Overlapping grid. +// oversetInterpolationMethod: the method of overset interpolation while field simulation +// 0 -- set the acceptor cell value by donor cell value. +// 1 -- set the acceptor cell value by distance weight of donor cell value. + +int codeOfOversetGrid = 0; +int oversetInterpolationMethod = 0; +int readOversetFileOrNot = 0; +int symetryOrNot = 0; +int readInAuxiliaryInnerGrid = 1; +int readInAuxiliaryOuterGrid = 0; +int readInSklFileOrNot = 0; +string auxiliaryInnerGrid0 = "./grid/aux-upper.fts"; +string auxiliaryInnerGrid1 = "./grid/aux-lower.fts"; +string auxiliaryInnerGrid2 = ""; +string oversetGridFileName = "./grid/iblank.ovs"; +double walldistMainZone = 1.0 +double toleranceForOversetSearch = 1.0e-3; +double toleranceForOversetBox = 1.0e-3; +int twoOrderInterpolationOrNot = 0; +int keyEnlargeOfActiveNodes = 0; +int outTecplotOverset = 0; + +int numberOfMovingBodies = 2; + +// ----------------- ALE configuration ------------------------------ +int codeOfAleModel = 1; +int aleStartStrategy = -1; + +int strategyForFaceNormalVelocity = 0; //0-By Sweeping volume; 1-By face center 1st; 2-By face center 2nd; +int strategyForGCLSource = 0; //0-present; 1-Ahn; + +//0:1st-Admas-Bashforth; 1:2nd-Admas-Bashforth; 2:1st-Implicit-Euler; 3:2nd-Implicit Euler; 4:2nd-Adams-Moulton; 5:3rd-Adams-Moulton +int methodForKineticEquation = 0; +double relaxParameterOfKinetic = 1.0; + +######################################################################### +# motive information # +######################################################################### +int numberOfMovingBodies = 1; + +############################## body0 ############################## +//mass of parts +double mass_0 = 1.0; +//mass matrix of parts Ixx Iyy Izz Ixy Ixz Iyz +double massMatrix_0[] = 1e-7, 1e-6, 1e-6, 0.0, 0.0, 0.0; +//initial six DOF position information of parts. xc yc zc +double massCenter_0[] = 0.0 , 0.0, 0.0; +//initial six DOF position information of parts. angleX angleY angleZ +double attitudeAngle_0[] = 0.0 , 0.0, 0.0; +//initial six DOF move information of parts. vc vy vz +double massCenterVelocity_0[] = 0.0, 0.0, 0.0; +//initial six DOF move information of parts. omigX omigY omigZ +double angularVelocity_0[] = 0.0, 0.0, 0.0; +//the object that the parts belong to. +int fartherIndex_0 = -1; +//the assembly position of the parts. xc yc zc angleX angleY angleZ +double configPamameter_0[] = 0.0 ,0.0 ,0.0 ,0.0 ,0.0 ,0.0; +//the move pattern of the parts. +// -1 given motion partten. +// 0 still. +// 1 six DOF motion. +// 2 three DOF motion. +// 11 X-axis forced motion. +// 12 Y-axis forced motion. +// 13 Z-axis forced motion. +// 14 forced pitch motion. +// 15 forced yaw motion. +// 16 forced roll motion. +int RBDMethod_0 = 0; +double amplitude_0 = 0.0; +double reduceFrequency_0 = 0.0; +//string uDFSixDofFileName_0 = "./Bin/UDFSixDof.Parameter"; +//additional force (system axis) fX fY fZ +double addedForce_0[] = 0.0 ,0.0 ,0.0 ; +//additional moment of Force (system axis) mX mY mZ +double addedMoment_0[] = 0.0 ,0.0 ,0.0 ; +//the deformation method of the parts. +int morphing_0 = 0; + +// post indentify +int integralOrder = 4; + + +// ---------------- ATP read -------------------------------------------- +//@int inflowParaType = 0; +//@double refReNumber = 6.5e6; +//@double refDimensionalTemperature = 288.15; +//@double freestream_vibration_temperature = 300.00; +//@double refDimensionalPressure = 0; +//@double height = 0; +//@int nsubsonicInlet = 0; +//@int nsubsonicOutlet = 0; +//@string inLetFileName = "./bin/subsonicInlet.hypara"; +//@string outLetFileName = "./bin/subsonicOutlet.hypara"; +//@double refDimensionalVelocity = 0; +//@double refDimensionalDensity = 0; + +######################################################################### +# Old Parameter # +######################################################################### +int isPlotVolumeField = 0; + diff --git a/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/cfd_para_subsonic.hypara b/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/cfd_para_subsonic.hypara new file mode 100644 index 0000000..d5bb3e7 --- /dev/null +++ b/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/cfd_para_subsonic.hypara @@ -0,0 +1,195 @@ +######################################################################### +# General Control Parameter # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual 'res.dat' saved. + +int maxSimuStep = 10000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; + +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) +int ifLowSpeedPrecon = 0; + +######################################################################### +# Inflow Parameter # +######################################################################### +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. + +double refMachNumber = 0.2; +double attackd = 19.0; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 9.0e6; +double refDimensionalTemperature = 288.0; + +//int inflowParaType = 1; +//double height = 0.001; + +double gridScaleFactor = 1.0; + +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. + +######################################################################### +# Physical models # +######################################################################### +// viscousType : Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "1eq-sa", when viscousType = 3. +// -- "2eq-kw-menter-sst", when viscousType = 4. +// DESType: Type of DES. +// 0 -- RANS.(default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; +######################################################################### +# Spatial Discretisation # +######################################################################### +#******************************************************************* +# Struct Solver * +#******************************************************************* +// str_limiter_name: Limiter of struct grid. +// -- "3rdsmooth", "smooth". +// -- "nolim", no limiter. + +string str_limiter_name = "smooth"; + +#******************************************************************* +# UnStruct Solver * +#******************************************************************* +// uns_limiter_name: Limiter of Unstruct grid. +// -- "vencat". +// -- "1st", meaning accuracy of first-order. +// -- "nolim", no limiter. +// venkatCoeff: Coefficient of vencat limiter, when uns_limiter_name = 'vencat'. +// The smaller the value, the more robust it is. + +string uns_limiter_name = "vencat"; +double venkatCoeff = 10.0; + +######################################################################### +# Temporal Discretisation # +######################################################################### +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// CFLEnd: The CFL number, [0.1, 100]. +// The bigger the value, the convergence faster but lower robustness. +// nLUSGSSweeps: Number of Sub-iteration of LU-SGS. +// 1 -- is recommended for structured solver. +// 1-3 -- is recommended for unstructured solver. + +int iunsteady = 0; + +double CFLEnd = 100.0; + +int nLUSGSSweeps = 5; + +######################################################################### +# Multi-Grid parameters # +######################################################################### +// nMGLevel: The number of Multi-Grid level. +// = 1 -- single-level. +// > 1 -- multi-level. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. + +int nMGLevel = 2; +int flowInitStep = 100; + +######################################################################### +# File In or Out # +######################################################################### +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// Please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the whole field results to tecplot or not, 0 / 1. + +string gridfile = "./grid/30p30n_hygrid_2d__4.fts"; +int plotFieldType = 0; + +// ----------------- Advanced Parameters, DO NOT care it ---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables: Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21). +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. + +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; diff --git a/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/grid_para.hypara b/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/grid_para.hypara new file mode 100644 index 0000000..31a7f0a --- /dev/null +++ b/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/grid_para.hypara @@ -0,0 +1,30 @@ +######################################################################### +# Grid data type # +######################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +// from_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +int gridtype = 0; +int axisup = 1; +int from_gtype = 5; + +######################################################################### +# File path # +######################################################################### +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +string from_gfile = "./grid/30p30n_hygrid_2d.cas"; +string out_gfile = "./grid/30p30n_hygrid_2d.fts"; diff --git a/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/key.hypara b/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/key.hypara new file mode 100644 index 0000000..78c5988 --- /dev/null +++ b/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/key.hypara @@ -0,0 +1,59 @@ +string title = "PHengLEI Main Parameter Control File"; + +// IMPORTANT NOTICE: DON NOT MODIFY THE FOWLLOWING LINE. +string defaultParaFile = "./bin/cfd_para.hypara"; + +// ndim: Dimensional of the grid, 2 or 3. +// nparafile: the number of parameter files. +// nsimutask: simulation task type. +// 0 -- CFD Solver of NS or Turbulation. +// 1 -- Grid generation: for special typical cases, such as cylinder, flat plate, etc. +// Grid conversion: from other format to PHengLEI format (.fts). +// Grid reconstruction: such as grid adaptation. +// Grid merging: merge two blocks into one block. +// Grid repairing: repair the original grid in order to remove the negative volume cells. +// 2 -- Wall distance computation for turb-solver. +// 3 -- Grid partition. +// 4 -- Knowledge repository / examples of PHengLEI-API. +int ndim = 2; +int nparafile = 1; + +int nsimutask = 0; +string parafilename = "./bin/cfd_para_subsonic.hypara"; +//string parafilename = "./bin/cfd_para_transonic.hypara"; +//string parafilename = "./bin/cfd_para_supersonic.hypara"; +//string parafilename = "./bin/cfd_para_hypersonic.hypara"; +//string parafilename = "./bin/incompressible.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_para.hypara"; + +//int nsimutask = 2; +//string parafilename = "./bin/cfd_para.hypara"; + +//int nsimutask = 3; +//string parafilename = "./bin/partition.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_deform_para.hypara"; + +//int nsimutask = 4; +//string parafilename = "./bin/repository.hypara"; + +//int nsimutask = 5; +//string parafilename = "./bin/overset_grid_view.hypara"; + +//int nsimutask = 13; +//string parafilename = "./bin/lbm_para.hypara"; + +//int nsimutask = 14; +//string parafilename = "./bin/integrative_solver.hypara"; + +//int nsimutask = 99; +//string parafilename = "./bin/post_processing.hypara"; + +// ---------------- Advanced Parameters, DO NOT care it ---------------- +int numberOfGridProcessor = 0; +// ATP read +//@string parafilename1 = "" +//@string parafilename2 = ""; diff --git a/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/partition.hypara b/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/partition.hypara new file mode 100644 index 0000000..5d0be15 --- /dev/null +++ b/B14-TwoD_30p30n_SA_Unstruct_4CPU/bin/partition.hypara @@ -0,0 +1,21 @@ +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// maxproc: The number of partition zones that want to be divided into, +// which is equal to the number of CPU processors you want. +// Usually, 50~100 thousands structured cells per CPU-Core is suggested. +// 30~70 thousands unstructured cells per CPU-Core is suggested. +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). + +int pgridtype = 0; +int maxproc = 4; + +string original_grid_file = "./grid/30p30n_hygrid_2d.fts"; +string partition_grid_file = "./grid/30p30n_hygrid_2d__4.fts"; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level,..., et al. +int numberOfMultigrid = 1; diff --git a/B14-TwoD_30p30n_SA_Unstruct_4CPU/grid/30p30n_hygrid_2d.cas b/B14-TwoD_30p30n_SA_Unstruct_4CPU/grid/30p30n_hygrid_2d.cas new file mode 100644 index 0000000..7d1a861 --- /dev/null +++ b/B14-TwoD_30p30n_SA_Unstruct_4CPU/grid/30p30n_hygrid_2d.cas @@ -0,0 +1,97638 @@ +(1 "exported from Gridgen 15.17R1") +(0 "21-Mar-13 08:21:19") + +(0 "Dimension : 2") +(2 2) + +(0 "Number of Nodes : 28439") +(10 (0 1 6f17 0 2)) + +(0 "Total Number of Faces : 65084") +(0 "Number of Boundary Faces : 729") +(0 "Number of Interior Faces : 64355") +(13 (0 1 fe3c 0)) + +(0 "Total Number of Cells : 36643") +(0 "Number of Tri Cells : 17133") +(0 "Number of Quad Cells : 19510") +(12 (0 1 8f23 0)) + +(0 "Zone : 1 Number of Nodes : 28439") +(10 (1 1 6f17 1 2)( +-1.9999999999999972e+01 -1.0000000000000000e+01 +-1.9999999999999972e+01 9.9999999999999787e+00 + 1.9999999999999993e+01 9.9999999999999787e+00 + 1.9999999999999993e+01 -1.0000000000000000e+01 + 8.8437670469282637e-01 -1.4419652521581838e-02 + 8.9087604906756468e-01 2.2059116057427275e-02 + 8.9075841962701929e-01 2.9001646422969429e-02 + 8.8054356118129107e-01 -1.9461406739466725e-02 + 1.1410672699136768e+00 -1.3917268537910843e-01 + 1.1308590173720603e+00 -1.4049689471718807e-01 + 9.3393379449844360e-01 -3.4889094531521891e-02 + 9.2966098484684778e-01 -4.5953617430583904e-02 + 1.1279749870299867e+00 -1.4552110433575649e-01 + 1.1299219011558463e+00 -1.5516149002606028e-01 + 6.9992999999998062e-01 -1.7223002796470155e-02 + 7.1106771016510351e-01 -2.6217477692171087e-02 + 6.9993650913164629e-01 3.2006995123126103e-02 + 7.1978125734838017e-01 1.5980981965881824e-02 + 8.1724727153778076e-01 3.2007001340389252e-02 + 8.1723654091416620e-01 2.0775885108193393e-02 + 8.7401002645495396e-01 3.0943000689148903e-02 + 8.7886474889809563e-01 3.0266294368907154e-02 + 3.6992357469726045e-01 9.0362175008706913e-02 + 3.7063220301325828e-01 6.0929026448476975e-02 + 3.5417660682493590e-01 -8.3848955995421193e-02 + 3.5416070404495770e-01 -5.4461835615782661e-02 + 5.1345251500592326e-02 -2.8959579765810872e-02 + 4.4792514578389842e-02 -4.0841260255646716e-02 + 4.5227038912550199e-02 -8.2076170126157422e-03 + 3.4432434377478671e-02 -4.2866246490689264e-03 + 8.7265771821584792e-02 5.8518499391396972e-02 + 9.8075836896910573e-02 3.1661614775629232e-02 +-2.6118399575352669e-02 -1.0855860263109207e-01 +-8.1985591606809294e-02 -1.0949414856378326e-01 +-8.9952087498772926e-02 -1.1638357989812675e-01 +-1.9493660250233802e-02 -1.0796533006337938e-01 + 1.8772000446908521e-02 5.0789997912801255e-03 + 2.3437524333694171e-02 9.2198235183857946e-03 +-1.9999999999999972e+01 -9.0476190476190510e+00 +-1.9999999999999972e+01 -8.0952380952380452e+00 +-1.9999999999999972e+01 -7.1428571428571388e+00 +-1.9999999999999972e+01 -6.1904761904761756e+00 +-1.9999999999999972e+01 -5.2380952380952124e+00 +-1.9999999999999972e+01 -4.2857142857142918e+00 +-1.9999999999999972e+01 -3.3333333333333144e+00 +-1.9999999999999972e+01 -2.3809523809523938e+00 +-1.9999999999999972e+01 -1.4285714285714306e+00 +-1.9999999999999972e+01 -4.7619047619048160e-01 +-1.9999999999999972e+01 4.7619047619047450e-01 +-1.9999999999999972e+01 1.4285714285714306e+00 +-1.9999999999999972e+01 2.3809523809523796e+00 +-1.9999999999999972e+01 3.3333333333333428e+00 +-1.9999999999999972e+01 4.2857142857142918e+00 +-1.9999999999999972e+01 5.2380952380952266e+00 +-1.9999999999999972e+01 6.1904761904761898e+00 +-1.9999999999999972e+01 7.1428571428571317e+00 +-1.9999999999999972e+01 8.0952380952380949e+00 +-1.9999999999999972e+01 9.0476190476190581e+00 +-1.9024390243902445e+01 9.9999999999999787e+00 +-1.8048780487804862e+01 9.9999999999999787e+00 +-1.7073170731707336e+01 9.9999999999999787e+00 +-1.6097560975609781e+01 9.9999999999999787e+00 +-1.5121951219512198e+01 9.9999999999999787e+00 +-1.4146341463414643e+01 9.9999999999999787e+00 +-1.3170731707317088e+01 9.9999999999999787e+00 +-1.2195121951219519e+01 9.9999999999999787e+00 +-1.1219512195121965e+01 9.9999999999999787e+00 +-1.0243902439024410e+01 1.0000000000000014e+01 +-9.2682926829268553e+00 9.9999999999999787e+00 +-8.2926829268292579e+00 9.9999999999999787e+00 +-7.3170731707317032e+00 1.0000000000000014e+01 +-6.3414634146341200e+00 9.9999999999999787e+00 +-5.3658536585365653e+00 9.9999999999999787e+00 +-4.3902439024390389e+00 1.0000000000000014e+01 +-3.4146341463414842e+00 1.0000000000000014e+01 +-2.4390243902439295e+00 9.9999999999999787e+00 +-1.4634146341463321e+00 9.9999999999999787e+00 +-4.8780487804877742e-01 9.9999999999999787e+00 + 4.8780487804878447e-01 1.0000000000000014e+01 + 1.4634146341463605e+00 1.0000000000000014e+01 + 2.4390243902439224e+00 9.9999999999999787e+00 + 3.4146341463414771e+00 9.9999999999999787e+00 + 4.3902439024390318e+00 9.9999999999999787e+00 + 5.3658536585366008e+00 9.9999999999999787e+00 + 6.3414634146341626e+00 9.9999999999999787e+00 + 7.3170731707317458e+00 9.9999999999999787e+00 + 8.2926829268292508e+00 9.9999999999999787e+00 + 9.2682926829268624e+00 9.9999999999999787e+00 + 1.0243902439024417e+01 9.9999999999999787e+00 + 1.1219512195121972e+01 9.9999999999999787e+00 + 1.2195121951219527e+01 1.0000000000000014e+01 + 1.3170731707317081e+01 9.9999999999999787e+00 + 1.4146341463414664e+01 9.9999999999999787e+00 + 1.5121951219512233e+01 9.9999999999999787e+00 + 1.6097560975609774e+01 9.9999999999999787e+00 + 1.7073170731707350e+01 9.9999999999999787e+00 + 1.8048780487804905e+01 9.9999999999999787e+00 + 1.9024390243902459e+01 9.9999999999999787e+00 + 1.9999999999999993e+01 9.0476190476190581e+00 + 1.9999999999999993e+01 8.0952380952380807e+00 + 1.9999999999999993e+01 7.1428571428571317e+00 + 1.9999999999999993e+01 6.1904761904761898e+00 + 1.9999999999999993e+01 5.2380952380952266e+00 + 1.9999999999999993e+01 4.2857142857142918e+00 + 1.9999999999999993e+01 3.3333333333333428e+00 + 1.9999999999999993e+01 2.3809523809523796e+00 + 1.9999999999999993e+01 1.4285714285714306e+00 + 1.9999999999999993e+01 4.7619047619047450e-01 + 1.9999999999999993e+01 -4.7619047619048160e-01 + 1.9999999999999993e+01 -1.4285714285714306e+00 + 1.9999999999999993e+01 -2.3809523809523938e+00 + 1.9999999999999993e+01 -3.3333333333333428e+00 + 1.9999999999999993e+01 -4.2857142857142918e+00 + 1.9999999999999993e+01 -5.2380952380952124e+00 + 1.9999999999999993e+01 -6.1904761904761756e+00 + 1.9999999999999993e+01 -7.1428571428571388e+00 + 1.9999999999999993e+01 -8.0952380952380452e+00 + 1.9999999999999993e+01 -9.0476190476190368e+00 + 1.9024390243902417e+01 -1.0000000000000000e+01 + 1.8048780487804905e+01 -1.0000000000000000e+01 + 1.7073170731707329e+01 -1.0000000000000000e+01 + 1.6097560975609753e+01 -1.0000000000000000e+01 + 1.5121951219512155e+01 -1.0000000000000000e+01 + 1.4146341463414643e+01 -1.0000000000000000e+01 + 1.3170731707317081e+01 -1.0000000000000000e+01 + 1.2195121951219527e+01 -1.0000000000000000e+01 + 1.1219512195121936e+01 -1.0000000000000000e+01 + 1.0243902439024417e+01 -1.0000000000000000e+01 + 9.2682926829268624e+00 -1.0000000000000000e+01 + 8.2926829268292650e+00 -1.0000000000000000e+01 + 7.3170731707317174e+00 -1.0000000000000000e+01 + 6.3414634146341413e+00 -1.0000000000000000e+01 + 5.3658536585365866e+00 -1.0000000000000000e+01 + 4.3902439024390105e+00 -1.0000000000000000e+01 + 3.4146341463414771e+00 -1.0000000000000000e+01 + 2.4390243902439224e+00 -1.0000000000000000e+01 + 1.4634146341463392e+00 -1.0000000000000000e+01 + 4.8780487804877026e-01 -1.0000000000000000e+01 +-4.8780487804880579e-01 -1.0000000000000000e+01 +-1.4634146341463747e+00 -1.0000000000000000e+01 +-2.4390243902439295e+00 -1.0000000000000000e+01 +-3.4146341463414842e+00 -1.0000000000000000e+01 +-4.3902439024390389e+00 -1.0000000000000000e+01 +-5.3658536585365937e+00 -1.0000000000000000e+01 +-6.3414634146341911e+00 -1.0000000000000000e+01 +-7.3170731707317032e+00 -1.0000000000000000e+01 +-8.2926829268293005e+00 -1.0000000000000000e+01 +-9.2682926829268553e+00 -1.0000000000000000e+01 +-1.0243902439024410e+01 -1.0000000000000000e+01 +-1.1219512195121965e+01 -1.0000000000000000e+01 +-1.2195121951219534e+01 -1.0000000000000000e+01 +-1.3170731707317088e+01 -1.0000000000000000e+01 +-1.4146341463414672e+01 -1.0000000000000000e+01 +-1.5121951219512226e+01 -1.0000000000000000e+01 +-1.6097560975609781e+01 -1.0000000000000000e+01 +-1.7073170731707336e+01 -1.0000000000000000e+01 +-1.8048780487804862e+01 -1.0000000000000000e+01 +-1.9024390243902459e+01 -1.0000000000000000e+01 + 8.8323742637272318e-01 -1.3536915563534535e-02 + 8.8181249268528461e-01 -1.2300891740608222e-02 + 8.8008992934116037e-01 -1.0630965793637870e-02 + 8.7812932573240943e-01 -8.4349148359592618e-03 + 8.7603220662641945e-01 -5.6886232748354360e-03 + 8.7400196813531750e-01 -2.4156948295370739e-03 + 8.7235706373784438e-01 1.2859572345860215e-03 + 8.7157882509426798e-01 5.2186281982784521e-03 + 8.7179333676427717e-01 8.9553099183206086e-03 + 8.7269528218298120e-01 1.2133745893024184e-02 + 8.7406892323118512e-01 1.4545528031426613e-02 + 8.7548361898716109e-01 1.6280381735668925e-02 + 8.7673313486754978e-01 1.7497640777413892e-02 + 8.7776668082607046e-01 1.8323336765469378e-02 + 8.7857389789662221e-01 1.8885223826174524e-02 + 8.7918830560560934e-01 1.9261662020056747e-02 + 8.7981750999760067e-01 1.9612784938288996e-02 + 8.8047494125766690e-01 1.9942887208422633e-02 + 8.8115550856414160e-01 2.0255428361238614e-02 + 8.8186400333000137e-01 2.0531440100711507e-02 + 8.8258414977431698e-01 2.0802843835490137e-02 + 8.8332871894496634e-01 2.1023427887371327e-02 + 8.8408294858359682e-01 2.1227121148285732e-02 + 8.8484396761282369e-01 2.1413358626027446e-02 + 8.8561245244584086e-01 2.1567098808390028e-02 + 8.8638268214270965e-01 2.1696872660641020e-02 + 8.8715102569530302e-01 2.1809876367498759e-02 + 8.8791598822363937e-01 2.1891617732251234e-02 + 8.8867338019227304e-01 2.1958794550826610e-02 + 8.8942063277195160e-01 2.2006633956671351e-02 + 8.9015589593260813e-01 2.2033147439728396e-02 + 8.9087594952646043e-01 2.2064991009237644e-02 + 8.9087583007713533e-01 2.2072040950256167e-02 + 8.9087568673794948e-01 2.2080500877841303e-02 + 8.9087551473097903e-01 2.2090652788563148e-02 + 8.9087530832269124e-01 2.2102835077973282e-02 + 8.9087506063279420e-01 2.2117453820307276e-02 + 8.9087476340507976e-01 2.2134996303883270e-02 + 8.9087440673198870e-01 2.2156047273767854e-02 + 8.9087397872452811e-01 2.2181308422574375e-02 + 8.9087346511593779e-01 2.2211621779277380e-02 + 8.9087284878618078e-01 2.2247997775544093e-02 + 8.9087210919122128e-01 2.2291648924877450e-02 + 8.9087122167846644e-01 2.2344030236752133e-02 + 8.9087015666478919e-01 2.2406887712691059e-02 + 8.9086887865083497e-01 2.2482316539935709e-02 + 8.9086734503764831e-01 2.2572830921305354e-02 + 8.9086550470712211e-01 2.2681447867782367e-02 + 8.9086329631827965e-01 2.2811787743442835e-02 + 8.9086064626322781e-01 2.2968194911172191e-02 + 8.9085746621442752e-01 2.3155882493760771e-02 + 8.9085365018175366e-01 2.3381106065968993e-02 + 8.9084907098150978e-01 2.3651372051645581e-02 + 8.9084357600027886e-01 2.3975687747089580e-02 + 8.9083698211292273e-01 2.4364861265169679e-02 + 8.9082906958626040e-01 2.4831861333936445e-02 + 8.9081957476730622e-01 2.5392248841050957e-02 + 8.9080818131498063e-01 2.6064694347070372e-02 + 8.9079450968713303e-01 2.6871598561100996e-02 + 8.9077810453958506e-01 2.7839836060302048e-02 + 8.7902854322967983e-01 -1.8353921432961329e-02 + 8.7698075152754029e-01 -1.6996731867052972e-02 + 8.7443600902044949e-01 -1.5184251820670625e-02 + 8.7176159603878034e-01 -1.2450244205027161e-02 + 8.6922969242300496e-01 -8.7310233945459004e-03 + 8.6711295624603935e-01 -4.1901978106295701e-03 + 8.6607059082470528e-01 9.7635775702542560e-04 + 8.6582133143448203e-01 6.2029096976203846e-03 + 8.6611940316386438e-01 1.1077279107553295e-02 + 8.6702657722735665e-01 1.5287397343207942e-02 + 8.6869320091492597e-01 1.8486989335059434e-02 + 8.7069564021292933e-01 2.0604329708433511e-02 + 8.7248579374033852e-01 2.2003071842696897e-02 + 8.7392399559978173e-01 2.2953140252596427e-02 + 8.7502300356623408e-01 2.3612130208803706e-02 + 8.7583945140384856e-01 2.4074915260300145e-02 + 8.7666300153756538e-01 2.4524866642536836e-02 + 8.7750884897888426e-01 2.4974951469538098e-02 + 8.7837262039833774e-01 2.5428176687782411e-02 + 8.7924906491610955e-01 2.5889055511584047e-02 + 8.8014982647273143e-01 2.6328493053981106e-02 + 8.8108369130632980e-01 2.6717020591490837e-02 + 8.8204355496087317e-01 2.7054920129124582e-02 + 8.8302191603195013e-01 2.7345689175277244e-02 + 8.8401144666461562e-01 2.7595690409015106e-02 + 8.8500538150772456e-01 2.7813475449804059e-02 + 8.8599766601511476e-01 2.8008965964609445e-02 + 8.8698291158282672e-01 2.8192648719979729e-02 + 8.8795620832546263e-01 2.8374858819312010e-02 + 8.8891292622889750e-01 2.8565175560387956e-02 + 8.8984852058729302e-01 2.8771905790165420e-02 + 8.8437346098595526e-01 -1.4423918986651074e-02 + 8.8436956853838211e-01 -1.4429038743855926e-02 + 8.8436489760213988e-01 -1.4435182451279616e-02 + 8.8435929247999212e-01 -1.4442554898536741e-02 + 8.8435256633532333e-01 -1.4451401832687338e-02 + 8.8434449496448053e-01 -1.4462018150055655e-02 + 8.8433480932342690e-01 -1.4474757725693621e-02 + 8.8432318655985398e-01 -1.4490045208887636e-02 + 8.8430923925198357e-01 -1.4508390177766728e-02 + 8.8429250249457425e-01 -1.4530404124542429e-02 + 8.8427241840322779e-01 -1.4556820837583473e-02 + 8.8424831751913047e-01 -1.4588520859732057e-02 + 8.8421939649534664e-01 -1.4626560837385227e-02 + 8.8418469132109578e-01 -1.4672208739199277e-02 + 8.8414304519145759e-01 -1.4726986116869512e-02 + 8.8409306995252734e-01 -1.4792718816678985e-02 + 8.8403309983765155e-01 -1.4871597830378391e-02 + 8.8396113595378978e-01 -1.4966252312717643e-02 + 8.8387477967037142e-01 -1.5079837195486334e-02 + 8.8377115269266682e-01 -1.5216138315011563e-02 + 8.8364680116244898e-01 -1.5379698549594423e-02 + 8.8349758059666783e-01 -1.5575969160039449e-02 + 8.8331851784312221e-01 -1.5811491360082641e-02 + 8.8310364547425024e-01 -1.6094114139249882e-02 + 8.8284580313302286e-01 -1.6433255553479853e-02 + 8.8253639926672633e-01 -1.6840216118112039e-02 + 8.8216512539501224e-01 -1.7328554632726423e-02 + 8.8171961352981043e-01 -1.7914538778299516e-02 + 8.8118502554930700e-01 -1.8617685216057112e-02 + 8.9181082607128559e-01 2.9011955311744941e-02 + 8.9299492032429839e-01 2.9052877318875403e-02 + 8.9432510195255333e-01 2.9130737488209490e-02 + 8.9581758031447123e-01 2.9248019377199341e-02 + 8.9749083628478132e-01 2.9398674102317557e-02 + 8.9936659079170056e-01 2.9562295485064283e-02 + 9.0146921245859346e-01 2.9699575085842866e-02 + 9.0382268987413283e-01 2.9753275947022928e-02 + 9.0644618718464187e-01 2.9657503167598520e-02 + 9.0935190985040038e-01 2.9351683976884146e-02 + 9.1254788456710401e-01 2.8794491694014823e-02 + 9.1606372785310697e-01 2.8052065796906334e-02 + 9.1992687019381236e-01 2.7142488893602490e-02 + 9.2415496048829482e-01 2.6038461204805685e-02 + 9.2876130422011727e-01 2.4706411135582584e-02 + 9.3375274370340833e-01 2.3105280313544085e-02 + 9.3912704325652641e-01 2.1184669635047726e-02 + 9.4486861346787521e-01 1.8882443043352737e-02 + 9.5095525100656175e-01 1.6147485351666546e-02 + 9.5738567557340559e-01 1.2997182053837264e-02 + 9.6414535512985822e-01 9.4338678871181969e-03 + 9.7121437902311669e-01 5.4671598051285741e-03 + 9.7856801425398032e-01 1.1159202303190341e-03 + 9.8617639930851908e-01 -3.5919358514178157e-03 + 9.9403939774484229e-01 -8.5651153140133829e-03 + 1.0021088561614135e+00 -1.3773702960349965e-02 + 1.0102501872256084e+00 -1.9302142230898767e-02 + 1.0183634901205636e+00 -2.5159177353302198e-02 + 1.0263931086311402e+00 -3.1279025483129885e-02 + 1.0343035674918184e+00 -3.7569001179150519e-02 + 1.0420499953953737e+00 -4.3952081208843197e-02 + 1.0496147091152395e+00 -5.0325099719998434e-02 + 1.0569711244455178e+00 -5.6605549705892599e-02 + 1.0640832861433367e+00 -6.2733194981618112e-02 + 1.0709158016334541e+00 -6.8660053593220027e-02 + 1.0774375541196122e+00 -7.4347601148900821e-02 + 1.0836233863079698e+00 -7.9765758615764071e-02 + 1.0894547943099298e+00 -8.4892315496702508e-02 + 1.0949200173954736e+00 -8.9712385272335382e-02 + 1.1000137283189133e+00 -9.4217786567256212e-02 + 1.1047364463520566e+00 -9.8406341129589237e-02 + 1.1090937419026119e+00 -1.0228112207565232e-01 + 1.1130952474204463e+00 -1.0584979485354040e-01 + 1.1167411263356968e+00 -1.0913787538575548e-01 + 1.1200337984274995e+00 -1.1217342368423999e-01 + 1.1229853820353455e+00 -1.1497701188835663e-01 + 1.1256050950014185e+00 -1.1757377546453540e-01 + 1.1278968297187788e+00 -1.1999341572607136e-01 + 1.1298714258188767e+00 -1.2225619809052546e-01 + 1.1316219827501683e+00 -1.2431195017769880e-01 + 1.1332757155962980e+00 -1.2608189969880357e-01 + 1.1347925175437865e+00 -1.2763264486659409e-01 + 1.1361416591166744e+00 -1.2902543317129300e-01 + 1.1371327942793954e+00 -1.3043953903533634e-01 + 1.1379093470396171e+00 -1.3177264289491575e-01 + 1.1385187208790484e+00 -1.3300357990809175e-01 + 1.1390108300383162e+00 -1.3412172135426204e-01 + 1.1394243030071749e+00 -1.3512534048912528e-01 + 1.1397814573876843e+00 -1.3602032950244336e-01 + 1.1400960010284606e+00 -1.3681517086277495e-01 + 1.1403767667653568e+00 -1.3751902881578815e-01 + 1.1406296779997476e+00 -1.3814095039143126e-01 + 1.1408588560312367e+00 -1.3868951798718854e-01 + 8.9187594236357626e-01 2.2055795829359681e-02 + 8.9300164326841980e-01 2.2046270632380072e-02 + 8.9426631675690516e-01 2.1988722941173933e-02 + 8.9568683422996287e-01 2.1913944755326042e-02 + 8.9727548192658446e-01 2.1757023667689168e-02 + 8.9905274521957779e-01 2.1554599342174185e-02 + 9.0103488748619753e-01 2.1271813567629749e-02 + 9.0323843012888716e-01 2.0888405431236379e-02 + 9.0568659705699872e-01 2.0410978230998467e-02 + 9.0839364158948399e-01 1.9794296690903934e-02 + 9.1137703042883089e-01 1.9018809202734133e-02 + 9.1466111133340178e-01 1.8086083226293681e-02 + 9.1826410801508018e-01 1.6972673868899335e-02 + 9.2219098104408204e-01 1.5623011889587701e-02 + 9.2646556500957189e-01 1.4046532983613247e-02 + 9.3109966912334841e-01 1.2221570189133502e-02 + 9.3609977757236607e-01 1.0122589254109471e-02 + 9.4146580010813352e-01 7.7226890026977912e-03 + 9.4717483123363877e-01 4.9638080291032338e-03 + 9.5323760102974830e-01 1.8758463632622124e-03 + 9.5963843700373985e-01 -1.5511213183856398e-03 + 9.6635766086342301e-01 -5.3160034312895732e-03 + 9.7336941585851378e-01 -9.4091363401531680e-03 + 9.8062116326066473e-01 -1.3846793143969194e-02 + 9.8806618433014393e-01 -1.8613826043861081e-02 + 9.9566308133022119e-01 -2.3670626139704609e-02 + 1.0033483770264056e+00 -2.8997110117430225e-02 + 1.0110577661711062e+00 -3.4561845813243508e-02 + 1.0187351573794601e+00 -4.0313862275823453e-02 + 1.0263368874675010e+00 -4.6181991143427581e-02 + 1.0338217145890383e+00 -5.2093554257780283e-02 + 1.0411516686075544e+00 -5.7976791736578548e-02 + 1.0482817165499512e+00 -6.3776676828013024e-02 + 1.0551637579531459e+00 -6.9452113764782553e-02 + 1.0617484167099178e+00 -7.4975507443895140e-02 + 1.0679980511582698e+00 -8.0318836170093277e-02 + 1.0738896031824439e+00 -8.5451471139592172e-02 + 1.0794115369808708e+00 -9.0344468002228950e-02 + 1.0845624842902950e+00 -9.4971960319981008e-02 + 1.0893257448928040e+00 -9.9338417215577124e-02 + 1.0936995169122241e+00 -1.0344312335304551e-01 + 1.0977021502126689e+00 -1.0727419152004813e-01 + 1.1013541529135722e+00 -1.1082647946622615e-01 + 1.1046763085186342e+00 -1.1410163356219982e-01 + 1.1076925338176977e+00 -1.1710350612887055e-01 + 1.1104277856197982e+00 -1.1983871174533078e-01 + 1.1129035014890363e+00 -1.2231985213786345e-01 + 1.1151394559305530e+00 -1.2456245876123262e-01 + 1.1171548328587946e+00 -1.2658298778686117e-01 + 1.1189679370398125e+00 -1.2839836824616668e-01 + 1.1205947915629011e+00 -1.3002683306322638e-01 + 1.1220526485610307e+00 -1.3148398727336996e-01 + 1.1233566847632943e+00 -1.3278581023813274e-01 + 1.1245209492885451e+00 -1.3394751424084461e-01 + 1.1255571888893954e+00 -1.3498460775055321e-01 + 1.1264738969429615e+00 -1.3591374312113658e-01 + 1.1272805786036031e+00 -1.3674849037066394e-01 + 1.1279928104503938e+00 -1.3749451320317974e-01 + 1.1286250385412799e+00 -1.3815685575350756e-01 + 1.1291859178098136e+00 -1.3874437511117321e-01 + 1.1296831770191957e+00 -1.3926516714992943e-01 + 1.1301236607352436e+00 -1.3972664287895498e-01 + 1.1305137702820858e+00 -1.4013522574310855e-01 + 1.1308667642658179e+00 -1.4049580049749011e-01 + 1.1308760669422782e+00 -1.4049448665468844e-01 + 1.1308872393130969e+00 -1.4049290892971555e-01 + 1.1309006592395292e+00 -1.4049101407083242e-01 + 1.1309167818043875e+00 -1.4048873797734984e-01 + 1.1309361554279107e+00 -1.4048600345047646e-01 + 1.1309594414652793e+00 -1.4048271746396779e-01 + 1.1309874380702496e+00 -1.4047876785167546e-01 + 1.1310211092904225e+00 -1.4047401928199577e-01 + 1.1310616205748403e+00 -1.4046830836846880e-01 + 1.1311103821336417e+00 -1.4046143773356334e-01 + 1.1311691018858454e+00 -1.4045316881504277e-01 + 1.1312398500676437e+00 -1.4044321317686581e-01 + 1.1313251379406921e+00 -1.4043122206746261e-01 + 1.1314280134275094e+00 -1.4041677396716068e-01 + 1.1315521751958784e+00 -1.4039934804389986e-01 + 1.1317021129089326e+00 -1.4037831146926294e-01 + 1.1318832769698801e+00 -1.4035291562375107e-01 + 1.1321022770512386e+00 -1.4032226423836391e-01 + 1.1323671200345160e+00 -1.4028529004139045e-01 + 1.1326874924089481e+00 -1.4024073066960341e-01 + 1.1330750952959647e+00 -1.4018710522563538e-01 + 1.1335440425693264e+00 -1.4012269342666173e-01 + 1.1341113355835262e+00 -1.4004551987156333e-01 + 1.1347974317903606e+00 -1.3995334648012658e-01 + 1.1356269289444541e+00 -1.3984367654741447e-01 + 1.1366293915642132e+00 -1.3971377405658814e-01 + 1.1378403517763616e+00 -1.3956070192242009e-01 + 1.1393025227385607e+00 -1.3938138273599066e-01 + 9.2936809435639134e-01 -3.3148849397505842e-02 + 9.2479748743058110e-01 -3.1421567772113690e-02 + 9.2022116154533506e-01 -2.9709492479554456e-02 + 9.1563835131888283e-01 -2.8014839299416394e-02 + 9.1104853363159322e-01 -2.6339242240723593e-02 + 9.0645526532951237e-01 -2.4673132467725623e-02 + 9.0187177409353581e-01 -2.2980448198495651e-02 + 8.9731517417613560e-01 -2.1216959824315040e-02 + 8.9282329300949925e-01 -1.9296229802606035e-02 + 8.8846915298982054e-01 -1.7084725415358548e-02 + 9.2483219614244661e-01 -4.4225445553280451e-02 + 9.1996902022913218e-01 -4.2596100394192149e-02 + 9.1510821418438582e-01 -4.0959723988038377e-02 + 9.1028728672795722e-01 -3.9209864124543969e-02 + 9.0555622036913519e-01 -3.7230852737323517e-02 + 9.0099276886012802e-01 -3.4892715497562676e-02 + 8.9666580406312590e-01 -3.2141073442133461e-02 + 8.9254538667864125e-01 -2.9087828993624498e-02 + 8.8855297811095824e-01 -2.5868364834323643e-02 + 8.8458751491763365e-01 -2.2615619003545362e-02 + 9.3393018307474307e-01 -3.4898459297224349e-02 + 9.3392584935951106e-01 -3.4909697011329399e-02 + 9.3392064889138027e-01 -3.4923182261479724e-02 + 9.3391440831550199e-01 -3.4939364551831886e-02 + 9.3390691960400574e-01 -3.4958783286043627e-02 + 9.3389793312082503e-01 -3.4982085746705138e-02 + 9.3388714929857741e-01 -3.5010048669931848e-02 + 9.3387420865065707e-01 -3.5043604135125861e-02 + 9.3385867978484782e-01 -3.5083870631709146e-02 + 9.3384004501825046e-01 -3.5132190338330815e-02 + 9.3381768311402880e-01 -3.5190173857046148e-02 + 9.3379084856242400e-01 -3.5259753892106005e-02 + 9.3375864671494924e-01 -3.5343249662219023e-02 + 9.3372000393954124e-01 -3.5443444191002982e-02 + 9.3367363179946494e-01 -3.5563677049751163e-02 + 9.3361798405600638e-01 -3.5707955640106093e-02 + 9.3355120505503209e-01 -3.5881088719534660e-02 + 9.3347106776471378e-01 -3.6088846612244652e-02 + 9.3337489938283369e-01 -3.6338153431188402e-02 + 9.3325949200729497e-01 -3.6637317697383764e-02 + 9.3312099535247484e-01 -3.6996309010120854e-02 + 9.3295478787354114e-01 -3.7427089937636993e-02 + 9.3275532190670418e-01 -3.7944014108262536e-02 + 9.3251593751189432e-01 -3.8564303639418540e-02 + 9.3222863857246807e-01 -3.9308621609265515e-02 + 9.3188382330485098e-01 -4.0201758317266467e-02 + 9.3146995957605583e-01 -4.1273453672459937e-02 + 9.3097319320194316e-01 -4.2559382262439271e-02 + 9.3037687453071527e-01 -4.4102332565600477e-02 + 1.1275632793310848e+00 -1.4523738480758652e-01 + 1.1271271199748156e+00 -1.4493673221588210e-01 + 1.1266796388343465e+00 -1.4459820155464342e-01 + 1.1262161364232952e+00 -1.4422630267287673e-01 + 1.1257322261077789e+00 -1.4382402982096210e-01 + 1.1252245992457404e+00 -1.4339257672740757e-01 + 1.1246911005639504e+00 -1.4293149834045948e-01 + 1.1241279212904658e+00 -1.4244204777395453e-01 + 1.1235321444403326e+00 -1.4192425222636018e-01 + 1.1229015694978557e+00 -1.4137717261728255e-01 + 1.1222335622573354e+00 -1.4080023341350056e-01 + 1.1215264957687410e+00 -1.4019155744001921e-01 + 1.1207770466431199e+00 -1.3955109437554825e-01 + 1.1199835247783412e+00 -1.3887677014356825e-01 + 1.1191442696558340e+00 -1.3816631194748652e-01 + 1.1182556158483123e+00 -1.3741969821646194e-01 + 1.1173169583273506e+00 -1.3663313963597545e-01 + 1.1163216589989133e+00 -1.3580993675626019e-01 + 1.1152699354320958e+00 -1.3494508929584015e-01 + 1.1141554120559007e+00 -1.3404143371707278e-01 + 1.1129783950124050e+00 -1.3309361979871426e-01 + 1.1117349607129157e+00 -1.3210134006226326e-01 + 1.1104224670031826e+00 -1.3106271089313282e-01 + 1.1090383965009067e+00 -1.2997555893841195e-01 + 1.1075784601813297e+00 -1.2884003316119674e-01 + 1.1060413108224196e+00 -1.2765242645734531e-01 + 1.1044209557408919e+00 -1.2641518118346085e-01 + 1.1027171530169682e+00 -1.2512319980598363e-01 + 1.1009246228163718e+00 -1.2377821731278971e-01 + 1.0990433207858459e+00 -1.2237504206254357e-01 + 1.0970684426649129e+00 -1.2091511216750916e-01 + 1.0949997095038810e+00 -1.1939389481636908e-01 + 1.0928327111837035e+00 -1.1781281190503989e-01 + 1.0905668585480655e+00 -1.1616830727915328e-01 + 1.0881965973205610e+00 -1.1446415445745117e-01 + 1.0857211443183203e+00 -1.1269785011343458e-01 + 1.0831342050491770e+00 -1.1087537028716099e-01 + 1.0804337748126756e+00 -1.0899698116791967e-01 + 1.0776172941992002e+00 -1.0706487232940276e-01 + 1.0746799086918841e+00 -1.0508483755110376e-01 + 1.0716251695239265e+00 -1.0305172843624177e-01 + 1.0684448494598939e+00 -1.0097824526744148e-01 + 1.0651474120025100e+00 -9.8853411895788668e-02 + 1.0617205327093089e+00 -9.6698666066842520e-02 + 1.0581789217755357e+00 -9.4494858763269463e-02 + 1.0545062296741889e+00 -9.2272894097263247e-02 + 1.0507232790005219e+00 -9.0005141706782865e-02 + 1.0468103840238854e+00 -8.7731689958204129e-02 + 1.0427935738372724e+00 -8.5417335342981460e-02 + 1.0386508297178452e+00 -8.3110395451598151e-02 + 1.0344136813238265e+00 -8.0766778720203547e-02 + 1.0300643423112419e+00 -7.8431469216241112e-02 + 1.0256312924430517e+00 -7.6066482905019939e-02 + 1.0211008898170562e+00 -7.3712920398492088e-02 + 1.0164985346458053e+00 -7.1339550837080878e-02 + 1.0118146682349618e+00 -6.8982994380831997e-02 + 1.0070716403062505e+00 -6.6619008675331770e-02 + 1.0022651625877614e+00 -6.4276540382664393e-02 + 9.9741016333313581e-01 -6.1947553781209308e-02 + 9.9250767303896481e-01 -5.9652193884431881e-02 + 9.8757170323403187e-01 -5.7385270506060237e-02 + 9.8261350622586008e-01 -5.5146144650606743e-02 + 9.7764015586569997e-01 -5.2944578532219566e-02 + 9.7267088121876100e-01 -5.0761998717035794e-02 + 9.6770373472208604e-01 -4.8628185003437352e-02 + 9.6275998379120153e-01 -4.6518920934033758e-02 + 9.5783978265053804e-01 -4.4458338668817987e-02 + 9.5295387815522759e-01 -4.2445528155511170e-02 + 9.4811394509582669e-01 -4.0475522202044090e-02 + 9.4332283843652931e-01 -3.8564450669667849e-02 + 9.3859411527397185e-01 -3.6700560862783504e-02 + 1.1270000578866899e+00 -1.5506649368576575e-01 + 1.1244959664196088e+00 -1.5499509494719632e-01 + 1.1225967466557449e+00 -1.5445680551839303e-01 + 1.1210103141867407e+00 -1.5399353855261211e-01 + 1.1197821999406017e+00 -1.5331514442110006e-01 + 1.1186766447575707e+00 -1.5276502507512646e-01 + 1.1177673045028413e+00 -1.5214580329316618e-01 + 1.1169146160039460e+00 -1.5158742409822423e-01 + 1.1161489798637518e+00 -1.5099177261761554e-01 + 1.1153911496185245e+00 -1.5042256961417877e-01 + 1.1146585479278102e+00 -1.4982436180959269e-01 + 1.1139111084481712e+00 -1.4921934575890816e-01 + 1.1131509764729941e+00 -1.4858403119507102e-01 + 1.1123571474959277e+00 -1.4792792332937665e-01 + 1.1115328651368941e+00 -1.4723523513096382e-01 + 1.1106621867266853e+00 -1.4651629247646270e-01 + 1.1097523047325240e+00 -1.4575556216425412e-01 + 1.1087862329722356e+00 -1.4496648739184081e-01 + 1.1077725612099130e+00 -1.4413086095891003e-01 + 1.1066943750562857e+00 -1.4326114749599128e-01 + 1.1055577903861931e+00 -1.4234257895509472e-01 + 1.1043524353197398e+00 -1.4138199556283837e-01 + 1.1030789551512257e+00 -1.4037355422196640e-01 + 1.1017337771349247e+00 -1.3931681232550375e-01 + 1.1003122226939936e+00 -1.3821271009783231e-01 + 1.0988152584141773e+00 -1.3705440154984672e-01 + 1.0972334309352405e+00 -1.3584798157822320e-01 + 1.0955698643536707e+00 -1.3458268036836785e-01 + 1.0938143658811654e+00 -1.3326567837069092e-01 + 1.0919707028699719e+00 -1.3188648753705934e-01 + 1.0900300332281176e+00 -1.3045268753165828e-01 + 1.0879964445652845e+00 -1.2895560759250202e-01 + 1.0858630409695422e+00 -1.2740279591125159e-01 + 1.0836339189460560e+00 -1.2578772084196999e-01 + 1.0813025975985440e+00 -1.2411888903122303e-01 + 1.0788720702537518e+00 -1.2239113093474430e-01 + 1.0763358171646189e+00 -1.2061176296128906e-01 + 1.0736922511727300e+00 -1.1877981828429540e-01 + 1.0709393380872854e+00 -1.1689485730154558e-01 + 1.0680685379595332e+00 -1.1496594314213837e-01 + 1.0650868009493522e+00 -1.1298115941312403e-01 + 1.0619792117565439e+00 -1.1096234954921158e-01 + 1.0587618168016419e+00 -1.0888631445561714e-01 + 1.0554126071455272e+00 -1.0678907694344275e-01 + 1.0519571246240957e+00 -1.0463359470864475e-01 + 1.0483662187420677e+00 -1.0247071873619973e-01 + 1.0446740144794120e+00 -1.0024990354422414e-01 + 1.0408458095509090e+00 -9.8034715616279300e-02 + 1.0369217002131776e+00 -9.5762883065404480e-02 + 1.0328628237251252e+00 -9.3508370389457696e-02 + 1.0287140313717842e+00 -9.1200519506401179e-02 + 1.0244423214575917e+00 -8.8911212591838762e-02 + 1.0200898572678767e+00 -8.6578625840289192e-02 + 1.0156316531698266e+00 -8.4267562071829616e-02 + 1.0111051258982897e+00 -8.1926554920130457e-02 + 1.0064923431654620e+00 -7.9611618109737492e-02 + 1.0018250039684418e+00 -7.7283380769770815e-02 + 9.9709366876335537e-01 -7.4983067818209292e-02 + 9.9231812013609044e-01 -7.2690926280031931e-02 + 9.8749460347445961e-01 -7.0431239730538664e-02 + 9.8263559188007576e-01 -6.8195134212118091e-02 + 9.7775023159544361e-01 -6.5982130909688408e-02 + 9.7284326205240745e-01 -6.3807167073207438e-02 + 9.6793737780568279e-01 -6.1647294318106560e-02 + 9.6302936698325681e-01 -5.9539930747277481e-02 + 9.5814507211110111e-01 -5.7454401048673276e-02 + 9.5328345433536299e-01 -5.5419687300513942e-02 + 9.4845690825398776e-01 -5.3430522018715010e-02 + 9.4367570137481493e-01 -5.1483369735919382e-02 + 9.3894207954242859e-01 -4.9593729419626698e-02 + 9.3426890520427008e-01 -4.7749128953682884e-02 + 1.1279763740565443e+00 -1.4552836361632160e-01 + 1.1279780405840896e+00 -1.4553708041957236e-01 + 1.1279800434029141e+00 -1.4554754872011699e-01 + 1.1279824510308600e+00 -1.4556012235598814e-01 + 1.1279853462057901e+00 -1.4557522745576534e-01 + 1.1279888289313078e+00 -1.4559337753951240e-01 + 1.1279930202035757e+00 -1.4561519189928163e-01 + 1.1279980665765450e+00 -1.4564141801211861e-01 + 1.1280041457580907e+00 -1.4567295891535537e-01 + 1.1280114734699112e+00 -1.4571090669193154e-01 + 1.1280203118498520e+00 -1.4575658346916498e-01 + 1.1280309797261268e+00 -1.4581159163414270e-01 + 1.1280438651468359e+00 -1.4587787529774232e-01 + 1.1280594406061795e+00 -1.4595779539550335e-01 + 1.1280782814735062e+00 -1.4605422117034550e-01 + 1.1281010882129223e+00 -1.4617064113583922e-01 + 1.1281287131007360e+00 -1.4631129696391554e-01 + 1.1281621923435381e+00 -1.4648134412018976e-01 + 1.1282027848253406e+00 -1.4668704355251805e-01 + 1.1282520109399243e+00 -1.4693599107982891e-01 + 1.1283116631939691e+00 -1.4723739668579583e-01 + 1.1283839839245644e+00 -1.4760238359566813e-01 + 1.1284717064264171e+00 -1.4804437726999709e-01 + 1.1285781716981020e+00 -1.4857955641284093e-01 + 1.1287074779767110e+00 -1.4922739127864304e-01 + 1.1288646718617201e+00 -1.5001128846940048e-01 + 1.1290559909938835e+00 -1.5095936564500789e-01 + 1.1292891695082332e+00 -1.5210538432872056e-01 + 1.1295738191277493e+00 -1.5348987438068207e-01 + 1.1407786764633698e+00 -1.4187297365037921e-01 + 1.1406447903278050e+00 -1.4411787911335239e-01 + 1.1400803157006791e+00 -1.4583397282713406e-01 + 1.1396004098705248e+00 -1.4736165529495793e-01 + 1.1387478796439368e+00 -1.4865447325723835e-01 + 1.1379380564247299e+00 -1.5001094722830999e-01 + 1.1366844712754016e+00 -1.5118543711348309e-01 + 1.1351888519994517e+00 -1.5253648401400710e-01 + 1.1328675721642156e+00 -1.5373936298014712e-01 + 1.1305706253279055e+00 -1.4099931859186654e-01 + 1.1302823066822683e+00 -1.4150178882745479e-01 + 1.1299938430401966e+00 -1.4200417585917080e-01 + 1.1297054182401922e+00 -1.4250658519435433e-01 + 1.1294170566644937e+00 -1.4300903082958882e-01 + 1.1291285889916978e+00 -1.4351141555340519e-01 + 1.1288401567251682e+00 -1.4401382060364654e-01 + 1.1285516972593470e+00 -1.4451621002285719e-01 + 1.1282633750363331e+00 -1.4501867820760594e-01 + 6.9993156056109740e-01 -1.7224263057954659e-02 + 6.9993345013216413e-01 -1.7225789017885518e-02 + 6.9993574194185726e-01 -1.7227639813526707e-02 + 6.9993852711103699e-01 -1.7229889031128209e-02 + 6.9994191962884855e-01 -1.7232628724997312e-02 + 6.9994606290213568e-01 -1.7235974706096613e-02 + 6.9995112835844964e-01 -1.7240065414043215e-02 + 6.9995734316876934e-01 -1.7245084305258729e-02 + 6.9996499944004142e-01 -1.7251267276321869e-02 + 6.9997447578414551e-01 -1.7258920082667828e-02 + 6.9999487087230250e-01 -1.7275390533583845e-02 + 7.0001940080187808e-01 -1.7295200156240753e-02 + 7.0004891575725026e-01 -1.7319035533645888e-02 + 7.0008444524192015e-01 -1.7347728061395173e-02 + 7.0012723739719007e-01 -1.7382285700278999e-02 + 7.0017880729871962e-01 -1.7423931979266172e-02 + 7.0024099627244851e-01 -1.7474153896998246e-02 + 7.0031604465946629e-01 -1.7534760684441153e-02 + 7.0040668086842572e-01 -1.7607955721317126e-02 + 7.0051622995644180e-01 -1.7696424222236828e-02 + 7.0064874534850929e-01 -1.7803439609565430e-02 + 7.0080916762989887e-01 -1.7932991749205485e-02 + 7.0100351464517274e-01 -1.8089940468840382e-02 + 7.0123910750331220e-01 -1.8280198072673670e-02 + 7.0152483770074525e-01 -1.8510945061947837e-02 + 7.0187148169510749e-01 -1.8790884174961775e-02 + 7.0229207119166404e-01 -1.9130539419379033e-02 + 7.0280233037216533e-01 -1.9542609164545865e-02 + 7.0342119536882564e-01 -2.0042385653056272e-02 + 7.0417143635099677e-01 -2.0648257378923063e-02 + 7.0508040708241992e-01 -2.1382314407091485e-02 + 7.0618095296586603e-01 -2.2271081682703198e-02 + 7.0751251329396325e-01 -2.3346409175132976e-02 + 7.0912245862536594e-01 -2.4646551902208103e-02 + 6.9993639920956241e-01 3.1006995129196468e-02 + 6.9993618021088366e-01 2.9594018115453480e-02 + 6.9993594590734176e-01 2.7639124116873859e-02 + 6.9993560415558420e-01 2.5011842088147773e-02 + 6.9993513571653665e-01 2.1615328462807781e-02 + 6.9993459591000118e-01 1.7438091547631984e-02 + 6.9993397439122162e-01 1.2604812488731909e-02 + 6.9993328311795722e-01 7.3919960956487785e-03 + 6.9993258089691324e-01 2.1791797038872573e-03 + 6.9993194181338936e-01 -2.6540993526111833e-03 + 6.9993138931004495e-01 -6.8313362661172050e-03 + 6.9993094237980813e-01 -1.0227849894278052e-02 + 6.9993061175970439e-01 -1.2855131921583052e-02 + 6.9993035478059795e-01 -1.4810026238563978e-02 + 6.9993013350554634e-01 -1.6223002925002561e-02 + 6.9993925733068352e-01 3.2004709925921304e-02 + 6.9994258493068884e-01 3.2001942949548834e-02 + 6.9994662089211346e-01 3.1998586965030995e-02 + 6.9995152568566255e-01 3.1994508544826772e-02 + 6.9995750005668356e-01 3.1989540777786374e-02 + 6.9996479656127519e-01 3.1983473681535202e-02 + 6.9997371828988975e-01 3.1976057671634806e-02 + 6.9998466599194131e-01 3.1966960927363175e-02 + 6.9999815504689877e-01 3.1955756871212770e-02 + 7.0001485352317161e-01 3.1941892676229600e-02 + 7.0005022172550468e-01 3.1911380023352365e-02 + 7.0009278144375742e-01 3.1874705758461630e-02 + 7.0014402004530751e-01 3.1830613080565229e-02 + 7.0020574200673735e-01 3.1777584092779421e-02 + 7.0028014000732952e-01 3.1713784402228384e-02 + 7.0036988184648408e-01 3.1636994614665070e-02 + 7.0047821814281264e-01 3.1544527338795092e-02 + 7.0060911486366706e-01 3.1433125899603453e-02 + 7.0076741591267222e-01 3.1298840904455005e-02 + 7.0095904170319301e-01 3.1136880217559337e-02 + 7.0119123013168405e-01 3.0941427164684399e-02 + 7.0147282673408284e-01 3.0705421074657124e-02 + 7.0181463108643527e-01 3.0420293508655050e-02 + 7.0222980694686044e-01 3.0075652706955225e-02 + 7.0273436468831108e-01 2.9658907807331047e-02 + 7.0334772688181602e-01 2.9154823106253502e-02 + 7.0409339208117672e-01 2.8544990760394739e-02 + 7.0499971823799967e-01 2.7807207429162872e-02 + 7.0610085546179135e-01 2.6914735841771176e-02 + 7.0743786824744603e-01 2.5835426807802264e-02 + 7.0906009567856643e-01 2.4530671318004238e-02 + 7.1102680899177528e-01 2.2954143461575427e-02 + 7.1340923478000917e-01 2.1050288794064898e-02 + 7.1629302342725509e-01 1.8752507906881988e-02 + 7.1957903385194300e-01 1.5001642567376905e-02 + 7.1930263218887092e-01 1.3663068943621681e-02 + 7.1893272907131234e-01 1.1871681182199723e-02 + 7.1845142709587861e-01 9.5408047244092131e-03 + 7.1784759455412939e-01 6.6165303024021682e-03 + 7.1712375073251167e-01 3.1110584591971246e-03 + 7.1630192766515677e-01 -8.6891282289514038e-04 + 7.1542448375674184e-01 -5.1182478631517370e-03 + 7.1454703984835533e-01 -9.3675829034367553e-03 + 7.1372521678095779e-01 -1.3347554185500599e-02 + 7.1300137295935428e-01 -1.6853026028712748e-02 + 7.1239754041760506e-01 -1.9777300450712687e-02 + 7.1191623844218554e-01 -2.2108176908488986e-02 + 7.1154633532463407e-01 -2.3899564669903839e-02 + 7.1126993366156910e-01 -2.5238138293644852e-02 + 8.1524727153779963e-01 3.2007001340389252e-02 + 8.1210782312214036e-01 3.2007001340389252e-02 + 8.0730696549851189e-01 3.2007001340389252e-02 + 8.0025136705997113e-01 3.2007001340389252e-02 + 7.9046487029476964e-01 3.2007001340389252e-02 + 7.7792616269328363e-01 3.2007001340389252e-02 + 7.6339867858187205e-01 3.2007001340389252e-02 + 7.4840537115472472e-01 3.2007001340389252e-02 + 7.3466952068857694e-01 3.2007001340389252e-02 + 7.2339298757120218e-01 3.2007001340389252e-02 + 7.1493996937204685e-01 3.2007001340389252e-02 + 7.0902546015736334e-01 3.2007001340389252e-02 + 7.0508388650925724e-01 3.2007001340389252e-02 + 7.0254169774488417e-01 3.2007001340389252e-02 + 7.0093650913161554e-01 3.2007001340389252e-02 + 8.1724727003425812e-01 3.2005427691700561e-02 + 8.1724726821374816e-01 3.2003522273811313e-02 + 8.1724726600570818e-01 3.2001211243894545e-02 + 8.1724726332234354e-01 3.1998402716993724e-02 + 8.1724726005381854e-01 3.1994981747935469e-02 + 8.1724725606198234e-01 3.1990803727225625e-02 + 8.1724725118166930e-01 3.1985695789593649e-02 + 8.1724724519400382e-01 3.1979428858960546e-02 + 8.1724723781758257e-01 3.1971708378627284e-02 + 8.1724722868760580e-01 3.1962152561419543e-02 + 8.1724720903795856e-01 3.1941586430484392e-02 + 8.1724718540462504e-01 3.1916850781414041e-02 + 8.1724715696843475e-01 3.1887088299761501e-02 + 8.1724712273756239e-01 3.1851260848149821e-02 + 8.1724708150946412e-01 3.1808109817802688e-02 + 8.1724703182445779e-01 3.1756107426829772e-02 + 8.1724697190852424e-01 3.1693396907130023e-02 + 8.1724689960316255e-01 3.1617719129116040e-02 + 8.1724681227973406e-01 3.1526322802392315e-02 + 8.1724670673470001e-01 3.1415854984281566e-02 + 8.1724657906278253e-01 3.1282228255889777e-02 + 8.1724642450395635e-01 3.1120460597932720e-02 + 8.1724623726042012e-01 3.0924483697354788e-02 + 8.1724601027853794e-01 3.0686915046871377e-02 + 8.1724573499187159e-01 3.0398788581820213e-02 + 8.1724540101778587e-01 3.0049237468197987e-02 + 8.1724499580098353e-01 2.9625120710605302e-02 + 8.1724450419193317e-01 2.9110582257018791e-02 + 8.1724390794663293e-01 2.8486527167927989e-02 + 8.1724318512717531e-01 2.7729994312572614e-02 + 8.1724230937958708e-01 2.6813400525860231e-02 + 8.1724124905898066e-01 2.5703624947865933e-02 + 8.1723996616756267e-01 2.4360897529611236e-02 + 8.1723841506619976e-01 2.2737450440672546e-02 + 7.2061200195841479e-01 1.6021855480332192e-02 + 7.2194550374693733e-01 1.6087465180298466e-02 + 7.2405741336056906e-01 1.6191373369508710e-02 + 7.2733185442370996e-01 1.6352479336958936e-02 + 7.3224530107474095e-01 1.6594226114797550e-02 + 7.3926760038204975e-01 1.6939730676298836e-02 + 7.4863551948897822e-01 1.7400642215640971e-02 + 7.6004650322767020e-01 1.7962074698125718e-02 + 7.7250211255907431e-01 1.8574903865896886e-02 + 7.8457074168176177e-01 1.9168693197649134e-02 + 7.9498720543826096e-01 1.9681194243972300e-02 + 8.0311728487689749e-01 2.0081202760927397e-02 + 8.0897868525013195e-01 2.0369589865651960e-02 + 8.1296697184440347e-01 2.0565817789091057e-02 + 8.1557505169411826e-01 2.0694138079292657e-02 + 8.7301115679177599e-01 3.0990533201205039e-02 + 8.7164714362059215e-01 3.1053259227803665e-02 + 8.6981223418285936e-01 3.1135348679555364e-02 + 8.6739300471735703e-01 3.1241048200215005e-02 + 8.6428630581303878e-01 3.1368029981862833e-02 + 8.6042921109479664e-01 3.1510542957661869e-02 + 8.5583613406016923e-01 3.1650988231675115e-02 + 8.5063108023579304e-01 3.1770571031614736e-02 + 8.4505398632670392e-01 3.1867262555998366e-02 + 8.3942557917793437e-01 3.1940116876569391e-02 + 8.3407819568886055e-01 3.1983861101274158e-02 + 8.2928145302363987e-01 3.2001574239274078e-02 + 8.2519538654958069e-01 3.2006179881442165e-02 + 8.2186513885646661e-01 3.2006942519259951e-02 + 8.1924727153761268e-01 3.2006975864959486e-02 + 8.7401070667475267e-01 3.0942905872365145e-02 + 8.7401153030390333e-01 3.0942791065612596e-02 + 8.7401252926148487e-01 3.0942651819557909e-02 + 8.7401374326537251e-01 3.0942482597922094e-02 + 8.7401522200131865e-01 3.0942276474931418e-02 + 8.7401702797769332e-01 3.0942024737441898e-02 + 8.7401923591669117e-01 3.0941716969849153e-02 + 8.7402194483787810e-01 3.0941339369647380e-02 + 8.7402528206531116e-01 3.0940874188999601e-02 + 8.7402941262895695e-01 3.0940298424141588e-02 + 8.7403830247173175e-01 3.0939059256965606e-02 + 8.7404899461560603e-01 3.0937568864601417e-02 + 8.7406185964029959e-01 3.0935775591423464e-02 + 8.7407734628734346e-01 3.0933616886741788e-02 + 8.7409599859859810e-01 3.0931016915900500e-02 + 8.7411847696759537e-01 3.0927883625672337e-02 + 8.7414558399427023e-01 3.0924105140599067e-02 + 8.7417829620200393e-01 3.0919545341760113e-02 + 8.7421780285383477e-01 3.0914038456202775e-02 + 8.7426555328080013e-01 3.0907382459673727e-02 + 8.7432331429621968e-01 3.0899331073690917e-02 + 8.7439323940991187e-01 3.0889584117623770e-02 + 8.7447795168942832e-01 3.0877775958543907e-02 + 8.7458064227116949e-01 3.0863461779603085e-02 + 8.7470518679437959e-01 3.0846101350249455e-02 + 8.7485628251820202e-01 3.0825039913167984e-02 + 8.7503960972264849e-01 3.0799485686465289e-02 + 8.7526202228846728e-01 3.0768483298423632e-02 + 8.7553177412651451e-01 3.0730882225292078e-02 + 8.7585879033359504e-01 3.0685298994328036e-02 + 8.7625499391089079e-01 3.0630071642434586e-02 + 8.7673470156357070e-01 3.0563204544634459e-02 + 8.7731510415203928e-01 3.0482301443683468e-02 + 8.7801684962906279e-01 3.0384484193568539e-02 + 8.1947039603931415e-01 2.0852822106974145e-02 + 8.2239406284098493e-01 2.0961796987045034e-02 + 8.2611275508244830e-01 2.1115059871959829e-02 + 8.3067433728886897e-01 2.1327924832654332e-02 + 8.3602731560599608e-01 2.1617791796451513e-02 + 8.4199134117579177e-01 2.2001609709192849e-02 + 8.4826295202609003e-01 2.2491865562336955e-02 + 8.5446772199279053e-01 2.3092362318628545e-02 + 8.6024357141952379e-01 2.3795990575280257e-02 + 8.6531777220098860e-01 2.4586155268508492e-02 + 8.6954533864640382e-01 2.5441766669430876e-02 + 8.7290066940691702e-01 2.6343848099557476e-02 + 8.7543828303093818e-01 2.7281640334045676e-02 + 8.7724297706610344e-01 2.8256497250751522e-02 + 8.7837576394605321e-01 2.9271243939454905e-02 + 3.7506654960897379e-01 9.0784233325372554e-02 + 3.8103361358792398e-01 9.1218357178988185e-02 + 3.8793110590636815e-01 9.1653804415024354e-02 + 3.9587002926282366e-01 9.2077008055909459e-02 + 4.0496251047110832e-01 9.2471603428478488e-02 + 4.1531758688836362e-01 9.2818715527378970e-02 + 4.2703525200911230e-01 9.3097491736955362e-02 + 4.4019919916475203e-01 9.3285937197194357e-02 + 4.5486857237320066e-01 9.3362050567989741e-02 + 4.7106898001615605e-01 9.3305215674291730e-02 + 4.8878360703541546e-01 9.3097767663607556e-02 + 5.0794545147658710e-01 9.2726392903060173e-02 + 5.2843145560898819e-01 9.2167183601219449e-02 + 5.5006161388867270e-01 9.1425886840262649e-02 + 5.7260147270936557e-01 9.0516780519386941e-02 + 5.9576932098202917e-01 8.9447202404429049e-02 + 6.1924878837894681e-01 8.8220474655528847e-02 + 6.4270519582872510e-01 8.6835534316030305e-02 + 6.6580375746866594e-01 8.5283820537213728e-02 + 6.8822711001321579e-01 8.3541589047193554e-02 + 7.0968873358155804e-01 8.1550553657876890e-02 + 7.2994523376080167e-01 7.9246887670066712e-02 + 7.4881682535013283e-01 7.6672631631844013e-02 + 7.6618523525610271e-01 7.3894488894225674e-02 + 7.8198994178288928e-01 7.0982953676704597e-02 + 7.9622265687434179e-01 6.8007407931290231e-02 + 8.0891879388713051e-01 6.5032108954611090e-02 + 8.2014779933996351e-01 6.2113290024107926e-02 + 8.3000353164982243e-01 5.9297421615717383e-02 + 8.3858265700182244e-01 5.6579986879533806e-02 + 8.4598231605104957e-01 5.3936180415469437e-02 + 8.5231303906967071e-01 5.1377279960924227e-02 + 8.5768381790306591e-01 4.8912976706546374e-02 + 8.6219926085627208e-01 4.6551869484332542e-02 + 8.6595785854268570e-01 4.4302030220272570e-02 + 8.6905090626501647e-01 4.2171771685154624e-02 + 8.7156248420400573e-01 4.0170254533279603e-02 + 8.7357358545015984e-01 3.8304321208130432e-02 + 8.7515588693172219e-01 3.6583812644067848e-02 + 8.7637929513868329e-01 3.5014193099897284e-02 + 8.7730705032885936e-01 3.3599993178704324e-02 + 8.7799738633955826e-01 3.2341163540770879e-02 + 8.7850203014137662e-01 3.1232741071697490e-02 + 3.7063196060276482e-01 6.0938990035538154e-02 + 3.7063166970769146e-01 6.0950946467883682e-02 + 3.7063132063009618e-01 6.0965294369843548e-02 + 3.7063090173194979e-01 6.0982512114371445e-02 + 3.7063039904704453e-01 6.1003173782545161e-02 + 3.7062979761653736e-01 6.1027968362964202e-02 + 3.7062907588942551e-01 6.1057722621583821e-02 + 3.7062820980213473e-01 6.1093428815375717e-02 + 3.7062717047676585e-01 6.1136277784399340e-02 + 3.7062592325772670e-01 6.1187698719272987e-02 + 3.7062442720712596e-01 6.1249518189974594e-02 + 3.7062263199486267e-01 6.1323701512137063e-02 + 3.7062047780980834e-01 6.1412721437356765e-02 + 3.7061789288804903e-01 6.1519545259379527e-02 + 3.7061479112621498e-01 6.1647733718828590e-02 + 3.7061106921957077e-01 6.1801559687800989e-02 + 3.7060660323000150e-01 6.1986150588580813e-02 + 3.7060124447148723e-01 6.2207659293378015e-02 + 3.7059481457770005e-01 6.2473469199289866e-02 + 3.7058709959069347e-01 6.2792440312250619e-02 + 3.7057784287758011e-01 6.3175204538524099e-02 + 3.7056673664610429e-01 6.3634520022162633e-02 + 3.7055341178423618e-01 6.4185696331996667e-02 + 3.7053742569787573e-01 6.4847104661694743e-02 + 3.7051824775885933e-01 6.5640790035288887e-02 + 3.7049524190219785e-01 6.6593205906912090e-02 + 3.7046764582561309e-01 6.7736095615615000e-02 + 3.7043454614568816e-01 6.9107550044051891e-02 + 3.7039484874474482e-01 7.0753276691746692e-02 + 3.7034724340662706e-01 7.2728122407312412e-02 + 3.7029016167876705e-01 7.5097900463006795e-02 + 3.7022172671038334e-01 7.7941582777995677e-02 + 3.7013969359955468e-01 8.1353930237312966e-02 + 3.7004137853100616e-01 8.5448648610821465e-02 + 3.7563096559563292e-01 6.1040227699230343e-02 + 3.8142657105628786e-01 6.1168769641071208e-02 + 3.8812171060105527e-01 6.1309266495428005e-02 + 3.9582395520837110e-01 6.1436883669578890e-02 + 4.0464132643607797e-01 6.1574356399901831e-02 + 4.1467986011814162e-01 6.1691791720988931e-02 + 4.2603646310966070e-01 6.1791256192989863e-02 + 4.3879278164127555e-01 6.1863970675801738e-02 + 4.5300687194587397e-01 6.1892498351824088e-02 + 4.6870435405647015e-01 6.1850366216567920e-02 + 4.8586961255075778e-01 6.1711417742365882e-02 + 5.0443840831859177e-01 6.1467876559582635e-02 + 5.2429230318755771e-01 6.1098064007694575e-02 + 5.4525695494738358e-01 6.0587425332073508e-02 + 5.6710390457334370e-01 5.9900248907688081e-02 + 5.8955980220272863e-01 5.9038765860186970e-02 + 6.1231799588026803e-01 5.8009413179028968e-02 + 6.3505408298033217e-01 5.6810100770135818e-02 + 6.5744473831819050e-01 5.5451924442451173e-02 + 6.7918668562233364e-01 5.3967035865177593e-02 + 7.0001091723035813e-01 5.2380215789945339e-02 + 7.1969479211728071e-01 5.0713956664225179e-02 + 7.3807127226010039e-01 4.9011303527564110e-02 + 7.5502938846769041e-01 4.7310769031994937e-02 + 7.7051151884829494e-01 4.5642003164239497e-02 + 7.8450842692929257e-01 4.4032665777407942e-02 + 7.9705163974439586e-01 4.2509587003422666e-02 + 8.0820267855264660e-01 4.1082474280258907e-02 + 8.1804682605167045e-01 3.9765304310407146e-02 + 8.2668445709494875e-01 3.8570895274496309e-02 + 8.3422228720553449e-01 3.7497933004814854e-02 + 8.4076870972844375e-01 3.6538787366950487e-02 + 8.4642910905526492e-01 3.5677125412405530e-02 + 8.5130559125407501e-01 3.4906537867797738e-02 + 8.5549383954310798e-01 3.4222257297074066e-02 + 8.5908147650418698e-01 3.3617998303064667e-02 + 8.6214789270037784e-01 3.3088242478676477e-02 + 8.6476409015581623e-01 3.2627592305061626e-02 + 8.6699252197442433e-01 3.2228450127824715e-02 + 8.6888846754435178e-01 3.1886102833013297e-02 + 8.7049946146372292e-01 3.1592236801792239e-02 + 8.7186697276357705e-01 3.1340582926397076e-02 + 8.7302685260032575e-01 3.1125672965089279e-02 + 3.5939456484845778e-01 -8.4190549556751648e-02 + 3.6524675348896096e-01 -8.4529363646652200e-02 + 3.7178338221961127e-01 -8.4852599326694644e-02 + 3.7905021405328654e-01 -8.5143798682324245e-02 + 3.8708680983008037e-01 -8.5382608617848632e-02 + 3.9592378322520716e-01 -8.5544708166736427e-02 + 4.0557867736165321e-01 -8.5602036901121892e-02 + 4.1605395835298253e-01 -8.5523477358165678e-02 + 4.2733313651407911e-01 -8.5275979915920175e-02 + 4.3937813015013916e-01 -8.4826232049209693e-02 + 4.5212860330116200e-01 -8.4142731687606442e-02 + 4.6550027727402465e-01 -8.3198258599679775e-02 + 4.7938634977568029e-01 -8.1972406791294361e-02 + 4.9366020774716191e-01 -8.0453909119512446e-02 + 5.0817972512075471e-01 -7.8642420161699533e-02 + 5.2279241116571029e-01 -7.6549537284904545e-02 + 5.3734186630109093e-01 -7.4198774337872919e-02 + 5.5167458995045138e-01 -7.1624457885960169e-02 + 5.6564639567501018e-01 -6.8869682112065789e-02 + 5.7912822416648169e-01 -6.5983510987109639e-02 + 5.9201023785099949e-01 -6.3017907226480929e-02 + 6.0420430166091421e-01 -6.0024714522782574e-02 + 6.1564548809748487e-01 -5.7052836261476614e-02 + 6.2629222924930872e-01 -5.4145922654896594e-02 + 6.3612357508036155e-01 -5.1341207555438473e-02 + 6.4513833022449774e-01 -4.8668301968120886e-02 + 6.5335073711908365e-01 -4.6149426462761767e-02 + 6.6078866065076625e-01 -4.3799360500287321e-02 + 6.6748907881358832e-01 -4.1626573644208520e-02 + 6.7349657682816400e-01 -3.9633706988070116e-02 + 6.7885980252517442e-01 -3.7818897778464589e-02 + 6.8362943060841985e-01 -3.6176755805371386e-02 + 6.8785691127815340e-01 -3.4699131925975735e-02 + 6.9159270682092711e-01 -3.3376084773934167e-02 + 6.9488525867770079e-01 -3.2196595315966192e-02 + 6.9778029151409271e-01 -3.1149137734317378e-02 + 7.0032060383694272e-01 -3.0222039127338007e-02 + 7.0254567093500242e-01 -2.9403867477270751e-02 + 7.0449155817168929e-01 -2.8683670013961660e-02 + 7.0619095985465208e-01 -2.8051129593535507e-02 + 7.0767331944105649e-01 -2.7496659008065194e-02 + 7.0896500443448929e-01 -2.7011447401974920e-02 + 7.1008951498921391e-01 -2.6587470930223844e-02 + 6.9894680521218788e-01 -1.7405562400782060e-02 + 6.9781706235705343e-01 -1.7615742431317472e-02 + 6.9652005077724510e-01 -1.7857599847516781e-02 + 6.9503230470036925e-01 -1.8134789264266260e-02 + 6.9332769976406183e-01 -1.8452162848916487e-02 + 6.9137722337339369e-01 -1.8815540872623160e-02 + 6.8914853644749030e-01 -1.9230131240931314e-02 + 6.8660619484823826e-01 -1.9702136370511880e-02 + 6.8371170496344291e-01 -2.0238963127582110e-02 + 6.8042356836201634e-01 -2.0848669855681123e-02 + 6.7669750903415604e-01 -2.1539470670902006e-02 + 6.7248702880381472e-01 -2.2319832825530739e-02 + 6.6774415707621415e-01 -2.3198180573047011e-02 + 6.6242046453313463e-01 -2.4182318752664855e-02 + 6.5646847010729914e-01 -2.5279051446958078e-02 + 6.4984347412351440e-01 -2.6494026910697244e-02 + 6.4250501123753168e-01 -2.7827375545086852e-02 + 6.3441921290755943e-01 -2.9272194616197567e-02 + 6.2556343806144099e-01 -3.0824339161725334e-02 + 6.1592841796507969e-01 -3.2477968020359071e-02 + 6.0552054818543866e-01 -3.4222138387747236e-02 + 5.9436115145501844e-01 -3.6019858896494839e-02 + 5.8249683140493858e-01 -3.7858969898664441e-02 + 5.6999396934060798e-01 -3.9714523676565250e-02 + 5.5693554601215567e-01 -4.1526760373358229e-02 + 5.4342850166409562e-01 -4.3254108111810297e-02 + 5.2960488844004772e-01 -4.4923264992647205e-02 + 5.1559735548359953e-01 -4.6470043316290344e-02 + 5.0154948773878516e-01 -4.7843904257746317e-02 + 4.8761788110633120e-01 -4.9135586729448733e-02 + 4.7393309769014991e-01 -5.0197009816812965e-02 + 4.6064097085380951e-01 -5.1190820530806036e-02 + 4.4784281636875534e-01 -5.1901117629739701e-02 + 4.3565188106681774e-01 -5.2574602835974815e-02 + 4.2413441859709877e-01 -5.3008306973651997e-02 + 4.1335437595471092e-01 -5.3414242665766665e-02 + 4.0334246340485436e-01 -5.3717125275298372e-02 + 3.9411274209111014e-01 -5.3932665279262437e-02 + 3.8566381354094403e-01 -5.4129971571768465e-02 + 3.7797718318226714e-01 -5.4266545853479897e-02 + 3.7102333257917053e-01 -5.4323565861508882e-02 + 3.6476566760623541e-01 -5.4374877304226743e-02 + 3.5916053596269393e-01 -5.4420838120648796e-02 + 3.5416071943949134e-01 -5.4471729249684131e-02 + 3.5416073787878588e-01 -5.4483601962004968e-02 + 3.5416075995711793e-01 -5.4497849720831937e-02 + 3.5416078638086645e-01 -5.4514947753204979e-02 + 3.5416081798875609e-01 -5.4535466424638912e-02 + 3.5416083476478377e-01 -5.4560090328365618e-02 + 3.5416085485812232e-01 -5.4589641115839527e-02 + 3.5416087891573511e-01 -5.4625105054782352e-02 + 3.5416090770696940e-01 -5.4667666034575291e-02 + 3.5416094214490101e-01 -5.4718745235177835e-02 + 3.5416098123886997e-01 -5.4780448480983068e-02 + 3.5416102810435746e-01 -5.4854492491188012e-02 + 3.5416108427507709e-01 -5.4943345469013138e-02 + 3.5416115158257355e-01 -5.5049969280162259e-02 + 3.5416123221193629e-01 -5.5177918194758035e-02 + 3.5416132876710549e-01 -5.5331457381754490e-02 + 3.5416144434704933e-01 -5.5515705107609392e-02 + 3.5416158263370789e-01 -5.5736803382984590e-02 + 3.5416174799364342e-01 -5.6002122749859495e-02 + 3.5416194559331871e-01 -5.6320508041750372e-02 + 3.5416218152977308e-01 -5.6702573317366500e-02 + 3.5416246297572940e-01 -5.7161055811391748e-02 + 3.5416279833906827e-01 -5.7711240715306644e-02 + 3.5416319743470126e-01 -5.8371470969419192e-02 + 3.5416367166622820e-01 -5.9163759085137713e-02 + 3.5416423421384025e-01 -6.0114521425333578e-02 + 3.5416490022513614e-01 -6.1255459459232497e-02 + 3.5416568700792084e-01 -6.2624617413192141e-02 + 3.5416661422927831e-01 -6.4267651621975119e-02 + 3.5416770413931431e-01 -6.6239353940417800e-02 + 3.5416898185882673e-01 -6.8605480036694644e-02 + 3.5417047580824601e-01 -7.1444943543752970e-02 + 3.5417221840501156e-01 -7.4852449254308340e-02 + 3.5417424721921975e-01 -7.8941653279045454e-02 + 3.4916088919338506e-01 -5.4436398372885719e-02 + 3.4316201539532187e-01 -5.4384126689768664e-02 + 3.3602143895756598e-01 -5.4321906686283228e-02 + 3.2760186438547123e-01 -5.4248542026712698e-02 + 3.1778538158185654e-01 -5.4077800973672652e-02 + 3.0648674343602522e-01 -5.3858765950977272e-02 + 2.9367620895488500e-01 -5.3541308423021405e-02 + 2.7939556132956511e-01 -5.3086879871784731e-02 + 2.6377533623868032e-01 -5.2457484517645980e-02 + 2.4703672586261405e-01 -5.1681146052942495e-02 + 2.2949247417906804e-01 -5.0745196315290286e-02 + 2.1152956671895140e-01 -4.9587122242911619e-02 + 1.9356688178358894e-01 -4.8274774044472224e-02 + 1.7602546407492525e-01 -4.6849238674667504e-02 + 1.5929215006914887e-01 -4.5312585664802896e-02 + 1.4367785441393011e-01 -4.3737595141976726e-02 + 1.2941137266875558e-01 -4.2130203613552908e-02 + 1.1661882142399804e-01 -4.0567158487448296e-02 + 1.0534259060132456e-01 -3.9079529776188338e-02 + 9.5551716058160707e-02 -3.7694733192779495e-02 + 8.7162774583781299e-02 -3.6420525947733040e-02 + 8.0056347307184694e-02 -3.5264974489209067e-02 + 7.4090401240773929e-02 -3.4252845876920901e-02 + 6.9121236470280678e-02 -3.3380219453903237e-02 + 6.5007802396507941e-02 -3.2646205169498899e-02 + 6.1625406619057799e-02 -3.2011987484992233e-02 + 5.8865290983803220e-02 -3.1427308315812752e-02 + 5.6624796195585247e-02 -3.0888022000610249e-02 + 5.4816400934612375e-02 -3.0387839669927530e-02 + 5.3374787434350424e-02 -2.9893162754959235e-02 + 5.2238064201219458e-02 -2.9409734714732849e-02 + 5.1343059722327666e-02 -2.8963553984439727e-02 + 5.1340429222690886e-02 -2.8968323709918309e-02 + 5.1337272109762466e-02 -2.8974048311326328e-02 + 5.1333482857138790e-02 -2.8980919133317684e-02 + 5.1328934758430478e-02 -2.8989165924883764e-02 + 5.1323475670457697e-02 -2.8999064558036025e-02 + 5.1316922848371860e-02 -2.9010946392972414e-02 + 5.1309056866870151e-02 -2.9025209300186816e-02 + 5.1299614217136025e-02 -2.9042331084355055e-02 + 5.1288278456837588e-02 -2.9062885531118354e-02 + 5.1274610655902109e-02 -2.9087668525662025e-02 + 5.1258208196891530e-02 -2.9117410109904540e-02 + 5.1238523681888637e-02 -2.9153102847331525e-02 + 5.1214900039703082e-02 -2.9195938165059943e-02 + 5.1186548514209562e-02 -2.9247346266970453e-02 + 5.1152522220874630e-02 -2.9309044081244906e-02 + 5.1111684376472510e-02 -2.9383092868030758e-02 + 5.1062670124181864e-02 -2.9471967439349100e-02 + 5.1003840658822241e-02 -2.9578639341394819e-02 + 5.0933228094379501e-02 -2.9706676822357281e-02 + 5.0848469203522484e-02 -2.9860364979214182e-02 + 5.0746725780797419e-02 -3.0044850157679548e-02 + 5.0624588932876691e-02 -3.0266313497392616e-02 + 5.0477964057527913e-02 -3.0532179492283262e-02 + 5.0301932627441204e-02 -3.0851366609581987e-02 + 5.0090586117612190e-02 -3.1234588419323472e-02 + 4.9836826483186769e-02 -3.1694715375962801e-02 + 4.9532126475234861e-02 -3.2247209422763490e-02 + 4.9166241743073158e-02 -3.2910646019587375e-02 + 4.8726865069838254e-02 -3.3707341096430810e-02 + 4.8199211180559587e-02 -3.4664103895920562e-02 + 4.7565518284606867e-02 -3.5813140795653453e-02 + 4.6804449791828517e-02 -3.7193140140928449e-02 + 4.5890376368653563e-02 -3.8850574047913256e-02 + 4.5701765936613015e-02 -4.1329085162729484e-02 + 4.6831814466223420e-02 -4.1918720868608261e-02 + 4.8235302864434004e-02 -4.2627123504928477e-02 + 4.9976616588146783e-02 -4.3472210486925178e-02 + 5.2133788576767870e-02 -4.4472048934295572e-02 + 5.4798178313141932e-02 -4.5642807623778481e-02 + 5.8078457524423754e-02 -4.6998611178239003e-02 + 6.2099961868931075e-02 -4.8549324297681551e-02 + 6.7000907031001589e-02 -5.0297797860508808e-02 + 7.2932514989744845e-02 -5.2239565012868638e-02 + 8.0049213303212241e-02 -5.4360251410741967e-02 + 8.8499705419181396e-02 -5.6635285360925991e-02 + 9.8413077655436609e-02 -5.9029975843401417e-02 + 1.0988072461474729e-01 -6.1500442862282512e-02 + 1.2293636190920409e-01 -6.3995769583755191e-02 + 1.3753674408956584e-01 -6.6461267864227125e-02 + 1.5354638584896918e-01 -6.8842493399031923e-02 + 1.7073101971619309e-01 -7.1089615518545202e-02 + 1.8876368616083994e-01 -7.3161492139618645e-02 + 2.0724515122923748e-01 -7.5028745468500802e-02 + 2.2573684643543857e-01 -7.6675279413905173e-02 + 2.4380109956458540e-01 -7.8098034221028456e-02 + 2.6104108425302286e-01 -7.9305175499428060e-02 + 2.7713304995198484e-01 -8.0313254359154485e-02 + 2.9184561715220525e-01 -8.1144003781730589e-02 + 3.0504484890496997e-01 -8.1821381750103228e-02 + 3.1668716321376422e-01 -8.2369246811339281e-02 + 3.2680354021027824e-01 -8.2809775198143143e-02 + 3.3548035542597887e-01 -8.3162606727199773e-02 + 3.4283975335589645e-01 -8.3444520253195265e-02 + 3.4902290621825216e-01 -8.3669493435024833e-02 + 4.5223428302193724e-02 -8.2063055078265279e-03 + 4.5219094967315243e-02 -8.2047314832323082e-03 + 4.5213894119832787e-02 -8.2028423465629885e-03 + 4.5207651921501224e-02 -8.2005749534772576e-03 + 4.5200159643457027e-02 -8.1978534859956653e-03 + 4.5191166653744119e-02 -8.1945869055459752e-03 + 4.5180371908912775e-02 -8.1906658622301620e-03 + 4.5167413940276901e-02 -8.1859590574708818e-03 + 4.5151858658414312e-02 -8.1803088141896296e-03 + 4.5133184774329038e-02 -8.1735257813875251e-03 + 4.5110669219781130e-02 -8.1653473143603605e-03 + 4.5083648745666949e-02 -8.1555324969428966e-03 + 4.5051221599891278e-02 -8.1437537800184145e-03 + 4.5012305361098015e-02 -8.1296179888568076e-03 + 4.4965600677350892e-02 -8.1126531517128342e-03 + 4.4909547705202613e-02 -8.0922926766646697e-03 + 4.4842273772815133e-02 -8.0678563414551263e-03 + 4.4761530493126145e-02 -8.0385274501679760e-03 + 4.4664618192022942e-02 -8.0033253831004458e-03 + 4.4548295086556777e-02 -7.9610726070455939e-03 + 4.4408668130913043e-02 -7.9103550263255329e-03 + 4.4241061827577255e-02 -7.8494743304844405e-03 + 4.4039860560360466e-02 -7.7763907237766716e-03 + 4.3798319115403217e-02 -7.6886540996099484e-03 + 4.3508334991770425e-02 -7.5833213354030704e-03 + 4.3160174822943986e-02 -7.4568569189636946e-03 + 4.2742145695065403e-02 -7.3050135593604182e-03 + 4.2240200305407427e-02 -7.1226887661453020e-03 + 4.1637462695774730e-02 -6.9037525784381160e-03 + 4.0913658660045371e-02 -6.6408406683535759e-03 + 4.0044431780657419e-02 -6.3251059005722254e-03 + 3.9000522298330509e-02 -5.9459200679725654e-03 + 3.7746781533051887e-02 -5.4905158935270038e-03 + 3.6240989184555872e-02 -4.9435574310336960e-03 + 3.3566102974752710e-02 -5.8835834985160318e-03 + 3.2851226223378660e-02 -7.3379466963672257e-03 + 3.2259926616418966e-02 -8.6717041538406647e-03 + 3.1770590881912142e-02 -9.9026847188952161e-03 + 3.1366264590602100e-02 -1.1045545907251153e-02 + 3.1033752484191268e-02 -1.2111684629871888e-02 + 3.0762193240221336e-02 -1.3111550541722750e-02 + 3.0543140332589758e-02 -1.4052790837794760e-02 + 3.0369442953997350e-02 -1.4943024421398832e-02 + 3.0235454215471691e-02 -1.5787830127834468e-02 + 3.0136423850784411e-02 -1.6592515106168548e-02 + 3.0068422667028472e-02 -1.7361969995249638e-02 + 3.0028285210903505e-02 -1.8099439571429343e-02 + 3.0013299118323289e-02 -1.8809167214669742e-02 + 3.0021282791011572e-02 -1.9493897290587370e-02 + 3.0050408821530539e-02 -2.0156232665613061e-02 + 3.0099238864139011e-02 -2.0799356661711954e-02 + 3.0166557232945479e-02 -2.1425001101135877e-02 + 3.0251416353010541e-02 -2.2035253640012797e-02 + 3.0353203821320562e-02 -2.2632632963322408e-02 + 3.0471360310073692e-02 -2.3218489862131264e-02 + 3.0605538587039405e-02 -2.3794383529846641e-02 + 3.0755737053574705e-02 -2.4362439666532509e-02 + 3.0921982772937895e-02 -2.4924041485803627e-02 + 3.1104359536463733e-02 -2.5480244313087042e-02 + 3.1303403174355537e-02 -2.6032957282097868e-02 + 3.1519750802765145e-02 -2.6583735122713392e-02 + 3.1753913653346899e-02 -2.7133379072523667e-02 + 3.2006980663396689e-02 -2.7683663022756377e-02 + 3.2280273894158995e-02 -2.8236318221800616e-02 + 3.2574902867011701e-02 -2.8792207505986767e-02 + 3.2892640203272094e-02 -2.9353067346306716e-02 + 3.3235680654172484e-02 -2.9920837041188975e-02 + 3.3606031976290751e-02 -3.0496644394574446e-02 + 3.4006516600506131e-02 -3.1082421981324160e-02 + 3.4440596403563006e-02 -3.1680411482511772e-02 + 3.4911679715172284e-02 -3.2292149517175517e-02 + 3.5424433656828569e-02 -3.2920162518081497e-02 + 3.5984283181292653e-02 -3.3567071704766249e-02 + 3.6597190162851234e-02 -3.4235242417125278e-02 + 3.7271130229513005e-02 -3.4928227566140890e-02 + 3.8014842884329880e-02 -3.5649141389527017e-02 + 3.8839715892265758e-02 -3.6402287246033893e-02 + 3.9759116659062954e-02 -3.7192070150695145e-02 + 4.0790081970385472e-02 -3.8024027019531559e-02 + 4.1953447500759466e-02 -3.8904255197806492e-02 + 4.3276222631838834e-02 -3.9840421704411710e-02 + 5.0486110452936828e-02 -2.8448192492604107e-02 + 4.9744933189188600e-02 -2.7952330377573276e-02 + 4.9101325105901594e-02 -2.7472455976266019e-02 + 4.8538522241130977e-02 -2.7009055263903292e-02 + 4.8038309404645929e-02 -2.6567793640509763e-02 + 4.7600973164009019e-02 -2.6136347662500725e-02 + 4.7223536150298173e-02 -2.5709408580070203e-02 + 4.6891639018284081e-02 -2.5293899576496415e-02 + 4.6597080617303277e-02 -2.4891191298863191e-02 + 4.6335456646495743e-02 -2.4500033174305713e-02 + 4.6102599596423488e-02 -2.4119510084901208e-02 + 4.5896953812317065e-02 -2.3747630337965120e-02 + 4.5710786426610639e-02 -2.3386267166586094e-02 + 4.5537571560089418e-02 -2.3036247286285061e-02 + 4.5375084253699072e-02 -2.2696318283408345e-02 + 4.5227830903108668e-02 -2.2362429615014889e-02 + 4.5089872863115943e-02 -2.2035602192971737e-02 + 4.4960076858501452e-02 -2.1714609120010664e-02 + 4.4839116997806627e-02 -2.1397790482296841e-02 + 4.4723250151115224e-02 -2.1085253905837931e-02 + 4.4615284517007581e-02 -2.0774661892957624e-02 + 4.4515163403758606e-02 -2.0465017437572897e-02 + 4.4420090060498296e-02 -2.0156037810281191e-02 + 4.4335003099824632e-02 -1.9845312021743666e-02 + 4.4252875656354718e-02 -1.9533799888975523e-02 + 4.4178451623601234e-02 -1.9219207431945051e-02 + 4.4108122772286151e-02 -1.8901452418745635e-02 + 4.4041759113355283e-02 -1.8579396769240475e-02 + 4.3986220357965067e-02 -1.8250750517324832e-02 + 4.3934899048565512e-02 -1.7915570865753239e-02 + 4.3893548999932364e-02 -1.7571806805463552e-02 + 4.3858353392259630e-02 -1.7218806435451484e-02 + 4.3827618715205574e-02 -1.6855196907982872e-02 + 4.3804251218801937e-02 -1.6479147089654589e-02 + 4.3787927098428270e-02 -1.6088962256063155e-02 + 4.3781082127416937e-02 -1.5682598487018140e-02 + 4.3788261691723562e-02 -1.5257713122451833e-02 + 4.3808354123562765e-02 -1.4811957457141034e-02 + 4.3839664166796410e-02 -1.4342287103616513e-02 + 4.3883880620107618e-02 -1.3845206343731320e-02 + 4.3950192804942390e-02 -1.3317557095945176e-02 + 4.4038722633544580e-02 -1.2754411858793446e-02 + 4.4147656074493113e-02 -1.2149458807840574e-02 + 4.4281222967342160e-02 -1.1495890795913510e-02 + 4.4449379172093018e-02 -1.0786518030229786e-02 + 4.4655442874102391e-02 -1.0010456431757575e-02 + 4.4904369188216720e-02 -9.1540380932997323e-03 + 8.1433475782873188e-02 5.6296175982339491e-02 + 7.6062952550209673e-02 5.3507079298341864e-02 + 7.1187531178999564e-02 5.0294746140828295e-02 + 6.6805059060300209e-02 4.6799319981900567e-02 + 6.2889001356289498e-02 4.3142403382390171e-02 + 5.9401593957872478e-02 3.9423495981658618e-02 + 5.6300332396830299e-02 3.5719335325822499e-02 + 5.3543374105615271e-02 3.2087560318728947e-02 + 5.1091745084811180e-02 2.8570176148527082e-02 + 4.8910194683458030e-02 2.5196721752614337e-02 + 4.6967376756242629e-02 2.1986992226686652e-02 + 4.5235678240359789e-02 1.8953254175116285e-02 + 4.3690837459102738e-02 1.6101904454757232e-02 + 4.2311464584379621e-02 1.3434631084436433e-02 + 4.1078976793301081e-02 1.0950075551143357e-02 + 3.9976877984372550e-02 8.6439531746052012e-03 + 3.8990792240056749e-02 6.5103967571857879e-03 + 3.8107920342945079e-02 4.5419099375081373e-03 + 3.7317106676425738e-02 2.7304320441885466e-03 + 3.6608354864000603e-02 1.0670336393019397e-03 + 3.5972878880500048e-02 -4.5732637789797081e-04 + 3.5402908585467685e-02 -1.8516990458010696e-03 + 3.4891485959363422e-02 -3.1251831958201137e-03 + 9.8072218052458027e-02 3.1670750363090860e-02 + 9.8067875397831017e-02 3.1681713087465369e-02 + 9.8062664153133028e-02 3.1694868384249730e-02 + 9.8056410574805852e-02 3.1710654779352865e-02 + 9.8048906159768023e-02 3.1729598508420054e-02 + 9.8039854404014193e-02 3.1752312665332738e-02 + 9.8028992137813020e-02 3.1779569793656037e-02 + 9.8015957191648795e-02 3.1812278542730610e-02 + 9.8000314934466815e-02 3.1851529311481386e-02 + 9.7981543770387702e-02 3.1898630603890865e-02 + 9.7958899798179289e-02 3.1955088166995438e-02 + 9.7931726647622952e-02 3.2022836898377705e-02 + 9.7899118314785483e-02 3.2104134880455604e-02 + 9.7859987521381697e-02 3.2201691745640915e-02 + 9.7813029428003517e-02 3.2318758957494254e-02 + 9.7756678075896275e-02 3.2459238134933344e-02 + 9.7689054097592987e-02 3.2627811023417053e-02 + 9.7607901941671571e-02 3.2830095434036366e-02 + 9.7510514501898626e-02 3.3072832333161273e-02 + 9.7393642616438569e-02 3.3364110296353999e-02 + 9.7253386386100260e-02 3.3713634776816548e-02 + 9.7085064643771091e-02 3.4133051118260482e-02 + 9.6883058159633606e-02 3.4636332015928417e-02 + 9.6640621266246285e-02 3.5240242249614084e-02 + 9.6349655502436349e-02 3.5964896053421569e-02 + 9.6000437563034779e-02 3.6834425522954461e-02 + 9.5581292260384032e-02 3.7877782094597023e-02 + 9.5078199291421583e-02 3.9129697475225100e-02 + 9.4474320300541592e-02 4.0631835597984889e-02 + 9.3749429940288564e-02 4.2434173397445818e-02 + 9.2879231266820739e-02 4.4596655646913064e-02 + 9.1834531730526692e-02 4.7191178038488601e-02 + 9.0580251066711526e-02 5.0303963439333188e-02 + 8.9074226329586281e-02 5.4038409234443918e-02 + 4.5578488897618286e-02 -7.2714538720077826e-03 + 4.6010394283939604e-02 -6.2610858463187924e-03 + 4.6523022490049470e-02 -5.1692630151194408e-03 + 4.7135974938584013e-02 -3.9976255599185606e-03 + 4.7855992985148532e-02 -2.7417000693787941e-03 + 4.8701901298272787e-02 -1.4042039162802666e-03 + 4.9685391119666633e-02 1.5751710371603167e-05 + 5.0827207287085230e-02 1.5117011491128096e-03 + 5.2133685010701925e-02 3.0867247807151443e-03 + 5.3621939048845491e-02 4.7348633699186848e-03 + 5.5302092746224218e-02 6.4544476827137487e-03 + 5.7195001412573276e-02 8.2318308042133026e-03 + 5.9300768260925452e-02 1.0072616324023898e-02 + 6.1640688070610850e-02 1.1956546551473934e-02 + 6.4213336075965799e-02 1.3887353713442963e-02 + 6.7025821659527196e-02 1.5855945800424820e-02 + 7.0088646813402988e-02 1.7843223174345724e-02 + 7.3396873201730273e-02 1.9847955354691749e-02 + 7.6951916963665212e-02 2.1855069682686690e-02 + 8.0743173663726964e-02 2.3863859551426003e-02 + 8.4762640604481021e-02 2.5863809143402250e-02 + 8.9002733173977333e-02 2.7835686828723283e-02 + 9.3447607634601582e-02 2.9769679593456999e-02 + 1.0274418368210547e-01 3.3452295733532367e-02 + 1.0789342844842764e-01 3.5315887269064206e-02 + 1.1355927747558070e-01 3.7213005013619238e-02 + 1.1975528708310179e-01 3.9153772263851749e-02 + 1.2650031075749979e-01 4.1114157844390320e-02 + 1.3380621731374021e-01 4.3066662638764797e-02 + 1.4168011423641502e-01 4.4964241536220584e-02 + 1.5013348272235305e-01 4.6680796859860152e-02 + 1.5915950374044030e-01 4.8076732969228431e-02 + 1.6870564941147137e-01 4.9193555925413079e-02 + 1.7870325171440982e-01 5.0189398268010166e-02 + 1.8908937241499757e-01 5.1147820677073241e-02 + 1.9979972320585659e-01 5.2080117842251639e-02 + 2.1076295956270741e-01 5.2978152087078456e-02 + 2.2190040669180888e-01 5.3834412757311156e-02 + 2.3312801551894324e-01 5.4644772540505926e-02 + 2.4435911616027539e-01 5.5405236800567081e-02 + 2.5550707299640152e-01 5.6111950338433303e-02 + 2.6648773028234984e-01 5.6763847257272460e-02 + 2.7722261443621221e-01 5.7349958112624222e-02 + 2.8763917206909184e-01 5.7884346237301543e-02 + 2.9767455110955865e-01 5.8370099285241395e-02 + 3.0727656465396080e-01 5.8800739166180449e-02 + 3.1640341923007753e-01 5.9177834946872565e-02 + 3.2502369859312807e-01 5.9521064732258822e-02 + 3.3311826148900536e-01 5.9809665342122287e-02 + 3.4067605139925661e-01 6.0073440833988911e-02 + 3.4769689799946235e-01 6.0290515160488667e-02 + 3.5418672677813134e-01 6.0491171191202397e-02 + 3.6015969744495635e-01 6.0652408448817141e-02 + 3.6563394631471624e-01 6.0797003814499817e-02 + 3.6473276216349859e-01 9.0704532948848282e-02 + 3.5904577998556420e-01 9.1049103244756679e-02 + 3.5283837180363520e-01 9.1388286201180335e-02 + 3.4609085123982197e-01 9.1712606546302311e-02 + 3.3878888481810066e-01 9.2010626800600903e-02 + 3.3092508242602037e-01 9.2268896085215601e-02 + 3.2250051807977087e-01 9.2472019345755996e-02 + 3.1352572521714706e-01 9.2602878658183840e-02 + 3.0402195905521268e-01 9.2643002131381991e-02 + 2.9402219779321115e-01 9.2573122353222459e-02 + 2.8357090240325533e-01 9.2373908856615117e-02 + 2.7272463955097237e-01 9.2026865932062663e-02 + 2.6155106165307984e-01 9.1515348952206921e-02 + 2.5012741485988244e-01 9.0825615316745711e-02 + 2.3853885330231606e-01 8.9947854836495367e-02 + 2.2687613958404995e-01 8.8877094681457436e-02 + 2.1523272243930336e-01 8.7613856084630015e-02 + 2.0370175472496044e-01 8.6164503775123080e-02 + 1.9237303187161814e-01 8.4541216813157405e-02 + 1.8133017936189333e-01 8.2761576709387441e-02 + 1.7064842826430748e-01 8.0847835033040383e-02 + 1.6039263219583688e-01 7.8825852442854227e-02 + 1.5061601828200821e-01 7.6723861099850410e-02 + 1.4135924665906430e-01 7.4571069174091065e-02 + 1.3265077831223238e-01 7.2396446777354129e-02 + 1.2450761849252956e-01 7.0227640036478078e-02 + 1.1693556358149237e-01 6.8089842818650936e-02 + 1.0993097221047066e-01 6.6005222731625679e-02 + 1.0348247758004447e-01 6.3992579465505628e-02 + 9.7571460834871004e-02 6.2066836017962146e-02 + 9.2175002492197677e-02 6.0239525278227291e-02 +-2.7078496036210709e-02 -1.0883827169591598e-01 +-2.8098321530066528e-02 -1.0913534326522267e-01 +-2.9184259800643986e-02 -1.0943467293807885e-01 +-3.0336057296807439e-02 -1.0974368819982772e-01 +-3.1551894280298143e-02 -1.1007498689487250e-01 +-3.2833600810576513e-02 -1.1042665517094008e-01 +-3.4182447850767517e-02 -1.1079749387656079e-01 +-3.5601477417117167e-02 -1.1117822738339100e-01 +-3.7090968468959318e-02 -1.1156792486627864e-01 +-3.8649882721230711e-02 -1.1196864802580819e-01 +-4.0277270335636217e-02 -1.1238008472682282e-01 +-4.1976694182494612e-02 -1.1278090886601433e-01 +-4.3743522414899871e-02 -1.1318005961935285e-01 +-4.5577153305814022e-02 -1.1356651873333590e-01 +-4.7472763754015546e-02 -1.1394523711419424e-01 +-4.9426042073690724e-02 -1.1431618416098388e-01 +-5.1433450759432731e-02 -1.1467179750482615e-01 +-5.3491373715914392e-02 -1.1499933244674310e-01 +-5.5595432813518642e-02 -1.1528464579899378e-01 +-5.7739936830373040e-02 -1.1551063073726198e-01 +-5.9917612509735818e-02 -1.1566026266874019e-01 +-6.2118590714618449e-02 -1.1573277295697437e-01 +-6.4333006413008320e-02 -1.1574748402796331e-01 +-6.6551012013931654e-02 -1.1568022620963347e-01 +-6.8759855802198899e-02 -1.1550480049957912e-01 +-7.0939352039687265e-02 -1.1516994023389771e-01 +-7.3062555835008425e-02 -1.1464545379467950e-01 +-7.5117612629995278e-02 -1.1397204500312341e-01 +-7.7068351005237901e-02 -1.1311674507625469e-01 +-7.8885125692764291e-02 -1.1207850519370766e-01 +-8.0544146444324838e-02 -1.1087791339504349e-01 +-8.1992202788441659e-02 -1.0950010235944774e-01 +-8.2000136149957825e-02 -1.0950724588563787e-01 +-8.2009656116227347e-02 -1.0951581665321442e-01 +-8.2021080001155156e-02 -1.0952609949607961e-01 +-8.2034788594270935e-02 -1.0953843596496426e-01 +-8.2051238871883925e-02 -1.0955323557500662e-01 +-8.2070979264145194e-02 -1.0957098926959929e-01 +-8.2094668000081583e-02 -1.0959228553478795e-01 +-8.2123095161406923e-02 -1.0961782968490752e-01 +-8.2157209214486215e-02 -1.0964846694412245e-01 +-8.2198148957559170e-02 -1.0968521007487197e-01 +-8.2247282028617974e-02 -1.0972927246096731e-01 +-8.2306251379804962e-02 -1.0978210773942010e-01 +-8.2377031439222037e-02 -1.0984545730569550e-01 +-8.2461996067635823e-02 -1.0992140728801303e-01 +-8.2564000871371945e-02 -1.1001245690174244e-01 +-8.2686482954727580e-02 -1.1012160044597863e-01 +-8.2833581771055265e-02 -1.1025242557387571e-01 +-8.3010285348478874e-02 -1.1040923084503618e-01 +-8.3222606827987988e-02 -1.1059716595424618e-01 +-8.3477797035001799e-02 -1.1082239849844200e-01 +-8.3784599884623390e-02 -1.1109231185982082e-01 +-8.4153559084214180e-02 -1.1141574000814103e-01 +-8.4597387074978769e-02 -1.1180324694717569e-01 +-8.5131410331868551e-02 -1.1226746099102058e-01 +-8.5774108306011954e-02 -1.1282347633401457e-01 +-8.6547765599505055e-02 -1.1348933567590791e-01 +-8.7479258724243891e-02 -1.1428660832373794e-01 +-8.8601002343224877e-02 -1.1524108043641945e-01 +-2.0182725476914243e-02 -1.1301105428123037e-01 +-2.2177515269035553e-02 -1.1658913609737453e-01 +-2.4325175392604592e-02 -1.1874444948573171e-01 +-2.6250665460409550e-02 -1.2005430191624100e-01 +-2.7954106429334047e-02 -1.2091668757076945e-01 +-2.9525046644934605e-02 -1.2154814452280505e-01 +-3.1048177603423710e-02 -1.2206146136159646e-01 +-3.2582428767966576e-02 -1.2251618642454787e-01 +-3.4162481463084760e-02 -1.2294425589034574e-01 +-3.5810767813217126e-02 -1.2336346733421522e-01 +-3.7543479194084739e-02 -1.2378304473213575e-01 +-3.9360979273837415e-02 -1.2420366253346060e-01 +-4.1257055000286869e-02 -1.2462163651458980e-01 +-4.3227830715849791e-02 -1.2503221616731253e-01 +-4.5270804895494621e-02 -1.2542991405570092e-01 +-4.7392926805940760e-02 -1.2580996186645166e-01 +-4.9604167370489449e-02 -1.2616643050452581e-01 +-5.1910822518678401e-02 -1.2649073140389078e-01 +-5.4312824759719547e-02 -1.2677134483574548e-01 +-5.6801639128252646e-02 -1.2699406073986097e-01 +-5.9360177676339276e-02 -1.2714270797597749e-01 +-6.1973927680384122e-02 -1.2720020205507865e-01 +-6.4655035916999282e-02 -1.2714723250341819e-01 +-6.7428473525836807e-02 -1.2695745859690533e-01 +-7.0304614883312411e-02 -1.2659629186116206e-01 +-7.3261730312836448e-02 -1.2602556636456086e-01 +-7.6241969478175520e-02 -1.2521258923938205e-01 +-7.9204179214642068e-02 -1.2412361291828233e-01 +-8.2113829736769617e-02 -1.2272213561851686e-01 +-8.4916776281787065e-02 -1.2097908174121130e-01 +-8.7555667271644211e-02 -1.1886801014134107e-01 +-2.6116365894665705e-02 -1.0855837064377738e-01 +-2.6113918892420429e-02 -1.0855809150777418e-01 +-2.6110972536727672e-02 -1.0855775541568846e-01 +-2.6107421795941832e-02 -1.0855735040124159e-01 +-2.6103137853169756e-02 -1.0855686180163104e-01 +-2.6097961814357973e-02 -1.0855627155363834e-01 +-2.6091696309492818e-02 -1.0855555726077171e-01 +-2.6084094111737954e-02 -1.0855469093884551e-01 +-2.6074842503930995e-02 -1.0855363730738077e-01 +-2.6063541559253167e-02 -1.0855235144005349e-01 +-2.6049673727115419e-02 -1.0855077551141790e-01 +-2.6032561081024141e-02 -1.0854883428351059e-01 +-2.6011305291348208e-02 -1.0854642886469890e-01 +-2.5984703913266571e-02 -1.0854342816782037e-01 +-2.5951135221617960e-02 -1.0853965743370964e-01 +-2.5908403221180265e-02 -1.0853488326125671e-01 +-2.5853535770153258e-02 -1.0852879493627654e-01 +-2.5782533580269273e-02 -1.0852098264990673e-01 +-2.5690077466549610e-02 -1.0851091455553785e-01 +-2.5569214575938304e-02 -1.0849791633391703e-01 +-2.5411055292224205e-02 -1.0848115827850791e-01 +-2.5204509278083265e-02 -1.0845965460907792e-01 +-2.4936060683344863e-02 -1.0843227684648582e-01 +-2.4589532524956326e-02 -1.0839777846797460e-01 +-2.4145744733132801e-02 -1.0835482490205095e-01 +-2.3581962533683054e-02 -1.0830202484412155e-01 +-2.2871070064340415e-02 -1.0823796665167151e-01 +-2.1980458985865425e-02 -1.0816127417052712e-01 +-2.0870651184580424e-02 -1.0807070597684287e-01 + 1.8072239642378918e-02 4.3646286931462441e-03 + 1.7302102551887799e-02 3.5593088593515176e-03 + 1.6456153396994466e-02 2.6532836062500564e-03 + 1.5526063554894165e-02 1.6387797564050288e-03 + 1.4502918890507033e-02 5.0794780621998825e-04 + 1.3373061444866607e-02 -7.4320092420521178e-04 + 1.2120477532320706e-02 -2.1165880890947619e-03 + 1.0725173139945809e-02 -3.6099892204646267e-03 + 9.1792528119611916e-03 -5.2313660888643199e-03 + 7.4717078156254502e-03 -6.9844719805587374e-03 + 5.5960668935455260e-03 -8.8755516131726608e-03 + 3.5484958486620144e-03 -1.0911022301016260e-02 + 1.3280155608157429e-03 -1.3097007619592205e-02 +-1.0617373425674259e-03 -1.5440398261247879e-02 +-3.6109248573126251e-03 -1.7949693672136391e-02 +-6.3032474669739713e-03 -2.0634382415892105e-02 +-9.1173068929890633e-03 -2.3502687913406817e-02 +-1.2023018654375051e-02 -2.6564097003912934e-02 +-1.4961098884668900e-02 -2.9846539981932096e-02 +-1.7894566608035234e-02 -3.3346985815427388e-02 +-2.0775233271791649e-02 -3.7063860958426176e-02 +-2.3596722537376991e-02 -4.0956739055289404e-02 +-2.6359608095432918e-02 -4.4979023131915596e-02 +-2.9035790633884062e-02 -4.9103075237908911e-02 +-3.1551925860114238e-02 -5.3326524104249984e-02 +-3.3892218146434061e-02 -5.7608089685942332e-02 +-3.6024644689575780e-02 -6.1916619671109174e-02 +-3.7910094111623494e-02 -6.6223957787116206e-02 +-3.9524557835648011e-02 -7.0495743055630555e-02 +-4.0869052314945975e-02 -7.4690478944816618e-02 +-4.1934546229867919e-02 -7.8773927589054438e-02 +-4.2721471906517650e-02 -8.2713215681792462e-02 +-4.3182073801574461e-02 -8.6483974077410153e-02 +-4.3272811778180653e-02 -9.0057217653608745e-02 +-4.3034860136614839e-02 -9.3393766048151861e-02 +-4.2390987056393215e-02 -9.6439477805645879e-02 +-4.1449247719270943e-02 -9.9165088512734201e-02 +-4.0233910681138241e-02 -1.0152863582936789e-01 +-3.8816873814838004e-02 -1.0351957650473764e-01 +-3.7196186873117654e-02 -1.0505789409654653e-01 +-3.5513723306991096e-02 -1.0621498927679340e-01 +-3.3853063887704593e-02 -1.0704465986965772e-01 +-3.2282555548505343e-02 -1.0765722657470178e-01 +-3.0807769000332996e-02 -1.0803083531322955e-01 +-2.9460591122500546e-02 -1.0831262689740129e-01 +-2.8229353973472371e-02 -1.0843965614483864e-01 +-2.7116815933013072e-02 -1.0850234628240685e-01 + 2.5892142682856445e-02 4.5406117688244763e-03 + 2.6177115969900910e-02 2.9770038383958308e-04 + 2.5456070290786670e-02 -2.7881414772821245e-03 + 2.4420245757610815e-02 -5.0473151569576657e-03 + 2.3278659566280169e-02 -6.8556635543757238e-03 + 2.2053862109672195e-02 -8.4668104247214160e-03 + 2.0719497952349286e-02 -1.0036043446945087e-02 + 1.9250925500529092e-02 -1.1652509489266549e-02 + 1.7634647773618894e-02 -1.3364803218962606e-02 + 1.5864608871787311e-02 -1.5197470280497782e-02 + 1.3940313077128508e-02 -1.7159554812607780e-02 + 1.1863764788287767e-02 -1.9254031118933312e-02 + 9.6404032560712949e-03 -2.1482251006645470e-02 + 7.2807437120019358e-03 -2.3845452022840163e-02 + 4.8010717032909156e-03 -2.6345400948571296e-02 + 2.2238805515684135e-03 -2.8984369102929008e-02 +-4.2071983955338510e-04 -3.1763036538748679e-02 +-3.0959343953753660e-03 -3.4678686993032670e-02 +-5.7754814613559802e-03 -3.7739197524658152e-02 +-8.4448416778855062e-03 -4.0961109714402255e-02 +-1.1096060154443421e-02 -4.4361923936619974e-02 +-1.3715361046251928e-02 -4.7945004648880740e-02 +-1.6263275863479976e-02 -5.1673115820449311e-02 +-1.8687296188915070e-02 -5.5484544853200646e-02 +-2.0951183903434867e-02 -5.9338964323274013e-02 +-2.3027566108396513e-02 -6.3208626453970851e-02 +-2.4885218316512692e-02 -6.7051914655735345e-02 +-2.6501645248856676e-02 -7.0832049793523311e-02 +-2.7862453052790670e-02 -7.4519355508840590e-02 +-2.8951388280404444e-02 -7.8070442154981379e-02 +-2.9750577242722898e-02 -8.1420246158430132e-02 +-3.0248466618587599e-02 -8.4482690969849727e-02 +-3.0454478022178932e-02 -8.7174797276176719e-02 +-3.0406091139226987e-02 -8.9460791953030139e-02 +-3.0163831423408283e-02 -9.1303828101274576e-02 +-2.9804040105730678e-02 -9.2719224454256732e-02 +-2.9400707331703302e-02 -9.3762096330891609e-02 +-2.9023907062210696e-02 -9.4482191041890928e-02 +-2.8709601584097300e-02 -9.4953528440015589e-02 +-2.8435875583070924e-02 -9.5292831318658955e-02 +-2.8117298688144388e-02 -9.5622243093856696e-02 +-2.7686210008965872e-02 -9.6008016238329219e-02 +-2.7073481644265485e-02 -9.6497594382384477e-02 +-2.6176826302759082e-02 -9.7179657562662669e-02 +-2.4862136485424458e-02 -9.8229736652626798e-02 +-2.3033461363453966e-02 -1.0000063071937859e-01 +-2.0863215382391331e-02 -1.0314916364168880e-01 + 1.8773506387390171e-02 5.0803287993872459e-03 + 1.8775315670154669e-02 5.0819256629850429e-03 + 1.8777490317361867e-02 5.0838452138037837e-03 + 1.8780105619171650e-02 5.0861540402635796e-03 + 1.8783253336081884e-02 5.0889333346901822e-03 + 1.8787045880642950e-02 5.0922826143775524e-03 + 1.8791621874605369e-02 5.0963246681234864e-03 + 1.8797153660614185e-02 5.1012122462523735e-03 + 1.8803857619744235e-02 5.1071372504267742e-03 + 1.8812008532158586e-02 5.1143435250509128e-03 + 1.8821959759733886e-02 5.1231448315363082e-03 + 1.8834171761071161e-02 5.1339502371234857e-03 + 1.8849252395845895e-02 5.1472999882875570e-03 + 1.8868013610102707e-02 5.1639159455731942e-03 + 1.8891550282674530e-02 5.1847717071424881e-03 + 1.8921347888394280e-02 5.2111883205441245e-03 + 1.8959425459613044e-02 5.2449613145171270e-03 + 1.9008517902065591e-02 5.2885226095824578e-03 + 1.9072295693362662e-02 5.3451354837079634e-03 + 1.9155609998620093e-02 5.4191118542306072e-03 + 1.9264740093511534e-02 5.5160312044932880e-03 + 1.9407615482499807e-02 5.6429364863959108e-03 + 1.9593997737835878e-02 5.8084936244924279e-03 + 1.9835640837776225e-02 6.0231313375993523e-03 + 2.0146490588572874e-02 6.2992151378793437e-03 + 2.0543006470425951e-02 6.6513293514063321e-03 + 2.1044674056170720e-02 7.0967270933692816e-03 + 2.1674733198523199e-02 7.6559695441957842e-03 + 2.2461108964861864e-02 8.3537415733374587e-03 +-8.3210962119480314e-02 -1.0791671692837213e-01 +-8.4179945219474916e-02 -1.0607841800614892e-01 +-8.4886658010631777e-02 -1.0403860976799706e-01 +-8.5254436491325691e-02 -1.0182732284452811e-01 +-8.5347534817259429e-02 -9.9506588799698648e-02 +-8.5123505918886622e-02 -9.7113570261427640e-02 +-8.4585591026609563e-02 -9.4688435907315238e-02 +-8.3793593208383754e-02 -9.2249122273130979e-02 +-8.2798768612562412e-02 -8.9800491858454734e-02 +-8.1631009893129658e-02 -8.7344000672374023e-02 +-8.0271569181405766e-02 -8.4902849680190684e-02 +-7.8766706567932943e-02 -8.2464125134293909e-02 +-7.7140626334568196e-02 -8.0021820856373438e-02 +-7.5402453297215288e-02 -7.7577767347847271e-02 +-7.3545279839052569e-02 -7.5145556596027063e-02 +-7.1577871726958620e-02 -7.2728200228326045e-02 +-6.9518133399370186e-02 -7.0320279315524203e-02 +-6.7381475380969391e-02 -6.7917092587066463e-02 +-6.5180729502998247e-02 -6.5515663877647512e-02 +-6.2925236658486483e-02 -6.3116054767718310e-02 +-6.0605758678107691e-02 -6.0736254432086412e-02 +-5.8231556479867663e-02 -5.8377486960736746e-02 +-5.5816164432101800e-02 -5.6035998297915057e-02 +-5.3368027032917098e-02 -5.3712921980448414e-02 +-5.0890314658786906e-02 -5.1415213116271730e-02 +-4.8399418162347274e-02 -4.9135461899737720e-02 +-4.5903688866033576e-02 -4.6874462567629394e-02 +-4.3407446539134753e-02 -4.4637300133871349e-02 +-4.0909170482322565e-02 -4.2435591007446760e-02 +-3.8417334441945172e-02 -4.0269528330682647e-02 +-3.5936870872305349e-02 -3.8142694316391612e-02 +-3.3474774530134255e-02 -3.6056099186481561e-02 +-3.1039830257824974e-02 -3.4008000551239093e-02 +-2.8636599603146351e-02 -3.2001008474807691e-02 +-2.6264607730126954e-02 -3.0043278928360451e-02 +-2.3932764538585616e-02 -2.8131076361134433e-02 +-2.1645590301261564e-02 -2.6265239407820218e-02 +-1.9404333585256950e-02 -2.4449964731715568e-02 +-1.7211156953138129e-02 -2.2687707996681183e-02 +-1.5070589815678659e-02 -2.0977268787206071e-02 +-1.2984202212521723e-02 -1.9320435033023386e-02 +-1.0952613577515535e-02 -1.7719564898115436e-02 +-8.9801253240722190e-03 -1.6171674701070060e-02 +-7.0679092303151947e-03 -1.4677085023720338e-02 +-5.2163478462432522e-03 -1.3236525778310693e-02 +-3.4266228859110015e-03 -1.1849120785086598e-02 +-1.6997496071411433e-03 -1.0513645926110371e-02 +-3.5739870014594999e-05 -9.2296597659782265e-03 + 1.5660054743520391e-03 -7.9970414383581101e-03 + 3.1070798626871010e-03 -6.8165387250331833e-03 + 4.5875983917085250e-03 -5.6865843207560829e-03 + 6.0079898688059075e-03 -4.6056599826584943e-03 + 7.3689124245390758e-03 -3.5722347555662282e-03 + 8.6713942249332376e-03 -2.5849883316766409e-03 + 9.9164076182134409e-03 -1.6422904856483456e-03 + 1.1104968767028822e-02 -7.4236875080657683e-04 + 1.2238570406196914e-02 1.1608418392938802e-04 + 1.3318596320573306e-02 9.3465070578702125e-04 + 1.4346482091738721e-02 1.7149455401224145e-03 + 1.5324215529389562e-02 2.4579286061339189e-03 + 1.6253926260922924e-02 3.1644224258471354e-03 + 1.7137410560600586e-02 3.8357134587201358e-03 + 1.7976162606373691e-02 4.4734899804552697e-03 +-9.2041770498795472e-02 -1.1351822789414712e-01 +-9.3758939930140173e-02 -1.1027785698642845e-01 +-9.5013864890162836e-02 -1.0676354874867400e-01 +-9.5764040028669228e-02 -1.0309454928469108e-01 +-9.6015794040283708e-02 -9.9377626563466492e-02 +-9.5809363744578491e-02 -9.5686179722434872e-02 +-9.5207696444930434e-02 -9.2107045184121716e-02 +-9.4286084118564872e-02 -8.8690381272726881e-02 +-9.3108691098890972e-02 -8.5433382728922425e-02 +-9.1719020074663149e-02 -8.2303535434476771e-02 +-9.0156657114576433e-02 -7.9287310955550083e-02 +-8.8456495108502509e-02 -7.6377979522945338e-02 +-8.6633667339654608e-02 -7.3548854082886805e-02 +-8.4694271359978757e-02 -7.0773497398235463e-02 +-8.2649558155864611e-02 -6.8042074659558693e-02 +-8.0518830798624208e-02 -6.5358969161962932e-02 +-7.8318476888014743e-02 -6.2725793383975770e-02 +-7.6057265589184908e-02 -6.0136652483748776e-02 +-7.3737395669908778e-02 -5.7581019437719760e-02 +-7.1356633755243593e-02 -5.5046876560510327e-02 +-6.8920697112801577e-02 -5.2533202394613454e-02 +-6.6444387950312489e-02 -5.0048877238751288e-02 +-6.3938313253785850e-02 -4.7597813246227361e-02 +-6.1409467344958557e-02 -4.5179731616059371e-02 +-5.8867959540151560e-02 -4.2797207132977633e-02 +-5.6321210107597608e-02 -4.0450861137543370e-02 +-5.3769324536730778e-02 -3.8135915439966084e-02 +-5.1212194880676520e-02 -3.5848959731978880e-02 +-4.8655878263829777e-02 -3.3593100698510625e-02 +-4.6109664156901431e-02 -3.1374464251086920e-02 +-4.3581396165691899e-02 -2.9197567889781340e-02 +-4.1078646451921941e-02 -2.7066292433318040e-02 +-3.8605495753998298e-02 -2.4981375769272063e-02 +-3.6163689335495519e-02 -2.2941748001784390e-02 +-3.3758893774219700e-02 -2.0949929323933247e-02 +-3.1396844613311714e-02 -1.9008785945288764e-02 +-2.9078880134022711e-02 -1.7117841480711604e-02 +-2.6807073020151506e-02 -1.5277450531058889e-02 +-2.4585514341183057e-02 -1.3489711334685239e-02 +-2.2417284317569397e-02 -1.1755906171401875e-02 +-2.0304425199199727e-02 -1.0076436811488065e-02 +-1.8250539774669505e-02 -8.4528825748577674e-03 +-1.6258156248227351e-02 -6.8859374736547352e-03 +-1.4327741397124782e-02 -5.3747219412230152e-03 +-1.2460230174795583e-02 -3.9188478656200232e-03 +-1.0656454610057153e-02 -2.5180061424237010e-03 +-8.9160897310307519e-03 -1.1711514303698323e-03 +-7.2380995116532176e-03 1.2317830903185722e-04 +-5.6216194996636659e-03 1.3662328713408556e-03 +-4.0669138276570038e-03 2.5583700319771197e-03 +-2.5746764296457059e-03 3.6996088493452817e-03 +-1.1446851741823139e-03 4.7905263522665109e-03 + 2.2454669532123717e-04 5.8320277524757103e-03 + 1.5368718242996238e-03 6.8251752249679498e-03 + 2.8009137321234334e-03 7.7716109081649165e-03 + 4.0340242515881641e-03 8.6747234851856092e-03 + 5.2672876777464239e-03 9.5407850158082397e-03 + 6.5531200307304971e-03 1.0379164987980971e-02 + 7.9781723275260674e-03 1.1198685414754550e-02 + 9.6846216782964234e-03 1.1991696915671923e-02 + 1.1901543960718186e-02 1.2685101213456562e-02 + 1.4957422243234930e-02 1.3007174665595755e-02 + 1.9086023242842032e-02 1.2217095377437204e-02 +-1.9352747938095675e+01 -9.3636610815619719e+00 +-1.9495785007785287e+01 -8.6821304547496823e+00 +-1.9401195395643157e+01 -7.3630819746150706e+00 +-1.9025230234529275e+01 -7.9999889652153655e+00 +-1.9212958475526250e+01 -6.4884621250270698e+00 +-1.9507979247908764e+01 -5.6771151922641536e+00 +-1.9293477563067654e+01 -4.8089480302018472e+00 +-1.9400304958588947e+01 -3.7790679791425674e+00 +-1.9425988372072595e+01 -2.9119096998362295e+00 +-1.9429946209604594e+01 -2.2232855833210152e+00 +-1.9137008696334519e+01 -9.4344387664261831e-01 +-1.9065926569495304e+01 -1.6986547672588017e+00 +-1.9265521001805169e+01 3.0840277204273292e-01 +-1.9064728540919745e+01 -3.0715609079747708e-01 +-1.9383263496654195e+01 1.1070063137125388e+00 +-1.9418666203820550e+01 1.7829531296312382e+00 +-1.9257027127399269e+01 3.0761700952150619e+00 +-1.9069653372956878e+01 2.2752778257942197e+00 +-1.9441050901764527e+01 3.7277644915133266e+00 +-1.9298105217789384e+01 5.1016399480760697e+00 +-1.9054510719938591e+01 4.3697547092951154e+00 +-1.9319166609444267e+01 5.9319767795661349e+00 +-1.9255857974353916e+01 6.8917332225077672e+00 +-1.9483754779682016e+01 7.5957147829268692e+00 +-1.9305080361677170e+01 8.2486738927548870e+00 +-1.9332896685299716e+01 9.5003277483557653e+00 +-1.8958158843385547e+01 8.9562601652788487e+00 +-1.8681934339210613e+01 9.4977595288809411e+00 +-1.7363655987053320e+01 9.4162710911993202e+00 +-1.8042027910692696e+01 9.0502725865573481e+00 +-1.6404244254431674e+01 9.2359719219857368e+00 +-1.5591232788856075e+01 9.3930124995315225e+00 +-1.4699839790188065e+01 9.4045463373865203e+00 +-1.3557995801361159e+01 9.2609232552765093e+00 +-1.2754744510344722e+01 9.4956457302458261e+00 +-1.1407656005480945e+01 9.2939544437078823e+00 +-1.2177113826766046e+01 9.1714797546299280e+00 +-1.0473829501890862e+01 9.3419376720248550e+00 +-9.6982780573816143e+00 9.5847813265461355e+00 +-8.9520051868714319e+00 9.4747453439164673e+00 +-7.3268797255751821e+00 9.4165613111755064e+00 +-8.1465342244743368e+00 9.1257532467847611e+00 +-5.9116412965842500e+00 9.1883352601889072e+00 +-6.6836070426105039e+00 8.9691480396315697e+00 +-4.5972509197057292e+00 9.2648671346268685e+00 +-5.2279464130193674e+00 9.0704193289049400e+00 +-3.9394332544899560e+00 9.4290677637219815e+00 +-2.6742888966445406e+00 9.3447974465830441e+00 +-3.3896743622064918e+00 9.0404500408422876e+00 +-1.9868246081882148e+00 9.5908042189852125e+00 +-1.3763445591392127e+00 9.4102317282944199e+00 + 1.6472611445790619e-01 9.4171930953898055e+00 +-7.7066094779094385e-01 9.0318640501216763e+00 + 9.0912141115953926e-01 9.5827641779206161e+00 + 1.5828586549382493e+00 9.4511541886202224e+00 + 3.0340154523790019e+00 9.4809939535514900e+00 + 2.3768820246516640e+00 9.0430051946433423e+00 + 3.7731198794778393e+00 9.4177209451311015e+00 + 5.1082421885971456e+00 9.4324898462393634e+00 + 4.5673746754250999e+00 9.1472899373426131e+00 + 5.9493875825584084e+00 9.2391872542457421e+00 + 6.8603756280208259e+00 9.3839229950837364e+00 + 7.5865299575637684e+00 9.5193311084929348e+00 + 8.9180393479322220e+00 9.4855907221214864e+00 + 8.2526075178765481e+00 9.0788888618973971e+00 + 9.7560975609756326e+00 9.3607211448479291e+00 + 1.0653597136666065e+01 9.3128483600524419e+00 + 1.2018628156080617e+01 9.3762189135364764e+00 + 1.1515438657400068e+01 8.9238543601903970e+00 + 1.2714822393084816e+01 9.3448614819495504e+00 + 1.3475665702334410e+01 9.2512553513576350e+00 + 1.4907597427401519e+01 9.2431562085809702e+00 + 1.4226449146629221e+01 8.9673215546592644e+00 + 1.5554347857736985e+01 9.2014089038863034e+00 + 1.6858203478237563e+01 9.4443546149863096e+00 + 1.6332769092228062e+01 9.0105720105583202e+00 + 1.7472514615941108e+01 9.4817408501134253e+00 + 1.8486806202546099e+01 9.5714596698335583e+00 + 1.8052221011715758e+01 9.1420655004028575e+00 + 1.9494151476918013e+01 9.3069173895690298e+00 + 1.8821833066761272e+01 9.1437731789313261e+00 + 1.9338954074953463e+01 8.4636121392072639e+00 + 1.9464508550922389e+01 7.6209671161242269e+00 + 1.9487550002444770e+01 6.8873060440447347e+00 + 1.9286997926741748e+01 5.6997682329803467e+00 + 1.9079180591711122e+01 6.3720712264972050e+00 + 1.9423673021001989e+01 4.4205865852854203e+00 + 1.8874251529468168e+01 4.9096252944320824e+00 + 1.9464314832357360e+01 3.6796440254000302e+00 + 1.9376314161870795e+01 2.8450848566877625e+00 + 1.9334900081209440e+01 2.0429776528903929e+00 + 1.9260688187032059e+01 1.2865858942026875e+00 + 1.9469195904706133e+01 -2.2821139239354693e-02 + 1.9066111449129160e+01 5.2988239785634050e-01 + 1.9332384691184345e+01 -5.9889918256992303e-01 + 1.9216546074385327e+01 -2.0596256217372826e+00 + 1.9087870550861986e+01 -1.2399240320800970e+00 + 1.9541994962555236e+01 -2.8830881750346151e+00 + 1.9268454485260762e+01 -3.7652644190609124e+00 + 1.9462906165468596e+01 -4.8658379929419482e+00 + 1.9614268941096498e+01 -5.7023591869392760e+00 + 1.9418665659312794e+01 -6.3580895771893324e+00 + 1.9474580753469894e+01 -7.6115651003471356e+00 + 1.9154133490819625e+01 -7.0831228116276463e+00 + 1.9235420628814417e+01 -8.3313853818032726e+00 + 1.9221953838309801e+01 -9.2264891844695569e+00 + 1.8429407329136851e+01 -9.4090049631740698e+00 + 1.7658969924105776e+01 -9.3140704102630281e+00 + 1.6586101918304081e+01 -9.3728397449616949e+00 + 1.7103576823947719e+01 -9.1994237555826857e+00 + 1.5483939881451917e+01 -9.3999366995307128e+00 + 1.6099454778374280e+01 -9.0917432923879034e+00 + 1.4705254661188647e+01 -9.1815801289877612e+00 + 1.3723061490409954e+01 -9.2776845891744131e+00 + 1.2879374839249607e+01 -9.3216197699332923e+00 + 1.1596392485100189e+01 -9.4914666697246020e+00 + 1.2165912556718432e+01 -9.2705501912475370e+00 + 1.0825391496750910e+01 -9.2998809578169812e+00 + 9.8056742526109844e+00 -9.2103667826733471e+00 + 9.0037582514841361e+00 -9.3249331554476811e+00 + 7.6254716269565463e+00 -9.3579992920014519e+00 + 8.4138447971953880e+00 -8.9986408802116813e+00 + 6.9232057364540083e+00 -9.5454465193179203e+00 + 6.2284300110295163e+00 -9.2952495760786320e+00 + 4.8037424359946357e+00 -9.3906256842521572e+00 + 5.4835022905800628e+00 -9.1671466551484002e+00 + 4.0657951285417440e+00 -9.5066884205301250e+00 + 2.8273176275369707e+00 -9.4548776448752960e+00 + 3.4970811724063964e+00 -9.1753798650832863e+00 + 2.1823417196413217e+00 -9.2980939461254479e+00 + 8.7547639529664423e-01 -9.1989200165983931e+00 + 1.5361284211420667e+00 -9.0745650255164776e+00 + 1.5716324853798369e-02 -9.3053275414362702e+00 +-9.2121014125832801e-01 -9.2661516304752070e+00 +-1.7033595195178037e+00 -9.3768312911356446e+00 +-3.0359918013187155e+00 -9.4978036860523929e+00 +-2.3215611477289144e+00 -9.0064038430827082e+00 +-3.7408087399709302e+00 -9.3310302946476895e+00 +-5.0136789378788507e+00 -9.4978168800351881e+00 +-4.5081508864689255e+00 -9.1397708273823781e+00 +-5.8396305256333392e+00 -9.2821111910226932e+00 +-6.5574376073721083e+00 -9.4639987317381298e+00 +-7.8909583225162834e+00 -9.1793994802858379e+00 +-7.0505359945751991e+00 -9.1964660270492971e+00 +-8.7804878048780637e+00 -9.5224758489827508e+00 +-9.6005965668083206e+00 -9.2685618280484050e+00 +-1.0522312085116198e+01 -9.2435381309660301e+00 +-1.1803506663689461e+01 -9.3462314889102061e+00 +-1.1173689648625185e+01 -9.1343104371666328e+00 +-1.2492855452509687e+01 -9.4593171132974589e+00 +-1.3615294190955737e+01 -9.3376885234866052e+00 +-1.2976261305548221e+01 -9.0053487732868547e+00 +-1.5002620874966397e+01 -9.2889215219726964e+00 +-1.4242816952695421e+01 -8.9627985237309247e+00 +-1.5844469412222139e+01 -9.3606119562135319e+00 +-1.6768286989994536e+01 -9.3896340859369616e+00 +-1.7462591846746207e+01 -9.5023402375553303e+00 +-1.8641620845627031e+01 -9.4995087024390017e+00 +-1.8051596953866067e+01 -9.0941011210016853e+00 + 4.0151630144087846e-02 1.4528713804388360e-02 + 3.9008467826612048e-02 1.1958305796696322e-02 + 7.2054858767066321e-01 1.5060917321278566e-02 + 3.8763688359828308e-01 9.6707612958475409e-02 + 3.8069334600054106e-01 9.6226657923239145e-02 +-1.8822980198470447e+01 -8.8405118439959409e+00 +-1.8857136835110396e+01 -7.2604660316694094e+00 +-1.8370900210919388e+01 -8.4036807390079673e+00 +-1.8178305827635782e+01 -7.5898130280802576e+00 +-1.9033460200949975e+01 -5.6595943775202926e+00 +-1.8467994242217600e+01 -6.8609840654093688e+00 +-1.8404183713336607e+01 -6.0732971310821284e+00 +-1.8861747937577718e+01 -4.0936354264385102e+00 +-1.8611635169127268e+01 -5.2628629126801059e+00 +-1.8509420909913274e+01 -4.5886987013792009e+00 +-1.8852434580994512e+01 -3.3317751579122330e+00 +-1.8908145035477588e+01 -2.5463016470435633e+00 +-1.8559827752548117e+01 -1.3123451409371825e+00 +-1.8433909020125100e+01 -6.8646842596396596e-01 +-1.8258643658360512e+01 -1.9635970455535556e+00 +-1.8420247839124698e+01 1.1762120326946501e-01 +-1.8698946430485861e+01 9.0996698654305419e-01 +-1.8842717032875441e+01 1.5752502541343034e+00 +-1.8509611589032247e+01 2.8937111024790596e+00 +-1.8724149784025826e+01 3.6982739922267598e+00 +-1.8368295227354338e+01 2.1812147412915905e+00 +-1.8584714101324025e+01 5.0599585075452893e+00 +-1.8818063152425509e+01 5.6737415973362957e+00 +-1.8279044314727756e+01 4.3451770306948205e+00 +-1.8435036686298417e+01 6.5642160411365111e+00 +-1.9004637570732399e+01 7.6533147239719170e+00 +-1.8528047582258722e+01 7.3639228103616787e+00 +-1.8450447155690171e+01 8.1665289113084469e+00 +-1.7173843177559391e+01 8.7388061675423643e+00 +-1.7726665885056747e+01 8.3127277588792197e+00 +-1.5725123471228997e+01 8.7190074193335079e+00 +-1.6399287261352114e+01 8.3909650558713906e+00 +-1.5139461674447688e+01 8.9377087240350690e+00 +-1.4442261933861886e+01 8.8231628672336200e+00 +-1.2750121112832346e+01 9.0095690141519640e+00 +-1.3778010199476554e+01 8.4384436592103782e+00 +-1.3063994403447154e+01 8.4829772537006249e+00 +-1.1621272468515471e+01 8.6594712855636828e+00 +-1.0889439045251223e+01 8.6629199542513575e+00 +-1.2333766912203359e+01 8.5702380541102627e+00 +-9.5339584918581011e+00 8.9434177351046955e+00 +-1.0246838791187372e+01 8.6656071959678940e+00 +-8.7752814152527492e+00 8.8894938956105349e+00 +-7.5055106949949817e+00 8.3597102104978518e+00 +-8.3000952685467979e+00 8.5311773906345110e+00 +-6.2289104615657607e+00 8.6155075121823401e+00 +-5.6126874227590093e+00 8.3733342857093191e+00 +-6.6939751902321518e+00 8.2120890086577489e+00 +-4.8075521545415683e+00 8.5430427515631422e+00 +-4.0311676103635392e+00 8.7766354229808314e+00 +-2.7878583041692764e+00 8.4547107266450467e+00 +-2.0277175687179039e+00 8.9828196930257675e+00 +-3.5241870568837754e+00 8.2876910581926211e+00 +-1.4680941701847701e+00 8.8031773939062177e+00 + 5.8163946552419077e-02 8.4987751392020598e+00 + 8.4680277420639527e-01 9.0454736055929388e+00 +-1.2164566797524827e+00 8.4395058597570412e+00 +-7.0381637521904850e-01 8.2955113166840917e+00 + 1.5384685317716702e+00 8.7408655089627842e+00 + 3.2142510658082486e+00 8.8602057526202174e+00 + 2.1328237673078405e+00 8.5264289506317681e+00 + 2.6974160679944603e+00 8.1580367211072016e+00 + 4.0701437734699937e+00 8.7252697881187657e+00 + 5.2683511240266014e+00 8.7759720396085186e+00 + 4.7122089700624770e+00 8.5331532395981071e+00 + 6.6658049537887152e+00 8.5697504407242349e+00 + 5.8346847589353104e+00 8.4186715641390606e+00 + 7.3935057434099321e+00 8.8973061370782034e+00 + 9.0596459624596122e+00 8.9372251607413347e+00 + 7.8995691850847507e+00 8.4829770394095902e+00 + 8.7567480260249724e+00 8.1927469919045706e+00 + 1.0244982601900780e+01 8.7210795226366358e+00 + 9.6164151081167262e+00 8.4724506670565489e+00 + 1.0839576985904365e+01 8.5873124402488017e+00 + 1.2298961125672143e+01 8.7456615055701548e+00 + 1.1301919686897065e+01 8.0517821636136659e+00 + 1.1959305703331133e+01 8.2265191506641315e+00 + 1.3008009304736696e+01 8.6107467146117287e+00 + 1.3676216814871651e+01 8.5072683350754801e+00 + 1.4872954514117936e+01 8.5304505646267472e+00 + 1.5264972790287125e+01 8.8058694815882745e+00 + 1.4180775694001134e+01 8.0829892648403856e+00 + 1.5638198430165117e+01 8.3268812733369018e+00 + 1.7199217878322266e+01 8.8264994148721314e+00 + 1.6550395648890749e+01 8.2346954708231905e+00 + 1.8567951054557042e+01 8.4398969529836947e+00 + 1.7881833776749275e+01 8.2499291126268304e+00 + 1.8972204681755912e+01 7.8797359925652941e+00 + 1.8976153237711912e+01 7.1807333479757176e+00 + 1.8481557512529406e+01 5.7885732154009872e+00 + 1.8412628724155496e+01 6.7922840094839074e+00 + 1.8758025588080770e+01 3.9286295883089295e+00 + 1.7972058617740217e+01 5.0152941291248894e+00 + 1.8157792401193404e+01 4.3083930774570405e+00 + 1.8868874519059901e+01 3.2121822075893363e+00 + 1.8683601236076512e+01 2.5087091872644720e+00 + 1.8826264247211093e+01 1.7578426485632903e+00 + 1.8475888546051415e+01 1.1757121385641511e+00 + 1.8934252058581507e+01 -1.1757251512611333e-01 + 1.8337313263724504e+01 2.3707626870634613e-01 + 1.8466254984163413e+01 -7.3310092038396135e-01 + 1.8633477857293641e+01 -1.5854793011343702e+00 + 1.9028599597797452e+01 -2.8771612377920519e+00 + 1.8421843584392853e+01 -2.3534170911982386e+00 + 1.8861214616615683e+01 -4.6656609469033867e+00 + 1.8596110297499287e+01 -3.2801514914663699e+00 + 1.8627972429548421e+01 -4.0332761909015318e+00 + 1.8948123692156265e+01 -5.5958163835109218e+00 + 1.8710092574121987e+01 -6.4917882502972759e+00 + 1.8925977136489109e+01 -7.6843293624330329e+00 + 1.8444321673483230e+01 -7.2747887844685692e+00 + 1.8656251121555655e+01 -8.7835885408459262e+00 + 1.8204453847116646e+01 -8.1062396924631912e+00 + 1.8088202731649645e+01 -8.7925748560876684e+00 + 1.7470525846952839e+01 -8.6735011918517699e+00 + 1.6729115698668551e+01 -8.6367074308369922e+00 + 1.5490726861729492e+01 -8.7111258816568409e+00 + 1.6083213713567780e+01 -8.4233474637981658e+00 + 1.4107791350057738e+01 -8.5063245780621628e+00 + 1.4901900017555491e+01 -8.2161561045882934e+00 + 1.3328874921231943e+01 -8.6565830580633047e+00 + 1.2518357576933582e+01 -8.7315247672224245e+00 + 1.1651480806879277e+01 -8.8341740656041594e+00 + 1.0418688302306549e+01 -8.7549004753469291e+00 + 1.0915637291698900e+01 -8.6419889103185028e+00 + 9.2084226896328545e+00 -8.5404785820533391e+00 + 9.9917690887959267e+00 -8.4991925389344090e+00 + 7.7789960189694938e+00 -8.4545347427617514e+00 + 7.0009568149411763e+00 -8.9409784232076959e+00 + 8.5441783837127829e+00 -8.3264763498487753e+00 + 5.7454831997875573e+00 -8.4502369554394221e+00 + 6.4409793506875701e+00 -8.5153799552159342e+00 + 4.9476264790276190e+00 -8.6673091209582651e+00 + 4.2611715504157317e+00 -8.8640205930999940e+00 + 2.8075698098023381e+00 -8.7745998772837766e+00 + 3.6059987718001167e+00 -8.4520926547104693e+00 + 2.0205954349764568e+00 -8.4845211290770806e+00 + 1.2194757624398918e+00 -8.3291412082364076e+00 + 3.6994803168256851e-01 -8.6305928016360696e+00 +-2.9254439765905715e-01 -8.7526692416677321e+00 +-1.4934154032121398e+00 -8.7570833642853927e+00 +-8.8056742401107613e-01 -8.3254944101681190e+00 +-3.1959676771556644e+00 -8.8625367427047337e+00 +-1.8357783755805457e+00 -7.9612030982086566e+00 +-2.6943734800091050e+00 -8.3533552214844349e+00 +-3.8998640261018096e+00 -8.4860705117465898e+00 +-5.1909568871912342e+00 -8.7709937929642763e+00 +-4.6575801513139368e+00 -8.4268165202136913e+00 +-6.5415439161485835e+00 -8.8290436120538089e+00 +-5.9092456372643909e+00 -8.4297071712888965e+00 +-7.2488978491083031e+00 -8.5350211070314970e+00 +-8.6948899525333161e+00 -8.7765765985832189e+00 +-7.9397648943497074e+00 -8.2384387867594313e+00 +-1.0104425405941839e+01 -8.6662776651333502e+00 +-9.4175246717126839e+00 -8.3728500605432146e+00 +-1.0777552105318904e+01 -8.4613055178315904e+00 +-1.1545565193879469e+01 -8.6204770481254087e+00 +-1.2292435416762899e+01 -8.7616594454990633e+00 +-1.3480413292583592e+01 -8.3653613618073734e+00 +-1.2619628865146680e+01 -8.2287445963919623e+00 +-1.4979969018787685e+01 -8.5365936548966630e+00 +-1.5602326146004984e+01 -8.8149049143411844e+00 +-1.4303527940732565e+01 -8.0406343265519382e+00 +-1.6476096453742926e+01 -8.7059383888270929e+00 +-1.7304520658878687e+01 -8.9733217840525015e+00 +-1.7482583727259907e+01 -8.2948030824369567e+00 +-1.7839876614582252e+01 -6.7613894936531693e+00 +-1.7293201497244809e+01 -7.3110609493294163e+00 +-1.7920967183069763e+01 -5.2610876916356517e+00 +-1.7580479348955279e+01 -6.0534327464251021e+00 +-1.8339916116952281e+01 -3.8375441417066725e+00 +-1.7823402444765080e+01 -4.3673735820625410e+00 +-1.8200347058247445e+01 -2.9998777531887271e+00 +-1.7837035218063832e+01 -1.1607538366365588e+00 +-1.7708733093069185e+01 -3.8162589849565620e-01 +-1.7712460192068647e+01 -2.4306958383347705e+00 +-1.7347236746638259e+01 -1.7662983399173129e+00 +-1.8075974391985156e+01 8.7180968035276152e-01 +-1.7640241529075084e+01 3.9364596825630116e-01 +-1.8205954820470495e+01 1.4797116957466230e+00 +-1.7782152663046077e+01 3.5949224566079323e+00 +-1.7770121372970820e+01 2.6692391662927406e+00 +-1.7824334846572185e+01 2.0033000438663748e+00 +-1.8151905700469115e+01 5.6739863153650631e+00 +-1.7801053565169866e+01 5.0071842746800854e+00 +-1.7396717332034925e+01 4.3152138703979546e+00 +-1.7783620041500996e+01 7.5250977583156953e+00 +-1.7677397350491759e+01 6.1760831577374589e+00 +-1.7432908303468324e+01 6.8102659858271579e+00 +-1.7107177766769809e+01 8.0266285907612556e+00 +-1.5721499689709859e+01 7.9776534661656981e+00 +-1.5095015158576615e+01 8.3787328484116586e+00 +-1.6431741951676088e+01 7.6167266349956080e+00 +-1.4325000372127391e+01 8.0587248239011089e+00 +-1.3462861119009673e+01 7.5938785702771270e+00 +-1.2656589132798203e+01 8.0511929680527032e+00 +-1.1290960461530631e+01 8.0390255323428548e+00 +-1.2038148697441187e+01 8.0217029549490775e+00 +-1.0470715618398145e+01 7.9586204514567314e+00 +-9.7278807513344958e+00 8.2128401391982706e+00 +-8.9438139045130782e+00 8.3723757616121617e+00 +-9.1738542925923952e+00 7.7269165508911470e+00 +-9.8145892407083579e+00 7.6432085430969252e+00 +-8.3826264278961418e+00 7.8954099892228413e+00 +-7.0544805292389015e+00 7.5488632150414503e+00 +-7.7777865574894358e+00 7.3742736890370111e+00 +-6.1933042797646038e+00 8.0935088835845690e+00 +-5.0357513590661398e+00 7.7635560503535714e+00 +-5.8396487189715600e+00 7.5581324852777456e+00 +-6.4980381332181025e+00 7.6857961910086630e+00 +-4.2513994673761459e+00 8.0660245828011483e+00 +-1.8570754625975781e+00 8.2522934304618047e+00 +-3.1281433482090506e+00 7.7753676975663097e+00 +-2.4871480914431459e+00 7.8604902604814555e+00 +-3.7921157688782614e+00 7.6700301036329392e+00 + 9.3652775558629031e-01 8.2627640112798701e+00 +-4.2254641005436611e-01 7.7130521225492004e+00 + 3.2540319191691225e-01 7.6571412985741318e+00 +-1.1675817850498902e+00 7.7943594117905661e+00 + 1.7876018461328300e+00 7.9946362529065027e+00 + 3.6295997839054053e+00 8.0888386585315857e+00 + 2.3775920148858845e+00 7.3174804754634053e+00 + 3.2679311192618243e+00 7.2399631335060519e+00 + 4.3745739788246425e+00 7.9845902122234094e+00 + 5.2110246672935077e+00 7.9670578401336485e+00 + 6.1243096994095509e+00 7.6628078113456581e+00 + 7.3484797937930750e+00 8.3135276793345909e+00 + 7.0013183290194831e+00 7.7927630704073749e+00 + 7.7822007576624941e+00 7.8248417090535654e+00 + 9.4582337294972021e+00 7.7763114927777721e+00 + 8.3005038343427771e+00 7.2915082034279237e+00 + 8.9631683003176619e+00 7.3783713262958628e+00 + 1.0360903966469209e+01 7.7763375850987160e+00 + 1.2577562539399487e+01 7.9917684124685877e+00 + 1.1965525066313333e+01 7.4634519046237031e+00 + 1.1170767741964262e+01 7.3332175408561682e+00 + 1.3465359615786831e+01 7.7826299897080915e+00 + 1.4871963623635411e+01 7.7370414200072730e+00 + 1.4230976293818323e+01 7.2669649845776902e+00 + 1.6153700523917209e+01 7.7161125412809710e+00 + 1.5504483390507572e+01 7.3788997939240133e+00 + 1.7203362133819034e+01 8.0667655253289539e+00 + 1.6823766831107669e+01 7.5647254515390401e+00 + 1.8410243279405002e+01 7.6493088888526728e+00 + 1.7650688201500436e+01 7.3532739174806210e+00 + 1.7774736310845256e+01 6.3655819430134812e+00 + 1.7711091516975031e+01 5.6422243459936752e+00 + 1.7744756564008611e+01 3.6465393332682794e+00 + 1.8324850853852816e+01 3.1849964934467181e+00 + 1.7449205169393295e+01 4.3574269561610208e+00 + 1.7193839514124569e+01 5.1800327382098175e+00 + 1.8318286244963367e+01 1.9606865095830344e+00 + 1.7860021270146824e+01 2.6188235136196738e+00 + 1.7757164081974068e+01 8.1921989571763731e-01 + 1.7633268625962216e+01 1.6688606234524457e+00 + 1.7811504323232619e+01 -2.8604033194494605e-01 + 1.7633291666363817e+01 1.7460753752052227e-01 + 1.7974874092664663e+01 -1.5413288402722856e+00 + 1.7559037388832422e+01 -9.3428762761375594e-01 + 1.7991192895637795e+01 -2.8948996312307287e+00 + 1.7610639890252202e+01 -2.3113782668017535e+00 + 1.8143400814243719e+01 -4.6053222733933836e+00 + 1.8439418823915325e+01 -5.2055161110912564e+00 + 1.7917153704482217e+01 -3.7064029672116448e+00 + 1.8130299064562927e+01 -5.8814626192140906e+00 + 1.7944876974987665e+01 -6.8015157908951807e+00 + 1.7975581937741978e+01 -5.2603993748332130e+00 + 1.7238704954706250e+01 -6.2830694812631265e+00 + 1.7569919236628714e+01 -5.5900154451800432e+00 + 1.7823557363301333e+01 -7.4524718335646725e+00 + 1.7295356496098933e+01 -7.9695459737436494e+00 + 1.6484751731336317e+01 -7.7375907055766220e+00 + 1.5670598118238722e+01 -7.9539916006481519e+00 + 1.4277389494630192e+01 -7.5758940948321509e+00 + 1.3626450091818896e+01 -8.0052751086209639e+00 + 1.5173256712185605e+01 -7.3653487579758377e+00 + 1.2960274329919550e+01 -8.0510533003112812e+00 + 1.2116019537196323e+01 -8.0948493599591131e+00 + 1.1298915311978909e+01 -8.1708623953283137e+00 + 1.0568867834305081e+01 -8.1960164085309231e+00 + 9.9571923651241647e+00 -7.7942004460675065e+00 + 9.0750091782363711e+00 -7.7774755599607772e+00 + 6.9812865322506070e+00 -8.1354326687770424e+00 + 8.3179837291437337e+00 -7.7518990096219653e+00 + 7.5157308888858338e+00 -7.5804290821171634e+00 + 6.2968257488316866e+00 -7.8576707471678162e+00 + 5.0193685801641408e+00 -7.9344129409872437e+00 + 5.6516619435387199e+00 -7.5366495222097569e+00 + 4.3724908172236070e+00 -8.1974118968223166e+00 + 2.8429658986352138e+00 -7.9338517346097461e+00 + 3.8173752621319395e+00 -7.6337799086673641e+00 + 1.7910385398117512e+00 -7.6410970150444655e+00 + 5.7553761693939265e-01 -7.7975854230808324e+00 + 1.1890146595528606e+00 -7.7407666921551055e+00 +-4.6608779562220093e-02 -8.2357798246229379e+00 +-9.5149043083135609e-01 -7.5683699897034131e+00 +-2.2493956664645509e-01 -7.6592692196436758e+00 +-3.2490592553540125e+00 -8.2150544635931908e+00 +-2.7905067716215939e+00 -7.5621338022423004e+00 +-1.3285233229403559e+00 -6.9036618613061478e+00 +-2.1604487391907412e+00 -7.0248840144087694e+00 +-4.3852553892691759e+00 -7.6278160119966714e+00 +-3.5910312344600612e+00 -7.5686062850554947e+00 +-5.2614190817428863e+00 -7.8723205533585769e+00 +-6.5821004459237713e+00 -8.0959433259855871e+00 +-5.9919769191605070e+00 -7.7149290768599883e+00 +-7.3288815827230138e+00 -7.5945078428886603e+00 +-8.6851228163497893e+00 -7.8473808695584921e+00 +-8.0048855683567837e+00 -7.5324391344001214e+00 +-1.0148348673972436e+01 -7.8954689599687526e+00 +-9.3478435255259882e+00 -7.7264435443687773e+00 +-1.1393594459457375e+01 -7.9424467785001980e+00 +-1.0748174759516886e+01 -7.7054621937622869e+00 +-1.1980874641290413e+01 -8.2023369254681313e+00 +-1.3063839841194152e+01 -7.5620126416334728e+00 +-1.3741343195082010e+01 -7.5715811229183885e+00 +-1.2160201312697211e+01 -7.5337026737307724e+00 +-1.5752157570732166e+01 -8.1526956519360141e+00 +-1.5043124735512919e+01 -7.9462031644763300e+00 +-1.4291659936787809e+01 -7.1856548868717312e+00 +-1.4766200357225117e+01 -7.5042289576145862e+00 +-1.6588577638697089e+01 -7.8535769349981734e+00 +-1.7211217172064167e+01 -6.5985240211106486e+00 +-1.6454778291842644e+01 -6.8671661088932296e+00 +-1.7235181506510074e+01 -5.4712743301815436e+00 +-1.7178897826099600e+01 -4.7823682687156861e+00 +-1.6887750107695879e+01 -5.9995708072523968e+00 +-1.7792143770215603e+01 -3.6439042292586095e+00 +-1.7134562272201492e+01 -3.8489642127231889e+00 +-1.7482238582357368e+01 -3.0278641578329797e+00 +-1.7108866126309138e+01 -8.5466904690530043e-01 +-1.6981237121418246e+01 -1.0954307675314112e-01 +-1.7231500327896654e+01 -2.4546830758075657e+00 +-1.6605423470538767e+01 -1.5245347909748688e+00 +-1.6791110977067277e+01 -2.2286733923937447e+00 +-1.7427643247049815e+01 1.3788050248668497e+00 +-1.6863579370141792e+01 7.7679744931565153e-01 +-1.6939493725498636e+01 3.1112282605666266e+00 +-1.7007039822209535e+01 3.8336841498910843e+00 +-1.7196840186321381e+01 2.2310583929448953e+00 +-1.7404360435566787e+01 5.6111310083078223e+00 +-1.6989579506896590e+01 5.0376389157695485e+00 +-1.6547500798200716e+01 4.4323433990465873e+00 +-1.7100001007522664e+01 7.4104675433171963e+00 +-1.7010425567787280e+01 6.2427172356386151e+00 +-1.6680024250170774e+01 6.8820388615693844e+00 +-1.4980746491475228e+01 7.6792143107990896e+00 +-1.5728852146035138e+01 7.0522291191622699e+00 +-1.4361792842616040e+01 7.4123068540857631e+00 +-1.2479996556149430e+01 7.4019045592822295e+00 +-1.4263919756067125e+01 6.8511825958993029e+00 +-1.2928905081276213e+01 6.8286123357904245e+00 +-1.3575597715198384e+01 6.5194250493049850e+00 +-1.1719113777243336e+01 7.2923748379654825e+00 +-1.1016338791731542e+01 7.2989170672490928e+00 +-1.0224643423550390e+01 7.2374524378146390e+00 +-1.1325797389143361e+01 6.4544257572684813e+00 +-1.0565161660107407e+01 6.6601928432490354e+00 +-1.2186221599598596e+01 6.4614997857262182e+00 +-9.5289736774112583e+00 7.1372508861007447e+00 +-9.9520815529456428e+00 6.7265248357352618e+00 +-8.6452417536910531e+00 7.1004139861158819e+00 +-7.3642436516669960e+00 6.7797667936792720e+00 +-6.5358108938039976e+00 6.8868451440502625e+00 +-8.0064082470715618e+00 6.6955280116287099e+00 +-5.2516853209372556e+00 7.1550238484720410e+00 +-4.4488118925654874e+00 7.3021174906321420e+00 +-5.7414558782656542e+00 6.7342344500904829e+00 +-1.8882356390880943e+00 7.4231671307216658e+00 +-2.6843074298021463e+00 7.2591439179052912e+00 +-3.5055801220424598e+00 6.9506607042030026e+00 +-1.0072946067200519e+00 6.9342104323006453e+00 +-2.2831825314608380e+00 6.8730993716545612e+00 +-1.7410924914549639e+00 6.7107587602289840e+00 +-2.8135548465691897e+00 6.6720783428048236e+00 +-1.4735315766594113e+00 6.1727076133383889e+00 +-1.3688409332179674e-01 6.9071414267530002e+00 +-6.4943317870248052e-01 6.0378727257888087e+00 +-2.2848424307129136e+00 6.2202199359682169e+00 +-3.1900348563009544e+00 6.0311095483368860e+00 +-3.8821177629954633e+00 6.0187579271059874e+00 +-4.2268790111831009e+00 6.5666405227054057e+00 + 1.0890691483957795e+00 7.5061894321782887e+00 + 6.0362691850892247e-01 6.8396656670690277e+00 + 1.6634023124711277e+00 7.2478577298401348e+00 + 4.0587356019474683e+00 7.4459164271566252e+00 + 2.7113972685728882e+00 6.5672529043424532e+00 + 4.0350087401283687e+00 6.6958321033701509e+00 + 3.3657683573983235e+00 6.4063846445709416e+00 + 1.9580045482666151e+00 6.6135226919696493e+00 + 4.6689694302366007e+00 7.2313331370274199e+00 + 5.3976864166290639e+00 7.1003511531079084e+00 + 6.7655735126470802e+00 7.0744248785866475e+00 + 6.1324589461815364e+00 6.9286887591448618e+00 + 7.5197973444005513e+00 7.1076331381593434e+00 + 9.5939332465575617e+00 7.0616508935331481e+00 + 8.8735347881325808e+00 6.6983753883919945e+00 + 8.0183789351971981e+00 6.4622119436679881e+00 + 1.0755889666869940e+01 6.9306143069493089e+00 + 1.0234162541155598e+01 6.8068217898919130e+00 + 1.2834117889090031e+01 7.1477903846369983e+00 + 1.1424881034094049e+01 6.7682219901666514e+00 + 1.2231781261266264e+01 6.6024657958594659e+00 + 1.3625500086715157e+01 6.7448189276729664e+00 + 1.4853034415417227e+01 6.9394460307150183e+00 + 1.4297732153602944e+01 6.4130495313166307e+00 + 1.6257073924455362e+01 7.0233712894938236e+00 + 1.5614256228634012e+01 6.6305116573579781e+00 + 1.7066902389472077e+01 6.7670713124124902e+00 + 1.7076613811223062e+01 5.9589768679404358e+00 + 1.6830200548546458e+01 3.8638822339847323e+00 + 1.7051522433308826e+01 3.0265031587464932e+00 + 1.6628582392438787e+01 4.6165117911689464e+00 + 1.6325485576977165e+01 5.4897623388698946e+00 + 1.7111374711328679e+01 2.3483270483146086e+00 + 1.7180277692475812e+01 1.1030867429743552e+00 + 1.7092728510485372e+01 4.7289925563878654e-01 + 1.6729867834795293e+01 1.6561685153935741e+00 + 1.7081552376057971e+01 -2.9387209859682173e-01 + 1.7245374509545059e+01 -1.6580734158352612e+00 + 1.6774664047330866e+01 -1.0933101586491460e+00 + 1.7360114023389556e+01 -3.0742815978996560e+00 + 1.6902348511231111e+01 -2.4625564863648748e+00 + 1.7535088708863519e+01 -4.3148489516629951e+00 + 1.7499880333513509e+01 -4.9673584944454063e+00 + 1.7157684677386527e+01 -3.7837455399192663e+00 + 1.7228777824820234e+01 -7.1102689262527150e+00 + 1.6952031156045187e+01 -5.4809857959706534e+00 + 1.6551437532774045e+01 -6.8720867813985365e+00 + 1.6387563835667152e+01 -6.0397879512102719e+00 + 1.5931101851397003e+01 -7.2268044957379800e+00 + 1.5651531358511356e+01 -6.5691713503115921e+00 + 1.3468055559193317e+01 -7.2990918942031726e+00 + 1.4638219687255635e+01 -6.7318088112605778e+00 + 1.4031892789473176e+01 -7.0086802833786237e+00 + 1.2590965369053180e+01 -7.3880536571153357e+00 + 1.1676123828413466e+01 -7.3934279741731359e+00 + 1.0906251512835304e+01 -7.4557118324001408e+00 + 9.5050684824131437e+00 -7.1066842264667685e+00 + 1.0356705400290991e+01 -6.8261719016903442e+00 + 8.7430891199969167e+00 -7.1157369731690352e+00 + 6.7896792913398940e+00 -7.3195181399959210e+00 + 8.0411803082816249e+00 -7.0034536692757570e+00 + 7.2500354628154469e+00 -6.7753220797049067e+00 + 6.1718641753856431e+00 -7.1888072413689059e+00 + 4.9509064163398691e+00 -7.1616132888818242e+00 + 4.4979673449965532e+00 -7.5991009143966153e+00 + 5.6587375975703935e+00 -6.8070520665030188e+00 + 6.5105018490501863e+00 -6.5258143255587839e+00 + 3.2527877923992747e+00 -7.0096109566427742e+00 + 2.5054484657582208e+00 -7.1562936896006732e+00 + 4.2064480243392666e+00 -6.8870957366836194e+00 + 1.1700067190204209e+00 -7.1952431222587165e+00 + 1.9169798157474318e+00 -6.6309584003174393e+00 + 4.3167271127196472e-01 -7.0177153113555590e+00 +-3.7928380163171482e-01 -6.9836231515179890e+00 +-2.6421481080414253e+00 -6.9843619271696014e+00 +-3.1691619407168332e+00 -6.9303705511907197e+00 +-1.9186479938558278e+00 -6.3761080427992454e+00 +-6.8217319983331492e-01 -6.2490188554632340e+00 +-1.4305228262523144e+00 -5.9744487981038645e+00 +-2.6314704633970365e+00 -6.3638954683646034e+00 +-3.9081709619073877e+00 -6.8371201742474454e+00 +-4.9885548066909706e+00 -7.1270215684211280e+00 +-4.5245258346216986e+00 -6.8339111981464953e+00 +-5.7063637813098467e+00 -7.0089597317654153e+00 +-6.5103671188816321e+00 -7.2628577926092674e+00 +-7.8088891647278444e+00 -6.8900274317954739e+00 +-7.1114981728637190e+00 -6.7083760086243984e+00 +-8.3768397286525840e+00 -7.1623621333877878e+00 +-9.0141113733174620e+00 -7.1225558288670499e+00 +-9.7378740810641347e+00 -7.1086421501451866e+00 +-1.0467719787137241e+01 -7.1422225355604638e+00 +-1.1270610916413034e+01 -7.1566502930262601e+00 +-1.3637071247703403e+01 -6.8339375822362882e+00 +-1.2768876286996687e+01 -6.8040305041784279e+00 +-1.1972111322288541e+01 -6.6827300650574415e+00 +-1.5413768790087090e+01 -7.4968632313824912e+00 +-1.5995940942077254e+01 -7.4884268901321462e+00 +-1.5074619327662816e+01 -6.8413273466336051e+00 +-1.4396842480966143e+01 -6.3856874637453132e+00 + 1.2293891935914303e-01 -6.2826190278752136e+00 +-2.5466947990472022e-01 -5.5032462485965823e+00 +-8.9220385412225767e-01 -5.6943351358879681e+00 + 1.0408948014428745e+00 -6.3142152319369700e+00 + 6.6639178782736508e-01 -5.5167162373652729e+00 +-2.1716271720288205e+00 -5.6245476237457268e+00 +-1.2014499104986669e+00 -5.0506266413880923e+00 + 4.1781503284405375e-01 -4.7695786341732855e+00 +-3.3328283257034741e-01 -4.6081365598868445e+00 + 1.3605739824305374e+00 -5.5336091439186532e+00 + 1.7653996577238757e+00 -5.8887250560504754e+00 + 1.2114881621014035e+00 -4.9111662634891928e+00 +-2.2485243930202898e+00 -4.8254000664834109e+00 +-3.1158889188381806e+00 -5.7077038707367933e+00 +-2.8308555538908422e+00 -5.1418784815628271e+00 +-9.9193494033809770e-01 -4.2009759188400153e+00 +-1.7203924221456646e+00 -4.2712494207808902e+00 +-3.4516441048734805e+00 -6.2661056500649579e+00 + 2.8522218232557606e-01 -4.0443851777547621e+00 + 9.8899507301369738e-01 -4.2098115750722656e+00 +-4.4248384305777222e-01 -4.0362724860469825e+00 + 2.0354307144790482e+00 -5.1408007696829401e+00 + 2.4582507363566037e+00 -5.9728059354562504e+00 + 2.7234702821974111e+00 -6.5659503413889979e+00 + 1.7997223820138188e+00 -4.2964812207228107e+00 +-2.9630844674124717e+00 -4.4623855202291480e+00 +-2.4255362838309509e+00 -4.1060454419344978e+00 +-3.6003827790699887e+00 -4.9482337016027458e+00 +-3.9209715502218359e+00 -5.6314660587172938e+00 +-1.4364633943891505e+00 -3.6647334057772980e+00 +-8.1314862497220020e-01 -3.6230417418970262e+00 +-1.9595086111395688e+00 -3.7308487711097058e+00 +-4.2838315527793895e+00 -6.2511939305901620e+00 +-4.3036780085873261e+00 -5.0809108172297925e+00 +-4.8013217380942876e+00 -5.6219140837489334e+00 +-4.3143296021939364e+00 -4.3758475665911334e+00 +-3.6462636958367796e+00 -4.0680509474331359e+00 +-5.0748214158310816e+00 -6.3872435375461691e+00 + 8.1817934823375538e-01 -3.6523968772453799e+00 +-1.8031589895058175e-01 -3.5971392935903452e+00 + 3.2426473582086146e-01 -3.5296938510004026e+00 + 1.4290068354159828e+00 -3.6859565282586715e+00 + 3.3896552423314432e+00 -6.1886549115567675e+00 + 1.6335476283761864e+01 6.2975385123065735e+00 + 1.5955140566355475e+01 4.8944146559954191e+00 + 1.5447643164754361e+01 5.4091552571973551e+00 + 1.5732657349908409e+01 6.0007195451393684e+00 + 1.5985597417272032e+01 4.1221220730737542e+00 + 1.5517764408185492e+01 4.7024135885264542e+00 + 1.5082730525079739e+01 6.1759001008867074e+00 + 1.4855258783778758e+01 4.8885881665506687e+00 + 1.4398607026529660e+01 5.5878097753459812e+00 + 1.6279323480440468e+01 3.2148272350628915e+00 + 1.5189492063408117e+01 4.2349882573222146e+00 + 1.5460993875392809e+01 3.3902136938258849e+00 + 1.3941673660549718e+01 4.7753379209407569e+00 + 1.4524618512576438e+01 4.3397470952264570e+00 + 1.3752042361507229e+01 6.0573761699326170e+00 + 1.3458803497725839e+01 5.3802841675469537e+00 + 1.5731870051906768e+01 2.6481355657169843e+00 + 1.6483458025381935e+01 2.4666195882286885e+00 + 1.4605396587454969e+01 3.6727433224254753e+00 + 1.4930171122097150e+01 2.7350717289440922e+00 + 1.4031271467690644e+01 4.1270778088932261e+00 + 1.2944543875032323e+01 4.6610915406523290e+00 + 1.3465623504451202e+01 4.2105137029521345e+00 + 1.2979569042962439e+01 6.1609184477805172e+00 + 1.2620312065591605e+01 5.3868728269633195e+00 + 1.4191110855172248e+01 2.9521268514990879e+00 + 1.3675526702749373e+01 3.4927905376810386e+00 + 1.5933175050989369e+01 1.9429104035465272e+00 + 1.5244451606544807e+01 2.1526070235393462e+00 + 1.4190898973375077e+01 2.0486976901015765e+00 + 1.6606302271689771e+01 8.9464462020340818e-01 + 1.5936777182632667e+01 1.1315517684378733e+00 + 1.6259040537317105e+01 1.8542845595801793e-01 + 1.5181836868787094e+01 1.5754818365741983e+00 + 1.5184066315619575e+01 9.4071285549833306e-01 + 1.5397741133147150e+01 3.1004984639602640e-01 + 1.4622581620166294e+01 1.2031621469870828e+00 + 1.3609982024000104e+01 2.7406326779864401e+00 + 1.4035582218151106e+01 1.0593872518424234e+00 + 1.3362772770207116e+01 1.5251523442669779e+00 + 1.3200907777284108e+01 2.2424760757268274e+00 + 1.5644599246668932e+01 -5.2571186278933624e-01 + 1.6296503558065822e+01 -6.2912407080976607e-01 + 1.4664685163891527e+01 5.6695992612968382e-01 + 1.4722994340514575e+01 -3.4834478666256530e-01 + 1.2891951111620145e+01 3.7797697166667561e+00 + 1.2933351368856286e+01 2.9666696833441009e+00 + 1.5669836372462100e+01 -5.7792017441217070e+00 + 1.5113985410399891e+01 -6.1076711068277376e+00 + 1.6261841639504020e+01 -5.2542125541960019e+00 + 1.3775292956564570e+01 -6.3577716910111235e+00 + 1.4549835292699775e+01 -6.0310897296460979e+00 + 1.2913932569620194e+01 -6.6044275541729860e+00 +-1.6245357155829481e+01 6.3023281846811301e+00 +-1.4809758182828674e+01 7.0826073507165148e+00 +-1.5624803203388907e+01 6.2529415826375967e+00 +-1.4977808293760845e+01 6.4854873345895712e+00 +-1.6622505911196697e+01 5.6744562157088509e+00 +-1.5931887162402402e+01 5.7777993970988675e+00 +-1.6073940263565419e+01 5.1127448653040943e+00 +-1.5240111258916798e+01 5.6468638776560596e+00 +-1.4311062664725341e+01 5.9503474448692870e+00 + 1.4203824518850141e+01 -5.4659976773849905e+00 + 1.3153231323478835e+01 -6.1086840647171812e+00 + 1.3274895324327389e+01 -5.5736303784758547e+00 + 1.5017853890428611e+01 -5.4921993617460032e+00 + 1.2089447165299113e+01 -6.6473062289996676e+00 + 1.2559525952860156e+01 -6.0733672462516211e+00 + 1.5596488963868225e+01 -5.0093827568891243e+00 + 1.5079267195446988e+00 -7.7143000659145855e-01 + 1.6573273231708896e+00 -8.0921161640367245e-01 + 1.5673752058408112e+00 -8.9872695303482431e-01 + 1.5986311754136580e+00 -6.8400319025435863e-01 + 1.4246914787971932e+00 -8.5724290080877097e-01 + 1.4699916182526636e+00 -6.5632642684838061e-01 + 1.3925581511276306e+00 -7.3945436166155787e-01 + 1.7188018035755022e+00 -9.4869643216796362e-01 + 1.7427186838409341e+00 -7.0843364237309459e-01 + 1.8122221532023843e+00 -8.5977160841058264e-01 + 1.4746818154198564e+00 -1.0028394346305163e+00 + 1.6208220945366847e+00 -1.0029413276064787e+00 + 1.5559390597429044e+00 -5.8472179081235254e-01 + 1.6706841959412131e+00 -5.9397484841855430e-01 + 1.2816763016038522e+00 -8.1218325418328163e-01 + 1.3178884393148280e+00 -9.6098081155061266e-01 + 1.3762786528325961e+00 -6.5763573245612861e-01 + 1.4567243599650155e+00 -5.5476744794299293e-01 + 1.4018832091420990e+00 -6.0227245821985775e-01 + 1.2958559551634607e+00 -6.8974968599795261e-01 + 1.8960016190937310e+00 -1.0464631224975989e+00 + 1.7271141727060879e+00 -1.0798715796110940e+00 + 1.9038849904622097e+00 -7.2733795687693714e-01 + 1.8134610618040767e+00 -5.7268530530163275e-01 + 2.0016076911882763e+00 -8.8921924175141953e-01 + 1.5914038373625772e+00 -1.1457568430092238e+00 + 1.3464798456489646e+00 -1.1666076818104187e+00 + 1.6194998545962918e+00 -4.9357681515654406e-01 + 1.5042747421357561e+00 -4.7543615547307638e-01 + 1.7192812194976952e+00 -5.0727015618046778e-01 + 1.1943954197338513e+00 -8.9576952239252705e-01 + 1.1953270290511142e+00 -7.2570421796848450e-01 + 1.1510176380388231e+00 -8.1638127890317946e-01 + 1.1727975578215961e+00 -1.0290984661968849e+00 + 1.3084322690794750e+00 -6.0077549630342730e-01 + 1.3744404279104501e+00 -5.3820479135949029e-01 + 1.4145181081075080e+00 -4.7638830858862491e-01 + 1.2127158772396740e+00 -6.2184470543226666e-01 + 1.7965279703684871e+00 -1.2767931047684868e+00 + 2.1536751159007821e+00 -1.0516626972480907e+00 + 2.0382724226491931e+00 -1.2128876073020081e+00 + 2.0029472847053995e+00 -5.8464495177828724e-01 + 2.0503530680322370e+00 -7.4927299164662031e-01 + 1.7903730282887835e+00 -4.4413710690648145e-01 + 1.8999873488339460e+00 -4.4428028381230433e-01 + 2.1946417939648484e+00 -8.3969174353927656e-01 + 1.5472568640734607e+00 -1.2897760191841314e+00 + 1.1283683436992362e+00 -1.1987857357489844e+00 + 1.4017537202304169e+00 -1.3969049984742412e+00 + 1.2458521947952050e+00 -1.3334240781645832e+00 + 1.5757563243246651e+00 -4.0503680845432655e-01 + 1.6910635859354812e+00 -3.9502113160042995e-01 + 1.4352403762543702e+00 -4.1239186877520240e-01 + 1.4956766327904205e+00 -3.9254171219918987e-01 + 1.0612636060900655e+00 -8.9705000657647815e-01 + 1.0742336486023731e+00 -7.6359173046314766e-01 + 1.1216247404696134e+00 -6.6230044561751811e-01 + 1.0045959669905997e+00 -1.0576590567450097e+00 + 1.2479181117607467e+00 -5.5072633604582677e-01 + 1.3010527425892775e+00 -5.1244831609349717e-01 + 1.1368727865351502e+00 -5.8753423485498502e-01 + 1.1795568623690400e+00 -5.2747720885986382e-01 + 1.3560527656397028e+00 -4.7716426453632721e-01 + 1.3638817160089047e+00 -4.0880990721356625e-01 + 2.0388907610678046e+00 -1.3848959933546610e+00 + 1.6377045152600900e+00 -1.4686943714620497e+00 + 1.8650437645129259e+00 -1.5542237137322417e+00 + 2.3062666468151036e+00 -1.3046231186411603e+00 + 2.4512190275830861e+00 -9.5871104572967170e-01 + 2.1627849919186417e+00 -6.8188161598222052e-01 + 2.0368833849747716e+00 -3.7218675995544004e-01 + 2.1955221495350727e+00 -5.1506238727527887e-01 + 1.7973998659670372e+00 -3.4931911947755623e-01 + 1.9085095400844594e+00 -3.2006049223605260e-01 + 2.3482108691659960e+00 -7.0740286887762238e-01 + 1.2469290108470972e+00 -1.5187988921053943e+00 + 1.4408055823355141e+00 -1.5734618065620793e+00 + 1.0801502426960852e+00 -1.3914486635661376e+00 + 9.2889530642979423e-01 -1.2246969723401975e+00 + 2.1587739846876630e+00 -3.1378381103427415e+00 + 1.9800715112377461e+00 -3.6597758058430543e+00 + 1.6804113949732695e+00 -3.0866572875358429e+00 + 2.5258005864301225e+00 -3.4864946487122666e+00 + 1.9749922165657097e+00 -2.6327626101033417e+00 + 2.5550179259470198e+00 -2.8529736189498038e+00 + 2.4080211497139317e+00 -4.0126766256109647e+00 + 1.5667601647999447e+00 -2.6498084993293674e+00 + 1.1065076253314103e+00 -3.1827226212132302e+00 + 1.2871984899691853e+00 -2.8065305779116727e+00 + 2.9601340237391867e+00 -3.2617417955894012e+00 + 3.0784884839529170e+00 -3.8686155221659817e+00 + 2.3577644616378848e+00 -2.2846068339875956e+00 + 1.5937836591845169e+00 -2.3248907686800777e+00 + 1.9473035078659677e+00 -2.1553299207457854e+00 + 3.0922336282787910e+00 -2.8058957548824708e+00 + 2.8854622928164133e+00 -2.2887119852244098e+00 + 2.6457019692104424e+00 -4.5327368241705699e+00 + 1.2529953890600964e+00 -2.4533115599715387e+00 + 8.2931787568126936e-01 -2.6601529215082849e+00 + 5.9562646090708427e-01 -3.1795113743974071e+00 + 3.6270750596584520e+00 -3.1680457042462109e+00 + 3.4756159856716451e+00 -4.5679878522044817e+00 + 3.8944033964765055e+00 -3.9035485661611773e+00 + 2.2061504456523977e+00 -1.9141731202322489e+00 + 2.5776603809798786e+00 -1.8636897486699553e+00 + 1.6067987546625275e+00 -1.9658894849361985e+00 + 1.2143405458733270e+00 -2.0417139388966490e+00 + 1.9019019782950295e+00 -1.8127813434087301e+00 + 3.4334788392328832e+00 -2.4580056704024571e+00 + 2.9357622862315154e+00 -1.8293626687975149e+00 + 3.2881282208280211e+00 -1.9324357690601772e+00 + 3.0769330994314430e+00 -5.3098589546361836e+00 + 9.5097779511863223e-01 -2.2855906459552955e+00 + 3.4515343785653130e-01 -2.8379252626156415e+00 + 3.1899588371020826e-01 -2.4514128694817998e+00 + 6.6764077412223344e-01 -2.2171404531180769e+00 + 1.0261158658835967e-01 -3.1750365320140759e+00 + 4.1766847042459716e+00 -3.4770493454235236e+00 + 3.9648119884365158e+00 -2.5078490268082874e+00 + 4.3581616956330080e+00 -3.0397622428277487e+00 + 4.2493012998313446e+00 -4.5649940849000643e+00 + 3.7708329433812438e+00 -5.0629515915865682e+00 + 4.7592548454986741e+00 -3.7745988880267305e+00 + 2.3538275557744797e+00 -1.6297403385527218e+00 + 2.1202154285509991e+00 -1.6152375365630576e+00 + 2.8425005140619675e+00 -1.5146963786917951e+00 + 2.5467015701882971e+00 -1.5106213307684584e+00 + 1.3577722303746782e+00 -1.7534407509829180e+00 + 1.6256906063815748e+00 -1.7071801869030878e+00 + 8.7871164280973346e-01 -2.0460675850263357e+00 + 1.0473313547316820e+00 -1.6393228169292087e+00 + 9.0523126964079381e-01 -1.8456955086371352e+00 + 3.8857168832164888e+00 -1.8125510504673201e+00 + 3.1884012789329148e+00 -1.4635387180700548e+00 + 3.4995174216710581e+00 -1.6051424640237002e+00 + 3.8064481499363936e+00 -5.6046403877384847e+00 +-4.1698114518652574e-02 -2.7325198670945809e+00 + 3.9050310125475818e-01 -2.0108812155717430e+00 + 6.6443733847373210e-01 -1.9051427157971688e+00 + 1.1450230109456072e-01 -2.0510138227338928e+00 +-6.1040075503143498e-02 -2.3484068310377211e+00 +-5.4189697996365283e-01 -3.0146335500293731e+00 + 5.0331126477723771e+00 -6.3884830324225561e+00 + 4.3467447672678929e+00 -6.0074990903062542e+00 + 1.1474316418540838e+00 -1.5170438820612731e-01 + 1.1443524416732842e+00 -1.5191384980008138e-01 + 1.1454297134788476e+00 -1.4961302759486728e-01 + 1.1502722952762099e+00 -1.5406913650208764e-01 + 1.1501858105275389e+00 -1.5073429847252839e-01 + 1.1463748980084745e+00 -1.5448610465493573e-01 + 1.1432210469221360e+00 -1.5437311077474192e-01 + 1.1442693483603463e+00 -1.5719663188694710e-01 + 1.1487026139648293e+00 -1.5765951075968587e-01 + 1.1531272230665266e+00 -1.5178124622723033e-01 + 1.1523554936492530e+00 -1.4820593150139416e-01 + 1.1525980737446346e+00 -1.5750249586182008e-01 + 1.1540002909336238e+00 -1.5471327219842124e-01 + 1.1471051317916903e+00 -1.6033218943917404e-01 + 1.1441402949918356e+00 -1.6044665287250837e-01 + 1.1513099060073415e+00 -1.6216082978863255e-01 + 1.1554521559066444e+00 -1.4916243344974589e-01 + 1.1578483109518629e+00 -1.5282878008130751e-01 + 1.1547236779603480e+00 -1.4546292414223672e-01 + 1.1511005479006187e+00 -1.4449633798818695e-01 + 1.1563361032660424e+00 -1.5655796482998596e-01 + 1.1560889778143491e+00 -1.5988381308457633e-01 + 1.1577095288608987e+00 -1.4632773981375635e-01 + 1.1587568404155064e+00 -1.4905370384042271e-01 + 1.1547676183256428e+00 -1.4228909545181523e-01 + 1.1569223998058575e+00 -1.4370716071292122e-01 + 1.1515358109494827e+00 -1.4027789949749092e-01 + 1.1614394607459246e+00 -1.5750741751982389e-01 + 1.1620654692774792e+00 -1.5334743362660674e-01 + 1.1616327817134362e+00 -1.5013646859470953e-01 + 1.1467551767603084e+00 -1.6341853769284853e-01 + 1.1430943276592345e+00 -1.6298706808707664e-01 + 1.1557777484192826e+00 -1.6355013188368162e-01 + 1.1534335368099633e+00 -1.6698464880404629e-01 + 1.1493131883289536e+00 -1.6634369108476221e-01 + 5.9274093351407089e+00 -5.8496296180404954e+00 + 5.0947938874228811e+00 -5.5309683650206978e+00 + 1.2321423898721171e+01 5.9457052307886471e+00 + 1.1614303917929597e+01 6.0618647785457966e+00 + 1.0730236224732579e+01 6.1799961684518721e+00 + 1.5964442195596931e+01 -1.1382659023906569e+00 + 1.5080854004500218e+01 -1.1703036160331237e+00 + 1.6362811925265390e+01 -1.8850541508921026e+00 + 1.5643639860970929e+01 -1.6948082818446295e+00 + 1.3974007262811099e+01 2.1146659083396457e-01 + 1.4435508768933872e+01 -9.3497209019848526e-01 + 1.3713187933087241e+01 -6.1573319076970279e-01 + 1.4996836046876673e+01 -1.9748466025552602e+00 + 1.4208027102103578e+01 -1.5189749737214271e+00 + 1.6290453736347246e+01 -2.6360500911716258e+00 + 1.5674317739664374e+01 -2.3667418141285737e+00 + 9.7298496011487146e+00 6.0855099954265626e+00 + 1.0452709041717029e+01 5.4155820586069368e+00 + 1.1142305346024173e+01 5.5509075362213025e+00 + 8.7441529060711574e+00 6.0484661711788092e+00 + 9.8163423377008385e+00 5.1924131300405492e+00 + 9.0151643112555107e+00 5.2876952020859420e+00 + 1.1835195742739323e+01 5.3238919497869261e+00 + 1.1062773893518937e+01 5.0239215006554119e+00 + 1.0404356330459436e+01 4.6499565693482481e+00 + 8.1564999354582284e+00 5.6355729092781601e+00 + 9.5651511166330963e+00 4.6051655059952452e+00 + 8.7719050181007319e+00 4.4955963592294879e+00 + 8.1945580848825443e+00 4.9188853137346769e+00 + 7.1981967972903149e+00 6.5578636769656811e+00 + 7.2699707385065580e+00 5.8120450019170136e+00 + 1.1411316225112074e+01 4.4717895825661031e+00 + 1.2252240549637925e+01 4.7602783465972465e+00 + 1.0704160972237794e+01 3.8303049958145650e+00 + 9.9996575110343286e+00 4.0230007529605984e+00 + 1.6824878794877215e+01 -4.6166913043024778e+00 + 1.3894203500467817e+01 -4.6750588730548657e+00 + 1.2404436546451002e+01 -5.3098259487545931e+00 + 1.3006020406786512e+01 -4.7430618780743004e+00 + 1.4783908697318196e+01 -4.6312607076774839e+00 + 1.1682507152142222e+01 -5.8547364788673093e+00 + 1.1298918456656970e+01 -6.7194110835781515e+00 + 1.3236742381988513e+01 -3.9773098973699206e+00 + 1.4377846667732541e+01 -4.1871639493944599e+00 + 1.4017136310868494e+01 -3.7927997610475330e+00 + 1.2226377143688318e+01 -4.6417070612787228e+00 + 1.1630890835961381e+01 -4.9284590894505129e+00 + 1.2457281270693677e+01 -4.0756162978285886e+00 + 1.4816138162275664e+01 -3.6495364557978434e+00 + 1.5562516127141961e+01 -4.1730314345109463e+00 + 1.0897331713363990e+01 -6.0950366197802026e+00 + 1.0866131544351887e+01 -5.3030646161296318e+00 + 1.3394064525582380e+01 -3.0774760569634338e+00 + 1.2703761523361393e+01 -3.2640137130564000e+00 + 1.4198464515978038e+01 -3.0058361655614476e+00 + 1.1633256658549001e+01 -4.1515720922856048e+00 + 1.1121856397806589e+01 -4.5918619175389921e+00 + 1.1882626484931080e+01 -3.3631968678123201e+00 + 1.6146978755283207e+01 -4.5950052526385434e+00 + 1.5778455402265656e+01 -3.2301007819782370e+00 + 1.6379839185406944e+01 -3.9491048800195472e+00 + 1.4973709466260274e+01 -2.7795909763295583e+00 + 1.0222201969648950e+01 -5.9920144837053897e+00 + 9.9877498135058218e+00 -5.2398521540015395e+00 + 1.0520289611670364e+01 -4.5639175689271951e+00 + 9.7236919379870557e+00 -6.4634144389447528e+00 + 1.1441874515709500e+00 -1.3248612685413264e-01 + 1.1444962166631498e+00 -1.3087646546584608e-01 + 1.1455846141986967e+00 -1.3217718114167099e-01 + 1.1430071342175623e+00 -1.3133366237531163e-01 + 1.1453260801554279e+00 -1.3348914910875465e-01 + 1.1440072562778667e+00 -1.3399321263241859e-01 + 1.1472257314243564e+00 -1.3030087580526128e-01 + 1.1432109167226443e+00 -1.2952632250531337e-01 + 1.1448632201166120e+00 -1.2925514243893588e-01 + 1.1472739088143911e+00 -1.3344952370232477e-01 + 1.1454143514229287e+00 -1.3503693354634549e-01 + 1.1458636005612135e+00 -1.2797106585443885e-01 + 1.1495957809974726e+00 -1.3261236555001688e-01 + 1.1481524952983193e+00 -1.2694543680873949e-01 + 1.1496261708224580e+00 -1.3093206767005938e-01 + 1.1501105255068538e+00 -1.2916773575280160e-01 + 1.1439775671731240e+00 -1.2753912077400287e-01 + 1.1417825904626469e+00 -1.2779580840535232e-01 + 1.1470812487659074e+00 -1.3644666062765509e-01 + 1.1492987512076525e+00 -1.3486318737980696e-01 + 1.1457873462863617e+00 -1.2535165066479692e-01 + 1.1517081050712221e+00 -1.3142652146066780e-01 + 1.1521137341274255e+00 -1.3463021798426666e-01 + 1.1510775756562950e+00 -1.2630766536086924e-01 + 1.1490143904800121e+00 -1.2397426565563308e-01 + 1.1532469259337290e+00 -1.2926709296493755e-01 + 1.1426707469119179e+00 -1.2545057545474947e-01 + 1.1504290833330941e+00 -1.3717716903482824e-01 + 1.6625504339473068e+01 -3.2347212194486730e+00 + 1.4396602690204176e+01 -2.2807364821709086e+00 + 1.3539192609460628e+01 -2.1939061370702575e+00 + 1.2918478815726765e+01 -2.5411884688955126e+00 + 1.2736081119678325e+01 -1.7599239868008709e+00 + 1.3415489668362291e+01 -1.3703140296646552e+00 + 1.2203594440832873e+01 -2.5235099091908069e+00 + 9.0739670880624175e+00 -6.5243752917967441e+00 + 9.3462389230239040e+00 -5.8115959303075329e+00 + 8.4453259338443303e+00 -6.5305340818921707e+00 + 8.5199864677069712e+00 -5.9321781465737331e+00 + 7.7309988895937636e+00 -6.1250853189589094e+00 + 7.0501996215001270e+00 -6.1152079813459466e+00 +-1.6017567047444558e+01 -5.8780491370642380e+00 +-1.5770422419027369e+01 -7.0718325234508228e+00 +-1.5736305568836414e+01 -6.5441404954565456e+00 + 1.1128266562616460e+00 -1.5459181435824121e-01 + 1.1135714054512675e+00 -1.5571190472230967e-01 + 1.1118997653630203e+00 -1.5561675484039483e-01 + 1.1117472669676687e+00 -1.5379601453317093e-01 + 1.1125777526013536e+00 -1.5745646899468113e-01 + 1.1152500129636564e+00 -1.5605829749823386e-01 + 1.1140840345578411e+00 -1.5723949163398743e-01 + 1.1103642514785150e+00 -1.5491787420722858e-01 + 1.1103112594177134e+00 -1.5722645222669485e-01 + 1.1101782488604428e+00 -1.5311326366834521e-01 + 1.1156273912076813e+00 -1.5760237344932193e-01 + 1.1141409397304827e+00 -1.5918786399667795e-01 + 1.1119021263480846e+00 -1.5931408483990595e-01 + 1.1088796901115074e+00 -1.5565605361814505e-01 + 1.1092801434066430e+00 -1.5421716654958573e-01 + 1.1093606203821977e+00 -1.5961118526529106e-01 + 1.1081007618541179e+00 -1.5750854372150513e-01 + 1.1085867509258946e+00 -1.5305624462416745e-01 + 1.1090273233688919e+00 -1.5151682604897587e-01 + 1.1168938001835542e+00 -1.5912000392131631e-01 + 1.1175885573731321e+00 -1.5731546491109327e-01 + 1.1131807011569066e+00 -1.6157990461431382e-01 + 1.1159175100108740e+00 -1.6157529439304597e-01 + 1.1112250335961988e+00 -1.6121655037048299e-01 + 1.1078662039582241e+00 -1.5426295331052131e-01 + 1.1073741606204663e+00 -1.5592978406426994e-01 + 1.1078361536549721e+00 -1.5198884717811723e-01 + 1.1070275126381546e+00 -1.5303705013693047e-01 + 1.1075925867435146e+00 -1.5052387572974624e-01 + 1.1065325561623638e+00 -1.5905651961588774e-01 + 1.1072331951721708e+00 -1.6229060210521595e-01 + 1.1099074217968052e+00 -1.6216363629730779e-01 + 1.1058951428659896e+00 -1.5684243837445422e-01 + 1.1189335153683828e+00 -1.6035056000022507e-01 +-1.2939848416425065e+01 6.1663537143615628e+00 +-1.3578926020948259e+01 5.8618716059655185e+00 +-1.3867919954790622e+01 5.2463629233945994e+00 +-1.4673155653395483e+01 5.0412387272748447e+00 +-1.2423955619458923e+01 5.7559091294851186e+00 +-1.1823635677964688e+01 5.7715173258586461e+00 +-1.3057344532540540e+01 5.4086384769647253e+00 +-1.5766441194967399e+01 4.3998396646864535e+00 +-1.6223572012885526e+01 3.7841541350063608e+00 +-1.5362461056339455e+01 4.9075412662875380e+00 +-1.6553408198131606e+01 2.4670022888548004e+00 +-1.5890502444231601e+01 3.1220660361793620e+00 +-1.0642559346198667e+01 5.9382915914010539e+00 +-1.0000195647998851e+01 6.1409307088093712e+00 +-1.1177577162817883e+01 5.7189497280276385e+00 +-9.2480138206988869e+00 6.3587740883143198e+00 +-9.9791067660390098e+00 4.9763191396459803e+00 +-9.8583434763846185e+00 4.2778596290346229e+00 +-1.0578052959415714e+01 4.5107437922848632e+00 +-9.3986335558466010e+00 4.8025770614991785e+00 +-1.0645344045574134e+01 5.2849482704507551e+00 +-9.4475295944885715e+00 5.4981252044552349e+00 +-1.0100495975308263e+01 5.5821849710411442e+00 +-1.0445074072601798e+01 3.6773000779692708e+00 +-9.1533212865648608e+00 4.2158539467642555e+00 +-9.6136265300015964e+00 3.5800381428780952e+00 +-1.1364405128034505e+01 4.9852199817234606e+00 +-1.1249093379344103e+01 4.0920453253728226e+00 +-8.7335193271720755e+00 4.9431769428474936e+00 +-8.7865939324820488e+00 5.6984227139148658e+00 +-1.0031199452092480e+01 2.9488213348226679e+00 +-1.1303878615913504e+01 3.2805504641140928e+00 +-1.0718704511149738e+01 2.9601529092584968e+00 +-8.8053581682353581e+00 3.5382850074419423e+00 +-8.3513676583359882e+00 4.1995792432053278e+00 +-9.2921653764864942e+00 2.9526584914323166e+00 +-1.1876548779913605e+01 4.3927260673535571e+00 +-1.2359572272638289e+01 5.0085802280155605e+00 +-1.1926600720185633e+01 3.7057315687917409e+00 +-1.2561778225245391e+01 4.1635594364159303e+00 +-1.3332554564146562e+01 4.5313170772978992e+00 +-8.1053851393559029e+00 5.4554918924489542e+00 +-8.0239264420160055e+00 4.7617641239957536e+00 +-8.3985217806949066e+00 6.2365454415083121e+00 +-1.1322471881546321e+01 2.4998297530701734e+00 +-1.2004039917159460e+01 2.9967271250679772e+00 +-1.0490898533594645e+01 2.3942629163162650e+00 +-9.7228740355449617e+00 2.2503300445965664e+00 +-1.2617253464611920e+01 3.4192655100484188e+00 +-7.9805546849970446e+00 3.5149739238837796e+00 +-8.6032393793831261e+00 2.8396525104605530e+00 +-7.5844057431757363e+00 4.3041396815885449e+00 +-9.0614956327464711e+00 2.3723316077396035e+00 +-1.3207133972226117e+01 3.8124260085142652e+00 +-1.2201181901880958e+01 2.2670222456075706e+00 +-1.2652852918818397e+01 2.8079632087758313e+00 +-1.0980825115188495e+01 1.9639129640811319e+00 +-1.1530166290247195e+01 1.8898334840492339e+00 +-1.3318160079938536e+01 3.1786604646781740e+00 +-1.3883191895171279e+01 3.7506768298845259e+00 +-1.4268511154206507e+01 4.4326924409596415e+00 +-7.4003681745377179e+00 5.0074610185578479e+00 +-7.7316101097554366e+00 6.1402175429782631e+00 +-7.3620066576112180e+00 5.5847430188785765e+00 +-6.9762744994478112e+00 6.1388936613974252e+00 +-6.7240764244321980e+00 5.4146115853449004e+00 +-6.8975795523140846e+00 4.5403246838623375e+00 +-1.0403863967307529e+01 1.6942028223561607e+00 +-9.1622999640718632e+00 1.7681476958787243e+00 +-9.7993840178743312e+00 1.4096758761207582e+00 +-7.9278764079655559e+00 2.5483362721615492e+00 +-8.5342592194748335e+00 2.1617690028779748e+00 +-7.1362509917819921e+00 3.7845899346385821e+00 +-7.1231855574106788e+00 2.8848115213630052e+00 +-1.6561186400502876e+01 1.6848036461887475e+00 +-1.6093802518081816e+01 9.3507956416898708e-01 +-1.6049533094787733e+01 2.3327947868438486e+00 +-1.5717807195583575e+01 1.7417249760336375e+00 +-1.6397922903748508e+01 2.2638967535215215e-01 +-1.5225926745783624e+01 9.2298755557085599e-01 +-1.5733647527599800e+01 1.3909390703022950e-01 +-1.5339125641488380e+01 2.5570105661664329e+00 +-1.4785504051540968e+01 1.7579152378156806e+00 +-1.6317347981500944e+01 -6.0947946700100886e-01 +-1.4809762704979875e+01 3.4864857492689794e+00 +-1.5530163276500915e+01 3.7991364420352625e+00 +-1.4957151338488387e+01 -3.7232628210404073e-02 +-1.4640888220237002e+01 1.1229772497055706e+00 +-1.4451669434719506e+01 5.5292946978776314e-01 +-1.5440596120397984e+01 -6.9812418588533376e-01 +-1.4451758248587510e+01 2.5745892399511519e+00 +-1.4048609887725803e+01 1.9681406161354715e+00 +-1.4038349964210923e+01 1.2273860625055306e+00 +-1.5851945543327119e+01 -1.3725748147570158e+00 +-1.5058656910852150e+01 4.3370191965162945e+00 +-1.3999664589569178e+01 3.0930535194591187e+00 +-1.3673221547069971e+01 2.4922520937262789e+00 +-1.4137376315231307e+01 -3.6812584088988842e-01 +-1.4755950337318950e+01 -9.3001580643132797e-01 +-1.3631495320710385e+01 5.0377415977593643e-01 +-1.3432759801851162e+01 1.8716906057638880e+00 +-1.3280878586564114e+01 1.2581514699528924e+00 +-1.5192427496028159e+01 -1.3302063341518249e+00 +-1.6633841839738764e+01 -5.2694162648047325e+00 +-1.6390479783674763e+01 -4.4078766311607467e+00 +-1.6257012359858692e+01 -3.7125904051532501e+00 +-1.6746074869582714e+01 -2.9653482702981933e+00 +-1.5858409267455912e+01 -5.0092109642639429e+00 +-1.5396040293735609e+01 -4.1098484134987388e+00 +-1.5377542330495118e+01 -5.4175269664944210e+00 +-1.5174341926047248e+01 -6.0393123522843268e+00 +-1.5096687166805836e+01 -4.8246549330785626e+00 +-1.4467286498173834e+01 -5.3532911234752305e+00 +-1.6096732165773560e+01 -3.0823756663527462e+00 +-1.6173435176193593e+01 -2.2598243666289335e+00 +-1.5658944859998968e+01 -3.3902932698067048e+00 +-1.5554960319759658e+01 -2.7643345189451907e+00 +-1.5331448096583671e+01 -2.0032883782232886e+00 +-1.4989979160867392e+01 -3.2823173450835839e+00 +-1.4443647984768390e+01 -3.7586324550507726e+00 +-1.4478952429575571e+01 -4.5108770581620519e+00 +-1.3890081795865839e+01 -6.0312080609626264e+00 +-1.4786007482067689e+01 -2.5186407506181894e+00 +-1.4684128107120131e+01 -1.7038662123153330e+00 +-1.4074773503739891e+01 -2.2318546170567686e+00 +-1.3979239431833648e+01 -1.3691333555657792e+00 +-1.4220455603131541e+01 -3.0443075843749057e+00 +-1.3254982340937502e+01 -6.1404214834843458e+00 +-1.3485395715639797e+01 -8.5761309730955304e-01 +-1.3411048724152622e+01 -1.3962314440055366e+00 +-1.3407791889137187e+01 -1.9591882845617192e+00 +-1.3408485415661517e+01 -1.7647828430662571e-01 +-1.2771767859999940e+01 -1.3989910385850521e+00 +-1.2835395621099778e+01 -4.8118359645152964e-01 +-1.3371018509149195e+01 -2.7959915149046424e+00 +-1.2683534044043171e+01 -2.2826613022171358e+00 +-1.2880852906967320e+01 2.5476945798128980e-01 +-1.2759253277162259e+01 9.6327820779351470e-01 +-1.3675123046296875e+01 -3.6235800367720543e+00 +-1.2171128286593913e+01 -7.6027026523878760e-01 +-1.2138679673553625e+01 -1.9495655874328861e+00 +-1.1813487900791671e+01 -1.4327086561759899e+00 +-1.2172899772284225e+01 -5.0616155407112728e-02 +-1.2445119384517469e+01 -3.0455183282809060e+00 +-1.2913937261690663e+01 -3.6506382286663381e+00 +-1.1966826947901609e+01 -2.5467130595375949e+00 +-1.2046389951775836e+01 7.0822156750033116e-01 +-1.2777893237075830e+01 1.6795853110361705e+00 +-1.2096018101177776e+01 1.4414986494639663e+00 +-1.3937297672201993e+01 -4.1834658505231914e+00 +-1.3290111780840135e+01 -4.2545717154080194e+00 +-1.2094882146549807e+01 -3.7428007638997940e+00 +-1.1644255862492912e+01 -3.2827613872744763e+00 +-1.2495472667863993e+01 -4.5668773183918319e+00 +-1.1382192015996722e+01 -9.0947565775957173e-01 +-1.1625324058537529e+01 -3.2181427300129428e-01 +-1.1360502733650435e+01 -2.0626160863492515e+00 +-1.0803295922546766e+01 -1.5912109152591256e+00 +-1.1478307808730975e+01 2.9658017676737103e-01 +-1.1153067353973185e+01 -2.7645617109099589e+00 +-1.0562943572616732e+01 -2.4277027737967671e+00 +-1.0625448467592406e+01 -9.0850918884206067e-01 +-1.0878866644365772e+01 -2.8678657074749481e-01 +-9.9470384811087058e+00 -1.9362066346222520e+00 +-9.9944558220171444e+00 -1.2379040502773790e+00 +-1.2525051657159324e+01 -6.0713785789282753e+00 +-1.1134401443760254e+01 -5.9697937752619907e+00 +-1.0300901844116055e+01 -6.2358524897555156e+00 +-1.0874644960355695e+01 -6.6481801845603457e+00 +-1.0711032373672296e+01 -5.3416102667641354e+00 +-1.1407618609715996e+01 -6.4735442229023192e+00 +-1.1576176046959219e+01 -5.1925958967473349e+00 +-1.1769848467027131e+01 -5.9253611866623288e+00 +-1.0031385164875857e+01 -5.4447921669962511e+00 +-9.6746508835978489e+00 -5.8501347214309760e+00 +-9.4167233639052625e+00 -6.4457522399958123e+00 +-1.0951813576009698e+01 -4.5670324886030897e+00 +-1.0095553798250506e+01 -4.7206353641656733e+00 +-1.2284608004977542e+01 -5.3975614561980478e+00 +-1.1700403359186794e+01 -4.4223810623136757e+00 +-9.3069883871541066e+00 -5.2109494468657118e+00 +-9.0845859387842296e+00 -5.8853517495904413e+00 +-8.5963436352626132e+00 -6.3883631381478097e+00 +-1.0596871618464135e+01 -3.9638412674028984e+00 +-1.1276733280256082e+01 -3.9394320044486335e+00 +-9.3180585103546747e+00 -4.3634476145161756e+00 +-9.9419586723981581e+00 -3.9926432313665572e+00 +-1.2907170298553822e+01 -5.4332159278452252e+00 +-1.3233724872069558e+01 -4.8833591558184821e+00 +-8.4282234240012741e+00 -5.5315592015119250e+00 +-8.5776448888152004e+00 -4.7310177280299683e+00 +-7.7291878830893666e+00 -6.1455717056087877e+00 +-1.0985132370528916e+01 -3.4016130134477010e+00 +-1.0337295962587874e+01 -3.2840568223237625e+00 +-9.3982465797658676e+00 -3.5393057401574310e+00 +-8.5879587357441807e+00 -3.9861341765117686e+00 +-1.3591983154188270e+01 -5.4351939564681686e+00 +-1.3798653119529007e+01 -4.7696679872230590e+00 +-9.8023770692292800e+00 -2.7272746780426331e+00 +-7.9114290193260643e+00 -4.9197787724799156e+00 +-7.4825765429844751e+00 -5.3558309060928764e+00 +-7.8235614323387779e+00 -4.2724009144491362e+00 +-6.8920404174455712e+00 -5.9261250200367925e+00 + 3.7882478768435135e-01 1.2134154761221083e-01 + 3.7908105395514724e-01 1.3302637963660402e-01 + 3.8882146530199435e-01 1.2443257847100142e-01 + 3.6870334562796359e-01 1.2314011294538574e-01 + 3.7486397949120231e-01 1.1511170033735851e-01 + 3.9131245054547037e-01 1.3619899909532762e-01 + 3.6835047927132791e-01 1.3392955798566675e-01 + 3.8346244734595558e-01 1.4645918690514748e-01 + 3.7240639143822563e-01 1.4185198199866278e-01 + 3.6759654147209631e-01 1.1105486493735839e-01 + 3.5935658830015171e-01 1.3157592913087512e-01 + 3.5831266418374952e-01 1.2345382873868260e-01 + 4.0036413328192566e-01 1.4894481686894068e-01 + 3.6237805068354589e-01 1.4100885675778585e-01 + 3.6957536487476972e-01 1.5342177623411146e-01 + 3.8756771325893880e-01 1.6384678753163939e-01 + 3.4632428942623505e-01 9.6965630144005388e-02 + 3.3923986674632545e-01 1.0429146087355434e-01 + 3.4662656334808162e-01 1.0379461385254274e-01 + 3.5010238461362775e-01 1.2834758379269573e-01 + 3.5390072828633379e-01 1.3871002258500198e-01 + 4.0678831653318070e-01 1.6748210421489773e-01 + 4.2001241579812643e-01 1.5614761464324545e-01 + 3.5329434941739635e-01 1.5061382206015139e-01 + 3.7338723433394705e-01 1.6786233973347464e-01 + 3.5907472894743364e-01 1.6593159053529405e-01 + 3.9652623026147893e-01 1.7801515067656482e-01 + 3.8233209508003796e-01 1.8133997031638671e-01 + 3.4478713963511609e-01 1.4037135651530264e-01 + 3.3963128530947984e-01 1.3117597533612724e-01 + 4.2429492970840954e-01 1.7487884350438776e-01 + 4.1048257245567754e-01 1.8569995703357733e-01 + 4.3895684290942683e-01 1.6043497705891241e-01 + 1.1063818369633012e+00 -1.5149608418676053e-01 + 1.1058852146915683e+00 -1.4977047016253664e-01 + 1.1047085542774653e+00 -1.5132419598880631e-01 + 1.1054478529899541e+00 -1.5276413639334407e-01 + 1.1042103252223399e+00 -1.4987601109366722e-01 + 1.1046609467873409e+00 -1.4848305855383614e-01 + 1.1058419553627914e+00 -1.5456489525379880e-01 + 1.1035163806551367e+00 -1.5309232061444789e-01 + 1.1028904546162863e+00 -1.5084231598721942e-01 + 1.1029270982951545e+00 -1.4881599074921326e-01 + 1.1035447224932327e+00 -1.4684348511492828e-01 + 1.1034825405769766e+00 -1.5579573672216895e-01 + 1.1011031980811907e+00 -1.5206624786098644e-01 + 1.1014515207902349e+00 -1.5440073044472058e-01 + 1.1011775785845401e+00 -1.4978021114845319e-01 + 1.1012506198998437e+00 -1.4732001704589948e-01 + 1.1020647120904599e+00 -1.4580898090321170e-01 + 1.0931923434597408e+00 -1.6039929813099718e-01 + 1.0921679271597853e+00 -1.6584099281662645e-01 + 1.0880570330982735e+00 -1.6304876725089912e-01 + 1.0957330293527150e+00 -1.6385237488223936e-01 + 1.0888038677030636e+00 -1.5844627539415512e-01 + 1.0971324588699218e+00 -1.6119041496118314e-01 + 1.0914988292837933e+00 -1.5658725100266224e-01 + 1.0979692144953219e+00 -1.5755229312547669e-01 + 1.0947382261993042e+00 -1.5570382787106496e-01 + 1.0864401425313446e+00 -1.6846747104062842e-01 + 1.0972224613914392e+00 -1.6780357965950543e-01 + 1.0927672773904860e+00 -1.7128039048765231e-01 + 1.0844151705091178e+00 -1.5891346036596588e-01 + 1.0837484643499025e+00 -1.6396764892905935e-01 + 1.0989499558827163e+00 -1.6402758884285618e-01 + 1.0877332957949477e+00 -1.5437736592828344e-01 + 1.1009212657462655e+00 -1.6005838163475516e-01 + 1.0922061289980647e+00 -1.5351852131084343e-01 + 1.0982919088650149e+00 -1.5332049924637658e-01 + 1.1012663195379346e+00 -1.5684540101887023e-01 + 1.0998896968687006e+00 -1.5548098672664423e-01 + 1.0952709320938752e+00 -1.5284510441006205e-01 + 1.0876980663144522e+00 -1.7589475833592871e-01 + 1.0791985991152586e+00 -1.6787660205126542e-01 + 1.0820514748308483e+00 -1.7364776653215586e-01 + 1.0981622124006805e+00 -1.7312904909344695e-01 + 1.1016411091164215e+00 -1.6629745384204853e-01 + 1.1025342177061361e+00 -1.7037793372412580e-01 + 1.0947022288158550e+00 -1.7709422022608123e-01 + 1.0799177122469246e+00 -1.6206916384598458e-01 + 1.0828677001425717e+00 -1.5441826876863729e-01 + 1.0777937986961064e+00 -1.5641753045858309e-01 + 1.1017095456413841e+00 -1.6306739537596115e-01 + 1.0903164582982896e+00 -1.5136164173196676e-01 + 1.0844825061169843e+00 -1.5063134215829166e-01 + 1.0882001973491384e+00 -1.5035443270529925e-01 + 1.1037674949863785e+00 -1.5833790446585283e-01 + 1.1040435050062456e+00 -1.6107029935139394e-01 + 1.0930151096436447e+00 -1.5021774747926031e-01 + 1.0967844337009609e+00 -1.5026624361424012e-01 + 1.0994206872297880e+00 -1.5074565720347266e-01 + 1.0810540893750229e+00 -1.8051181028559427e-01 + 1.0915732491453696e+00 -1.8124585071167587e-01 + 1.0866698710179747e+00 -1.8405358501310332e-01 + 1.0758664768181916e+00 -1.7548819094729140e-01 + 1.0744325285642446e+00 -1.6317057742512020e-01 + 1.0701141323242211e+00 -1.7039188693499341e-01 + 1.1029171072775483e+00 -1.7498268170209030e-01 + 1.1004382115626328e+00 -1.7836662186822139e-01 + 1.1044757340841684e+00 -1.6720815999759964e-01 + 1.1046501222557197e+00 -1.6408157389231803e-01 + 1.1074576468434856e+00 -1.7405434987023227e-01 + 1.1068018985265269e+00 -1.6949489376699489e-01 + 1.0972871511953599e+00 -1.8346082871035208e-01 + 1.0799137295956456e+00 -1.5175164493210502e-01 + 1.0707167868963694e+00 -1.5848312357996974e-01 + 1.0759605054900874e+00 -1.5159760579145143e-01 + 1.0717961056361034e+00 -1.5312660437700742e-01 + 1.0904275597055104e+00 -1.4834014123607631e-01 + 1.0875534727323597e+00 -1.4748950964373364e-01 + 1.0815305561277029e+00 -1.4868107495729532e-01 + 1.0846781240094430e+00 -1.4680320433090799e-01 + 1.0953934797814853e+00 -1.4780316410283945e-01 + 1.0927938901818095e+00 -1.4695876063558444e-01 + 1.0993497533917491e+00 -1.4860377756926368e-01 + 1.0974807994152371e+00 -1.4781775380190254e-01 + 1.0802981638894522e+00 -1.9178675494202935e-01 + 1.0744755688120193e+00 -1.8363438356742279e-01 + 1.0915089283831776e+00 -1.8572586127285717e-01 + 1.0875995241140117e+00 -1.8996865238143812e-01 + 1.0694229155291239e+00 -1.7939493349395264e-01 + 1.0681404778580159e+00 -1.6432237758940005e-01 + 1.0621590559880474e+00 -1.6654877559106751e-01 + 1.0635952653225615e+00 -1.7452517257946454e-01 + 1.1059932478748991e+00 -1.7898545395441090e-01 + 1.1038480134619988e+00 -1.8382894024270513e-01 + 1.1071266541121361e+00 -1.6601093441020964e-01 + 1.1108746025203473e+00 -1.7061039356590868e-01 + 1.1091531729622588e+00 -1.6745240880419487e-01 + 1.1121799339939855e+00 -1.7451274620364643e-01 + 1.1112443086081640e+00 -1.7786140505869241e-01 + 1.1012999751616235e+00 -1.8907243908454063e-01 + 1.0949934330851931e+00 -1.9196855855716422e-01 + 1.0779270839087047e+00 -1.4758710999130642e-01 + 1.0733179906682224e+00 -1.4863149435581136e-01 + 1.0659006771179875e+00 -1.5392376529652552e-01 + 1.0686335173346748e+00 -1.4916131767434138e-01 + 1.0639210489333095e+00 -1.5965888162045871e-01 + 1.0988535856766930e+00 -1.4665143602707076e-01 + 1.0969135518429738e+00 -1.4649824196210659e-01 + 1.0953098853629797e+00 -1.4514971384946307e-01 + 1.1002021056063001e+00 -1.4532713501989747e-01 + 1.0903446668885906e+00 -1.4490206303153741e-01 + 1.0929967740684674e+00 -1.4452143644598436e-01 + 1.0979365778376859e+00 -1.4501642549291205e-01 + 1.0945081928618094e+00 -1.4253018255818972e-01 + 1.0969221319028648e+00 -1.4306793781155136e-01 + 4.5784852833251648e+00 -2.2567989009727114e+00 + 4.9128620596195489e+00 -2.9543860354233686e+00 + 5.4555573612017199e+00 -2.3704753212727496e+00 + 5.0332704315225385e+00 -1.7409907582231767e+00 + 4.4956647217041237e+00 -1.4834150585436277e+00 + 5.5391565801976768e+00 -3.3108071964323926e+00 + 5.4915637856414037e+00 -4.1258944093888772e+00 + 5.0159729280042029e+00 -4.7234693683619469e+00 + 5.7012711866459753e+00 -1.4945987322851124e+00 + 6.0747345330261453e+00 -2.7745401977478679e+00 + 6.2863906979273381e+00 -2.0597386195955920e+00 + 4.0402195688591647e+00 -1.2334952326758639e+00 + 3.5982567098887728e+00 -1.2348293192707160e+00 + 5.0247552979898131e+00 -9.7940161057941566e-01 + 4.3686155385392027e+00 -8.7037472233548385e-01 + 6.2303528101490002e+00 -4.1381169685983821e+00 + 6.3271368191443784e+00 -3.2837308206179188e+00 + 5.8017705371283270e+00 -4.8939591619757010e+00 + 4.3806823293073336e+00 -5.2490871479856480e+00 + 6.5772787796262122e+00 -1.1405721427240536e+00 + 5.8303745516082373e+00 -6.7641394131558741e-01 + 6.8509813626075911e+00 -2.8409563612428315e+00 + 6.9830762350636562e+00 -1.8588642488402201e+00 + 3.8528439909472567e+00 -7.6630601276218613e-01 + 3.4037636846773793e+00 -7.7426068652030722e-01 + 3.2480741621959481e+00 -1.1190048410975635e+00 + 4.6430126717420990e+00 -4.2086384563479839e-01 + 5.2237982870203155e+00 -3.4861603510162809e-01 + 4.1174833135013102e+00 -3.9727618874577786e-01 + 6.8996981216455922e+00 -3.6781036316007629e+00 + 6.5189005965166160e+00 -5.0781746623365507e+00 + 7.0342432307688867e+00 -4.5961488978365139e+00 + 6.5780733133418963e+00 -1.5381651015297848e-01 + 7.2849807423597710e+00 -1.2003281821351095e+00 + 7.2966398867177773e+00 -5.2276581188158389e-01 + 5.7651182349153061e+00 1.4948811416476815e-01 + 7.4600531965184800e+00 -2.4276987385179893e+00 + 7.2415596307605625e+00 -3.4017750326749479e+00 + 7.6435308226662286e+00 -3.1324707670519132e+00 + 7.7537281286548421e+00 -1.7427702773801741e+00 + 4.9394433473870620e+00 1.8045507495503443e-01 + 4.4187722405498349e+00 -2.8874608961814374e-02 + 3.5623685186401559e+00 -2.7447584737163311e-01 + 4.0017282550912796e+00 7.3566432288004080e-02 + 2.9585564879738016e+00 -1.1834619184203916e+00 + 3.0356221624802942e+00 -7.8050862952447631e-01 + 3.2039003138310918e+00 -4.5478987508303703e-01 + 7.5720282161227814e+00 -3.9555693708042696e+00 + 7.2029075550867958e+00 -5.4118533738459433e+00 + 7.8380487115283444e+00 -5.0719935912745200e+00 + 6.6419837914589053e+00 -5.7961359922255298e+00 + 3.6205609426608092e+00 3.2703510616606479e-01 + 3.2766054938144649e+00 1.4499699041284941e-01 + 3.1939331816138576e+00 -1.6624092143993607e-01 + 4.3921936150274306e+00 4.1974548232849429e-01 + 3.9803479518651343e+00 6.1712294008577828e-01 + 3.3127929533887652e+00 5.5562441942039698e-01 + 3.6159314109098517e+00 7.3745791562642893e-01 + 2.9269302811524511e+00 4.9126546672511040e-03 + 2.9835386461315636e+00 3.6770983166024962e-01 + 2.9998613006311317e+00 -2.5184852982509653e-01 + 2.8693934823130007e+00 -4.7007990754603668e-01 + 4.3114583126779493e+00 9.9269082434124556e-01 + 4.8395851483088634e+00 8.3622221784756334e-01 + 3.8303402521795604e+00 1.0766522493750870e+00 + 5.3448363877792389e+00 6.5081798601998031e-01 + 3.3283292899278010e+00 1.0170933385961973e+00 + 3.0077615449370256e+00 6.9069767215785305e-01 + 2.6622791804715789e+00 -6.9446393709057475e-01 + 2.7834880568615716e+00 -9.8266587385171533e-01 + 2.7027652935916819e+00 2.0451832259735880e-01 + 2.7456408049460705e+00 -2.2846129909829926e-01 + 2.6297093149575161e+00 -2.6442500738980357e-02 + 2.7223710099961878e+00 4.7553907001015716e-01 + 2.6240352068522554e+00 -4.2753441548437365e-01 + 4.7243749254775196e+00 1.4243858565876479e+00 + 4.1019079832092444e+00 1.5820161998229310e+00 + 5.3714934629320155e+00 1.3638712892857043e+00 + 3.5669028944553958e+00 1.4095997186666551e+00 + 5.8375704359074874e+00 8.5515253833926863e-01 + 6.4675592044435746e+00 6.3040606865821758e-01 + 2.9035766515798755e+00 1.0383737880481476e+00 + 3.0901710241336815e+00 1.4464446761240310e+00 + 2.7104146030501681e+00 7.6382503101594068e-01 + 2.5075638543013881e+00 1.3511374793154118e-01 + 2.4853761313033544e+00 3.3219095318520431e-01 + 2.5158171385781003e+00 -2.3831651308930191e-01 + 2.3795385171753836e+00 -3.6421917442424956e-02 + 2.4718184096179883e+00 5.6378409148639008e-01 + 2.6532527533100989e+00 -1.2403570692867447e+00 + 2.3945867263803891e+00 -4.6300889040571747e-01 + 4.7754744138828400e+00 2.0470793678888271e+00 + 3.4278674095302009e+00 1.8709343071572988e+00 + 4.0088114319821386e+00 2.2413505911808045e+00 + 6.2388448894672237e+00 1.4811792335676017e+00 + 5.6228072338993300e+00 2.1839303789698690e+00 + 9.3959112650640293e+00 -5.0566640170116841e+00 + 8.7395246213371749e+00 -5.1698694495419772e+00 + 9.7975551569966939e+00 -4.5619641487068634e+00 + 9.1084878104565519e+00 -4.5000384025005218e+00 + 8.3434164903103039e+00 -4.3840097073612867e+00 + 1.0323229450267505e+01 -3.8692366025046283e+00 + 9.5268712449093087e+00 -3.8571970359238605e+00 + 1.0913111135873166e+01 -4.1083814689717570e+00 + 8.8742299167326948e+00 -3.8842358045175018e+00 + 8.2989576012352302e+00 -3.4806458791087920e+00 + 1.0013054960085569e+01 -3.0687188570724970e+00 + 1.0966923561072349e+01 -3.3653191636023365e+00 + 9.0713023670946171e+00 -3.1467768716862849e+00 + 8.3386063316048080e+00 -2.4321181788188682e+00 + 8.9017594828246160e-01 3.2169767729200771e-02 + 8.8889011218157066e-01 3.1986680129989509e-02 + 8.8881152792147589e-01 3.3400762655546146e-02 + 8.8963001386976259e-01 3.1009928423017641e-02 + 8.9080869967784082e-01 3.3648937036154791e-02 + 8.8768074342817727e-01 3.2380936661922988e-02 + 8.8815232740600436e-01 3.0972005180309736e-02 + 8.8956250516651636e-01 3.4942418299728217e-02 + 8.8728277904368014e-01 3.3572416493065305e-02 + 8.8790268003126016e-01 3.4568245888863203e-02 + 8.9133821044420358e-01 3.5528537188980636e-02 + 8.9291057987159661e-01 3.3661628832007295e-02 + 8.8679845828634285e-01 3.1233214946865928e-02 + 8.8610362661459163e-01 3.2746847797369583e-02 + 8.8797321835799181e-01 3.6343344184111004e-02 + 8.8990733845848524e-01 3.6694426768136168e-02 + 8.8615046562606636e-01 3.4743580483699077e-02 + 8.9338244635546715e-01 3.5983391781016394e-02 + 8.9153035396770264e-01 3.7455367080767132e-02 + 8.8562560489960163e-01 3.1225580297771671e-02 + 8.8431132504580034e-01 3.1704352044386042e-02 + 8.8422449676076553e-01 3.3591873360592217e-02 + 8.8474959931308206e-01 2.9967801614859013e-02 + 8.8917193415671392e-01 3.8729359907563321e-02 + 8.8507106777208833e-01 3.6989966125773321e-02 + 8.8679806965199504e-01 3.8430089272608825e-02 + 8.8326718860167119e-01 3.5442523906823453e-02 + 8.9355945304551199e-01 3.8169180341206754e-02 + 8.9517327082575804e-01 3.6489408674270862e-02 + 8.9146859995905459e-01 4.0017026895718288e-02 + 8.8288193034482987e-01 3.2339657701932367e-02 + 8.8193794189110974e-01 3.3581717555300372e-02 + 8.8611753029300644e-01 3.0098876788031248e-02 + 8.8253643952875649e-01 5.6937144038890608e-02 + 8.8004676423272343e-01 6.1703976684768236e-02 + 8.8545280990643960e-01 6.0821517669594982e-02 + 8.8788444047949611e-01 5.5993831009033102e-02 + 8.8436575523770244e-01 5.2615145509136596e-02 + 8.7931170479211573e-01 5.3261169361810801e-02 + 8.8286663635543050e-01 6.7244817282492875e-02 + 8.9075232225215473e-01 5.9631101170730005e-02 + 8.8836502333307266e-01 6.4398823526119031e-02 + 8.8927824994075877e-01 5.1750601691473719e-02 + 8.9299762470888311e-01 5.4476618195621995e-02 + 8.8710347098552234e-01 4.9529524806288805e-02 + 8.8428021870676332e-01 4.8274964076966853e-02 + 8.8062328495787767e-01 4.9091195625990736e-02 + 8.8958248321099376e-01 7.0015800053745636e-02 + 8.8455511423300948e-01 7.5520583024896837e-02 + 8.7769055293414056e-01 7.4757700365211122e-02 + 8.9317086494033759e-01 6.4280881454003236e-02 + 8.9673855258017454e-01 5.8900390614326170e-02 + 8.8690335363976658e-01 4.6464306038799918e-02 + 8.8967820209953175e-01 4.8000224562102289e-02 + 8.8453231621036110e-01 4.5146037853065479e-02 + 8.8180891310791054e-01 4.5523957221767830e-02 + 8.9222408308035739e-01 4.9931886589426711e-02 + 8.8689796494683293e-01 4.3474994409486101e-02 + 8.8972446501824010e-01 4.4695815424674379e-02 + 8.8364185033097442e-01 4.2472022484759009e-02 + 8.9345454859530093e-01 4.6081157642213100e-02 + 8.9581668989861640e-01 5.0063368391853658e-02 + 8.9894346090886046e-01 5.4254301801535121e-02 + 8.8936144842914189e-01 4.1662447679364334e-02 + 8.8677675579907600e-01 4.0482258848676622e-02 + 8.9212897069491959e-01 4.2575230590003343e-02 + 8.8411826797860016e-01 3.9484089038751335e-02 + 1.1094488271078831e+00 -1.6469951501782987e-01 + 1.1117150419908626e+00 -1.6650567318541221e-01 + 1.1117742982970498e+00 -1.6341394083568161e-01 + 1.1144683329368874e+00 -1.6836513360836136e-01 + 1.1151156612069855e+00 -1.7228534883737723e-01 + 1.1145710181208841e+00 -1.6449264728051105e-01 + 1.1154097719881904e+00 -1.7636210455171408e-01 + 1.1180070405989895e+00 -1.6946457004854665e-01 + 1.1171132943944997e+00 -1.6638065486191067e-01 + 1.1196123483156839e+00 -1.7370737747778264e-01 + 1.1099402551096418e+00 -1.8325446815734381e-01 + 1.1150400939380418e+00 -1.8063626080127904e-01 + 1.1183484625738913e+00 -1.6338251799201942e-01 + 1.1197231997179955e+00 -1.7856288125682340e-01 + 1.1143561745644490e+00 -1.8571228087115799e-01 + 1.1080776914427304e+00 -1.8942031545083182e-01 + 1.1195827431315166e+00 -1.8322344407968671e-01 + 1.1218010294708591e+00 -1.6929146970645093e-01 + 1.1208924571270771e+00 -1.6595339659399144e-01 + 1.1251737435855986e+00 -1.7108799209280789e-01 + 1.1239217922681988e+00 -1.7592890339545875e-01 + 7.2133546631544476e-01 -1.5962304865363421e+00 + 9.0289357981649232e-01 -1.4356328373985292e+00 + 2.2077587639693519e+00 -3.5624420215121688e-01 + 2.3040719522788393e+00 -2.4047286615611085e-01 + 8.9402716193789900e-01 4.0650901748897184e-02 + 8.9626269422483062e-01 3.8707551792889205e-02 + 7.7212517188472418e-01 -2.2544426380477489e-02 + 7.8364554169580458e-01 -3.0108886732804763e-02 + 7.7412755553429236e-01 -3.7114935254734860e-02 + 7.6091719554935366e-01 -3.4962733208601549e-02 + 7.8438594355363023e-01 -4.0558877048610498e-02 + 7.9391027357679889e-01 -3.7775314964875406e-02 + 7.9190637531783636e-01 -2.5142953717221417e-02 + 7.6621842449703337e-01 -4.6087233589474863e-02 + 7.7747305602520811e-01 -4.8427454568326311e-02 + 7.5244729134581689e-01 -4.5373673357772759e-02 + 7.5011775987690754e-01 -3.6681021883481435e-02 + 7.4888645212884342e-01 -2.7096688746809150e-02 + 7.8791121981985413e-01 -5.0550566598147384e-02 + 8.0338845279483451e-01 -2.7391729250496155e-02 + 8.0057880838968742e-01 -5.1616673109691646e-02 + 8.0589536213903301e-01 -3.9517883629756057e-02 + 7.9599627935435535e-01 -1.4495272816205329e-02 + 7.6834661464438625e-01 -5.6878972475544742e-02 + 7.5966986188529972e-01 -5.3687129071064987e-02 + 7.7918534272154716e-01 -6.1427541909779393e-02 + 7.4410135157827284e-01 -4.0090296788136470e-02 + 7.5275549255235319e-01 -5.3455486036526167e-02 + 7.4090989046981548e-01 -4.5780950541143284e-02 + 7.4556872413837283e-01 -5.4507949875912232e-02 + 7.4181974963387631e-01 -3.3971850856218566e-02 + 7.9124646523531794e-01 -6.3499292407499297e-02 + 8.0819892229244772e-01 -1.6916029558132095e-02 + 8.1238188787891374e-01 -3.2482328177010800e-02 + 8.1121929517142632e-01 -2.5501859460732135e-02 + 8.0971185447209137e-01 -4.9600395701716593e-02 + 8.1525956174660053e-01 -4.3032234000094149e-02 + 8.1043049034833814e-01 -5.8928246264557060e-02 + 8.0452310951740458e-01 -6.7124308090455997e-02 + 7.6122035960640488e-01 -6.2585930508262777e-02 + 7.6755738298538745e-01 -7.0917784409786577e-02 + 7.5333609283991620e-01 -6.0253191841383114e-02 + 7.8042669681328647e-01 -7.5708899731012025e-02 + 7.3562354980747102e-01 -3.9279294736118686e-02 + 7.3389926205895506e-01 -3.3219931778006639e-02 + 7.3731409097982947e-01 -5.2139338449876504e-02 + 7.3686000514202021e-01 -6.0562293692171920e-02 + 7.4501082884152936e-01 -6.5021459891710265e-02 + 7.3272847811973918e-01 -4.6704670210587551e-02 + 7.2909401719514477e-01 -3.7288885160592145e-02 + 7.2861298904024352e-01 -4.2535229922222584e-02 + 7.2854894775375811e-01 -3.2277163884074866e-02 + 7.1361578335724118e-01 -3.1483760067061439e-02 + 7.1540961197521113e-01 -3.1930380710235795e-02 + 7.1389281705894092e-01 -3.3773697699558625e-02 + 7.1205484898057847e-01 -3.2720770698830393e-02 + 7.1678075773134253e-01 -2.9856774344210635e-02 + 7.1787141568420765e-01 -3.2297648076948349e-02 + 7.1958707710667369e-01 -2.9662774828409511e-02 + 7.1305779064771002e-01 -2.9686322850494662e-02 + 7.1195771764249827e-01 -3.0607654114490401e-02 + 7.1729395062441625e-01 -2.7470701343219162e-02 + 7.1620592622080892e-01 -3.4573040426920443e-02 + 7.2016168057344032e-01 -3.2472193455575393e-02 + 7.1941436252903657e-01 -3.5524697597878685e-02 + 7.1993950369711257e-01 -2.6450289951384320e-02 + 7.2254227846413954e-01 -3.0933088389701879e-02 + 7.2318856500457684e-01 -2.5609210315167275e-02 + 7.2229256571701939e-01 -2.8360770771115540e-02 + 7.1419107813149196e-01 -3.6242004004947148e-02 + 7.1141254192598780e-01 -3.5500976894326186e-02 + 7.1683584649312593e-01 -3.7584452189378226e-02 + 7.1002879545781639e-01 -3.3436740829273504e-02 + 7.2253186785013668e-01 -3.3834305982480828e-02 + 7.2023274142671312e-01 -3.9829061448216407e-02 + 7.2224139975471502e-01 -3.6865767221854640e-02 + 7.2584379759156548e-01 -2.8459806205574978e-02 + 7.2498751689624186e-01 -3.2314979472545247e-02 + 7.1199821080190873e-01 -3.8591471034095548e-02 + 7.1445896867399483e-01 -3.8776378238765119e-02 + 7.0854487146019096e-01 -3.5458558795966155e-02 + 7.0917717159090898e-01 -3.8283595197583509e-02 + 7.1656260050573906e-01 -4.1089293515042868e-02 + 7.0776574955380056e-01 -3.3219195673652280e-02 + 7.0948390907433634e-01 -4.2297988141640985e-02 + 7.1329112631255498e-01 -4.1589596556889319e-02 + 7.0629466234454696e-01 -3.7526674781616975e-02 + 7.0670561111545283e-01 -4.0572491478400252e-02 + 7.0572161559148583e-01 -3.4324711651649409e-02 + 7.1629279845756599e-01 -4.8345719143824795e-02 + 7.2123248047131483e-01 -4.9133786163892523e-02 + 7.1839071566152057e-01 -5.2889402873461222e-02 + 7.1899488506704756e-01 -4.4598141829283122e-02 + 7.1440708931650931e-01 -5.3991560059699850e-02 + 7.1556203506092686e-01 -4.4158130827696596e-02 + 7.1204330900712876e-01 -4.9870664689890987e-02 + 7.1217575671420974e-01 -4.5543688123956372e-02 + 7.2341930630312135e-01 -5.4642317574675303e-02 + 7.2327716026790512e-01 -4.4377326855254751e-02 + 7.2639537891189576e-01 -4.8156415046548773e-02 + 7.1787717126692741e-01 -5.8427282833491745e-02 + 7.0845967087139883e-01 -5.3591099985226265e-02 + 7.1065417242529350e-01 -6.0556497928928366e-02 + 7.0829426020419106e-01 -4.7613092207086538e-02 + 7.3050335702912861e-01 -5.3140827929539114e-02 + 7.2321457230184905e-01 -6.2522872928781226e-02 + 7.2850548540066740e-01 -5.9558921815849430e-02 + 7.2455934993932658e-01 -3.9404787524233598e-02 + 7.1665380057103079e-01 -6.5483282902064843e-02 + 7.0406489013691242e-01 -5.8943710688495798e-02 + 7.0405054105095388e-01 -4.9729147619075320e-02 + 7.0287952196706271e-01 -5.4003795694740120e-02 + 7.0989770714477629e-01 -6.8830967285194333e-02 + 7.0487410390579441e-01 -6.4726387708518018e-02 + 7.0467945051818504e-01 -4.4308102896835067e-02 + 7.2994966016577933e-01 -6.6371790690340049e-02 + 7.2288201010361774e-01 -7.0653641756237562e-02 + 7.2521312649755032e-01 -3.5616985710518634e-02 + 7.1585169944550131e-01 -7.2682837739051820e-02 + 7.3740203411148997e-01 -6.8736987762434865e-02 + 7.3155577578373254e-01 -7.6345002393736650e-02 + 7.2118223939720849e-01 -8.1506645322079407e-02 + 7.4206491753425041e-01 -7.6592380724434861e-02 + 7.5397882990917253e-01 -7.1750375423306423e-02 + 7.3407356058552864e-01 -8.7849560976763996e-02 + 7.0185599399237475e-01 -7.1912430680271200e-02 + 7.1039862212082028e-01 -7.7596488666756613e-02 + 6.9789775582950142e-01 -6.3388331959643551e-02 + 6.9821223440601443e-01 -5.6234115248869898e-02 + 6.9907280497353241e-01 -5.0556338798912748e-02 + 7.0037101687920256e-01 -4.6674806543308023e-02 + 7.3152950535679651e-01 -2.6362963832752939e-02 + 7.0340657915721749e-01 -3.9856869032590225e-02 + 6.9960384936908326e-01 -4.2304341390575928e-02 + 6.9546483991427976e-01 -4.5978470992096732e-02 + 6.9207010434310234e-01 -5.6814895330163040e-02 + 6.8743469080473574e-01 -6.4845802752671489e-02 + 6.9397152839614762e-01 -7.0214917024429724e-02 + 1.0995226296713341e+00 -1.4302491154347763e-01 + 1.0981667673438125e+00 -1.4131249377564359e-01 + 1.0917391737235462e+00 -1.4176903807405949e-01 + 1.0890339753522014e+00 -1.4186538415250993e-01 + 1.0872195310905255e+00 -1.4430009729500171e-01 + 6.8267410356895653e-01 -1.2542593668496238e-01 + 6.8989962301390051e-01 -1.1486647009633089e-01 + 6.9535474819263499e-01 -1.2336355692546874e-01 + 6.8069777693261813e-01 -1.1057723167598965e-01 + 6.9591032852373758e-01 -1.3728689319651721e-01 + 6.6925904300196493e-01 -1.1542070760795298e-01 + 6.7884398337139373e-01 -1.3920170482336403e-01 + 6.6557766125075091e-01 -1.3047889263177126e-01 + 7.0314046402330632e-01 -1.1223616448707219e-01 + 6.9113689385272181e-01 -1.0371414549221925e-01 + 7.0940309497510157e-01 -1.2562087547996725e-01 + 6.6913229221970738e-01 -1.0253884171498839e-01 + 6.7980907789370093e-01 -9.8436968831421723e-02 + 6.8300636290864247e-01 -1.5364123393399609e-01 + 7.1649080905079643e-01 -1.4132142678940340e-01 + 7.0113265173799988e-01 -1.5599594997503630e-01 + 6.5799584783318465e-01 -1.1802048090252981e-01 + 6.5748957041725475e-01 -1.0644653590640019e-01 + 6.6705146060487408e-01 -1.4917556766964424e-01 + 6.5004677113172704e-01 -1.2525381321933082e-01 + 6.5089053986815770e-01 -1.4116935641553141e-01 + 7.0247896307478186e-01 -9.8000481892682956e-02 + 7.1746874857895193e-01 -1.1646133017136151e-01 + 7.1624117647494501e-01 -1.0362629135141788e-01 + 6.9017470396950387e-01 -9.3280253156279969e-02 + 7.2876404071661938e-01 -1.2569153977352698e-01 + 6.8162393844130520e-01 -8.8172360999848820e-02 + 6.8639758790902050e-01 -1.7027488118463907e-01 + 6.6843247416730378e-01 -1.6853187026792682e-01 + 7.2118734013317010e-01 -1.5891345901810894e-01 + 7.3652920078634310e-01 -1.4286237250517786e-01 + 7.0380348190277431e-01 -1.7453780572751043e-01 + 6.4760619336422565e-01 -1.1250245514713697e-01 + 6.4557386100669589e-01 -9.8913304337074237e-02 + 6.4664062974126324e-01 -1.6125826453419734e-01 + 6.3958555052930421e-01 -1.3380045389209272e-01 + 6.3355134147020919e-01 -1.4670649517572087e-01 + 6.3669153559217051e-01 -1.1995090300267464e-01 + 7.1147929888955019e-01 -8.9824412411260823e-02 + 6.9859078485712445e-01 -8.7487852426292534e-02 + 7.2661903095745828e-01 -1.1179771716086861e-01 + 7.2274706038700742e-01 -9.2712566485602110e-02 + 7.3075902658787584e-01 -1.0075592236647424e-01 + 6.8989638782720419e-01 -8.5431516806494301e-02 + 7.5011395339879527e-01 -1.2758680678896894e-01 + 7.4274943995728648e-01 -1.1066708162809391e-01 + 6.8456144777155004e-01 -7.9595170601933773e-02 + 6.7870735322316023e-01 -1.9199168053609128e-01 + 6.5071915813164338e-01 -1.8452802770227095e-01 + 7.4435435414608975e-01 -1.6558442535830409e-01 + 7.2347964395756037e-01 -1.7779517230074759e-01 + 7.5668480449266440e-01 -1.4285621772057766e-01 + 7.0781446189958785e-01 -1.9727279431820932e-01 + 6.2488490161094035e-01 -1.6791821530188145e-01 + 6.3764473680235056e-01 -1.7664203108634524e-01 + 6.2632250174398507e-01 -1.3032588003241585e-01 + 6.1298392532761170e-01 -1.4576680087814964e-01 + 6.2428852123181855e-01 -1.1131383426928210e-01 + 7.0361169165063586e-01 -8.1403263499879586e-02 + 6.9453106409653742e-01 -7.8621946848159041e-02 + 7.4199080429114161e-01 -9.6552615705235212e-02 + 7.6428192520457117e-01 -1.0891183660069714e-01 + 7.6651326881995629e-01 -1.2486771723312984e-01 + 7.5458410177093072e-01 -9.6046330713477346e-02 + 3.5285315977949949e-01 -1.4421852776958133e-01 + 3.5033697992284374e-01 -1.3011607497624311e-01 + 3.6654063318093222e-01 -1.3947438445325133e-01 + 3.3844448983381881e-01 -1.4058477866218766e-01 + 3.6047931530242749e-01 -1.5659942154356088e-01 + 3.4521657912500814e-01 -1.5625725941129076e-01 + 3.6173785226198873e-01 -1.2479169752471364e-01 + 3.3691259750407454e-01 -1.2681024943586294e-01 + 3.5329472946865792e-01 -1.1961865220617085e-01 + 3.4350767643350366e-01 -1.1642668173803372e-01 + 3.7297694983496399e-01 -1.5495515257866543e-01 + 3.7180599548148052e-01 -1.2658679450335342e-01 + 3.8012746992846047e-01 -1.3175742903018772e-01 + 3.8165077578099726e-01 -1.4462356148428057e-01 + 3.3059084219515000e-01 -1.5458875100391367e-01 + 3.2118176702691414e-01 -1.4406520792350364e-01 + 3.5321445584363431e-01 -1.7208765692576833e-01 + 3.7140478212165107e-01 -1.7113153516449131e-01 + 3.3571721179544056e-01 -1.6946442056287481e-01 + 3.7122200108846926e-01 -1.1589676495123058e-01 + 3.8415455183003644e-01 -1.5966632877561437e-01 + 3.9360206712122192e-01 -1.5047998394565809e-01 + 3.1618376812099314e-01 -1.6409058232488860e-01 + 3.0761792920137054e-01 -1.4783255445948384e-01 + 3.6054381236727551e-01 -1.8945516421993602e-01 + 3.4278930204289537e-01 -1.8663946461529690e-01 + 3.8672939699348774e-01 -1.7435925391880858e-01 + 3.7986514965631812e-01 -1.8856898638935604e-01 + 3.2442170694682204e-01 -1.8276543672766365e-01 + 4.0061115197453034e-01 -1.6521680968878627e-01 + 3.9331694178721932e-01 -1.3815247615872295e-01 + 4.0686605285888788e-01 -1.4708341409824754e-01 + 2.9802670691891109e-01 -1.6160153585408921e-01 + 3.0353355590999342e-01 -1.7908149117492655e-01 + 2.8929057206200781e-01 -1.4003280835500220e-01 + 3.4941523901974136e-01 -2.0847235470991166e-01 + 3.7200537653681920e-01 -2.0618224846904809e-01 + 3.3183216842488861e-01 -1.9931578840311204e-01 + 3.9695665842610595e-01 -1.8393207810369461e-01 + 3.9473304083856675e-01 -2.0485199898946860e-01 + 3.1418884282200565e-01 -1.9749445817321032e-01 + 4.1963670633790429e-01 -1.6019914648543931e-01 + 4.1514953666847987e-01 -1.7799766519070204e-01 + 7.3620608739003046e-01 -1.9779444242735167e-01 + 7.1631960618121582e-01 -2.1910160347940177e-01 + 6.9219028903584956e-01 -2.2176256623221491e-01 + 7.6562371389428563e-01 -1.8486194653539201e-01 + 7.3675163074538119e-01 -2.2491460775354710e-01 + 7.5909920090608551e-01 -2.1503054724600190e-01 + 7.7223646680597113e-01 -1.5638270447060165e-01 + 6.6627290664820293e-01 -2.2155311744954531e-01 + 6.5554409459461738e-01 -2.0456959793045826e-01 + 7.1708343246933026e-01 -2.4744131333446262e-01 + 6.8079888974180847e-01 -2.4889817808295334e-01 + 7.9115844170026151e-01 -2.0592809049431082e-01 + 7.9321821429820005e-01 -1.7350309811777720e-01 + 7.5434300520539921e-01 -2.4962273062914164e-01 + 7.8053905031615045e-01 -2.3868953709390439e-01 + 7.7876764344284055e-01 -1.3345858638400898e-01 + 8.0127088373355093e-01 -1.4798962248661951e-01 + 6.3899501739803810e-01 -2.2254975972069246e-01 + 6.5369689378822926e-01 -2.4362907043013138e-01 + 6.3809444872079268e-01 -2.0143501431633126e-01 + 6.2997036967195896e-01 -1.8726773524444695e-01 + 6.9982354941107161e-01 -2.8510863171533174e-01 + 7.3696886111797255e-01 -2.8410322091752960e-01 + 6.5572626709809612e-01 -2.7389436933597722e-01 + 8.1382220340633893e-01 -1.9112511837361978e-01 + 8.0702370899676623e-01 -2.3911733913678290e-01 + 8.2566192614903855e-01 -2.1548472415895503e-01 + 8.2129758014045962e-01 -1.6772426610941693e-01 + 7.9058648465480985e-01 -2.7678613403475083e-01 + 7.9585167689349845e-01 -1.2305641608148221e-01 + 7.7993540158760055e-01 -1.1303925081315924e-01 + 8.1357890032849411e-01 -1.3111057925372904e-01 + 8.2991336141415673e-01 -1.4541360791375268e-01 + 6.2572584374191820e-01 -2.5234226809597260e-01 + 6.2049700711171596e-01 -2.0636044576309587e-01 + 6.1713379043094108e-01 -2.2648819062276004e-01 + 6.0990967316919864e-01 -1.8640111125006342e-01 + 7.1977035985418070e-01 -3.1457757705761935e-01 + 6.7377424523516538e-01 -3.0771307680164739e-01 + 6.9449050884796293e-01 -3.2231255032357353e-01 + 7.5468812130193186e-01 -3.2770118668902626e-01 + 6.2071365908546738e-01 -2.8587185817508498e-01 + 6.4361011676749769e-01 -3.1498265254012381e-01 + 4.6058604825965688e-02 -1.1882206009534713e+00 + 7.9781159887936326e-02 -1.4105598286206060e+00 +-1.2812603196665862e-01 -1.3298791101717455e+00 + 1.9853545340614431e-01 -1.2793198908110526e+00 +-1.5573229013980949e-01 -1.1395623491990250e+00 + 2.2686502133394981e-01 -1.1282797114631364e+00 +-2.3647155676655984e-02 -1.0232438407433477e+00 + 1.1318328486356677e-01 -1.0322700231595832e+00 +-1.0526557716593743e-01 -1.5712890860192346e+00 + 2.6476437535588815e-01 -1.4330559548597392e+00 + 2.0491494627179208e-01 -1.7075410016698100e+00 +-3.1094124625218456e-01 -1.2544362913530591e+00 +-2.7835365102333753e-01 -1.4212795998483045e+00 + 3.9279103734023835e-01 -1.2560150199240780e+00 +-1.9041277337210261e-01 -9.7811359495197792e-01 +-3.5919194098984519e-01 -1.0846089425491812e+00 + 2.3586045625921059e-01 -9.2718532627590378e-01 + 3.6238704929560583e-01 -1.0315864585551111e+00 + 8.0779497575292680e-02 -8.9442063636207081e-01 +-4.8394386682744539e-02 -9.1977451460475379e-01 +-5.7966186380156159e-02 -1.8315944301387788e+00 +-3.9418737745596388e-01 -1.5822229988322363e+00 +-2.6702221579132868e-01 -1.7786147013705715e+00 + 4.4269694865367626e-01 -1.5220544040965507e+00 + 4.8569626507023145e-01 -1.7469183435139115e+00 +-5.1314024457252572e-01 -1.3391537644928064e+00 +-4.2546749472683132e-01 -1.2023346937713484e+00 + 4.9312164567534467e-01 -1.0724579947098363e+00 + 5.6533988276835601e-01 -1.3874943156568236e+00 + 5.9264535608902236e-01 -1.2005645161186038e+00 +-3.4894655975890032e-01 -9.4989875849690009e-01 +-1.3435938714073359e-01 -8.7614509204117041e-01 +-2.7061239349497157e-01 -8.4985351961616118e-01 +-5.5090448698409489e-01 -1.0813638957379936e+00 +-4.7746428232966309e-01 -9.7332603771324955e-01 + 3.6494383400015096e-01 -8.8113090084891610e-01 + 1.8106425080629407e-01 -7.8210624418869656e-01 + 2.9572111317361305e-01 -7.5876842356404950e-01 + 4.5169065448367718e-01 -9.5323086265132417e-01 +-2.7838546829542565e-02 -8.2834177252155428e-01 + 6.8309343870183170e-02 -7.6620908233934415e-01 +-2.6193869503910605e-01 -2.0634608542390112e+00 +-5.1575324291542302e-01 -1.8445061376236396e+00 +-7.0592203606445025e-01 -1.6095483939492965e+00 +-6.9682605396688757e-01 -1.1680744792499809e+00 +-7.8097645989853959e-01 -1.3290461103800055e+00 + 6.1828513340766733e-01 -1.0405872279293078e+00 + 5.4093064343592800e-01 -9.5276388308053583e-01 + 7.3675552890946960e-01 -1.3264652476207885e+00 + 7.4052926175198763e-01 -1.1491483554132174e+00 +-4.4998761461155823e-01 -8.4561278406521012e-01 +-1.4104656794906134e-01 -7.6565581221692014e-01 +-3.5785992088874252e-01 -7.3824621060383322e-01 +-2.4977782840714724e-01 -7.2983238577721465e-01 +-6.0646531841803153e-01 -9.0618854463582466e-01 +-7.6723163207562095e-01 -9.9429294113281230e-01 + 2.2427305412145415e-01 -6.9037185855796679e-01 + 1.3655146004423813e-01 -6.7456196276370406e-01 + 3.8636545893209018e-01 -7.7139136804353825e-01 + 4.9031182455487254e-01 -8.2884661271246785e-01 + 3.0044486812056448e-01 -6.3277451112637095e-01 + 3.6651618956548759e-01 -6.9721040978473070e-01 +-2.2162200351758088e-02 -7.2636606321260899e-01 + 4.9931352290286668e-02 -6.8768023923914257e-01 +-6.8688598121367761e-01 -2.2509908369462863e+00 +-3.9063772695585897e-01 -2.5170732081194558e+00 +-7.8553535069464431e-01 -1.9322768088423885e+00 +-9.8004201463966467e-01 -1.4834225120959985e+00 +-9.6291930652222391e-01 -1.7810830478233868e+00 +-8.4615727461620338e-01 -1.1605141164612292e+00 +-9.5747513401109074e-01 -1.2638064500828818e+00 + 1.1266369551753996e+00 -1.7387393859615941e-01 + 1.1293678762796731e+00 -1.7176639317861486e-01 + 6.1069214703950792e-01 -1.2315109237447075e-01 + 5.9864706426992598e-01 -1.3215274133108323e-01 + 5.9254666816459434e-01 -1.4875317139393474e-01 + 6.0312140947511494e-01 -1.6540109464290254e-01 + 5.8277979994981166e-01 -1.3082673493866537e-01 + 5.8387242264808492e-01 -1.6583585759033781e-01 + 5.7114201982352597e-01 -1.4879103836770469e-01 + 5.9121479094578433e-01 -1.8380184934204635e-01 + 5.9760804350648300e-01 -2.0975567688805086e-01 + 5.6844708928194621e-01 -1.6726203618112834e-01 + 5.7514656693515320e-01 -1.7919253693931125e-01 + 5.5130098059321853e-01 -1.6013334004621527e-01 + 5.5529566807905439e-01 -1.3623789550371157e-01 + 5.7571827256278141e-01 -1.9679548812520409e-01 + 1.1251821642392912e+00 -1.8116865072987309e-01 + 1.1284714262125988e+00 -1.7654428003157818e-01 + 1.1328635145033346e+00 -1.7367548842726421e-01 + 1.1304066593003128e+00 -1.8131901995045041e-01 + 1.1325023383030057e+00 -1.7776173468405432e-01 + 2.1257230018568194e+00 2.8124523814535820e+00 + 2.1195586853481956e+00 2.2554090642077398e+00 + 1.6823607023016507e+00 2.5872138422815709e+00 + 2.4625738228956493e+00 2.5698457672774211e+00 + 1.7381824877818843e+00 3.1403337702590477e+00 + 2.6488766994300690e+00 3.0851678120668993e+00 + 2.2257605881090257e+00 3.3146835842182867e+00 + 1.7307192070748272e+00 2.2119255317125948e+00 + 2.6277573087488548e+00 2.1242569399250115e+00 + 1.9049772104005527e+00 1.8782656590829774e+00 + 2.3525219133986539e+00 1.7744151879706962e+00 + 1.2922197669670226e+00 2.8362836302584640e+00 + 1.3501578412317201e+00 2.3320297187256074e+00 + 2.7909534190943290e+00 2.5719426387338942e+00 + 1.8952075993683195e+00 3.8288588758159605e+00 + 1.2078232680884753e+00 3.4625103075263652e+00 + 2.6033103914925348e+00 3.7256285728312690e+00 + 3.2482936370224493e+00 2.8220339023897054e+00 + 3.2800184029924608e+00 3.5378988382453329e+00 + 1.5965415960920311e+00 2.0067093742650641e+00 + 2.7143611944807375e+00 1.6198871545720976e+00 + 3.0805935605031749e+00 2.2312580300896414e+00 + 2.9837552720874854e+00 1.8343957948893745e+00 + 2.1120015056064645e+00 1.5009987408647021e+00 + 1.5933425183730279e+00 1.7659304309986723e+00 + 1.7797744457788056e+00 1.5496861843731864e+00 + 2.4697380585555351e+00 1.3668503084528396e+00 + 8.6114631931158669e-01 2.5656933566402742e+00 + 9.3098692223622947e-01 2.9989957668261908e+00 + 1.2953024052994095e+00 1.8969464424071489e+00 + 9.4859502891873149e-01 2.1833823017091873e+00 + 1.1796313935919898e+00 4.2697386120906984e+00 + 2.3571397408976438e+00 4.4637480486396157e+00 + 1.7512109101418858e+00 4.5864298729073170e+00 + 5.8032859335672526e-01 3.3569563665494897e+00 + 7.3052215312142721e-01 3.9458743758158192e+00 + 3.1530733673874920e+00 4.2088747195066745e+00 + 3.9511982636119214e+00 3.2740270004425014e+00 + 3.5115706655214396e+00 2.3612339743213937e+00 + 3.8316354884062065e+00 2.6939020099180482e+00 + 4.0753580590104548e+00 4.1116610222349550e+00 + 2.7532655424179282e+00 1.2971743776479983e+00 + 1.9402772504051171e+00 1.2663311170631601e+00 + 2.2327475308611895e+00 1.1159296076656915e+00 + 1.4369352696847741e+00 1.5304753570389948e+00 + 1.6909897765043098e+00 1.3216822621614739e+00 + 2.5897655255211731e+00 1.0593984717654621e+00 + 5.7439365175939372e-01 2.9168336137360598e+00 + 6.3212491286453343e-01 2.3037397282705498e+00 + 3.4423180945088205e-01 2.5677372021942944e+00 + 9.5649573828453782e-01 1.8246445265858426e+00 + 1.1545392731432571e+00 1.6529147047932753e+00 + 6.7616265537863995e-01 1.9941934394349161e+00 + 1.2162378986508031e+00 5.0844630025847835e+00 + 5.1730410454207743e-01 4.6635664767147205e+00 + 2.1078379182005946e+00 5.2853408254056404e+00 + 3.0008836935549326e+00 4.9344175382956621e+00 + 1.6752340602779725e-01 3.9766001161978366e+00 + 1.9137718401527337e-01 2.9743053521446825e+00 +-3.5138206194474719e-02 3.4206159649961876e+00 + 3.6293781073327267e+00 4.6993533605134132e+00 + 4.8796814820173111e+00 3.3662497854564748e+00 + 4.4383034438931048e+00 2.7708645812558359e+00 + 4.2515104640420063e+00 5.0263076702117573e+00 + 4.7144983679075665e+00 4.6268204094884382e+00 + 4.9272216539529694e+00 4.0068557807401533e+00 + 2.0089232113291331e+00 1.0262943814589036e+00 + 2.4080052886452066e+00 8.3170431356223418e-01 + 2.1740055146148833e+00 8.5056836479375164e-01 + 1.7680793019383003e+00 1.0375198480626437e+00 + 1.5298826147146229e+00 1.2243988042694269e+00 + 1.1499452534428229e+00 1.4299867296556528e+00 + 1.2938291650363851e+00 1.2553710187816876e+00 + 3.7497339973010213e-01 2.1527568220942825e+00 +-5.4235866748740591e-02 2.3023256290651233e+00 +-4.6307307927406782e-02 2.6550916669688789e+00 + 7.0285937091263406e-01 1.6638252694554154e+00 + 9.6151569605461873e-01 1.5566050017149848e+00 + 4.4254640553009494e-01 1.8112097495348252e+00 + 3.6800254078204233e+00 5.9679781780052465e+00 + 2.9552231620714977e+00 5.7588630241202594e+00 + 4.2224676019389236e+00 5.8719934438030208e+00 + 3.6206485821203884e+00 5.3617718526555223e+00 + 4.9575064139893641e+00 6.4035144000289961e+00 + 2.2486335555456805e+00 6.0316048269769027e+00 + 4.9969728754652749e+00 5.4484711399178423e+00 + 5.6015784390931316e+00 5.8985145351471360e+00 + 5.8188024035069432e+00 6.4618028308731326e+00 + 1.4216848791715648e+00 5.9260990348124167e+00 + 5.8570981446939285e+00 5.1213356823513578e+00 + 5.3214287870671200e+00 4.5408064343374903e+00 + 1.2495421161934246e+00 6.7283921872795744e+00 + 6.3744026981982103e+00 5.7089554962276878e+00 + 6.6173599595810586e+00 6.3967928154969655e+00 + 6.8844362101663137e-01 5.5626653065028506e+00 + 8.6965721213687885e-01 6.1835874776443731e+00 + 6.1483464451564629e+00 4.4114380240016757e+00 + 6.8146876182611678e+00 4.9612677277310979e+00 + 5.6945888328862466e+00 3.7183916435220254e+00 + 9.0525925222873838e-01 6.5341219902592229e-02 + 9.1229183142329617e-01 6.6574759757443758e-02 + 9.0891349332994054e-01 6.0299036778758364e-02 + 9.0685135304732256e-01 7.1597995811934823e-02 + 9.0270409989653899e-01 5.8332426112379210e-02 + 9.0172054100378318e-01 6.8980726601786557e-02 + 8.9929743404304219e-01 6.4240334281350897e-02 + 9.1456899956867233e-01 6.0782730701021137e-02 + 9.1383500866916023e-01 7.4405721474150255e-02 + 9.1908484001918822e-01 6.3752022330248792e-02 + 9.1857242511981241e-01 7.0275847410684378e-02 + 9.0663220114929288e-01 5.4967011580096425e-02 + 9.1202457571303341e-01 5.5796072618903736e-02 + 9.0016139009610185e-01 7.5273360739409156e-02 + 9.0784009486290529e-01 7.9012186396042239e-02 + 9.0308086582765412e-01 5.3716092007860539e-02 + 8.9619129360868044e-01 6.9606361003053507e-02 + 9.1993891745148204e-01 5.6542290729566957e-02 + 9.2507069351037075e-01 6.9433178418293551e-02 + 9.2371148736780384e-01 6.2082416953003872e-02 + 9.2123908642708585e-01 7.7388511733389009e-02 + 9.1483401799639097e-01 8.4017669272490991e-02 + 9.1022878467411772e-01 5.0171400368654417e-02 + 9.1505523159784730e-01 5.1963535232104618e-02 + 9.0502169521322884e-01 5.0321212746119670e-02 + 8.9378915138735238e-01 7.4283444736252591e-02 + 9.0204488277714745e-01 8.4507189444572361e-02 + 8.9523978828980688e-01 8.0749673141198741e-02 + 9.1901898733683396e-01 4.9335271457849217e-02 + 9.2728752465955466e-01 5.7864341342870773e-02 + 9.2485622524954181e-01 5.1696723516840848e-02 + 9.0043225207027433e-01 4.9636527868791802e-02 + 9.1477378226582573e-01 4.7857622577751613e-02 + 9.0689948299399958e-01 4.6040401518922636e-02 + 9.1166769348133414e-01 4.3970999142885603e-02 + 9.0307764159845050e-01 4.7084708857745738e-02 + 9.0884297263126257e-01 8.7056758588325067e-02 + 9.2383958527298660e-01 8.7881910790670759e-02 + 9.1463305083404123e-01 9.3483555710349719e-02 + 9.2860533375763055e-01 7.7165136010961533e-02 + 9.0517309142848745e-01 9.3503321340804746e-02 + 8.9509781985148607e-01 8.9909273944883239e-02 + 8.8996014913886512e-01 7.6371998249975093e-02 + 8.8795101259115228e-01 8.2141192699111798e-02 + 9.2848053736118175e-01 6.3729471299680540e-02 + 9.3256307186180010e-01 6.8991861040927915e-02 + 9.3059903023981150e-01 5.3342950960256985e-02 + 9.3613895028743599e-01 5.9792194597875437e-02 + 9.2968519121610171e-01 4.7191603213867950e-02 + 9.0018427491513364e-01 4.4688887535365041e-02 + 8.9703112759312376e-01 4.6776825543823009e-02 + 9.0408580870605704e-01 4.3207416637358165e-02 + 9.2471487476892378e-01 1.0103525870017194e-01 + 9.3304556340373068e-01 8.3609241964367698e-02 + 9.3390309419352491e-01 9.2829226734686188e-02 + 9.1148573590859883e-01 1.0294748529391029e-01 + 9.3694333923263429e-01 7.5660940313355241e-02 + 8.9915957666147506e-01 1.0157875896288715e-01 + 8.8587366145553403e-01 8.8855700228052115e-02 + 8.8903790155594464e-01 9.7592248486748190e-02 + 8.7974984572970527e-01 8.3349667514340808e-02 + 9.4131642165167762e-01 6.7924831418352483e-02 + 1.1468569266794759e+00 -1.2262165584155582e-01 + 1.1440201202419473e+00 -1.2264073639930473e-01 + 1.1523582876909018e+00 -1.2298370267357939e-01 + 1.1546812547888976e+00 -1.2605339168872831e-01 + 1.1494710729957163e+00 -1.2067734056805079e-01 + 1.1549849993474908e+00 -1.3219976406772105e-01 + 1.1530615823252504e+00 -1.3733500641774299e-01 + 1.1553668755826578e+00 -1.3577496311073389e-01 + 1.1558604460314683e+00 -1.2893873532827627e-01 + 1.1457888466525290e+00 -1.1941931154828467e-01 + 1.1419338902160945e+00 -1.2000817346843462e-01 + 1.1576137800411885e+00 -1.3422061417529108e-01 + 1.1584113022742244e+00 -1.3104313034006054e-01 + 1.1553208681612119e+00 -1.3908269395992079e-01 + 1.1591062894934581e+00 -1.3718148205954606e-01 + 1.1563543543583634e+00 -1.2238609758288987e-01 + 1.1532698976106630e+00 -1.1892381603969682e-01 + 1.1586305677045132e+00 -1.2668180141679386e-01 + 1.1491982825603486e+00 -1.1729024175278369e-01 + 2.2692801482058087e+00 6.3672031464614776e-01 + 2.2858104356146924e+00 4.3002496418678504e-01 + 2.2841476506384026e+00 1.9665762673060527e-01 + 2.1335097295882051e+00 5.1812918188963408e-01 + 2.0627335222791530e+00 6.5893605924192400e-01 + 2.0841178914332943e+00 3.4821892784925979e-01 + 1.9390361326176020e+00 8.2267227375226071e-01 + 2.0749178109987412e+00 1.4844017029096790e-01 + 2.1977568648867987e+00 4.1737045098230396e-02 + 2.0017399802574332e+00 5.0783583955634981e-01 + 1.8588296283909358e+00 6.1769038081345684e-01 + 1.9476709060122985e+00 2.3494192117506429e-01 + 1.8610287269232728e+00 4.0150279111547604e-01 + 1.7416750146185933e+00 7.6572076933192079e-01 + 2.2158167648115636e+00 -8.7404920074334314e-02 + 2.0438280722371047e+00 -1.6589533023704917e-02 + 1.9053728278833759e+00 1.0122634458275570e-01 + 1.1513388280111620e+01 3.5248008282090098e+00 + 1.2178076389239585e+01 4.0632453127828043e+00 + 9.3158535702802538e+00 3.8478258981668176e+00 + 1.0057963547822254e+01 3.3702006592413554e+00 + 1.0873006778024745e+01 2.9062900643794620e+00 + 1.2211005963207548e+01 3.2136092222314687e+00 + 1.1717338302676197e+01 2.5811009584304045e+00 + 8.6194502190802851e+00 3.9203400918299138e+00 + 9.3613145604718824e+00 2.9297917051543436e+00 + 8.7739752877363486e+00 3.4375666927899573e+00 + 8.0634950187868668e+00 4.2525758977468797e+00 + 1.0093787894884535e+01 2.6839905389723739e+00 + 1.1144440285187102e+01 1.9791755181678070e+00 + 1.0415902921132748e+01 2.0487741151102696e+00 + 7.5862079588811753e+00 5.1920318121740578e+00 + 7.4953234172974064e+00 4.6323881082093123e+00 + 1.2425118932057352e+01 2.3973629654765176e+00 + 1.1873361616697835e+01 1.7495201424829716e+00 + 7.2846112537409340e+00 3.4023874495085948e-01 + 6.9437266559086197e+00 1.0939011102754748e+00 + 5.1047239024900577e+00 2.7082788558612378e+00 + 6.3136792547562095e+00 2.3205777494116404e+00 + 7.0887178522120706e+00 1.8745172543206010e+00 + 5.7094223879567707e+00 2.9394990878038882e+00 + 6.5742112213369950e+00 3.7672826767647294e+00 + 6.9237667201777313e+00 4.2953319461735475e+00 + 7.3853608515612237e+00 3.8244476753208261e+00 + 6.3323914284686893e+00 3.0791396719011317e+00 + 7.0829084622144194e+00 3.0732081894256638e+00 + 7.7973693187919366e+00 3.0116114096073616e+00 + 8.1720222004972385e+00 3.5681356112165616e+00 + 6.9046772739129310e+00 2.5095404332932389e+00 + 7.5301558965460273e+00 2.4119459694075545e+00 + 8.4985639468283409e+00 2.9107489522547922e+00 + 8.1190969706726079e+00 2.4398785652252641e+00 + 7.9357580692121630e+00 1.8288982923848778e+00 + 8.8336376219845789e+00 2.0361882024717204e+00 + 7.6389000796794306e+00 1.1431642498801580e+00 + 8.5066502697289792e+00 1.2114695019093986e+00 + 1.6087060872651477e+00 4.9365808613939066e-01 + 1.5911878287635020e+00 3.8410507406644001e-01 + 1.5034670798529888e+00 4.2537462016937155e-01 + 1.6977941064236148e+00 4.0674342768159732e-01 + 1.4730375866909995e+00 5.3607687215215094e-01 + 1.7564167581352947e+00 5.0965504871426504e-01 + 1.5736901945693731e+00 6.6989531502586175e-01 + 1.7097587403068601e+00 6.0061361558073401e-01 + 1.5230264145513530e+00 3.3019538388617775e-01 + 1.6337187727309583e+00 2.9264372018367624e-01 + 1.3905051408627287e+00 4.5636590707135127e-01 + 1.4262322030500556e+00 3.6549419319050003e-01 + 1.7436795927395679e+00 3.1277778457652516e-01 + 1.4460182918530293e+00 6.4866590861750240e-01 + 1.3557675716546669e+00 5.7134448961920725e-01 + 1.4473527171540042e+00 7.7599657720902826e-01 + 1.5892829240970201e+00 8.6853537615021992e-01 + 1.5391771166225894e+00 2.3811172274537995e-01 + 1.4340935328458215e+00 2.6751352019900310e-01 + 1.7123266317867660e+00 2.0262704432702350e-01 + 1.6200332285201426e+00 1.7943442010888333e-01 + 1.3553789674769305e+00 3.8443953185233681e-01 + 1.2895909234409899e+00 4.9761535651106925e-01 + 1.3125041997289699e+00 4.2972076451562202e-01 + 1.3537555212612489e+00 3.2107523603092858e-01 + 1.8262995046928694e+00 2.2346872418204100e-01 + 1.3154063046982998e+00 6.9637255838410539e-01 + 1.2329202007758653e+00 5.8739165462363019e-01 + 1.4164886307327151e+00 9.5623009188608421e-01 + 1.3318567911821688e+00 8.3888240658403390e-01 + 1.5605059803347743e+00 1.0479313535728991e+00 + 1.4663830551965304e+00 1.8646427196431148e-01 + 1.5456639219201946e+00 1.6200469253974603e-01 + 1.3445794556168309e+00 2.4792333910281883e-01 + 1.3917961882430987e+00 1.9162246513040770e-01 + 1.6911604188038609e+00 1.0026447802021465e-01 + 1.7861677165902776e+00 1.2606633398518596e-01 + 1.5859121851232345e+00 8.5006231035599455e-02 + 1.2921185851691916e+00 3.6986195162134550e-01 + 1.2349273816950159e+00 4.4032107552215649e-01 + 1.2089819755842797e+00 5.0938573952782917e-01 + 1.2701303834086701e+00 2.9121888021956011e-01 + 1.1435968083126795e+00 6.8715505406472488e-01 + 1.2223840689657521e+00 7.9509223908456050e-01 + 1.1248970576645689e+00 5.5017572515052393e-01 + 1.4288330510905070e+00 1.1189794469697318e+00 + 1.2033166482156545e+00 9.3763586258569376e-01 + 1.3086480430630445e+00 1.0715844542028776e+00 + 1.4884597676837785e+00 1.0962878961409217e-01 + 1.4165455894886350e+00 1.3302968948255511e-01 + 1.3243322072473021e+00 1.8745366666998109e-01 + 1.2887096946569869e+00 2.2501878041718726e-01 + 1.3574288333005171e+00 1.4061711157646073e-01 + 1.6687952234294343e+00 1.0806587128541878e-02 + 1.7861862610447758e+00 1.5850962340770991e-02 + 1.5130964033841394e+00 3.4640004614090003e-02 + 1.5852287184391898e+00 -7.9397682220587740e-03 + 1.2303648868438515e+00 3.6812179289239566e-01 + 1.1888117803819824e+00 3.2823307125781298e-01 + 1.2375831939516502e+00 2.2819460910262990e-01 + 1.2074222440024087e+00 2.7216541968891050e-01 + 1.1625743143449725e+00 4.7142488583178022e-01 + 1.1695919321620494e+00 4.0658082627523129e-01 + 1.4425736647823513e+00 6.9304464756953621e-02 + 1.3776178697904484e+00 8.6626452780208751e-02 + 1.3044054881951439e+00 1.4146103478091732e-01 + 1.2639972797379215e+00 1.7620648022926844e-01 + 1.3299572104307202e+00 1.0912738566418057e-01 + 9.5212789287430155e-01 7.6599641229606164e-02 + 9.4938847613186539e-01 6.8603249907738473e-02 + 9.4459200397304244e-01 7.4573550310603309e-02 + 9.5899461949119313e-01 6.9449920235221896e-02 + 9.4318388997472624e-01 8.4079088683978398e-02 + 9.6156732709753356e-01 7.9161938457993131e-02 + 9.5478931314366378e-01 8.4536397768289362e-02 + 9.5299782667756006e-01 6.3445850029673068e-02 + 9.4632373030054140e-01 6.1465491473228440e-02 + 9.6844724683401040e-01 7.3080173946486582e-02 + 9.5972907257034024e-01 6.1486082309087919e-02 + 9.6870449425280469e-01 6.3772505766046095e-02 + 9.5142669903224686e-01 9.2881841160654233e-02 + 9.4193547632723096e-01 9.5327161300687635e-02 + 9.6448440619352027e-01 8.8976749578236536e-02 + 9.7540644403812138e-01 8.0153804475145307e-02 + 9.5360865322405175e-01 5.6074712638590540e-02 + 9.4382562916739232e-01 5.3705232416710658e-02 + 9.7806012875489046e-01 6.9726290311137973e-02 + 9.6384371592139928e-01 5.5197476665256318e-02 + 9.7978061219826174e-01 6.0147392418556933e-02 + 9.7352204404415943e-01 5.4648552762351699e-02 + 9.4874743252819371e-01 1.0346445295029838e-01 + 9.5989042142356595e-01 9.9820049770151797e-02 + 9.3747979782571633e-01 1.0365923730928728e-01 + 9.7696999166129217e-01 8.9878052404834818e-02 + 9.7194443212454473e-01 9.9904075441926921e-02 + 9.8601783996648606e-01 7.5140286376488064e-02 + 9.8716641616027800e-01 8.4201520550344355e-02 + 9.3588223362077372e-01 5.0340104245321982e-02 + 9.4961287620234458e-01 4.7562549142448063e-02 + 9.5875680315067768e-01 4.7748026368779506e-02 + 9.9042189034800998e-01 6.4959559884144369e-02 + 9.6863339760857770e-01 4.5010056686486166e-02 + 9.8115613199583152e-01 5.2579299836303051e-02 + 9.8681898379390987e-01 5.5198145951436572e-02 + 9.7731457294624136e-01 4.6652388039944981e-02 + 9.6111014602519873e-01 1.1449546651206788e-01 + 9.4531912913939209e-01 1.1238926128939397e-01 + 9.3231034786060007e-01 1.1260085310111378e-01 + 9.1860471362787166e-01 1.1395339533223137e-01 + 9.8584825978988988e-01 9.6154111978570711e-02 + 9.8093180404485736e-01 1.1025175542110333e-01 + 9.9689876053193416e-01 7.5565931372800321e-02 + 9.9942563736496481e-01 8.8468669707779668e-02 + 9.6184163418976709e-01 4.0880325903287940e-02 + 2.2295407353404073e-01 6.1213525805831210e+00 +-7.9455941341393554e-02 5.3637791049169437e+00 +-2.6699662849827632e-01 4.6048698413952280e+00 +-7.6177114876537644e-01 5.1885159033869925e+00 + 1.1572313348629848e+00 1.1056942457785723e+00 + 1.0141659106733343e+00 1.1445454835006927e+00 + 1.1156121052387462e+00 1.2595363508842183e+00 + 1.0660683412250265e+00 1.0114874117352670e+00 + 9.7643359394295715e-01 1.3275971120721266e+00 + 9.2898841888575845e-01 9.8721508276848624e-01 + 8.4066166988455393e-01 1.1757426977655143e+00 + 1.0489222440411652e+00 9.1665913867174709e-01 + 1.0986913926542741e+00 8.2147513772527248e-01 + 7.9427851768096502e-01 1.4114011146367318e+00 + 8.0180929913164789e-01 1.0070345861156227e+00 + 9.4754641922498450e-01 8.2548219854402305e-01 + 8.2181829030399456e-01 8.7179203825144214e-01 + 6.7221737016335936e-01 1.2389086205959643e+00 + 7.1028331047858728e-01 1.0790097200366944e+00 + 1.0164324315605597e+00 7.1341184534510660e-01 + 5.9443487627937230e-01 1.4191578121409307e+00 + 7.1329909834152261e-01 9.2834278358115796e-01 + 8.2493569666416988e-01 7.2488850020936013e-01 + 7.2609119197224459e-01 7.9578530117412072e-01 + 9.2432139735650054e-01 7.1001717046055290e-01 + 5.8870193550787064e-01 1.1199482843463642e+00 + 6.0497253052805888e-01 9.8624665088760821e-01 + 4.6882343921230785e-01 1.2124372816726776e+00 + 6.1481996763459534e-01 8.3018840502161595e-01 + 8.8186386129339667e-01 6.5977117445578415e-01 + 7.2673084508947738e-01 7.0608071952344176e-01 + 8.2117923597657239e-01 6.2798343681771485e-01 + 7.5541531361355396e-01 6.3418730574561977e-01 + 9.5082857803939902e-01 6.2653213374843375e-01 + 1.0335424373830975e+00 6.1426829186944332e-01 + 6.4901767758782825e-01 7.1643028122925756e-01 + 4.6749223967736953e-01 1.5837907928826667e+00 + 3.7357934742670551e-01 1.4178265747721568e+00 + 4.8260718411606263e-01 1.0267626670708694e+00 + 2.8079461146408846e-01 1.2348668507751057e+00 + 3.3514172615751647e-01 1.0319281465544776e+00 + 5.2891705102364028e-01 8.9868492732284011e-01 + 9.4871470022161475e-01 5.2863805214454374e-01 + 1.0362681595375705e+00 5.2045198191417086e-01 + 8.7265322672217849e-01 5.7887022994403736e-01 + 1.0821484643576511e+00 4.4783941998612420e-01 + 7.8357172456489366e-01 5.5814913179564485e-01 + 6.8181081998638859e-01 6.4665311280514004e-01 + 6.9159405312969113e-01 5.8184998204657035e-01 + 2.2404119823804791e-01 1.6069345585099839e+00 + 1.5607504199260802e-01 1.3842528406968668e+00 + 4.0326365035571143e-01 8.8183895788403532e-01 + 1.7171222621102800e-01 1.0909738105676325e+00 + 1.2608923543361072e-01 1.2259835036469866e+00 + 1.9896457599497097e-01 9.5693700024076378e-01 + 2.6196555216880313e-01 8.8275870795619937e-01 + 1.1809183642490950e-01 1.9198875700373748e+00 + 5.0316477055697106e-01 7.8942888634377084e-01 + 5.7358522962435643e-01 7.1963490292961296e-01 + 9.7274664727510896e-01 1.4501593823326431e-01 + 9.6026903911779016e-01 1.3413873547361277e-01 + 9.5655932271372990e-01 1.5254477433838787e-01 + 9.7560953288763130e-01 1.2719457998169048e-01 + 9.7473953478589692e-01 1.6666244679197462e-01 + 9.9005516067319377e-01 1.4509926557187214e-01 + 9.3932649721697459e-01 1.4062315388025581e-01 + 9.4424491784511133e-01 1.2278774749317733e-01 + 9.4542350307156653e-01 1.7045107459951936e-01 + 9.4152922080138524e-01 1.5488636148648283e-01 + 9.9319177586689733e-01 1.2171265282375998e-01 + 1.0034068968163865e+00 1.6717683049737531e-01 + 9.6266644062820461e-01 1.9356856687010549e-01 + 9.9231877232304555e-01 1.9278067743334049e-01 + 1.0058780117384813e+00 1.3332451170590787e-01 + 1.0100693649517538e+00 1.4808851289357960e-01 + 9.2780920312944204e-01 1.2605924139832325e-01 + 9.2480756020329835e-01 1.5592644312781090e-01 + 9.2048831065757497e-01 1.3896881964642205e-01 + 9.3275810738136045e-01 1.9743085434486574e-01 + 9.1769985960285538e-01 1.7861608692474107e-01 + 9.9731655862859725e-01 1.0359875551466047e-01 + 1.0125850857521144e+00 1.1436697926581019e-01 + 1.0209381664250188e+00 1.8626426720371114e-01 + 1.0263150490107193e+00 1.5923010264283732e-01 + 9.7832027121052789e-01 2.1257046704339189e-01 + 9.5179710130719286e-01 2.1977760880620423e-01 + 1.0093772319719534e+00 2.1925414815858346e-01 + 1.0246917065199739e+00 1.3561185404993381e-01 + 9.1188043156851961e-01 1.2742147893677469e-01 + 9.0345750559367133e-01 1.4467660025755436e-01 + 9.0537368100477522e-01 1.6389808990094679e-01 + 9.0922125402762788e-01 1.9721941173417434e-01 + 9.1752872418410902e-01 2.2237652454795409e-01 + 8.9350101126283477e-01 1.8018402381647292e-01 + 1.0134023432955104e+00 9.5138138083960655e-02 + 1.0314860569511026e+00 1.1586491406916366e-01 + 1.0292384068225218e+00 1.0067648453824063e-01 + 1.0472822541409315e+00 1.7449281200971711e-01 + 1.0448801724580221e+00 2.0507502985969950e-01 + 1.0451022985240073e+00 1.4783180074167745e-01 + 9.7821318403688906e-01 2.3896127060086769e-01 + 9.4318302568094481e-01 2.5096225626421642e-01 + 1.0068321163075069e+00 2.5173105833044218e-01 + 1.0426100035504433e+00 2.3941186062616282e-01 + 1.0464193544204576e+00 1.2659092325806398e-01 + 9.0307560069484794e-01 1.1430335440653039e-01 + 8.9652187991922716e-01 1.2886052189399777e-01 + 8.9043239399257601e-01 1.5842983088543150e-01 + 8.8756643882020114e-01 1.4016345043567213e-01 + 8.8891566690084289e-01 2.0654224744016858e-01 + 8.7032617556719316e-01 1.8746383741829220e-01 + 8.7876714957813107e-01 1.6841650758524906e-01 + 8.8388916905419279e-01 2.3377966408805406e-01 + 9.1293674493661570e-01 2.5092362915798105e-01 + 5.2854034116755599e-01 2.5724459948646938e-01 + 5.2847600411809026e-01 2.9421259100418951e-01 + 5.5043083126243886e-01 2.7367373220704394e-01 + 5.0033239518478467e-01 2.7836618177413186e-01 + 5.5647044824281977e-01 2.4425871769140883e-01 + 5.0035457494364266e-01 2.5089813093407543e-01 + 5.3432950328724615e-01 2.3036412313274468e-01 + 5.1205611043172183e-01 2.2847205587967068e-01 + 5.6193080281362739e-01 3.0260092021072182e-01 + 5.0291063869541830e-01 3.1696905142285914e-01 + 5.3543030392983582e-01 3.2022707944527440e-01 + 5.7947016861716349e-01 2.7056996978591030e-01 + 4.7778683935616328e-01 2.6317112541528331e-01 + 4.7308860818093734e-01 2.9448739580535488e-01 + 5.5021590365252138e-01 2.1197012433900397e-01 + 5.8273145906800039e-01 2.4328672702283427e-01 + 5.7259374169296251e-01 2.2236248693533156e-01 + 4.8440865643095066e-01 2.3630832725638129e-01 + 5.2759313943366948e-01 2.1176604977189584e-01 + 4.9088987656337935e-01 2.1075313033949072e-01 + 5.1137732969804262e-01 2.0380627093138060e-01 + 5.5930295298119859e-01 3.3871569361773624e-01 + 5.9170558889987035e-01 2.9762260387802542e-01 + 5.9152112873596252e-01 3.2752648123102546e-01 + 5.2700342896917363e-01 3.4748121730660131e-01 + 4.6692747522940437e-01 3.3044967701856365e-01 + 4.9267989924685196e-01 3.5867168965793894e-01 + 6.0609351991905669e-01 2.5369280743855427e-01 + 6.1299753517704403e-01 2.8035886788983788e-01 + 4.4729835862793266e-01 2.7598970783824939e-01 + 4.5804915613856423e-01 2.4575500177316201e-01 + 4.4694384328207093e-01 3.0808595359743407e-01 + 5.7845972703887583e-01 1.9768660814838768e-01 + 5.2847993405990223e-01 1.8957269399459165e-01 + 5.5338029983272463e-01 1.8609578830253781e-01 + 6.0257995937877951e-01 2.2242908381070947e-01 + 4.6731538115218285e-01 2.1880051919657006e-01 + 4.9846568205826713e-01 1.8493104138267569e-01 + 4.7483423897451615e-01 1.9561758144669028e-01 + 5.8762582442228961e-01 3.6117833182995440e-01 + 5.4681127134242047e-01 3.7561314318480754e-01 + 6.1848392849038447e-01 3.1224392183759164e-01 + 6.1516031814767302e-01 3.4411708098605231e-01 + 5.1456108212443041e-01 3.8005903130419938e-01 + 4.5843252273945012e-01 3.6327182084288978e-01 + 4.2955326884589340e-01 3.4153319574015484e-01 + 4.7540938107523800e-01 3.9488341427653495e-01 + 6.3545103185449392e-01 2.6173278588091620e-01 + 6.3177311209403086e-01 2.3663193955901818e-01 + 6.4181072625866875e-01 2.9182751757367953e-01 + 4.3621422492711304e-01 2.5211524971830102e-01 + 4.2325374250007997e-01 3.0124919141584883e-01 + 4.2037734084885869e-01 2.7181281730135254e-01 + 4.3981662989870074e-01 2.2620051972949540e-01 + 5.6510092079692242e-01 1.6514687589591404e-01 + 6.0924068291666345e-01 1.8897054064895258e-01 + 5.9061863677264625e-01 1.6565786330664878e-01 + 5.4167879869337554e-01 1.6469669463687353e-01 + 5.1679962346970143e-01 1.6344296347354259e-01 + 6.3270005764348269e-01 2.0644103067873942e-01 + 4.5270444227686824e-01 2.0094654752382013e-01 + 4.7715880740372540e-01 1.7442629997614745e-01 + 4.6149678309775766e-01 1.8252960256349127e-01 + 5.7018745897585177e-01 4.0861067774629589e-01 + 6.2406214429383056e-01 3.8413038040231129e-01 + 5.1740134294696816e-01 4.2041367853695988e-01 + 6.5410856479590507e-01 3.3550628962935036e-01 + 4.2759258929987709e-01 3.9082112752127074e-01 + 4.5365568043835935e-01 4.4553721406022362e-01 + 4.0005701483398326e-01 3.6116264538913612e-01 + 3.9613714823461521e-01 3.2589305241806699e-01 + 6.5221755186939134e-01 2.4411890554402760e-01 + 6.6415141280955226e-01 2.6798538405033412e-01 + 6.5276172583992320e-01 2.2173567795202587e-01 + 6.6778479296625903e-01 2.9893435258128420e-01 + 5.4669242790129857e-01 4.5436891427156212e-01 + 5.9853174294836720e-01 4.5595961825223696e-01 + 5.4731616340883704e-01 5.0553815130449209e-01 + 5.0324812338293157e-01 4.7890096828143669e-01 + 6.5522540705266863e-01 4.2382289016551056e-01 + 6.1790274385229793e-01 5.3425704362883408e-01 + 6.5452656100079309e-01 4.7435879296454431e-01 + 6.6476982151404229e-01 3.7691276041478261e-01 + 4.9433018825195063e-01 5.2898054919008786e-01 + 5.3179583626117477e-01 5.7360959910716502e-01 + 4.5206215275391060e-01 5.0627401374858749e-01 + 6.9024365922059872e-01 4.4973596299090701e-01 + 6.9988328973241209e-01 4.0073637163510512e-01 + 7.0992123364710835e-01 5.0619655201295899e-01 + 6.0325461154508986e-01 6.2867306817685886e-01 + 4.0467473915192897e-01 4.7661046937660956e-01 + 4.0350538136062397e-01 4.3260351115251439e-01 + 6.9292234266148256e-01 3.5117134577652820e-01 + 6.8969700297139980e-01 3.1564449460394428e-01 + 4.4448010564033069e-01 5.7607141332478307e-01 + 4.9376476968879501e-01 6.7204386322571708e-01 + 4.0434641955636152e-01 5.2913862766177289e-01 + 7.3166180466990483e-01 4.4356520817638767e-01 + 7.2411486978097628e-01 3.6009806759973628e-01 + 7.4289918488829443e-01 3.9425074750185729e-01 + 7.7907693293845171e-01 4.7822556330794441e-01 + 3.7979977258490294e-01 3.9306709365384052e-01 + 3.5549918677266845e-01 4.3760011716773306e-01 + 3.4940531283735510e-01 5.0256048992105207e-01 + 7.1720417838548656e-01 3.2710778673728669e-01 + 6.9073039328299757e-01 2.8266562902472003e-01 + 7.1517682384511261e-01 2.9389854526844772e-01 + 4.0162664951881055e-01 6.3856166210690901e-01 + 3.7071666290373884e-01 5.7428830395762986e-01 + 3.8592445611980963e-01 7.3376780254623952e-01 + 8.5516207592671378e-01 4.9973085269456163e-01 + 7.7134431769439260e-01 4.2754572384917111e-01 + 8.1837030994361726e-01 4.2476983074656971e-01 + 7.5428168532726403e-01 3.6239517112363728e-01 + 7.4374442203281177e-01 3.3826628524124658e-01 + 7.8141727698432817e-01 3.8505220112736538e-01 + 6.3875817901994481e-01 1.8176510113114119e-01 + 6.5768541456260010e-01 1.9868797047863040e-01 + 4.6081518961076995e-01 1.6220399943301800e-01 + 4.4397129047052175e-01 1.8025100256846827e-01 + 4.2900730089495909e-01 1.9852344893192253e-01 + 4.1835451736690743e-01 2.2065270977169149e-01 + 4.0831221901457582e-01 2.0540141684620750e-01 + 4.1590639198760471e-01 2.4338851816605001e-01 + 3.9375678456971741e-01 1.9315158727746962e-01 + 3.9988655542266116e-01 2.2533330914713900e-01 + 3.9062021375978873e-01 2.0962045352311520e-01 + 3.9743835975379227e-01 2.6687980913155940e-01 + 3.8575826719425521e-01 2.4989030202199558e-01 + 3.9599998993946883e-01 2.9217572610484410e-01 + 3.6914980879875969e-01 2.7713168206358318e-01 + 3.7311858885180982e-01 2.2698848033486740e-01 + 3.6043893695870111e-01 2.5136031235444989e-01 + 3.6798603949850417e-01 3.1519104510672946e-01 + 3.3001136495199290e-01 2.6946421780927210e-01 + 3.4292915835197846e-01 3.0260164740709428e-01 + 3.7218326387819900e-01 2.0031601284417633e-01 + 3.4407048478074387e-01 2.3745773275730642e-01 + 3.5047082353811732e-01 2.1484825816260411e-01 + 3.6720229520474845e-01 3.5449875761233329e-01 + 3.2998526221540914e-01 3.3757438448039068e-01 + 3.1711725390413648e-01 3.0615612013629345e-01 + 3.1752859271871614e-01 2.3982522759047242e-01 + 2.9322411920465186e-01 2.8909554402464721e-01 + 2.9554177459328201e-01 2.5898685775572972e-01 + 3.3053609104982939e-01 2.2281030617912023e-01 + 3.5052801026118630e-01 1.9400325232641080e-01 + 3.6467308933548281e-01 1.8147337304414890e-01 + 3.3145058652362280e-01 2.0469433761194011e-01 +-4.7513176663755985e-03 1.4973394373681970e+00 +-3.2726781116423354e-02 1.3039324309190974e+00 +-7.4913225530394811e-02 1.7026886447809346e+00 +-2.3198215071400341e-01 1.4618277886203543e+00 +-1.1296308091203855e-02 1.1189733887600397e+00 +-2.1851051041275582e-01 1.2184490561475698e+00 +-2.0386089266965257e-01 1.9434100162391417e+00 +-3.3388642647935285e-01 1.6918201076555448e+00 +-4.3295923770443778e-01 1.2855778791988328e+00 +-5.2612755608838313e-01 1.5329869642724816e+00 + 7.0286610549743500e-02 9.3852242155387700e-01 +-1.9771241398387929e-01 1.0290572103121178e+00 +-6.9125168432620399e-02 9.5578413616925673e-01 +-3.7862169060265671e-01 1.0750833137475837e+00 +-5.6627987870054142e-01 1.8659219496053083e+00 +-3.8911543768131196e-01 2.1702737087092885e+00 +-3.5691137311167154e-01 2.5061755249921589e+00 +-7.0255042480683016e-01 1.3068998282707156e+00 +-5.9632609566354233e-01 1.1091150643865433e+00 +-8.5399185858653937e-01 1.5778218507670090e+00 + 1.5571676488767849e-01 8.4050191457163947e-01 +-3.8624392390772755e-02 8.2213000057950580e-01 + 6.7686004533783262e-02 8.0425327387048640e-01 + 3.0609684233058942e-01 8.0044549900959794e-01 + 2.2046334431507830e-01 7.7006207108051683e-01 +-1.6827933824693275e-01 8.7023765964087829e-01 +-3.0658934661242654e-01 8.9809819390400492e-01 +-4.8434000994211601e-01 8.9694277449319770e-01 +-7.2458478101934531e-01 2.2578942145425600e+00 +-9.0497665767688318e-01 1.9171777517357640e+00 +-2.6924543635342957e-01 2.9285972984231350e+00 +-6.5797940893963869e-01 2.7228706322439535e+00 +-1.2361403655586969e+00 5.5935970385531988e+00 +-1.9223863868073465e+00 5.5395867871903803e+00 + 1.6679420585014526e-01 1.3882273176432136e-01 + 1.5908088824416922e-01 1.5050526863527125e-01 + 1.7372862551077617e-01 1.4783584210904621e-01 + 1.5445143423403351e-01 1.3503119354685111e-01 + 1.7998474412055998e-01 1.3403524699926805e-01 + 1.6685615090451478e-01 1.2779099296772500e-01 + 1.6883168328502762e-01 1.6002866261641202e-01 + 1.4615552123286335e-01 1.4579167176181329e-01 + 1.5380717254632970e-01 1.6702724514397715e-01 + 1.4516660248732904e-01 1.5609124867181379e-01 + 1.8611124980616722e-01 1.4619451871413958e-01 + 1.8149099400754665e-01 1.5879669278554331e-01 + 1.3745008170148054e-01 1.3531274246457770e-01 + 1.4686729624121853e-01 1.2358123695606338e-01 + 1.9552514667847731e-01 1.3749395029871891e-01 + 1.7334086219394607e-01 1.7420137088523546e-01 + 1.3444216862091452e-01 1.4982921881404820e-01 + 1.3414016811147889e-01 1.6497101215995968e-01 + 1.5483644178868872e-01 1.8439704934110068e-01 + 1.4125356171376069e-01 1.7899610369801167e-01 + 1.9743331034074885e-01 1.5365485766076858e-01 + 1.9130522509979642e-01 1.7179421482425994e-01 + 1.3499474722150495e-01 1.2069889507708353e-01 + 1.2661572270227595e-01 1.4118798963361456e-01 + 1.2283222300868601e-01 1.2903659201863604e-01 + 1.6691151325101572e-01 1.1531031642911671e-01 + 1.5795589546382871e-01 1.2341371027826398e-01 + 1.7006596383463091e-01 1.9045764046647662e-01 + 1.8572511425247740e-01 1.8900868556233519e-01 + 1.2153040809260318e-01 1.5134790253087260e-01 + 1.2819215471348144e-01 1.7717510400688496e-01 + 1.1712154393244845e-01 1.6529808400803603e-01 + 1.3410295238149672e-01 1.9505612989389931e-01 + 1.5840679532616520e-01 2.0097289021076392e-01 + 2.0500311314620490e-01 1.6774860613394083e-01 + 2.0854111496210237e-01 1.4081421753341061e-01 + 2.1587254090276531e-01 1.5535104017797607e-01 + 2.0533811446165373e-01 1.8452784418873591e-01 + 2.1766228057414594e-01 1.4267012791846412e-01 + 1.1452320963939400e-01 1.3913311366757597e-01 + 1.1003688617806517e-01 1.2953699596829438e-01 + 1.1281089439337677e-01 1.1990569276966312e-01 + 1.7788700404165070e-01 2.0638984179347375e-01 + 1.9756289773676627e-01 2.0353849657701062e-01 + 1.0794563421933390e-01 1.5201275622140287e-01 + 1.1434254742822247e-01 1.8155419027451103e-01 + 1.0226727203069430e-01 1.6763706915354248e-01 + 1.4470072151677726e-01 2.1342017879094755e-01 + 1.0933417133746559e-01 1.9790902786062503e-01 + 1.2530615856341853e-01 2.1607546741400085e-01 + 1.6325823208210011e-01 2.1957757700384661e-01 + 2.1892664432024134e-01 1.7265299903174025e-01 + 2.2876680916866121e-01 1.4299757813529368e-01 + 2.3102178002911700e-01 1.6185831727977273e-01 + 2.1632365216838423e-01 2.0060554691703913e-01 + 2.2252015450754925e-01 1.8634636027488938e-01 + 1.0002934248282713e-01 1.3870275784491071e-01 + 9.8998286410200365e-02 1.2266462712035775e-01 + 1.0483736044565006e-01 1.1076753593853539e-01 + 1.1431642373548812e-01 1.0903321385342224e-01 + 1.0931927730452173e-01 9.9571964445424044e-02 + 1.2414758067146181e-01 1.0245420116343240e-01 + 9.3490490704127183e-02 1.5348278001070526e-01 + 8.7450495356385716e-02 1.3052962131556001e-01 + 8.6932902295650649e-02 1.4222698958716506e-01 + 9.4948794825718608e-02 1.1023072064345030e-01 + 8.6970850006508726e-02 1.1814811658904745e-01 + 9.9020018019800204e-02 1.0293715531764747e-01 +-1.0117391059964262e+00 2.5278163119527051e+00 +-1.2186886508136894e+00 2.1824238014834663e+00 +-6.1147191123497180e-01 3.2411134541262285e+00 +-1.0636229816308145e+00 2.9444130158973252e+00 +-1.1709216446328838e+00 1.7358126900365534e+00 +-1.1472184884186873e+00 1.4228567312838578e+00 +-9.7185686586844611e-01 1.2579036802592469e+00 +-1.4410390080936679e+00 2.5949225780638230e+00 +-1.4927842705195218e+00 1.8345944375087697e+00 +-1.7864396246164915e+00 2.1233933023170124e+00 +-1.1473760952476937e+00 3.5216472029327974e+00 +-5.7022924143814180e-01 3.9190184861757587e+00 +-1.5121323602725170e+00 3.0581079160645004e+00 +-1.4078699417818825e+00 1.4800015674404108e+00 +-8.0172719163823558e-01 1.0790212613864512e+00 +-1.2525060812022559e+00 1.1769089732479898e+00 +-1.0093474569258518e+00 1.0084721944917447e+00 +-1.9238406046765135e+00 2.7634885314961863e+00 +-1.7925102832363393e+00 1.5676696650838267e+00 +-2.3631295599277706e+00 2.3200410894090950e+00 +-2.2544820081974279e+00 1.8114414878341165e+00 + 8.9659286952397110e-02 9.9051015871808090e-02 + 9.8556715243546478e-02 9.3711543967707200e-02 + 8.3990331064860868e-02 1.0776643725611734e-01 + 9.1385446122210112e-02 9.0058423742391369e-02 + 7.9237313513218055e-02 9.8195170961417944e-02 + 8.3506729221731746e-02 9.0521691760201861e-02 + 7.2639280954490459e-02 1.0530368740661089e-01 + 7.8553258327808351e-02 1.1375995556085172e-01 + 8.7688835997560943e-02 8.3232106887535906e-02 + 7.6554453112649412e-02 9.1077329091831416e-02 + 6.9073799773249789e-02 9.5450864381945166e-02 + 7.9916993544237869e-02 8.3790274146643640e-02 + 7.7883934054035819e-02 1.2393733763802572e-01 + 6.8613438587583175e-02 1.1507532957786992e-01 + 6.2866475757395790e-02 1.0447581993754795e-01 + 8.3336738331482252e-02 7.5355450818420877e-02 + 7.2248706479953739e-02 8.4851123444451559e-02 + 5.7662798387909220e-02 9.2373747334718814e-02 + 6.4498431766281783e-02 8.5134095922917652e-02 + 7.6184150255812710e-02 7.8239349034348038e-02 + 7.5716624882936401e-02 1.3739686302751153e-01 + 6.4675857473133647e-02 1.2723493356693893e-01 + 5.5936011536950048e-02 1.1489758720007615e-01 + 5.2793481456888003e-02 1.0223915059002309e-01 + 6.9287853205679539e-02 7.7195426220598051e-02 + 5.5975359659811375e-02 8.0277479844163224e-02 + 6.2684425158650470e-02 7.7286275886834233e-02 + 4.7424107060351162e-02 9.3732074273276567e-02 + 4.9941654738084651e-02 8.6114774369605129e-02 + 7.7977558051983920e-02 1.5102292573713783e-01 + 6.0670148091325871e-02 1.4306000745301617e-01 + 5.3429825323412672e-02 1.2874211597325314e-01 + 8.4747363303797840e-02 1.6649964379649163e-01 + 4.0990697986543978e-02 4.0763258921536760e-01 +-3.1380079641394332e-03 4.5789096515970584e-01 + 6.1425397523336756e-02 4.7352696422349538e-01 +-2.0195602570041160e-02 3.8789614593904531e-01 + 1.0248433476163399e-01 4.1295296307421125e-01 + 3.2183689409237104e-02 3.5898068555435714e-01 + 7.5836924092719471e-02 3.5901067006298604e-01 + 1.5689282190699316e-02 5.3159406345936588e-01 +-8.4855692031339913e-02 4.4289557312819028e-01 +-4.4971823217011320e-02 5.1261333359885697e-01 + 1.1348236812560941e-01 4.7708475992025967e-01 + 9.5027605460465736e-02 5.4636739680321966e-01 + 4.5589432962458432e-03 3.2986817759761777e-01 +-8.7443706526329379e-02 3.7580957850305197e-01 +-4.3665142160548953e-02 3.4219545241505500e-01 + 1.1976646025975413e-01 3.5850162760343096e-01 + 1.6253273807449631e-01 4.5231505566608377e-01 + 1.5939444663397495e-01 3.9137043474495670e-01 + 5.1247845500874689e-02 3.0811511608837350e-01 + 1.0102207069367353e-01 3.1708178509701668e-01 +-5.3162624628470212e-02 5.9958383822514350e-01 + 3.8955145970007266e-02 5.9958188274574553e-01 +-1.2850889021272849e-01 5.2424188435756491e-01 +-1.6117203168624883e-01 4.1141988564687892e-01 +-1.6658429260522212e-01 4.7190821204043232e-01 + 1.5769818889808107e-01 5.0689161938596783e-01 + 1.1287172721731054e-01 6.3200868078302364e-01 + 1.9810869047596924e-01 5.6360569880271072e-01 +-3.2786393286144744e-02 2.9276952944292134e-01 + 1.1479595887486482e-02 2.9115876493816728e-01 +-8.7528943261546033e-02 3.1958963503201687e-01 +-1.5599542063087313e-01 3.4409822894586028e-01 + 1.6154464624216303e-01 3.5306561695025351e-01 + 1.4395350503468052e-01 3.1872696887620577e-01 + 2.1257597476351009e-01 4.1822570540445980e-01 + 2.0777909386494997e-01 4.8536154213126537e-01 + 1.9678234086924817e-01 3.6756786605104708e-01 + 8.9015419362326043e-02 2.8823739802427895e-01 + 3.4346497563156220e-02 2.6585813645640854e-01 + 6.8703905815056032e-02 2.6586519430984623e-01 + 1.2089779994285266e-01 2.8834250189993327e-01 + 2.5058414214555569e-02 6.9106409366919763e-01 +-1.6125700438780655e-01 6.0139697318921037e-01 +-1.5141265449018704e-01 6.8129601688142571e-01 +-7.0108552022588810e-02 7.0695555560765655e-01 +-2.2920074802415513e-01 5.4444526382334857e-01 +-2.3553864735866625e-01 4.5425386036851023e-01 +-2.2795326864913079e-01 3.7791741599659190e-01 + 1.9865039048685418e-01 6.7054370646819450e-01 + 1.2599262540768308e-01 7.2904793897815523e-01 + 2.6878087259636629e-01 5.0644772374768365e-01 + 2.5554555618457186e-01 6.2330455689635755e-01 + 2.9668461062492923e-01 5.6320248114978710e-01 +-2.4400010458344923e-01 6.5741786265859048e-01 +-3.0534403221442119e-01 5.0498985794531848e-01 +-3.3445772445313082e-01 6.0822112183964805e-01 +-1.3170898443210888e-01 2.9002655330934601e-01 +-2.2707018622598696e-01 3.2470349100205453e-01 +-1.8880165714267605e-01 2.8693335187900715e-01 +-8.0519594295552110e-02 2.6416460289059529e-01 +-3.0475278638692771e-01 4.1462034333754616e-01 +-3.0117555631343862e-01 3.2467281312189300e-01 +-1.2978264947149398e-01 7.6281188477871353e-01 +-2.2145045149382270e-01 7.7092291246503919e-01 +-1.6178161250053336e-03 2.5834866240764143e-01 +-3.2211796344242316e-02 2.4406141081938415e-01 +-1.2520366208494238e-01 2.4748903678155898e-01 +-1.6532911244787840e-01 2.5580815058800965e-01 +-6.1369942231507935e-02 2.2162645136678094e-01 +-9.6499549197503143e-02 2.2960926274190996e-01 +-2.5787723123640660e-01 2.7673436845783073e-01 +-2.1704638941862697e-01 2.3255196174547166e-01 + 3.8571039344645897e-03 2.2040485237431540e-01 + 2.5511677983196535e-02 2.3839458681773351e-01 +-2.7245146116058550e-02 2.0225421929687570e-01 + 5.2916825358046538e-02 2.3686174473576216e-01 + 1.0320547485920883e-01 2.6178239272626769e-01 + 8.5454506733917412e-02 2.3885320102514385e-01 +-3.4218199708921304e-01 7.5314432684598387e-01 +-3.5649338763187188e-01 5.4405922402978035e-01 +-4.6349974948792294e-01 6.9849399433964976e-01 +-4.0683859842783932e-01 5.7271273035751591e-01 +-3.8969061423327389e-01 4.7331715515053929e-01 + 2.6114341297181909e-01 4.5096398845790020e-01 + 2.7892039932052626e-01 7.0523329226838882e-01 + 3.0715462291399831e-01 4.6351349276524445e-01 + 3.2621336264865874e-01 6.4253959561047225e-01 + 2.3831901437015546e-01 3.7646830213171256e-01 + 2.6017217337558662e-01 4.0642419452174749e-01 + 1.8782647841315026e-01 3.2916118747562706e-01 + 2.2791433091791902e-01 3.3104019294374609e-01 + 1.7583049455714672e-01 3.0286224996888222e-01 + 1.5584837691331899e-01 2.8453617289856936e-01 + 6.5480326457524995e-02 1.6213884952456681e-01 + 4.8995582906613322e-02 1.5338945596137421e-01 + 4.7660062163252803e-02 1.7035784885236183e-01 + 7.0676083055722927e-02 1.8189369419889090e-01 + 4.1225334799477764e-02 1.3771671830393473e-01 + 2.7389855705735044e-02 1.5617199622971611e-01 + 4.4705455043192899e-02 1.9015417642174270e-01 + 3.1669306034324052e-02 1.7887709123985474e-01 + 9.4718266727056744e-02 1.8285896975742588e-01 + 6.2368127464154099e-02 1.9960909639073066e-01 + 8.4560079772337815e-02 1.9909265140584864e-01 + 4.4641774716197347e-02 1.2080133334221443e-01 + 2.3743933113777871e-02 1.3299345862009915e-01 + 3.4107132204077573e-02 1.2194531117358309e-01 + 1.1606744806179847e-02 1.7883830649597598e-01 + 1.0113431752920121e-02 1.4233619693888500e-01 + 1.5145404900778203e-03 1.5765834856565419e-01 + 2.1393462335822733e-02 1.9711287238327202e-01 + 4.0078987465996363e-02 2.1364567615698604e-01 + 7.1072392713134036e-02 2.1589709000422630e-01 + 9.9191437336372701e-02 2.1638803022317177e-01 + 3.6994447418749132e-02 1.0914478671665506e-01 + 4.7743872226376993e-02 1.0936014591393928e-01 + 2.2920019195893815e-02 1.1477003478051273e-01 + 6.7078250244847482e-03 1.2502049429382112e-01 +-1.1835027400351805e-02 1.7731323113996922e-01 + 5.1902785991586597e-04 1.9384029603246944e-01 +-1.0507192934241516e-02 1.3919858845608246e-01 +-1.9129644088337727e-02 1.5754171164363129e-01 + 1.1763700432172186e-01 2.3632475415148235e-01 + 4.4487654134272248e-02 1.0142306018906311e-01 + 2.7956920228248805e-02 1.0240577981119259e-01 + 3.7105610303200365e-02 9.4934663220016091e-02 + 1.0363571480809242e-02 1.1077791641057644e-01 + 1.8306904668172308e-02 1.0121009828148431e-01 +-1.1479261202467228e-02 1.2285771972315018e-01 +-4.1267762257461982e-03 1.1147577805065367e-01 +-3.4052074093224860e-02 1.7035447600754594e-01 +-3.3679219581557618e-02 1.4683942831325680e-01 +-2.9592485183130179e-02 1.2807827691408136e-01 +-6.8266272269750061e-01 9.3213631896522031e-01 +-6.0000792748277831e-01 7.8458676494137336e-01 +-7.3836424100403519e-01 7.9419933661871767e-01 +-8.5909846613014906e-01 8.8528117943190665e-01 +-6.9950403930134541e-01 6.5838007050336955e-01 +-5.7170865827399098e-01 6.5163595310097833e-01 +-8.5054804940850204e-01 7.1061234925179662e-01 +-1.0204169804400323e+00 7.7901237429476566e-01 +-5.0259467623779130e-01 5.4181132351758521e-01 +-6.1982184462478074e-01 5.4475771290655928e-01 +-8.0556785817249477e-01 5.5200164403864704e-01 +-7.0722024198607869e-01 5.4200943636398335e-01 +-1.0011819218823916e+00 5.8877106337796192e-01 +-1.1870833245564114e+00 9.0919326062265782e-01 +-1.1984980522914128e+00 6.9796945593898840e-01 +-5.7799161731517756e-01 4.5413185213720908e-01 +-4.8745150270610793e-01 4.1467874870749455e-01 +-7.0398722584570805e-01 4.1289831800736465e-01 +-8.7810166811699730e-01 4.1120077693278034e-01 +-1.1927160269688670e+00 4.5828099130314115e-01 +-1.0213213309003777e+00 3.9993580112223981e-01 +-1.4259389627655139e+00 8.7983320827964917e-01 +-1.5825965256430550e+00 1.1875468891095338e+00 +-1.4061511699976705e+00 5.8521336121147272e-01 +-3.9400846458023864e-01 3.6048383429174891e-01 +-5.7614458305626215e-01 3.5212223278464450e-01 +-4.8659649511593273e-01 3.1906582781404325e-01 +-7.8837053722038775e-01 2.6671845936548522e-01 +-6.6104787213960492e-01 2.9100031991750086e-01 +-9.4086238155085766e-01 2.6389036568715341e-01 + 2.4332651743343092e-02 -3.1177085706190155e-02 + 2.6003650657770550e-02 -3.0774588062058683e-02 + 2.5772262092807807e-02 -3.2508482176922371e-02 + 2.5145842768949933e-02 -2.9675432352888720e-02 + 2.4059429003301602e-02 -3.3231026096345317e-02 + 2.3353400139335179e-02 -2.9591798219954057e-02 + 2.1182926453718665e-02 -3.1323927278918973e-02 + 2.7248163945245096e-02 -3.1622158285713908e-02 + 2.6562504335061021e-02 -2.9499165040249409e-02 + 2.7360750935585543e-02 -3.0315296219683319e-02 + 2.5436966052694743e-02 -3.4205374988417248e-02 + 2.6558000713201579e-02 -3.3900140009677671e-02 + 2.7446942912291661e-02 -3.2975812581980790e-02 + 2.4754632538694921e-02 -2.8223401337783116e-02 + 2.5922034059789212e-02 -2.8567811258142228e-02 + 2.4596354214693861e-02 -3.5680777782260975e-02 + 2.6426856427605117e-02 -3.5367419935653288e-02 + 2.2054045112128051e-02 -3.4396927765669716e-02 + 2.1378027351389051e-02 -2.8684041021918461e-02 + 2.2977501361097552e-02 -2.7229008591248771e-02 + 2.1994709206055063e-02 -3.6817671696951493e-02 + 2.6625799890950930e-02 -3.7262164951883392e-02 + 2.4534510436524215e-02 -3.8383314430802784e-02 + 2.8136201121220950e-02 -3.2134985214227640e-02 + 2.7892029272578611e-02 -3.4585039124181094e-02 + 2.8713094803350714e-02 -3.2963417448769405e-02 + 2.5944560933908178e-02 -2.7523558637227552e-02 + 2.4956021224262770e-02 -2.6689553614090755e-02 + 2.8030466110323005e-02 -3.6320990864908254e-02 + 2.4187877897134058e-02 -2.5774125091075462e-02 + 2.1888822285319520e-02 -4.0277188089063998e-02 + 1.8444895227915481e-02 -3.7455200538730082e-02 + 2.9397664139189317e-02 -3.4200855418077936e-02 + 2.9241075135217898e-02 -3.5468705939564416e-02 + 2.5431428413050128e-02 -2.5504275905745999e-02 + 2.7125200834454688e-02 -3.9622412110901450e-02 + 2.8453071487057002e-02 -3.8121699486424632e-02 + 2.4976176187628596e-02 -4.0639671953783818e-02 + 2.9545152953296849e-02 -3.6908377503792167e-02 + 2.4410059553794383e-02 -2.4598424824731069e-02 + 1.7348543253973503e-02 -4.1667477377174578e-02 + 2.4491541855056198e-02 -4.3422558503138475e-02 + 2.1166725799645292e-02 -4.3421683603014571e-02 + 3.0435455905077902e-02 -3.4866670344285922e-02 + 3.0555151073379250e-02 -3.5940766169701988e-02 +-5.7145053086102848e-02 1.5657208175521475e-01 +-5.9904094909285277e-02 1.8518365644979440e-01 +-5.1748928964684637e-02 1.3414655311816404e-01 +-9.1057225188151847e-02 1.6230820171517024e-01 +-7.6709556151627112e-02 1.3760501403958614e-01 +-9.3359989180399339e-02 1.9727447673637499e-01 +-4.6946771594107872e-02 1.1427134608057088e-01 +-6.6379720627338656e-02 1.2084672673157115e-01 +-2.3193536821764837e-02 1.1115602579325667e-01 +-9.8665087060254564e-02 1.3457042570119881e-01 +-1.3146184322724253e-01 1.7030693780320405e-01 +-1.1583460522506073e-01 1.4345039296062367e-01 +-9.0113291202783330e-02 1.1307877229808838e-01 +-1.2823626513144859e-01 2.0999052166220622e-01 +-6.6380055223604018e-02 1.0513194812159554e-01 +-3.5783672416528134e-02 1.0030246918164210e-01 +-4.9814825101435645e-02 9.6645922400625750e-02 +-1.2735436083403329e-02 1.0085858204746501e-01 +-2.3534467827474259e-02 9.1532510807255107e-02 +-1.1961075753363559e-01 1.1640974749258248e-01 +-1.3327694370416054e-01 1.3643709602890652e-01 +-1.5900767793763748e-01 1.9322356668550356e-01 +-1.7720873831873973e-01 1.6190424518140389e-01 +-1.5894966029257773e-01 1.3394677245413789e-01 +-8.3806305532419856e-02 9.4090671047553087e-02 +-1.0540839915999811e-01 9.2977546686746848e-02 +-1.6388486916098088e-01 2.2203984922470710e-01 + 2.2470842202437780e-03 9.6935496961897627e-02 +-3.7954964355179754e-02 8.3357764458710903e-02 +-6.6236261587732770e-02 8.5867330576206768e-02 +-5.0556395546578869e-02 8.1828232254586908e-02 +-1.0949804612479852e-02 9.0625993586037623e-02 +-2.7181171781222702e-02 7.7481307609133410e-02 +-1.6325335929323614e-02 7.7770285367463998e-02 + 2.6566899285192846e-02 -4.1862219771743980e-02 + 1.8601762550090939e-02 -4.5740401320102819e-02 + 1.5028539072368119e-02 -4.5191227263487121e-02 + 2.2542771712572574e-02 -4.6447869022813393e-02 + 2.8060946277904009e-02 -4.4057439649449748e-02 + 2.6455362235090263e-02 -4.6703653826241975e-02 + 2.8568655722722269e-02 -4.1642578794437668e-02 + 2.9428859836912125e-02 -3.9828856992329520e-02 + 1.5763150445863516e-02 -4.8487726637574724e-02 + 1.9760845016236317e-02 -4.9226424016524106e-02 + 1.1715909885971598e-02 -4.6861938870165432e-02 + 2.4280031141756808e-02 -5.0172139711662567e-02 + 2.9757677201018851e-02 -4.6434645260077900e-02 + 2.9978785701459287e-02 -4.2731627462970323e-02 + 3.0957999007156900e-02 -4.4457523329981541e-02 + 2.8598857008724110e-02 -4.9187817147242185e-02 + 3.0312993690138512e-02 -3.8305031295010394e-02 + 3.0240893372713629e-02 -4.1266669118058985e-02 + 3.1411867111863501e-02 -3.9925564240533618e-02 + 1.6721790909976164e-02 -5.2419701971757604e-02 + 2.0334926783924345e-02 -5.2594994775105874e-02 + 1.1895550901243723e-02 -5.2341100298903598e-02 + 2.7800633929707885e-02 -5.2819172510709222e-02 + 2.3324815556136969e-02 -5.5741367893247684e-02 + 7.4172119442579287e-03 -4.8805870282606634e-02 + 3.1295635684372769e-02 -4.8318226838262035e-02 + 3.2315902247887607e-02 -4.6493982226678554e-02 + 3.1965706012059059e-02 -5.1254952820968924e-02 + 3.1816298490639383e-02 -4.2204718099981164e-02 + 3.3105623641233706e-02 -4.4291058554406959e-02 + 3.0738611153928730e-02 -3.7001497177826081e-02 + 3.1865364161077991e-02 -3.7783062137904722e-02 + 3.2817916579190864e-02 -3.9086458700126059e-02 + 3.2989227224540230e-02 -4.0646961407176718e-02 + 1.8688290369389904e-02 -5.5495236222114386e-02 + 1.4937807569715744e-02 -5.6369911418045149e-02 + 2.7791738902287477e-02 -5.6241249596922671e-02 + 1.8602105563786608e-02 -5.9296946139781426e-02 + 2.6289040692233812e-02 -5.9155394040118381e-02 + 2.3118162856263780e-02 -6.1953368293913513e-02 + 3.1643520550233006e-02 -5.5245626204879272e-02 + 9.9487553773869308e-03 -5.7513136182393509e-02 + 6.3682417641572897e-03 -5.4248931247371956e-02 + 1.3770352296489818e-02 -6.1153347693277738e-02 + 3.3982369744066432e-02 -4.8551588706331472e-02 + 3.4358316904977926e-02 -5.3478743971211884e-02 + 3.5411534452158833e-02 -5.1076013557221245e-02 + 2.9723294321740923e-02 -5.9145794142835939e-02 + 1.8441138593495054e-02 -6.5632829286130345e-02 + 2.7487191824683066e-02 -6.2695190273686308e-02 + 2.4473244760883972e-02 -6.7308564642900137e-02 + 3.6275150821950319e-02 -5.6661457803954818e-02 + 3.3884648006527129e-02 -5.9509151104492730e-02 + 3.4979815060054875e-02 -4.6115906504013537e-02 + 7.7864827223095290e-03 -6.2764786479462487e-02 + 1.2984618324317410e-02 -6.5509732466594528e-02 + 8.6973191623584967e-03 -6.8219469242592368e-02 + 3.4363708482487709e-02 -3.9094994094838853e-02 + 3.4710777960313521e-02 -4.0764896967004915e-02 + 3.3801770090086336e-02 -4.2419857394719429e-02 + 3.5451099328916769e-02 -4.2345636900734007e-02 + 3.6189657029957800e-02 -4.0763568021759511e-02 + 3.4836286043045561e-02 -4.3846840379174523e-02 + 3.1551682886792776e-02 -3.6491007353490090e-02 + 3.6914159431177040e-02 -4.1987047210568562e-02 + 3.6843122095007175e-02 -4.4061742541941840e-02 +-3.8015890353335635e-03 -6.4297268387051076e-02 + 2.3188853755726768e-03 -6.6497342572674256e-02 +-3.4493984593808591e-03 -6.8895466956490736e-02 + 3.9262035872553724e-02 -4.3782930190658931e-02 + 3.8530443992485175e-02 -4.5360458092417844e-02 + 4.0308896378334680e-02 -4.5387168941033451e-02 + 3.7277836375707807e-02 -4.6577823422808251e-02 + 3.9444691797065445e-02 -4.7748469072161015e-02 + 4.1681008772300743e-02 -4.6779173787498962e-02 + 4.2444406276011648e-02 -4.4917680238043545e-02 + 3.6561080601906326e-02 -4.8566231682428906e-02 + 4.2622730824888322e-02 -4.8845844122908488e-02 + 3.8464756795974608e-02 -5.0747199287414446e-02 + 4.0969083939764062e-02 -5.0343078407536268e-02 + 4.3871734862634071e-02 -4.7136575561125937e-02 + 4.2966721845608902e-02 -5.1238694812084873e-02 + 4.0932822859517159e-02 -5.2759121745225457e-02 + 3.7662175210108728e-02 -5.3729463511444919e-02 + 4.0804614605832512e-02 -5.6709323876290796e-02 + 3.8439593646657499e-02 -6.0266799056009290e-02 + 4.3959750394442665e-02 -5.3942108074409134e-02 + 4.2907346629988297e-02 -6.1197076846923437e-02 + 4.0103978802399354e-02 -6.4642635059485087e-02 + 3.5351005296689664e-02 -6.4755050957302274e-02 + 4.4110339620800687e-02 -6.7170825513969135e-02 + 4.9138182645044992e-02 -6.1856032211451861e-02 + 4.5556920840176929e-02 -4.9923739508201948e-02 + 3.8888277701431662e-02 -6.9171147936728516e-02 + 3.1276062853301312e-02 -6.2413590098984173e-02 + 3.3388615627302443e-02 -7.1734728732351982e-02 + 2.9865956002474547e-02 -6.7095537230514424e-02 + 4.2142033175018412e-02 -7.2699086321989626e-02 + 4.8319581258589039e-02 -7.4307369581433136e-02 + 3.8233693686350989e-02 -7.4024561035301417e-02 + 2.7239559434050875e-02 -7.1807099787363882e-02 + 3.5003401519162480e-02 -7.9396776818811077e-02 + 2.7409575851059742e-02 -7.9554818477760136e-02 + 4.1552271957712605e-02 -7.7827730572508358e-02 + 4.7302517743140982e-02 -8.2723448021951640e-02 +-2.2305020597315206e-03 1.2052142993255188e-02 +-9.7754734461830139e-04 1.4764834904482882e-02 +-2.5109369155984496e-04 1.2176971274755033e-02 +-3.6836173148628859e-03 1.4494806503421387e-02 +-1.0419170817641543e-03 1.0012315742471856e-02 +-4.5546815397869977e-03 1.1770583927976475e-02 +-3.2366068738554077e-03 9.9464185816984241e-03 + 1.0039426419297115e-03 1.3796347547504695e-02 +-2.7147445464521525e-03 1.7289973639051937e-02 + 1.6486593339521960e-03 1.1902463224849669e-02 +-5.6330419073447047e-04 1.7138393238930405e-02 + 1.3761221215915498e-03 1.6277833342982717e-02 + 2.3828246298265299e-03 1.3762218457436859e-02 +-6.3211149599879946e-03 1.3739461456680147e-02 +-5.8501388847247426e-03 1.7111173220207831e-02 +-5.3907820162919506e-03 9.5703402360527434e-03 +-6.6094277927817302e-03 1.1518418157329791e-02 +-3.8432637306584638e-03 7.4555401151883416e-03 +-4.5122451362544780e-04 1.9458615100020893e-02 +-4.2720090955157275e-03 1.9959772171084467e-02 + 3.9736260058944595e-03 1.9038686035990793e-02 +-8.7420248526797195e-03 1.5683174278997569e-02 +-8.5047998285006088e-03 1.2499691986889161e-02 +-8.3638271172929990e-03 1.9970491044752237e-02 +-7.7596344880390689e-03 9.6535170362628264e-03 +-2.3464274616742387e-03 2.2414397051250035e-02 + 1.6124960581649361e-03 2.2766745454234183e-02 +-5.9056920493389953e-03 2.3513982971017811e-02 + 6.5349978553399524e-03 2.3371046678946072e-02 +-1.1287095409201697e-02 1.3670318727484698e-02 +-1.2125172916256588e-02 1.7107909237992658e-02 +-1.0875269997555392e-02 9.9810469215242392e-03 +-1.0016837212077689e-02 2.4351719249253279e-02 +-1.3113504651343533e-02 2.0798483857085159e-02 +-9.0493612036794957e-03 8.0639558467012762e-03 +-2.1195847963753067e-03 2.5848939371456936e-02 + 3.2226493123488353e-03 2.7208836107817547e-02 +-6.3008417561150054e-03 2.8724379313509019e-02 + 4.2096453103923182e-02 3.9978231791209851e-02 + 3.5721193165912268e-02 3.9531217042664935e-02 + 3.7997946766267887e-02 4.5953654252301135e-02 + 3.9496716807050802e-02 3.3781810898254605e-02 + 4.3492619888908735e-02 4.5910447800906695e-02 + 3.1614444672612763e-02 4.5429315510773449e-02 + 3.3737794467313620e-02 3.3817655297092131e-02 + 2.9383803178362200e-02 3.8226634506273172e-02 + 3.4312874074039712e-02 5.1162282915271362e-02 + 4.1297495609939006e-02 5.0947781314008012e-02 + 2.6277954587484942e-02 5.1856360072420671e-02 + 2.4213898728291383e-02 4.4130975546536888e-02 + 3.7504080036391940e-02 5.7158050476090239e-02 + 3.0937922830361231e-02 5.6583153298603861e-02 + 4.4368453030358523e-02 5.6772706690196628e-02 + 4.7779972808363880e-02 4.9948300784386390e-02 + 1.8408892507146390e-02 4.9052090437001539e-02 + 1.9215423304132173e-02 4.2243419958239770e-02 + 2.2881913013264921e-02 3.6912313551063392e-02 + 4.0621347907112693e-02 6.3443747147772456e-02 + 3.2418643824470905e-02 6.4103330874431208e-02 + 5.0294673405126389e-02 5.6069742613736651e-02 + 4.8573446243274532e-02 6.2922106621662977e-02 + 2.5287013831785998e-02 5.9840119822453630e-02 + 2.0217456671176137e-02 5.6043947691982510e-02 + 1.6900301190297284e-02 3.7627438416741654e-02 + 1.3672111081682203e-02 4.3494281839826954e-02 + 3.6438709671436698e-02 6.9634124476863235e-02 + 4.3829415842886021e-02 6.9632229660562928e-02 + 2.5317937764157250e-02 6.7513400983216343e-02 + 2.9465142586388993e-02 7.4300959680890344e-02 + 5.1181555384054889e-02 7.0883103699031835e-02 + 5.4559057376280862e-02 6.5434218661394539e-02 + 1.7810657855221734e-02 6.3557289468519684e-02 + 1.3888172946302291e-02 5.5274933978360252e-02 + 1.1806062721788635e-02 4.9293982865521002e-02 +-8.4492670737289188e-01 4.5811910656036687e+00 +-1.2951775437194897e+00 4.1483679455437255e+00 +-1.9410708985974308e+00 3.5432050621099407e+00 +-1.4889386739756816e+00 4.9090248828768210e+00 +-1.8750931229032659e+00 4.3626161574369462e+00 +-2.5681358718161391e+00 4.2086220200023376e+00 +-2.7637747132153834e+00 3.5035970417539630e+00 +-2.4992321765510894e+00 2.9412612410127039e+00 +-2.2633686131747766e+00 4.8732486205688446e+00 +-2.6854734628546879e+00 5.4219218480389486e+00 +-2.9383865712974000e+00 4.7760242272125524e+00 +-3.5201452405917877e+00 3.9934832306509591e+00 +-3.1379480830480162e+00 3.0822352205628647e+00 +-2.8655725188979488e+00 2.5059221290704841e+00 +-3.5842193498087056e+00 5.1807185529938664e+00 +-4.1918144572996994e+00 4.5774957825879525e+00 +-3.7895019847315865e+00 3.1149182224435066e+00 +-4.3823935314350564e+00 4.0426692800151400e+00 +-4.3251326026740031e+00 3.4550687282862071e+00 +-4.4427669761315798e+00 5.2855304949519706e+00 +-3.4667474978272139e+00 2.4253900543690321e+00 +-4.9048163948133663e+00 4.3947553268581032e+00 +-4.3163990484921300e+00 2.6891608380001273e+00 +-4.7825859245295845e+00 3.7749953005073706e+00 +-4.9628265139817387e+00 3.1814362504937463e+00 +-2.8234584571893180e+00 1.9782731916358927e+00 +-4.5070781904582873e+00 6.0446100230889357e+00 +-5.0906643031092500e+00 5.7326739103637010e+00 +-5.2962427816359821e+00 5.0268813747674557e+00 +-1.6874304185222400e-02 5.2570883232760934e-03 +-1.6460799138016569e-02 8.4709799521718310e-03 +-1.4795721606191137e-02 6.3279753853393572e-03 +-1.9063054853830863e-02 7.0490349681477937e-03 +-2.0139996490073031e-02 3.4303823266199629e-03 +-1.6809663165517463e-02 1.5843579959238241e-03 +-1.3379689169241260e-02 8.0655600981032194e-03 +-1.9805589209667573e-02 1.0141674828489045e-02 +-1.4303819722854882e-02 1.1590453786780586e-02 +-1.7066721622100545e-02 1.0934910039750889e-02 +-1.0791683902738214e-02 6.9254040442672249e-03 +-1.2637847101004240e-02 5.2896353064895152e-03 +-2.2320145419726600e-02 7.0030987430627079e-03 +-2.3133233355338234e-02 3.3096375087353636e-03 +-1.5543510596430110e-02 -3.8184598753332466e-03 +-1.7635451225160637e-02 -2.2677954717380544e-03 +-1.4898866075299111e-02 -1.1091896464847650e-03 +-1.7696678417834732e-02 1.3536531591583412e-02 +-2.3268145701337062e-02 1.0294365391835925e-02 +-2.2153871967844907e-02 1.3286428362270897e-02 +-1.4303322932491369e-02 1.4672907693238812e-02 +-2.5526646251847751e-02 4.6094716061020335e-03 +-2.6073381818790153e-02 8.6434779266397754e-03 +-2.5286842144680577e-02 1.2081902059293270e-03 +-2.0348505669687711e-02 1.6083257716644539e-02 +-1.6550018704265312e-02 1.7597645807668982e-02 +-2.5987740090670286e-02 1.2397147098702987e-02 +-2.4584668666605580e-02 1.6196479181303403e-02 +-2.9178784153927495e-02 6.1990580395985262e-03 +-2.9952409499770738e-02 1.0481089089992679e-02 +-2.8654648481975187e-02 2.3278574968941257e-03 +-2.1451284105353352e-02 2.0128015590728410e-02 +-1.7152458130851755e-02 2.1657907678218180e-02 +-2.9579383051896002e-02 1.5196927017910866e-02 +-2.7128849980741165e-02 1.9840677958754327e-02 +-3.5244737412810423e-02 1.2613606376604025e-02 +-3.2912530435979193e-02 1.8635375024857126e-02 +-3.3138794274137240e-02 7.7248239333016500e-03 +-3.1034708467728933e-02 2.4714056623295733e-02 +-2.4783453357400731e-02 2.4919311788977438e-02 +-3.9104002315212938e-02 1.6874941315805358e-02 +-3.7897586345906120e-02 7.8673018000401385e-03 +-4.1435390765357738e-02 1.1630072427735172e-02 +-3.6732426403688123e-02 2.1801167609773131e-02 +-1.9669816543114393e-02 2.5061335664545936e-02 +-3.1986500991166622e-02 3.8478286540311046e-03 +-3.5590376764375264e-02 4.8854538785860768e-03 +-2.7062648577953041e-02 2.9524257703982926e-02 +-3.8372601514012672e-02 2.7666691642480146e-02 +-3.1392738683521770e-02 3.1992652854199832e-02 +-2.2316718948189873e-02 3.0188897993994601e-02 +-4.5603015422074122e-02 1.5372737640653611e-02 +-4.2695913451424872e-02 2.1196688815180664e-02 +-4.3032692517613214e-02 6.7942959813862558e-03 +-3.9893929767799818e-02 3.1089222485931600e-03 +-4.8487172185218697e-02 9.3559920982926315e-03 +-1.4802269495106657e-02 2.5366395252746088e-02 +-1.7084518056819320e-02 3.0619285494957182e-02 +-3.5376565553846717e-02 1.5514640937652757e-03 +-3.1638617255964618e-02 1.8671413846504947e-04 +-2.8075560026479707e-02 -1.9090036561806301e-03 +-2.5015694694673130e-02 3.6452964205551552e-02 +-1.8796760438647198e-02 3.7558368950030285e-02 +-3.6412608403807667e-02 3.4726981076360630e-02 +-4.6923150380521861e-02 2.5986927048116115e-02 +-4.3416664807494953e-02 3.3248367470399387e-02 +-3.1007482883836701e-02 4.0370573895572193e-02 +-1.1776482376433250e-02 2.9709639572274682e-02 +-1.2553940728409430e-02 3.6936855826994019e-02 +-4.9844220258478344e-02 2.0312795472058554e-02 +-5.2912674607313193e-02 1.4636420707148545e-02 +-4.4798213526405561e-02 1.9843048288024079e-03 +-4.7882495865948727e-02 4.7610985798769434e-03 +-3.8204979979980180e-02 -1.1520121198316247e-03 +-4.2365936966177742e-02 -2.2785602265429361e-03 +-5.5174099956104783e-02 9.3868409438044864e-03 +-5.3696711838398414e-02 3.9091796528367695e-03 +-3.3972150433996262e-02 -3.5159093793879492e-03 +-3.0966546487718460e-02 -2.3906814982268543e-03 +-5.5475965309810249e-02 3.0187257189773220e-02 +-5.2508953961691418e-02 2.4308093925043295e-02 +-3.9015843809195871e-02 4.1738357739170340e-02 +-4.9020933591734206e-02 4.0933622365727729e-02 +-5.6839586643377515e-02 2.0606494427767075e-02 +-2.2109055747307593e-02 4.5974301463516554e-02 +-3.1461483975988358e-02 5.0339504454555595e-02 +-5.9225968051748623e-02 1.3025116009430349e-02 +-6.3346627165643099e-02 2.4249311371093540e-02 +-6.1102839930654795e-02 4.1030657475182863e-02 +-6.6789662305239972e-02 3.2441735149049578e-02 +-6.5268090854502248e-02 1.7521790882440769e-02 +-5.5666194642583378e-02 5.0893176139354068e-02 +-6.7719444985684163e-02 5.1386839006902107e-02 +-6.2442075202440606e-02 6.2047519370821647e-02 +-5.0200660540809849e-02 6.0543415145708934e-02 +-4.4048669646130634e-02 5.0593100888647768e-02 +-7.9269484547154434e-02 6.0723960673328747e-02 +-7.0899918434832898e-02 4.1337926880174791e-02 +-7.7273114253799235e-02 4.7613596760712085e-02 +-5.7333336094515630e-02 7.2209561123131039e-02 +-7.0896180198431580e-02 7.1579839778998178e-02 +-3.8965570561032337e-02 6.0413598808608526e-02 +-4.4166846680681715e-02 7.1002187041770526e-02 +-8.8803784873377367e-02 4.8270501744120509e-02 +-8.9199743560328670e-02 7.7050827151580847e-02 +-9.6405881618650824e-02 6.1704929253231455e-02 +-7.8592095044612620e-02 3.5262765918616878e-02 +-7.1284320997435202e-02 2.3633106434445494e-02 +-3.3763561491923610e-02 6.9497210567476486e-02 +-3.0152201030645642e-02 6.0506174753406583e-02 +-2.2591586808829334e-02 5.6883402257099647e-02 +-1.0822160669036407e-01 4.6343940458989152e-02 +-9.3060527085654599e-02 3.7973817399809207e-02 +-1.1506331297314887e-01 6.9314960993885677e-02 +-8.0296099936319365e-02 2.2800402803966335e-02 +-8.8209462938124261e-02 2.8965472544498994e-02 +-7.3433096895911376e-02 1.4022668476194156e-02 +-2.4130630300248868e-02 6.7902928644677729e-02 +-1.3345351313390097e-02 5.3989498703430172e-02 +-1.4769924759463038e-02 6.5279191313415197e-02 +-1.4404859437803452e-02 4.4286717166350797e-02 +-1.0040519242608070e-01 2.7554960142190055e-02 +-1.2522939056484006e-01 5.1334224929370009e-02 +-1.1245081302385529e-01 3.1726257294423021e-02 +-1.2396311501819923e-01 3.3470004457498703e-02 +-1.2964077374059002e-01 8.8864055760041083e-02 +-1.3795924883336852e-01 6.5332524122780455e-02 +-8.8693400198010863e-02 2.1235416457805911e-02 +-8.3370375318011725e-02 1.4384442362839422e-02 +-5.9982914063994031e-03 6.1400417688204811e-02 +-9.4430996665124667e-03 4.8651802048325976e-02 +-5.1143808624658504e-03 5.3280053565814001e-02 +-6.2466825276743521e-03 7.2026701344483968e-02 +-8.3080731685356568e-03 4.2782419024412377e-02 +-3.4883308932478485e-03 8.3664214901062905e-02 + 1.5878797506374553e-03 5.7188738563652919e-02 + 1.8987112738670930e-03 6.6638322638397085e-02 +-4.3727409418039542e-03 4.7404428535969600e-02 + 1.0828845095289807e-03 4.9908531559637481e-02 + 3.3856815554997866e-03 7.6977165250148971e-02 +-6.7498918166961630e-03 3.8610700259127384e-02 +-8.5698283400290620e-03 3.3512796647606535e-02 +-4.0624797216679553e-03 4.2328909106593926e-02 + 6.8563348387229439e-03 8.5881935672617260e-02 + 8.0334846098679691e-03 6.0885531707086216e-02 + 1.0827761768098298e-02 7.0214476981121265e-02 + 7.0524833125915620e-03 5.2816761699986614e-02 + 1.3360277993925251e-02 7.9646918008521084e-02 + 1.9879694123815739e-02 7.2919495123485945e-02 + 7.0704672317134509e-04 4.3980127230391020e-02 + 6.9154867839174017e-03 4.4886321622328751e-02 +-3.8332785090887000e-02 -4.9565917115188540e-03 +-3.5936452184188283e-02 -6.3450548813648311e-03 +-4.7853467678052652e-02 -2.3257799318088246e-03 +-4.2036456857317717e-02 -7.4849194305102174e-03 +-4.6045807569939257e-02 -5.3941239435602029e-03 +-4.9499425212644610e-02 1.3054331487296622e-03 +-3.7187529386500273e-02 -9.2541296739909740e-03 +-5.1185342384314936e-02 -6.4161778175133577e-03 +-5.3266237154488749e-02 -1.8016373859808255e-03 +-4.6685215463440954e-02 -9.3253760866360835e-03 +-4.0308865689610229e-02 -1.2456884705215998e-02 +-4.4211411234400089e-02 -1.2527915900875541e-02 +-5.7126983878944770e-02 -5.6899612240499664e-03 +-5.1059092009765550e-02 -1.1599717852988078e-02 +-5.5571571133882003e-02 -1.0297995426540751e-02 +-5.8807208700855540e-02 -3.0402587998423769e-04 +-4.7512934042174493e-02 -1.2926419094171138e-02 +-4.6947497231130342e-02 -1.6666270949315276e-02 +-5.9441654182805337e-02 6.3128912459831099e-03 +-1.9836216376923232e-01 1.9168925670368253e-01 +-2.8367688451044160e-01 2.2516480216177115e-01 +-2.5383009335540407e-01 1.8584634582292381e-01 +-3.1157336255601820e-01 2.6344915398091473e-01 +-2.2542169006071333e-01 1.4870906067571354e-01 +-3.0261030127813626e-01 1.8442490330102146e-01 +-3.3914575238340205e-01 2.1728178939024190e-01 +-2.8362885374012592e-01 1.3796610016123623e-01 +-3.6193554935888983e-01 2.7276389501936649e-01 +-1.9132479975094441e-01 1.2658569165557765e-01 +-2.4778856369270841e-01 1.1357687742759026e-01 +-2.1923854372202811e-01 1.1499015471358121e-01 +-3.4840480957009845e-01 1.5385831046279463e-01 +-4.0331224523514209e-01 2.0351047106496623e-01 +-3.2057919522489442e-01 9.6090246415243996e-02 +-2.7179147506842583e-01 9.0490125557607826e-02 +-4.2503632104738642e-01 2.7687352508466034e-01 +-4.0237590124249323e-01 1.3792713534082424e-01 +-3.7535517103096083e-01 1.0069243552903373e-01 +-4.8164773478946188e-01 2.2523775203175234e-01 +-4.6463964825420589e-01 1.4063089012516627e-01 +-2.3087621038621364e-01 8.5309562315579512e-02 +-2.0321809611323260e-01 1.0089904155960028e-01 +-1.7576216355108443e-01 9.8934804214792393e-02 +-2.9480382312812026e-01 5.1163897056277108e-02 +-2.5501066886475598e-01 6.2390453017108882e-02 +-3.5288475257320329e-01 4.8986062914011086e-02 +-1.4466347320332318e-01 1.0951185984099254e-01 +-5.0232676512806052e-02 -1.5157753410107944e-02 +-5.4540741471569731e-02 -1.5943724609954302e-02 +-5.9192442962682890e-02 -1.3567658774348956e-02 +-6.0902001127061567e-02 -9.4627806963103467e-03 +-5.9402246647380252e-02 -1.7154808869477733e-02 +-6.2815057049718348e-02 -4.0292322867969688e-03 +-6.3768352404721895e-02 -1.2268550634303210e-02 +-6.3425777173378606e-02 -1.6045287883613923e-02 +-6.7327674679603433e-02 -8.5598749138711128e-03 +-6.1960877583530305e-02 -2.0261057788516723e-02 +-1.1280707997394757e-01 5.5422595105270034e-03 +-1.2722314515114874e-01 1.5111987088069156e-02 +-1.1393602704443140e-01 2.0822757683831128e-02 +-1.2451475794253497e-01 1.9594629868322500e-03 +-1.0440526664811500e-01 1.5322142198847644e-02 +-1.1738381061394421e-01 -6.4212312181552988e-03 +-9.9240570899340241e-02 3.5956224312698737e-03 +-1.0721192210732511e-01 -5.0671089087614973e-03 +-1.3699124391898465e-01 2.0436488977253475e-03 +-1.3796073027110367e-01 2.6137443393999149e-02 +-1.4182701117559304e-01 1.3844142209478605e-02 +-1.2944841163997012e-01 -9.2723624757127254e-03 +-9.3213826257326104e-02 1.4284883246972413e-02 +-1.1162659677160036e-01 -1.6234958373061659e-02 +-1.2050548539215811e-01 -1.5924275559513035e-02 +-9.7351068666441165e-02 -8.5553654490269082e-03 +-8.7240939363368852e-02 6.3012066062881900e-03 +-9.0257424271811715e-02 -2.0151148559079957e-03 +-1.0356752966951888e-01 -1.4288984456300113e-02 +-1.4272009238186456e-01 4.2813420353809306e-02 +-1.5679266829087624e-01 -9.0908530492583850e-04 +-1.4214146931378480e-01 -8.4722511173396242e-03 +-1.5242220135017703e-01 2.3374693405493474e-02 +-1.2801274794455253e-01 -2.3300310881083419e-02 +-1.3947307355925886e-01 -1.8516454993147136e-02 +-1.1770357894346262e-01 -2.3145680952524117e-02 +-1.0399156945557309e-01 -2.1346209850662490e-02 +-1.1020164181677217e-01 -2.5487901161767468e-02 +-8.8636914634747654e-02 -1.0191923949648185e-02 +-9.7920297081429908e-02 -1.7869413385611210e-02 +-9.3083328400297205e-02 -1.5181393821293909e-02 +-8.2303352752433057e-02 5.7260624500798940e-04 +-7.8595651480398487e-02 6.0972500132692176e-03 +-8.2430540696719845e-02 -6.0472536884503825e-03 +-1.6547599038801764e-01 3.9755067743996619e-02 +-1.5624682686650715e-01 5.7009695721475850e-02 +-1.4948386157134053e-01 -1.4695597538931793e-02 +-1.7136083874734709e-01 1.7704546843717139e-02 +-1.7678764539743952e-01 1.5890926626553892e-03 +-1.6244531407826912e-01 -2.0533358962580905e-02 +-1.7386981834800963e-01 -1.1403274437626010e-02 +-1.3675006674766621e-01 -2.7830403292085748e-02 +-1.2070394549326124e-01 -3.0958443613570807e-02 +-1.2928073996485523e-01 -3.4244265553979858e-02 +-1.4681459604119595e-01 -2.6030534954387008e-02 +-8.5995612533963595e-02 -1.7600627589843043e-02 +-8.1801164485156619e-02 -1.2117814926426718e-02 +-9.2392800155508326e-02 -2.0807611746761268e-02 +-9.6828023044579936e-02 -2.5327066757895977e-02 +-7.4970819290044233e-02 -3.1685448114870951e-03 +-7.1031912160918864e-02 5.2327553271140914e-03 +-7.7551258177749105e-02 -9.2954186220026713e-03 +-1.0380532834946621e-01 -2.8868934969281668e-02 +-1.1450097957610694e-01 -2.9217973070245762e-02 +-1.0927433470750714e-01 -3.2403801523031461e-02 +-1.5513945074008006e-01 7.9637695423357968e-02 +-1.7710068673011392e-01 6.2489560861237692e-02 +-1.8469891249158366e-01 3.5545277316472834e-02 +-1.9000987313347650e-01 1.1959949138365289e-02 +-1.9190502846748814e-01 -9.4066729262038962e-03 +-1.7937848849048521e-01 -2.4324526378890710e-02 +-1.6702691071819231e-01 -3.6082800460889075e-02 +-1.5435361741234033e-01 -3.6011530622872101e-02 +-2.0190614714620381e-01 7.5168100022118267e-02 +-1.9866182747493610e-01 5.0816964601729353e-02 +-2.2638795915004550e-01 5.0153071558312945e-02 +-2.0665389515454535e-01 2.8885196407379965e-02 +-2.3080135561167481e-01 1.7028440357115926e-02 +-2.6080560941210251e-01 3.1472784187158709e-02 +-4.9826311561392487e+00 6.5680410778382665e+00 +-5.6165993673562156e+00 6.0766922192322497e+00 +-1.0834421449298759e-01 -6.8258703827140721e-02 +-1.1003436269660938e-01 -6.5350913944953959e-02 +-1.0507915070516560e-01 -6.4430683870469352e-02 +-1.1271560987340479e-01 -6.8781346575875091e-02 +-1.0921815502862842e-01 -7.3155325044893971e-02 +-1.1038102475487221e-01 -6.0902117816510781e-02 +-1.0591324362468413e-01 -5.8181273549394064e-02 +-1.0096086190279152e-01 -6.0676119047272437e-02 +-1.1477346568300106e-01 -6.4194673383525469e-02 +-1.1583790107390257e-01 -7.2994167524171871e-02 +-1.1728684086189389e-01 -6.8489002698527202e-02 +-1.1373459561714583e-01 -7.7771553857587605e-02 +-1.1016601637909673e-01 -5.5388478846964517e-02 +-1.1586886749705627e-01 -5.8747962772869755e-02 +-1.0096200280887047e-01 -5.5576896634320860e-02 +-1.0513446088276623e-01 -5.1972662600675790e-02 +-9.6388437009693462e-02 -5.8981393366309476e-02 +-1.2147416516830845e-01 -6.3710864464809447e-02 +-1.2153415405251167e-01 -7.1498007600069968e-02 +-1.2023303442055067e-01 -7.7814252844333964e-02 +-1.1665188311464192e-01 -8.2670320534049324e-02 +-1.1084577097133774e-01 -8.2816393011754030e-02 +-1.1628639796872164e-01 -5.2581394480739618e-02 +-1.1032032921919210e-01 -5.0491943555243779e-02 +-1.2095360886759465e-01 -5.6669852618512095e-02 +-9.6069846207967657e-02 -5.4034393310303130e-02 +-9.9455344363960307e-02 -5.0718790076359710e-02 +-9.5385184397656531e-02 -5.0050844147676798e-02 +-9.1434837661594770e-02 -5.2263787285610874e-02 +-1.0181002206743983e-01 -4.6816691124007548e-02 +-1.0731426771597796e-01 -4.6634564418425839e-02 +-1.2633126580163889e-01 -6.9000868381820624e-02 +-1.2705273091475533e-01 -5.7458789548775258e-02 +-1.2990560356439573e-01 -6.4285957915274139e-02 +-1.2654849979406890e-01 -7.5145815041935293e-02 +-1.2136976670676347e-01 -8.2921435112325526e-02 +-1.2651684469427948e-01 -8.0829698126194671e-02 +-1.1440294651873728e-01 -8.7961315626529313e-02 +-1.1958715882391857e-01 -8.7159654334669767e-02 +-9.7128560987130186e-02 -4.5986103632913000e-02 +-1.1442849516394915e-01 -4.5407897622965265e-02 +-1.2268510820146616e-01 -4.9300835759282791e-02 +-1.0384900206412340e-01 -4.2524433073324985e-02 +-1.0840899862716924e-01 -3.9995768429079703e-02 +-9.9229457179120573e-02 -4.1410555317014541e-02 +-1.8372229436673138e+00 8.3940167310274205e-02 +-1.6268539421291877e+00 2.4146929856449617e-01 +-1.5551638016850120e+00 -6.4262825447656269e-03 +-1.9030334236908999e+00 3.8450700577743646e-01 +-1.7114222582616208e+00 -2.0562917279112014e-01 +-2.1311204396791794e+00 2.0527920292798285e-01 +-2.0712439510646306e+00 -1.0221028760852846e-01 +-1.3806796488976119e+00 1.6108169862404509e-01 +-1.6356471741500798e+00 5.0269645599369994e-01 +-1.4056046802998310e+00 3.6185973098412916e-01 +-1.4528934867356185e+00 -1.9298485862849191e-01 +-1.2902949567793627e+00 -5.2878590132849013e-02 +-2.1676575129823874e+00 5.8833984144327189e-01 +-1.8645683886304738e+00 6.8926966579861926e-01 +-1.9392929541106980e+00 -3.4763551667545300e-01 +-1.4490546117674512e+00 -3.9404634461615728e-01 +-1.6750840588005786e+00 -4.8004108677460522e-01 +-2.4076412476563007e+00 -2.4423204774862484e-02 +-2.4655547284380503e+00 3.7612210174292926e-01 +-2.2341707202280787e+00 -3.4380954828182553e-01 +-1.2378305249684303e+00 2.8857141897491090e-01 +-1.1865398051441503e+00 1.3821667063248100e-01 +-1.6197362849725039e+00 7.1559581983784426e-01 +-1.2154672862535421e+00 -3.1323276057926819e-01 +-1.1243112868348959e+00 -1.9794135083373021e-04 +-1.0798144356310928e+00 -1.6452877774281660e-01 +-2.1187977908845710e+00 9.9024748505232196e-01 +-1.7425381451024009e+00 9.5423138668711260e-01 +-2.5349351513911813e+00 8.4634973357211152e-01 +-1.9797413449618233e+00 -6.2972067481864258e-01 +-1.3850392255610018e+00 -6.5061192668203205e-01 +-1.2441492249170523e+00 -4.9718929550728319e-01 +-1.6337497414004218e+00 -7.7527183888774687e-01 +-2.7077625331090900e+00 -3.4345309583119388e-01 +-2.7922812703191084e+00 1.2889193467403004e-01 +-2.3994216879429331e+00 -7.1112029315068526e-01 +-2.9314900288082839e+00 6.3136753200752338e-01 +-2.5946508860764226e+00 1.3687120167858424e+00 +-1.8765922930818704e+00 1.2059717289075991e+00 +-2.1242703556940086e+00 1.4008565012849346e+00 +-2.9958052745688235e+00 1.0753272511834311e+00 +-1.0937446559828174e+00 2.7753580831013380e-01 +-1.0410180867674370e+00 1.2069682639449297e-01 +-9.7362037723149797e-01 -3.2454227119453094e-01 +-1.0674310198182582e+00 -4.6893701370447616e-01 +-9.7300181263157981e-01 -1.7076035323398742e-02 +-9.2406913530975032e-01 -1.7139742032853178e-01 +-1.8599939925567952e+00 -9.7323548115849690e-01 +-2.1740743706489241e+00 -9.2795404955784022e-01 +-1.0968483718455815e+00 -6.5361478624687663e-01 +-1.4140259460330640e+00 -8.8438339461769999e-01 +-1.1823626241628773e+00 -8.6973674012381252e-01 +-1.5764889238570277e+00 -1.0538825036280031e+00 +-3.0978417143343080e+00 -1.1331462457491170e-01 +-2.7703576042988658e+00 -8.1477939380117448e-01 +-3.2456930063310239e+00 -6.2895915503018784e-01 +-3.3027733816550011e+00 3.1271052750349071e-01 +-2.5232079735378790e+00 -1.1224204527646009e+00 +-3.5289929711455699e+00 8.8193441708038023e-01 +-3.3017053850342819e+00 1.5529411438629097e+00 +-9.3448486891338689e-01 1.0847174595774334e-01 +-9.1965041133688885e-01 -4.6607689968234922e-01 +-8.2241820575080737e-01 -2.7390261305005481e-01 +-7.9507615325684355e-01 -4.2556068760208632e-01 +-9.5485044732498636e-01 -5.5896606901654877e-01 +-8.5605169630169087e-01 -4.8178064835312284e-02 +-8.5150493938598970e-01 5.7574450604036542e-02 +-7.5982482459500034e-01 -1.3752710886119246e-01 +-5.6501056606154521e-01 2.5196922256043308e-01 +-6.5337282714271794e-01 1.8305770694525592e-01 +-7.6150778209127168e-01 1.2304012183635393e-01 +-8.4969524081525094e-01 1.6812125610701401e-01 +-5.4792953898478913e-01 1.6906479235967709e-01 +-6.6254209289729715e-01 6.0056925362374614e-02 +-5.9646107518538827e-01 1.0543693169259427e-01 +-7.6356105508591554e-01 2.7119326339786198e-03 +-5.2979125893439516e-01 7.6283304512109851e-02 +-4.2280603808427486e-01 1.0063178634052150e-01 +-4.5716448567172563e-01 6.4440513458805526e-02 +-6.2610642591263854e+00 6.1068749536716780e+00 +-6.0850701671052292e+00 5.5866455274962163e+00 +-6.0861716608830108e+00 4.9373382335501645e+00 +-5.6525687379551783e+00 5.4647724271054301e+00 +-7.9594105390054466e+00 1.7872932208964230e+00 +-8.5940254033554879e+00 1.4604139809694061e+00 +-7.3039734615431229e+00 2.0672161978433508e+00 +-9.1871139414264746e+00 9.9612127805360018e-01 +-8.0337426400498941e+00 1.2272826097424669e+00 +-7.4142007938677921e+00 1.3166931505735917e+00 +-8.4534763932847454e+00 5.5531350185772510e-01 +-6.7153829868259152e+00 2.2463939523028387e+00 +-6.4251193761788841e+00 3.3762770811742087e+00 +-6.4247556848063567e+00 2.7138451763265081e+00 +-6.6837844841833771e+00 1.6197690697626044e+00 +-6.2972129497264575e+00 4.1416081152543072e+00 +-5.7564826794750417e+00 2.9753807644985812e+00 +-5.5827959525060749e+00 3.7468268558651943e+00 +-5.9767548370439698e+00 2.1602756317587080e+00 +-7.7550684496782338e+00 7.5620577218103335e-01 +-6.6578797971577757e+00 8.7637362776141714e-01 +-7.2616500083313014e+00 6.1628636257445635e-01 +-1.0411219860339344e+01 1.0544417097229015e+00 +-9.9089323385558146e+00 6.9481170611658882e-01 +-1.1209279874397836e+01 1.1816001181286140e+00 +-9.3638733165291512e+00 9.9094253342826732e-02 +-7.5763439352044770e+00 -1.4498199362705577e-02 +-8.7641403750423166e+00 -2.8972293930041815e-01 +-8.1700888852530511e+00 -3.2225328987581747e-01 +-5.6553601646946987e+00 4.4642919024353915e+00 +-5.9514245630961398e+00 1.2546698511728778e+00 +-6.7601194212302289e+00 1.0686612010361074e-01 +-5.8760995122377722e+00 3.4395721238136190e-01 +-5.1537127357119630e+00 2.4781728983647469e+00 +-5.2870304880006955e+00 1.6710445119370974e+00 +-1.0646588576972434e+01 4.8537394886051288e-01 +-1.0173077236135526e+01 5.6289288842926055e-02 +-9.2955972238754612e+00 -7.9555198982234288e-01 +-1.0068431933035555e+01 -5.1716875016670372e-01 +-8.5243308634374131e+00 -1.0166025046057570e+00 +-7.7045030417937568e+00 -8.3212573278061086e-01 +-6.7844852016046246e+00 -7.7105030977750744e-01 +-9.2898363255430780e+00 -1.5010994860446374e+00 +-3.8149470835052881e+00 3.8727662398694918e-01 +-4.2076163866330489e+00 9.1490056915333184e-03 +-4.3160854335786070e+00 7.0485751519164808e-01 +-3.5904853359699302e+00 -1.0583023297523653e-01 +-4.9532146257755159e+00 1.8348926400771859e-01 +-3.9550375841739793e+00 -5.6875146438275692e-01 +-4.6754529363573454e+00 -5.3504035278179174e-01 +-3.9613893122357240e+00 1.3130447286926028e+00 +-5.1743184737849361e+00 9.1338277541746038e-01 +-4.5800308483997014e+00 1.4105506798800533e+00 +-5.4408882906670328e+00 -4.2450987423981701e-01 +-4.3683726429298702e+00 -1.2817730941280274e+00 +-3.6968342340013294e+00 -1.0644938816720639e+00 +-5.1275880879646252e+00 -1.1278459536395076e+00 +-4.0869984307943810e+00 1.9036366077685045e+00 +-4.6887576062979406e+00 2.0354264967354752e+00 +-3.0854895169570256e+00 -1.3382046307509654e+00 +-6.1649403329195280e+00 -3.4021613384686589e-01 +-5.8810759404450437e+00 -9.7355963070974383e-01 +-3.7835959565823458e+00 -1.6580349811899850e+00 +-4.9357532546776213e+00 -1.8774621337145874e+00 +-4.3472518227242176e+00 -1.9649852588648429e+00 +-5.6758575986447966e+00 -1.6840728571415156e+00 +-3.3680057970068731e+00 -1.9544153853227044e+00 +-2.5696930286319457e+00 -1.6226941326721089e+00 +-2.9648009252083938e+00 -1.9277652706735324e+00 +-6.4674222022076293e+00 -1.4392102789607293e+00 +-7.2053484412413411e+00 -1.3642457186945194e+00 +-5.5122729818416047e+00 -2.4329799760870685e+00 +-6.2128662877538972e+00 -2.1468521596717665e+00 +-4.7380121037302132e+00 -2.7638669317649374e+00 +-7.1205293626526043e+00 -2.0488208076858996e+00 +-3.8617500782630998e+00 -2.4671707424638925e+00 +-1.3141773270097445e+00 -1.0870126394980986e+00 +-1.4862132966156594e+00 -1.3709290461421659e+00 +-1.7775772321240311e+00 -1.2364774489746679e+00 +-1.1709596332816119e+00 -1.3167422972150433e+00 +-1.0282770931288781e+00 -1.0473506014606073e+00 +-1.8285328173439552e+00 -1.5362439398141277e+00 +-1.2564052346187680e+00 -1.7004303534793053e+00 +-1.5854025269299967e+00 -1.7062766839937780e+00 +-2.1402116327475937e+00 -1.3197702166547600e+00 +-9.1940330305040163e-01 -8.1832610357915314e-01 +-1.8267541873416633e+00 -1.8600664912351021e+00 +-2.2011706017152477e+00 -1.7978090006415641e+00 +-1.5291070987298809e+00 -2.0637135892981746e+00 +-1.0866918965936776e+00 -2.1797371707499877e+00 +-9.0602335166497028e-01 -6.5389226599405958e-01 +-7.3629189284442020e-01 -8.2847590085712852e-01 +-7.4601554848081264e-01 -6.8370115149700439e-01 +-1.9930149161842792e+00 -2.2264273040361218e+00 +-2.5965002131698185e+00 -2.2863605611328239e+00 +-1.5626059793361833e+00 -2.5964152082324716e+00 +-9.6636289455787505e-01 -2.6338870625934732e+00 +-8.2625215544537411e-01 -5.5478409985344967e-01 +-6.1215502446590619e-01 -7.6001475306510713e-01 +-5.9384817363925890e-01 -6.3787713643537813e-01 +-6.9324597579402791e-01 -5.4462260029310983e-01 +-6.3402777450392733e+00 -6.5335375461677216e+00 +-5.7106900739950817e+00 -6.2949717236507325e+00 +-6.0367653489610831e+00 -5.7030188425501649e+00 +-6.6519368117355100e+00 -5.1104151111768203e+00 +-9.2468991209238567e+00 -2.2399232688926105e+00 +-9.1464857484461248e+00 -2.8587482984012382e+00 +-8.6005453924176862e+00 -1.8303184289370762e+00 +-8.6597927159446328e+00 -3.2382366269272751e+00 +-8.6251132563669017e+00 -2.5490011779862556e+00 +-7.9682488104380553e+00 -2.2790551263053658e+00 +-8.0927860496571640e+00 -2.8212533583551647e+00 +-7.8539176519967953e+00 -1.5618613865015476e+00 +-7.9271533732481743e+00 -3.5182184725655077e+00 +-7.2183317715828537e+00 -4.6135282596674756e+00 +-7.0701591046321823e+00 -3.6693099185714999e+00 +-6.4495571186465810e+00 -4.3112729408552184e+00 +-7.4569511051564064e+00 -2.8059111268631938e+00 +-6.2334270726876468e+00 -3.5008840471150933e+00 +-6.6863082648424239e+00 -2.8074296230633422e+00 +-5.8728948690283289e+00 -4.8599575007542768e+00 +-5.6505930822131205e+00 -4.1135428078462724e+00 +-6.0868942168850424e+00 -2.8031316519399780e+00 +-5.5362800490731985e+00 -3.2584563460347340e+00 +-4.9705147925785838e+00 -4.7314870876013515e+00 +-5.3931162316938668e+00 -5.3578639145353861e+00 +-4.9004961017533617e+00 -3.8130278222326979e+00 +-5.3952220788341947e+00 -5.8420989602242486e+00 +-4.1632979971450084e+00 -3.4301983240410721e+00 +-3.4558612289533244e+00 -3.1745462543786545e+00 +-3.0269440988259504e+00 -3.6847044823582422e+00 +-1.2277594030109782e+00 -3.1094256327667722e+00 +-1.8256586670433279e+00 -3.2251616095171158e+00 +-2.3894922882887641e+00 -3.3870539775387982e+00 +-6.4644589567279809e-01 -2.6041461644221613e+00 +-4.8912303842983818e-01 -7.0423708184048905e-01 +-5.6267670097243183e-01 -5.3266362880506790e-01 +-6.3560712296930433e-01 -4.3314889756561570e-01 +-4.9373201846347570e-01 -6.0158332191758745e-01 +-7.2009637430586793e-01 -3.4437837912348357e-01 +-3.9591471341637430e-01 -6.2141146337296504e-01 +-4.5040447928086280e-01 -5.1416099708622198e-01 +-5.2567310934639977e-01 -4.6087079503210759e-01 +-6.3205743278156490e-01 -3.3047864917396907e-01 +-5.4744789627780222e-01 -3.8219027004463157e-01 +-2.2419514168128671e+00 -2.7541989736764378e+00 +-2.8325954333727594e+00 -2.9600013864864678e+00 +-3.2043160702763345e+00 -2.4371516434890736e+00 + 2.7474191754238575e-01 -4.3775528993307944e-01 + 2.6739537633562804e-01 -3.9068599187298503e-01 + 3.0673154530770574e-01 -4.1076310690549178e-01 + 2.1464244370643826e-01 -4.0977863806045889e-01 + 3.2876738337143507e-01 -4.4436035937209795e-01 + 2.3166502324314564e-01 -4.7398966293189915e-01 + 2.9639318270820070e-01 -4.9058438370168744e-01 + 3.0877437147984921e-01 -3.6925154084120493e-01 + 2.3043077121206323e-01 -3.5566243312494805e-01 + 2.7559863429650733e-01 -3.5217476432828221e-01 + 3.4933816421294495e-01 -3.9673603022342263e-01 + 1.8110007474273004e-01 -4.4510870724384688e-01 + 1.8842249418030832e-01 -3.6736121164165070e-01 + 1.5662794475299080e-01 -3.9700080324321618e-01 + 3.5964143320411779e-01 -4.8628965911437660e-01 + 3.7239744284750742e-01 -4.3794130964251110e-01 + 2.6114009203665489e-01 -5.4287938624625554e-01 + 1.8054748775372786e-01 -5.1629456186093137e-01 + 3.4125756988577649e-01 -5.4851727279128681e-01 + 3.0633836650974899e-01 -3.1629829722444924e-01 + 3.4724414221658151e-01 -3.4885105449268394e-01 + 2.6439161038003078e-01 -3.1958249667127347e-01 + 1.8966657814332422e-01 -3.2958550588311653e-01 + 2.2736469469666787e-01 -3.0689189052428389e-01 + 4.0699793183797794e-01 -4.0092099464922626e-01 + 3.8059669069445334e-01 -3.6688531451997619e-01 + 1.3337183942638831e-01 -4.5348170247578423e-01 + 1.5074473308672509e-01 -3.4477867789648542e-01 + 1.0830421367061405e-01 -4.0847188056912387e-01 + 1.0670072179995316e-01 -3.5898669011027096e-01 + 4.1007876761022288e-01 -4.5813801244904084e-01 + 4.1004830211468146e-01 -5.2479811850862745e-01 + 2.0758357846259656e-01 -6.0364815114701287e-01 + 1.0222372317749517e-01 -5.0879565271792160e-01 + 1.2660193417553955e-01 -5.8404573251027614e-01 + 4.0589942421028269e-01 -6.1389221843616326e-01 + 3.4312816278914937e-01 -3.1054317530106346e-01 + 2.7951085422277089e-01 -2.8413063505072955e-01 + 3.3233283845942196e-01 -2.8184416225448672e-01 + 3.0489542381972257e-01 -2.6954809319136075e-01 + 3.8150140237943475e-01 -3.2588830190873352e-01 + 2.5296484408256248e-01 -2.8919619509275662e-01 + 1.9293449942435359e-01 -2.9838287263599739e-01 + 1.5374922604095786e-01 -3.0164060995838327e-01 + 2.3716794085244430e-01 -2.7734050577448954e-01 + 2.1310542243354291e-01 -2.7634309098522181e-01 + 4.1628738410160082e-01 -3.5062796680001895e-01 + 4.5943153971354889e-01 -4.2763042003987550e-01 + 4.5509774403672765e-01 -3.7679475527161799e-01 + 6.6681454817967278e-02 -4.4148450978289588e-01 + 1.1750466333769793e-01 -3.1683024630747525e-01 + 7.2810941906134019e-02 -3.9040320037739207e-01 + 5.5870295371335033e-02 -3.5211394452711886e-01 + 8.6966072668445804e-02 -3.2396249704918034e-01 + 4.7028084295305916e-01 -4.8907070141980569e-01 + 4.7691168268958961e-01 -5.6010090757973785e-01 + 4.4285167923656132e-01 -7.1227443857171124e-01 + 4.9322363705995542e-01 -6.4379115526165265e-01 + 5.5477853431590063e-02 -5.6934843031953619e-01 + 7.7227502183575325e-02 -6.3162563625265022e-01 + 3.2972967870705361e-02 -4.9949752572344153e-01 + 3.6329842223502595e-01 -2.8808052744096813e-01 + 2.8368013301908945e-01 -2.5162597453224578e-01 + 2.5680487629440307e-01 -2.6117035136752520e-01 + 3.2566347239370685e-01 -2.4842587407773919e-01 + 3.5067318300917805e-01 -2.5816900629126849e-01 + 3.0438045412746106e-01 -2.3724997557121696e-01 + 4.1582259453746673e-01 -3.1691413253737721e-01 + 3.9636152107919287e-01 -2.9143431131362263e-01 + 1.7923192473377014e-01 -2.7408822346899342e-01 + 2.2985310777161772e-01 -2.5316522741979952e-01 + 1.9895130530868954e-01 -2.4699490039687078e-01 + 1.2056591501102076e-01 -2.8054638393122389e-01 + 1.4914382919653946e-01 -2.7223792248391021e-01 + 4.5745121768457864e-01 -3.2142744524357170e-01 + 4.9775923354179241e-01 -3.9803675257076065e-01 + 4.9408939657447348e-01 -3.5203266126092103e-01 + 5.1352600441433083e-01 -4.4817717559904224e-01 + 2.4788744953867337e-01 -1.4600724539455712e-01 + 2.3844543200792145e-01 -1.6803767672932679e-01 + 2.2645858740516189e-01 -1.5604391299666531e-01 + 2.5283533754277698e-01 -1.6768983355282785e-01 + 2.6747568422373291e-01 -1.6097055690545403e-01 + 2.6861990626245813e-01 -1.3916969388701261e-01 + 2.2157694705374809e-01 -1.8096336764398302e-01 + 2.4508456066762818e-01 -1.8807367729563396e-01 + 2.0627623818047880e-01 -1.6325509200488852e-01 + 2.1111931347185475e-01 -1.3825058580705729e-01 + 2.6333913725986235e-01 -1.7935144134668235e-01 + 2.8223901558782671e-01 -1.7573732603116810e-01 + 2.8254039816658860e-01 -1.5595029354184931e-01 + 2.2495405848783889e-01 -2.0558602416716099e-01 + 1.9652641368608670e-01 -1.8589315658427097e-01 + 2.0815202574035396e-01 -2.0046544001641564e-01 + 2.7101074654741808e-01 -1.9924733259531990e-01 + 2.4499188702842645e-01 -2.1133808192426784e-01 + 1.9230818907699643e-01 -1.5074243413194210e-01 + 1.8966797838898941e-01 -1.6763709486536982e-01 + 2.9399495821279231e-01 -1.9275383880537333e-01 + 1.7499646861409701e-01 -1.5933739959565685e-01 + 1.7845903474295710e-01 -1.4296974144704677e-01 + 1.9024033717866473e-01 -2.0856050992318842e-01 + 1.7362744480979586e-01 -1.7704996498865455e-01 + 1.7292528500973248e-01 -1.9635048696002855e-01 + 2.0566083138775326e-01 -2.2140489152127429e-01 + 2.2435051574669274e-01 -2.2855001157341803e-01 + 1.6114726103977262e-01 -1.4583290006626726e-01 + 1.5359855534644851e-01 -1.6723236488131477e-01 + 1.8950829407553726e-01 -1.3070434799776365e-01 + 2.6271174820217169e-01 -2.2155084830703231e-01 + 2.9900263019674611e-01 -2.1220858605224180e-01 + 2.8171351459464944e-01 -2.2595720551734644e-01 + 2.4796529241415044e-01 -2.3441668878557209e-01 + 2.9084974091432514e-01 -9.9542025734422168e-02 + 3.0361493840815257e-01 -1.1068713945894615e-01 + 2.9029710610628001e-01 -1.0967223301872764e-01 + 3.2513364991305593e-01 -2.2221609897746930e-01 + 3.4782866142074198e-01 -2.3340060029291010e-01 + 2.6649196169823597e-01 -2.3831723291704066e-01 + 3.6370349000343083e-01 -2.2306340577695494e-01 + 3.6710062037622038e-01 -2.4203202089746867e-01 + 3.8216755266354596e-01 -2.2522980451540775e-01 + 3.7832700150743648e-01 -2.6289056713949321e-01 + 3.8888866450725601e-01 -2.4380945115586883e-01 + 4.0540737030428176e-01 -2.6053552872791386e-01 + 4.3124304496249977e-01 -2.8210497346159968e-01 + 4.0751576977493187e-01 -2.3129299707919415e-01 + 4.3130718872547646e-01 -2.4976064140284393e-01 + 4.6292493795309753e-01 -2.8179469899251330e-01 + 4.5421939105804654e-01 -2.6119502148361562e-01 + 4.8865168198464914e-01 -2.9166943975018000e-01 + 4.9549295732595056e-01 -3.1948093387421750e-01 +-2.0768658085572156e-02 -1.3331738634957446e-01 +-1.9822335030056593e-02 -1.3819254009212045e-01 +-2.4887360266831138e-02 -1.3662823035714666e-01 +-2.6236230748111211e-02 -1.3297664737720538e-01 +-2.3464466180627142e-02 -1.4103188660678256e-01 +-1.9314669286075059e-02 -1.4255737184883799e-01 +-1.5779314055052396e-02 -1.4022216300902812e-01 +-2.8347843192250366e-02 -1.3562810313615614e-01 +-2.8565279847242664e-02 -1.3911945413477156e-01 +-3.0037250869540344e-02 -1.3289660958579930e-01 +-2.8606451291551593e-02 -1.2967984240266617e-01 +-2.2216737587669400e-02 -1.4661064085923670e-01 +-2.7239913976060848e-02 -1.4390392513749362e-01 +-1.5140672960555435e-02 -1.4578180357048609e-01 +-1.0497825332379307e-02 -1.4029967704428259e-01 +-3.1728100268466619e-02 -1.3587256069254749e-01 +-3.1002673224108435e-02 -1.4191504883112316e-01 +-3.3286601822396733e-02 -1.3885642418190969e-01 +-3.2043281323566930e-02 -1.3048643068688648e-01 +-3.3464371320093278e-02 -1.3338608119326523e-01 +-3.1353384845388632e-02 -1.2797096000240060e-01 +-2.9823231852844856e-02 -1.2708285342206693e-01 +-2.6718224147813885e-02 -1.4790918081718019e-01 +-1.8227200780444264e-02 -1.5199682449897978e-01 +-2.4810331455981327e-02 -1.5193767500163347e-01 +-3.1310268785560424e-02 -1.4603190961804557e-01 +-8.2804785288885796e-03 -1.4605400544699876e-01 +-1.1857470036872542e-02 -1.5240295955078409e-01 +-3.9124356144100148e-03 -1.4037813085556650e-01 +-6.2212472506786298e-03 -1.3488108466204096e-01 +-3.5047494604484086e-02 -1.3607400049424712e-01 +-3.4768410143740880e-02 -1.4226271591832074e-01 +-3.6818568670895502e-02 -1.3877042166268438e-01 +-3.5008066129250892e-02 -1.3104639556671316e-01 +-3.2765740531303322e-02 -1.2854307505683948e-01 +-3.4198197076875658e-02 -1.2856306981494470e-01 +-3.6478621193964500e-02 -1.3335701043727965e-01 +-3.8410208346277841e-03 -1.5411878406764856e-01 +-2.7700230783551660e-03 -1.4599820632710703e-01 +-1.5656380933407377e-02 -1.5846114797668065e-01 +-2.2659104333456526e-02 -1.5802342325321206e-01 +-1.0180716150202329e-02 -1.5838644982726180e-01 + 1.0622863820515249e-03 -1.3525136573751695e-01 + 1.4363092379880982e-03 -1.4237249666204832e-01 +-2.1485397370639703e-03 -1.2868359417959141e-01 +-2.9079132353501791e-02 -1.5070084736939293e-01 +-2.9961589533016308e-02 -1.5638513321184178e-01 +-3.7335955754002725e-02 -1.4617443891243909e-01 +-3.3695359409776415e-02 -1.5063827995693657e-01 +-5.9644584221842933e-03 -1.6367651738801214e-01 +-1.3236304321665671e-02 -1.6429402140271065e-01 +-1.0023341128174934e-02 -1.7043362688225727e-01 +-1.6991412682045848e-03 -1.7250998290157327e-01 + 2.3925739802876933e-03 -1.6185006379575384e-01 +-2.0126407571524396e-02 -1.7067040840666436e-01 +-1.9650307347362173e-02 -1.6302137613472212e-01 +-1.1937691406799900e-02 -1.7926278179129440e-01 + 5.3172696554781851e-03 -1.5369856350639566e-01 + 1.3068917138667757e-03 -1.4879609063163457e-01 + 7.5878373667066512e-03 -1.6890260707810967e-01 +-1.0063285566275226e-03 -1.8647259278122874e-01 + 8.4345060822528239e-03 -1.7881072590263614e-01 + 1.2808243808983377e-02 -1.5984311274998220e-01 + 7.0290554605563216e-03 -1.4614219413155638e-01 + 1.2207873803724567e-02 -1.5144113566186945e-01 +-2.6573339576728472e-02 -1.6365787963432865e-01 +-2.5071738151325462e-02 -1.8105764438905680e-01 +-3.0857741387833926e-02 -1.7075423800280021e-01 +-1.3466738610560469e-02 -1.9147949643632955e-01 + 1.6003004230178419e-02 -1.7149915004065974e-01 + 1.0526577101266810e-02 -1.9237017825189184e-01 + 2.0238470048781210e-02 -1.8327466903362222e-01 + 5.3466870839002922e-04 -2.0301828970659130e-01 + 1.9305845992938941e-02 -1.5224466199319409e-01 + 2.2759225608815825e-02 -1.6167891455070560e-01 + 1.5998308331404587e-02 -1.4258217695979170e-01 + 8.1006594305463864e-03 -1.3745413357727898e-01 + 2.7632836880869149e-02 -1.7362762303842771e-01 +-3.5165474642468553e-02 -1.6275259543007792e-01 +-3.6045007850589172e-02 -1.7722762894368316e-01 +-2.6878549989206135e-02 -1.9362696259824475e-01 +-3.4144819515972813e-02 -1.8635313018462796e-01 +-3.8043189394755927e-02 -1.6965226593221416e-01 +-1.6440792267800930e-02 -2.0543870735164660e-01 + 2.3174226319945035e-02 -1.9447288597734769e-01 + 3.5706354171367138e-02 -1.8728451526921219e-01 + 1.7398396571245200e-02 -2.0496467857269351e-01 + 2.8225129958038053e-02 -1.5270560376283981e-01 + 3.4130805112241092e-02 -1.6313575189792573e-01 + 2.4304477296787752e-02 -1.4534613543779074e-01 + 4.0075195275939279e-02 -1.7419143481527044e-01 +-9.3709191173587669e-03 -2.2087999877101083e-01 + 8.8771804272056443e-03 -2.2065341172061892e-01 + 1.5302587467580508e-02 -1.3442651437959796e-01 + 2.3976097599664570e-02 -1.3664339669827541e-01 + 8.0228593464113374e-03 -1.2770036154262243e-01 +-3.6885136156968201e-02 -1.5586021956777074e-01 +-4.2476131462478861e-02 -1.6491914185297674e-01 +-4.0555295490975141e-02 -1.5945042716030855e-01 +-4.3390843149211378e-02 -1.8275278417561935e-01 +-4.4761715504520794e-02 -1.7279571097779467e-01 +-4.1907713830426019e-02 -1.9591911951843599e-01 +-2.9849996187152783e-02 -2.0479188054324027e-01 +-3.6614003371227000e-02 -1.2820707660375774e-01 +-3.7881643394641173e-02 -1.3091059362048441e-01 +-3.8488807622925947e-02 -1.3586936615274681e-01 +-3.8981344092377412e-02 -1.3285562559617858e-01 +-7.0150390791967254e-01 -2.5170763123526285e-01 +-6.6359119324063442e-01 -1.8058297628807907e-01 +-6.7841882089729211e-01 -4.8626885773884965e-02 +-6.5516553340302153e-01 -1.2143979502211266e-01 +-6.1103541684421714e-01 -2.4337606091482655e-01 + 9.3136937437318466e+00 -2.3974578830223692e+00 + 1.0122944723503423e+01 -2.2617478879208619e+00 + 1.0666860203963132e+01 -2.6908857200593275e+00 + 8.9101319872785680e+00 -1.9308120068962609e+00 + 8.5091828194361057e+00 -1.5566028601899120e+00 + 9.5156085764910969e+00 -1.5378711401892957e+00 + 1.1402955513656096e+01 -2.7071495658191225e+00 + 1.0909745154550578e+01 -2.1634374845138495e+00 + 1.0410596037166513e+01 -1.7101175756807834e+00 + 7.9464694469462671e+00 -9.8100945577898813e-01 + 8.7782240651019663e+00 -7.4483644326392096e-01 + 1.0445604812276542e+01 -9.8295792423233763e-01 + 9.6344904234340163e+00 -7.1843654030783455e-01 +-1.3017628910148488e+01 2.4056543487996151e+00 + 1.2614748563622136e+01 1.6308017106433468e+00 + 1.1620258942186048e+01 -2.1534669346358584e+00 + 1.2000759017317066e+01 -1.7514957214189764e+00 + 1.1307643730215759e+01 -1.5178022617672298e+00 + 1.2120516993954176e+01 -9.1566297330442126e-01 + 1.1218622246077089e+01 -6.4988294852231832e-01 + 1.2954536292094510e+01 -1.0233906680615945e+00 + 1.1671710277401601e+01 -2.2896526218347901e-01 + 1.2857525398191271e+01 -4.8784008252359001e-01 + 1.2353484172359913e+01 1.6517916708295388e-01 + 1.0688564304588589e+01 -2.4098187436690921e-01 + 1.1137099733944360e+01 -8.5932407437496749e-03 + 1.0083816884545350e+01 -1.2597338220389531e-01 + 1.1531671470361402e+01 4.8670681807200822e-01 + 1.3207145867529299e+01 1.5616256327257361e-01 + 1.2847940431795301e+01 8.8562954689732010e-01 + 1.2094742214436636e+01 9.8202823992394173e-01 + 1.0557677846099608e+01 5.6249812386771936e-01 + 9.3098871708048208e+00 -1.0408004319293696e-01 + 9.6765072699281660e+00 5.1542518137914328e-01 + 1.3496730006931024e+01 7.7827334811444615e-01 + 1.1358521412434236e+01 1.1306224152171325e+00 + 8.0901879124684584e+00 -2.3060966201715871e-01 + 8.7031391720342697e+00 -4.8974469817153476e-03 + 8.9476657107320321e+00 5.9176188258483364e-01 + 8.1580270227183433e+00 4.8397740196260486e-01 + 1.0680300680904132e+01 1.3874369013514496e+00 + 9.9952885714934894e+00 1.2700629704859949e+00 + 9.2667598228035928e+00 1.2373884595803446e+00 + 9.7085933163026255e+00 2.0656886973045587e+00 +-1.0812877526689135e-03 3.0486181640682730e-02 + 4.4859176356126795e-03 3.2454561915372437e-02 +-4.2675374510849906e-03 3.4261639166942359e-02 + 7.5519041188698566e-04 3.4834988337316020e-02 + 3.9142585227622817e-03 3.8580284640509888e-02 + 1.0173560616053123e-02 3.6130281520385665e-02 + 1.0086843379376376e-02 2.7721192064674938e-02 +-9.0735196282423658e-02 -5.2152011583783064e-01 +-1.2916750458506954e-01 -6.0016444281164638e-01 +-1.7974185190908543e-01 -5.4997580955492253e-01 +-6.3247323638989883e-02 -5.9082944044386920e-01 +-1.5241547539322653e-01 -4.8450329546054149e-01 +-1.5242310362893363e-02 -5.4894417277269270e-01 +-1.1821118687174703e-01 -4.5520014156629429e-01 +-2.3154688518687294e-02 -4.9002026519994502e-01 +-6.4594882185303959e-02 -4.4456632191969447e-01 +-1.8984736015343628e-01 -6.5160475092419290e-01 +-9.3709683149171497e-02 -6.6124196415906056e-01 +-2.0071164366025585e-01 -4.8445057731159125e-01 +-2.4166000332957083e-01 -5.9453994300918112e-01 +-2.5730561152461462e-01 -5.1530151124796930e-01 +-4.5077507593305199e-04 -6.3070015818179570e-01 +-1.7696074436275921e-01 -4.2782792174428153e-01 +-1.2128280481900333e-01 -4.1038005928774623e-01 +-2.5073933952484140e-03 -4.3640435754210216e-01 +-8.2947594187515961e-02 -3.8665068726565721e-01 +-4.1053156463519258e-02 -3.9617700645392517e-01 +-2.9382808174482022e-01 -6.5982289894043333e-01 +-2.3713453511156501e-01 -4.4464434855025559e-01 +-3.0729164226541172e-01 -5.8086849391960982e-01 +-3.0976000846207796e-01 -4.5415363939440567e-01 +-3.4975116921543759e-01 -5.2434692115839709e-01 +-1.5843335467663167e-01 -3.8393814388820147e-01 +-2.2906313334671324e-01 -3.9986453512027254e-01 +-2.0457712857970023e-01 -3.6494980743970018e-01 +-1.2404156515846410e-01 -3.5973421666611216e-01 +-5.1407746369562801e-03 -3.9000258409731714e-01 + 3.2236714964660962e-02 -3.9365099776958346e-01 +-5.9823085829691536e-02 -3.5427704883835531e-01 +-2.6345309933205385e-02 -3.5908452222156484e-01 +-9.0009433535627181e-02 -3.4861464990187585e-01 +-2.7651064895601962e-01 -4.0435772137297477e-01 +-3.8783971104257375e-01 -4.5338780727294647e-01 +-3.3661398919043961e-01 -4.0075032510979725e-01 +-1.6412121935265134e-01 -3.4326415654859943e-01 +-2.4907388252641738e-01 -3.6466221382738695e-01 +-2.2913753527839731e-01 -3.2999242560688913e-01 +-1.9445832106087835e-01 -3.1922860872853676e-01 + 1.2769972367976834e-02 -3.5908530170381425e-01 +-1.0987261727228770e-01 -3.2111992362857222e-01 +-1.3940119463298117e-01 -3.2020888341169496e-01 +-3.6838171413549503e-02 -3.2721215709611329e-01 +-7.1221752717164577e-02 -3.1984077532004562e-01 +-5.4080346911291599e-03 -3.3087682650716488e-01 +-2.9741834509894716e-01 -3.6207126623584429e-01 +-4.0043739884049501e-01 -3.7887529884805815e-01 +-4.6351370784181256e-01 -4.1632177943087356e-01 +-3.4738713370477114e-01 -3.4340143827557768e-01 + 1.9666410563206469e+00 -2.3567042782048020e-01 + 2.1077296066775943e+00 -1.9049010696345192e-01 + 1.8347662569073577e+00 -2.1566287063342315e-01 + 1.9390766674841586e+00 -1.2760995757278693e-01 + 1.7293104721143209e+00 -2.7940914584715415e-01 + 1.8180051877511900e+00 -9.6073621766990414e-02 + 1.7332123374072665e+00 -1.6169435907150387e-01 + 1.8947862988586337e+00 -2.6052996349861246e-02 + 1.6227001429563330e+00 -3.0640037256003438e-01 + 1.6580181497205757e+00 -2.1220451677072560e-01 + 1.7200033048049477e+00 -6.1272509315088541e-02 + 1.6535926336904225e+00 -1.2118684616717701e-01 + 1.5329968430546259e+00 -3.3474669126924539e-01 + 1.5930913433646339e+00 -2.3831692687556938e-01 + 1.5527264387132362e+00 -2.7714554770511768e-01 + 1.5911088315360402e+00 -1.6510300426483582e-01 + 1.6425732412003242e+00 -4.7892702241384200e-02 + 1.5818887304567113e+00 -8.0101739161293040e-02 + 1.5126209129731905e+00 -4.3154465547601717e-02 + 1.5244711418496806e+00 -1.3413772653062495e-01 + 1.5283536175756893e+00 -2.1835234933678294e-01 + 1.4756438719490177e+00 -9.0226935265661723e-02 + 1.4557649527242802e+00 7.9673715631187747e-03 + 1.4477686309796809e+00 -4.4361302966336780e-02 + 1.4726854707608581e+00 -1.8621594714997514e-01 + 1.4601108337539443e+00 -1.3617045826916296e-01 + 1.4645432591658505e+00 -2.3746790982661992e-01 + 1.4942268233214051e+00 -2.8347529820372586e-01 + 1.4267141696128718e+00 -9.2501482899450593e-02 + 1.3994247273714109e+00 -2.9333669578335275e-03 + 1.4067556696887493e+00 3.8609013837671569e-02 + 1.4054696847000656e+00 -4.7372193813018271e-02 + 1.4244251223167268e+00 -1.7521327046065949e-01 + 1.4090120501944767e+00 -1.3755784308078489e-01 + 1.4329966509917682e+00 -2.0962818534032124e-01 + 1.3708307980813075e+00 -6.9675015349844216e-02 + 1.3821530388984584e+00 -1.1247311237420377e-01 + 1.3633065860739393e+00 3.9199129284547496e-02 + 1.3651029603321589e+00 -2.8633815898956527e-02 + 1.3473908373177181e+00 7.6552550557664745e-03 + 1.4406602045173358e+00 -2.8168848571812077e-01 + 1.4145331927850577e+00 -2.4449017710963972e-01 + 1.4568946962216529e+00 -3.4388040849313484e-01 + 1.3887962099303408e+00 -2.0475362215466930e-01 + 1.3771896496380833e+00 -1.6696304421311936e-01 + 1.3609196806290669e+00 -1.3999601919242366e-01 + 8.6014392850692190e-01 -1.0713447400143536e+00 + 3.0094432939178262e-01 4.1999514453189590e-01 + 2.8681802838985959e-01 3.7208722715023868e-01 + 3.3577377305865497e-01 3.8542250776151832e-01 + 2.6005529014528861e-01 3.4289438935339689e-01 + 2.9207028710003158e-01 3.2706338618859121e-01 + 2.6212520099922898e-01 3.0797101317843101e-01 + 2.3591179165214271e-01 2.8903664298631782e-01 + 2.0374415977909877e-01 2.9980507832550529e-01 + 2.6445932790863935e-01 2.6729012687636100e-01 + 2.1117298187805744e-01 2.6883389405212199e-01 + 2.3619672460487351e-01 2.5456922627684264e-01 + 1.8380888125621908e-01 2.7789630252634367e-01 + 2.7632304950166287e-01 2.4509392263307461e-01 + 2.5576176733970613e-01 2.4009798497891666e-01 + 2.9300182597316393e-01 2.3347051824651288e-01 + 7.5367521584269070e-01 -9.9314670269320970e-01 +-1.1740233493408425e-01 -9.2550686408543470e-02 +-1.1258868469636241e-01 -9.2453861268879223e-02 +-1.2501836466954330e-01 -8.6087942519455396e-02 +-1.2284692740533387e-01 -9.0658051226668590e-02 +-1.2313607436090024e-01 -9.6300998724856868e-02 +-1.1708890625274648e-01 -9.8933235729148805e-02 +-1.1277111041140131e-01 -9.7539151811417923e-02 +-1.3369785695120129e-01 -7.6993680833638223e-02 +-1.3176273620165091e-01 -8.4424301502409094e-02 +-1.3118980943369252e-01 -7.1190898982564477e-02 +-1.2909070423826563e-01 -9.1190974145789028e-02 +-1.2075413899817988e-01 -1.0143498231838066e-01 +-1.2656734645717904e-01 -1.0260031948321569e-01 +-1.2925672740625771e-01 -9.7552791940302086e-02 +-1.1719585618260453e-01 -1.0335662321466543e-01 +-1.1317810375194881e-01 -1.0307788521267014e-01 + 6.4219431237705749e-01 -8.9747778194241334e-01 + 8.9152074580790952e-01 -9.2483321307332744e-01 + 7.6937791320457904e-01 -8.7548889778668126e-01 + 5.1682987972330352e-01 -7.2581802594709188e-01 + 6.0217444266920950e-01 -7.6553596585038974e-01 + 1.1486542337774779e+00 -1.4223069193847948e-01 + 1.1478566882979919e+00 -1.3950042762327541e-01 + 1.1580286686465300e+00 -1.4097054703282197e-01 +-5.8866965796779880e-01 3.8721929283610734e-02 +-6.0782877390487045e-01 -1.3988236400038545e-02 +-5.9003420416840413e-01 -8.0673475273798090e-02 + 1.4436119889325028e-02 -7.0671804426496010e-02 + 9.2591397343397830e-03 -7.3920737676402837e-02 + 4.5274817181706339e-03 -7.1178647209691803e-02 + 2.1259447386611896e-02 -7.3541792000455075e-02 + 8.2100021214355223e-01 -3.5391426170278351e-02 + 8.1816304832314302e-01 -2.7659171994116605e-02 + 8.2707080342240147e-01 -2.7970908050548360e-02 + 8.2712153578951586e-01 -4.4450074301266795e-02 + 8.2953103777212078e-01 -3.5363797104494665e-02 + 8.2374742300672921e-01 -2.0808492356565012e-02 + 8.1589171910717795e-01 -2.0816730953995943e-02 + 8.2007382331299539e-01 -5.4885837102176538e-02 + 8.3694682491496764e-01 -2.8370737784072730e-02 + 8.3303627437398120e-01 -2.0231822893862272e-02 + 8.3654813287324004e-01 -3.8017001122398142e-02 + 8.3234562699538372e-01 -5.5806629426328414e-02 + 8.3943897777639620e-01 -4.7172166956983119e-02 + 8.1812990674209374e-01 -1.3198101400377027e-02 + 8.2750173195736210e-01 -1.3439867153095975e-02 + 8.2758621228556706e-01 -6.2846334631942113e-02 + 8.1834238665543779e-01 -6.8616758830813751e-02 + 8.4169304160971592e-01 -1.8849384824164872e-02 + 8.4223485038986468e-01 -3.3328072685193888e-02 + 8.4556281322078775e-01 -2.7404768792393952e-02 + 8.3591259978131660e-01 -1.0991531485885275e-02 + 8.4401557059652532e-01 -3.9417157902306599e-02 + 8.4128534405397914e-01 -5.5425543839476177e-02 + 8.3451448704881415e-01 -6.3367485870728046e-02 + 8.3935453504753355e-01 -6.0668376574682270e-02 + 8.4789819179918879e-01 -4.5140501434360658e-02 + 8.4808345153756193e-01 -5.2305017984082269e-02 + 8.1059795750969954e-01 -8.0519579891955573e-03 + 8.2338042762739150e-01 -6.0313777341036712e-03 + 8.1694943184893987e-01 -5.8042501337780550e-03 + 8.2953674248697240e-01 -5.9381805681084643e-03 + 8.3265473741512608e-01 -7.1554961929663818e-02 + 8.0982868851721435e-01 -8.2677967994698065e-02 + 8.2517523655628366e-01 -8.1355967694065612e-02 + 8.4970338425359415e-01 -2.0677615707867858e-02 + 8.4304292719281193e-01 -1.1021399460446446e-02 + 8.4695693420483309e-01 -1.4342428147884334e-02 + 8.4871559054001011e-01 -3.3785998843370635e-02 + 8.5346574293990329e-01 -2.7924070322626449e-02 + 8.3419674145191891e-01 -2.5049633697733498e-03 + 8.4065907700200171e-01 -3.8252229265367532e-03 + 8.5169581102939418e-01 -4.0373521940637147e-02 + 8.4837136168425076e-01 -6.1947728256541268e-02 + 8.5535675175118087e-01 -4.7968833060096472e-02 + 8.5527915726023451e-01 -5.6296830782514462e-02 + 8.4025585545516179e-01 -6.6794495480337446e-02 + 7.9412108814685212e-01 -8.0233625197720926e-02 + 8.2054816655446672e-01 1.2751058130433535e-03 + 3.4138642862384927e-01 1.4964139374274055e-01 + 3.4442135506293425e-01 1.6193968704636319e-01 + 3.3285637187207584e-01 1.4019564106235549e-01 + 3.2969255933590347e-01 1.2642707577907686e-01 + 1.6301523943155871e-01 2.5727550760491624e-01 + 1.3615437806613784e-01 2.6109790902926022e-01 + 1.4482800981972588e-01 2.3456288802012182e-01 + 1.8935088516529675e-01 2.5086044965413379e-01 + 1.7303710209407797e-01 2.3530627374826452e-01 + 1.9131672656462939e-01 2.2399727458562779e-01 + 2.1405437742159705e-01 2.3665012480143588e-01 + 1.7758091048221303e-01 2.2154745524009911e-01 + 2.0980255521508440e-01 2.1624071723650218e-01 + 2.3667039203319007e-01 2.3276145159739059e-01 + 2.2705459724733146e-01 2.1601236864214712e-01 + 2.5028449355252746e-01 2.1647755328753249e-01 + 2.3687162189978039e-01 1.9637722689572001e-01 + 6.6599296921928897e-02 6.9131899927832308e-02 + 5.8543876625904545e-02 7.0872055011918178e-02 + 5.4667285412051569e-02 5.9404580003985075e-02 + 6.0346714959109704e-02 6.2517591524169802e-02 + 5.9549939651184047e-02 5.6290819001340253e-02 + 4.7276753371221503e-02 7.7796585878402880e-02 + 4.2553443341724062e-02 8.5307049936169221e-02 + 3.9328068774835856e-02 7.6152466990947687e-02 + 3.3178187299299111e-02 8.3919762861128788e-02 + 2.2496386775081589e-02 8.2283925618568787e-02 + 2.5187178751579609e-02 9.2231276904193749e-02 + 1.4930274405294597e-02 9.0384485719710028e-02 + 2.4820604891260700e-02 2.4565358718675157e-02 + 1.5764348564864861e-02 2.2787394419495399e-02 + 1.8669129605221713e-02 3.0686771520151979e-02 +-1.5887394044682424e-03 3.8866870483090565e-02 + 3.9360602959462199e-02 -8.5163915190676676e-02 + 5.4862884746306406e-02 -8.8165978524671118e-02 + 4.4534600395103041e-02 -9.0537126161407855e-02 + 5.3751724041990911e-01 -1.4192150426798378e-01 + 5.6124257208237793e-01 -1.8097231014895954e-01 + 5.3224201139089189e-01 -1.6029818614637747e-01 + 5.4055741214504138e-01 -1.7866348377556562e-01 + 5.1676666364120649e-01 -1.4910133181469121e-01 + 5.5461151511059370e-01 -1.9895240424689575e-01 + 5.2077749096572745e-01 -1.7277478367125809e-01 + 5.2730394441447004e-01 -1.9785634810067165e-01 + 5.0164513224047624e-01 -1.6388251728645287e-01 + 4.9845566304827571e-01 -1.4652148969814505e-01 +-1.7880774027500479e-01 -5.8098183177833107e-02 +-1.7037236550460477e-01 -5.1318060878159599e-02 +-1.6608587837711752e-01 -6.0999166079142242e-02 +-1.7975399677087012e-01 -4.2286250150553428e-02 +-1.7442844655724343e-01 -7.3119466397798760e-02 +-1.9462634387227240e-01 -5.1632402308598557e-02 +-1.8977193303066997e-01 -6.9082476945609983e-02 +-1.5881494956205700e-01 -4.9037004702171316e-02 +-1.6899205563895237e-01 -4.4681029047922038e-02 +-1.5996141912438588e-01 -7.3266830510945624e-02 +-1.5480792580396496e-01 -6.1462625456528031e-02 +-2.0150252464421214e-01 -3.0600102405401230e-02 +-1.8637840418020346e-01 -8.1720202459734992e-02 +-1.6673316126166071e-01 -8.2083193477757277e-02 +-1.7662246984616559e-01 -8.6831396279507089e-02 +-2.0303985938778624e-01 -6.5977817721460497e-02 +-2.1276631036558058e-01 -5.0437549357923217e-02 +-2.0135080391149529e-01 -8.3946789608148720e-02 +-1.4911835216393854e-01 -5.3675509203841898e-02 +-1.4643247368965717e-01 -4.5764546347641044e-02 +-1.4823464733916580e-01 -7.0241585874214252e-02 +-1.5779540694818195e-01 -8.4018500728689105e-02 +-1.4886521744924153e-01 -8.0680899550245044e-02 +-1.4532814271504435e-01 -6.1234050799285455e-02 +-2.2468384427280341e-01 -2.9804190783806916e-02 +-2.1299058144110461e-01 -1.3630186809379552e-02 +-1.9083209818471403e-01 -9.5494482342772358e-02 +-1.6485806383224144e-01 -9.3179773471774752e-02 +-1.7727714843739761e-01 -1.0102857586799985e-01 +-2.1870374182195462e-01 -7.2163536572759313e-02 +-2.0626535701640591e-01 -1.0633643629962819e-01 +-2.1898874266886992e-01 -9.3745411801350542e-02 +-2.3743159948543280e-01 -5.2161021939738816e-02 +-1.4076980786171589e-01 -5.2961345476688848e-02 +-1.4016917622851111e-01 -3.7060450077973428e-02 +-1.3757236055410260e-01 -4.5495561318048772e-02 +-1.4213406197495715e-01 -7.6073820553986593e-02 +-1.3831111696757148e-01 -6.8731288374294763e-02 +-1.5122790698643485e-01 -9.1087129285980950e-02 +-1.4355578613039199e-01 -8.6983866961958256e-02 +-1.3942192959217437e-01 -8.2559943254011614e-02 +-1.3547239215681373e-01 -5.9547658582346230e-02 +-1.8947568064338327e-01 -1.0994990645866665e-01 +-1.6665574533126915e-01 -1.0711562336844338e-01 +-1.5605010550009979e-01 -1.0222220811643012e-01 +-1.7689966533041002e-01 -1.1199831748756139e-01 +-2.3864513511252028e-01 -8.6712629007891451e-02 +-2.2702722628690708e-01 -1.0932270591776216e-01 +-1.9970133983932215e-01 -1.2328452674842083e-01 +-2.1502680539219909e-01 -1.2159934703629460e-01 +-1.3182550752988220e-01 -5.1237567952625795e-02 +-1.2956449089517719e-01 -4.2856770902432118e-02 +-1.8302891334545279e-01 -1.2525484538348053e-01 +-1.5709253679544588e-01 -1.1475495795257018e-01 +-1.6913349334406291e-01 -1.1929516927273198e-01 +-1.4699365419389210e-01 -9.9148229748820427e-02 +-1.4176076382032932e-01 -9.3539311363159072e-02 +-1.4679729983558332e-01 -1.0824114635722992e-01 +-1.3680178594235315e-01 -8.8774477778343908e-02 +-2.0993350359404417e-01 5.4018804509539109e-03 +-2.3263922197246245e-01 -9.4499372523841885e-03 +-2.4365030801348553e-01 -2.7977003331372430e-02 +-2.6097119279825165e-01 -6.4214174725506723e-02 +-2.5798177797456390e-01 -4.1156378462915200e-02 +-4.9473140523616621e-02 -1.3812588971879336e-01 +-5.2088099419250966e-02 -1.3576512279377084e-01 +-4.9545555035138023e-02 -1.3393238146485942e-01 +-5.3769650823355164e-02 -1.3838995512001873e-01 +-4.7069723528281315e-02 -1.3593909830377982e-01 +-5.1925532654635731e-02 -1.4154954149923071e-01 +-4.5581807419267761e-02 -1.3895866783171584e-01 +-4.8475870466305082e-02 -1.4223617947567391e-01 +-5.5704796941441259e-02 -1.4253076423577227e-01 +-5.7545607331718429e-02 -1.3875677297964728e-01 +-4.4148396011081559e-02 -1.3542366144746154e-01 +-4.4701952961318625e-02 -1.4338455968729136e-01 +-4.1889218098262404e-02 -1.3724221622393884e-01 +-4.2340231673051676e-02 -1.4078696507942823e-01 +-5.1590928319257046e-02 -1.4465135032456544e-01 +-4.7737462441489242e-02 -1.4599020402098972e-01 +-4.1428612591417391e-02 -1.3404996649735779e-01 +-4.3955598991573197e-02 -1.3244822630930742e-01 +-3.9762902769538755e-02 -1.3875768712753711e-01 +-4.1168141908315192e-02 -1.3097767331775856e-01 +-4.1048842977403410e-02 -1.4427735178882983e-01 +-3.8856392605424617e-02 -1.4182805230373674e-01 +-4.3027502790337735e-02 -1.4805798992696850e-01 +-5.9229937594395210e-02 -1.4185102365249236e-01 +-5.4765776066489025e-02 -1.4701511632839015e-01 +-5.8762739335222136e-02 -1.4541310565078902e-01 +-6.2053950302015437e-02 -1.3846914747084327e-01 +-5.0631387281200091e-02 -1.4790440327254828e-01 +-4.7463583718183600e-02 -1.5035280103192861e-01 +-3.8429191805391838e-02 -1.5101004003962260e-01 +-4.3069104768775901e-02 -1.5423722832387909e-01 +-4.6000337431095772e-02 -1.5984391220396788e-01 +-4.9009047911567905e-02 -1.5513878182838425e-01 +-5.2310099591835524e-02 -1.5109830560703585e-01 + 1.1492564927096822e+00 -6.7695185078875397e-02 + 1.1564946203983411e+00 -7.1714942701007089e-02 + 1.1460211492831078e+00 -7.6161585945698107e-02 + 1.1553045193553970e+00 -6.1501587422512216e-02 + 1.1406819031957909e+00 -6.8954726019796908e-02 + 1.1452685421259545e+00 -5.8517533037928615e-02 + 1.1522875783478526e+00 -8.0116169071700938e-02 + 1.1631062780574482e+00 -6.4742361754795752e-02 + 1.1603311566783532e+00 -7.9814086074833313e-02 + 1.1666960227462724e+00 -7.2119903305704725e-02 + 1.1383399036629669e+00 -7.5770037098038756e-02 + 1.1457622862938663e+00 -8.6541079774818286e-02 + 1.1389238075055772e+00 -8.2287570224025330e-02 + 1.1537345613428869e+00 -5.0968856248914562e-02 + 1.1622959376013853e+00 -5.6007844382151006e-02 + 1.1333451514268305e+00 -6.1873772902785618e-02 + 1.1334613855336286e+00 -7.0932575320057367e-02 + 1.1453599577268179e+00 -4.7458069707019490e-02 + 1.1373431620657257e+00 -5.1140651027253625e-02 + 1.1544180181637884e+00 -8.6413442541029895e-02 + 1.1721508994386625e+00 -6.2335643916327399e-02 + 1.1695839918227691e+00 -8.1515239554363461e-02 + 1.1620082729185270e+00 -8.7727524378081512e-02 + 1.1763404387495271e+00 -7.4300652333846529e-02 + 1.1328290898637121e+00 -7.8510749081317499e-02 + 1.1369825704526164e+00 -9.0059758746662055e-02 + 1.1502461898590894e+00 -9.1056155778218795e-02 + 1.1410101498869238e+00 -9.4029858569498970e-02 + 1.1463132496366413e+00 -9.3424099179017617e-02 + 1.1317209573860225e+00 -8.6174030290592896e-02 + 1.1621057842525815e+00 -4.4015403810803377e-02 + 1.1520847168367325e+00 -3.9017911633848712e-02 + 1.1699159940447146e+00 -5.1615418506855804e-02 + 1.1256988232941012e+00 -6.9219933134178291e-02 + 1.1285044750315265e+00 -5.3824478622885863e-02 + 1.1235042268212609e+00 -6.0769953478910566e-02 + 1.1279403094517733e+00 -7.4615186261183908e-02 + 1.1383992881045728e+00 -3.7003820394517106e-02 + 1.1283348733326761e+00 -4.5322775780206825e-02 + 1.1558726248849780e+00 -9.3225640168512314e-02 + 1.1854797343213050e+00 -6.4954531093206924e-02 + 1.1777868829713327e+00 -5.2913160694885164e-02 + 1.1703645166109737e+00 -8.9933897302415744e-02 + 1.1780360842735291e+00 -8.4371131820972778e-02 + 1.1629074947468467e+00 -9.6785763877207387e-02 + 1.1873320093235975e+00 -7.9230184076862997e-02 + 1.1256719770124732e+00 -8.0988117089333400e-02 + 1.1503923626518571e+00 -9.6416610376650169e-02 + 1.1446416735501828e+00 -9.8908450806845849e-02 + 1.1390606279318547e+00 -9.9398443779477930e-02 + 1.1636047854316871e+00 -2.6402587463536520e-02 + 1.1740107862634375e+00 -4.1220641457158536e-02 + 1.1493039241617566e+00 -2.8258732178187529e-02 + 1.1164312379976025e+00 -6.9961408678238968e-02 + 1.1207328190883032e+00 -7.6011881208515319e-02 + 1.1150346629673322e+00 -6.0268068936323971e-02 + 1.1198069214721897e+00 -5.1544159527963984e-02 + 1.1265693533873886e+00 -3.5832031489547944e-02 + 1.1400963812459466e+00 -2.1235722545554836e-02 + 1.1293498979090231e+00 -2.6319551642316696e-02 + 1.1193394016682490e+00 -4.1029216378149158e-02 + 1.1552761489132735e+00 -9.9855956144153879e-02 + 1.1777803006118859e+00 -9.3336783224827968e-02 + 1.1703510448549466e+00 -9.7707649014751041e-02 + 1.1861177212427805e+00 -9.0412544872378930e-02 + 1.1592318962621206e+00 -1.0358713949335652e-01 + 1.1662718349098924e+00 -1.0434361159997252e-01 + 1.1888920743639630e+00 -4.7616540096584004e-02 + 1.1987572380339628e+00 -7.4560759636057128e-02 + 1.1974747509654122e+00 -6.1368451055358264e-02 + 1.1978659184174276e+00 -8.9785731826751203e-02 + 1.1495750798226680e+00 -1.0239242974428464e-01 + 1.1451152783366325e+00 -1.0438970957665106e-01 + 1.1172731754826515e+00 -8.4297947252863992e-02 + 1.1244525379224228e+00 -8.8531300179667483e-02 + 1.1178878320314425e+00 -9.2425370565052845e-02 + 1.1539493855891507e+00 -1.0623320314310547e-01 + 9.9203813806088448e-01 4.6133842042027595e-01 + 1.0209913778596444e+00 3.9801120961259073e-01 + 1.1249811627663107e+00 3.7451025006829752e-01 + 1.0722254944797811e+00 3.8059464463542270e-01 + 9.2022078324125545e-01 4.5399854903965320e-01 + 9.6032568532941553e-01 4.0349824307129722e-01 + 1.0387945177131002e+00 3.4842285165071019e-01 + 9.8253424140292367e-01 3.4641941770848206e-01 + 1.0942119497021778e+00 3.3418949185938374e-01 + 1.1361435091718519e+00 3.2061773124124215e-01 + 8.6692611910202544e-01 4.3464200333025360e-01 + 9.0090546586264963e-01 3.8908289982461497e-01 + 1.0864962680571466e+00 -1.4158218416750401e-01 + 1.0878182777149377e+00 -1.3888688100406910e-01 + 1.0846095739207655e+00 -1.3989231600540109e-01 + 1.0845919713599272e+00 -1.4310814852009912e-01 + 1.0853975007985213e+00 -1.3635284397938108e-01 + 1.0815785512157561e+00 -1.4522645413498481e-01 + 1.0818281471200493e+00 -1.4157026726934419e-01 + 1.0824431525069684e+00 -1.3826413202905030e-01 + 1.0786502394154596e+00 -1.4339455933991019e-01 + 1.0794480068766816e+00 -1.3902778174764308e-01 + 1.0758356146754764e+00 -1.4071277760632483e-01 + 1.0746573759337963e+00 -1.4448885303298198e-01 + 1.0771370708614114e+00 -1.3653177488993151e-01 + 1.0720432427280855e+00 -1.4243335782404642e-01 + 1.0733064300204376e+00 -1.3843303289979758e-01 + 1.0709333557059821e+00 -1.4582747526790740e-01 + 1.0747053299807590e+00 -1.3415343754213893e-01 + 1.0710568047661440e+00 -2.8371491542871752e-01 + 1.0727430150878661e+00 -3.0833304825401342e-01 + 1.0498800460244411e+00 -2.9796120065452669e-01 + 1.0907150959141347e+00 -2.9336255319718418e-01 + 1.0501969629814667e+00 -2.6849212123414645e-01 + 1.0914299634632556e+00 -2.7278239676444116e-01 + 1.0721761555204239e+00 -2.6517364075210992e-01 + 1.0518033346261078e+00 -3.2236539889244398e-01 + 1.1010016989705704e+00 -3.1719797575533448e-01 + 1.0745163052584843e+00 -3.3589464962925319e-01 + 1.0276886470854123e+00 -2.8743300951362016e-01 + 1.0205120955618767e+00 -3.1977835582679859e-01 + 1.1113043097897233e+00 -2.9069570302306147e-01 + 1.0620851953935642e+00 -2.4953668416702612e-01 + 1.0267202059825280e+00 -2.6249096415085660e-01 + 1.0441394654554159e+00 -2.4531262088704864e-01 + 1.0831040177620395e+00 -2.4991456204257645e-01 + 1.1124795454898617e+00 -2.6979804385126727e-01 + 1.0989896141899180e+00 -2.5819319093749016e-01 + 1.0418679269693527e+00 -3.4792174469691872e-01 + 1.1111199165183692e+00 -3.5626542286370011e-01 + 1.1326497780572069e+00 -3.0790113235431704e-01 + 1.1289443774407530e+00 -3.3248006622575588e-01 + 1.0734436824665750e+00 -3.6959681254590748e-01 + 9.9841357032180156e-01 -2.9617351551038951e-01 + 1.0093459065540387e+00 -2.7272581881430824e-01 + 9.9262700595978970e-01 -3.6206788305781856e-01 + 9.8130413794622484e-01 -3.2452573846182986e-01 + 1.1345854104592163e+00 -2.8426698151774588e-01 + 1.0577425671361240e+00 -2.2750193197853719e-01 + 1.0723235896763654e+00 -2.3492938590050017e-01 + 1.0284226623541244e+00 -2.3986211877338803e-01 + 1.0074600445735911e+00 -2.4797851779020164e-01 + 1.0391110783257744e+00 -2.2642631919478617e-01 + 1.0952379103210461e+00 -2.4416852856339233e-01 + 1.0877890131216930e+00 -2.3025849090788597e-01 + 1.1113986308606627e+00 -2.5053857595460727e-01 + 1.1271693441765436e+00 -2.6231141491034293e-01 + 1.0340226193274518e+00 -3.8770067855826085e-01 + 1.1489070110911896e+00 -3.5296058093081228e-01 + 1.1016066057884828e+00 -4.0058234645009350e-01 + 1.1397257065748292e+00 -3.8985271972603641e-01 + 1.1577230358639525e+00 -3.2559787208194280e-01 + 1.1581825508672310e+00 -2.9981169794692164e-01 + 1.0664586111461887e+00 -4.0759756767840827e-01 + 9.8268377144457020e-01 -2.7010335134716001e-01 + 9.7156551172245287e-01 -2.9747065709592846e-01 + 9.5436219455542926e-01 -3.4431636744371019e-01 + 9.8856788158078501e-01 -4.0989652221563233e-01 + 9.4378195221959515e-01 -3.7896529484540054e-01 + 9.4576667336223608e-01 -3.1183371449701269e-01 + 1.1417903945810934e+00 -2.6819801730438542e-01 + 1.1562743996727676e+00 -2.7681135009335378e-01 + 1.0741601028052798e+00 -2.1761919290730702e-01 + 1.0492842158871909e+00 -2.1208686369686802e-01 + 1.0623079199406504e+00 -2.1168516625675693e-01 + 1.0204151674068953e+00 -2.2274616728117280e-01 + 9.8241670324750174e-01 -2.4052148459584544e-01 + 9.9929953568165786e-01 -2.2705716135833143e-01 + 1.0344786555625447e+00 -2.0940137761638766e-01 + 1.1026237111785520e+00 -2.3340044324868359e-01 + 1.0896337423550264e+00 -2.1447217098275928e-01 + 1.0997209641579815e+00 -2.2069295457070837e-01 + 1.1158864281316809e+00 -2.3680825830179231e-01 + 1.1237712440773961e+00 -2.4693450320133081e-01 + 1.0831117912211639e+00 -2.0462998780297426e-01 + 1.0711533488193652e+00 -2.0207443631329625e-01 + 1.1108575554734799e+00 -2.2477658337328421e-01 + 1.0998059487755683e+00 -2.1065692108405187e-01 + 1.0945653585675856e+00 -2.0293976172330019e-01 + 1.1094666407271774e+00 -2.1273253130982539e-01 + 1.1376928365383563e+00 -2.5036852012175359e-01 + 1.1298011500868128e+00 -2.3484761468233728e-01 + 1.1206435698353729e+00 -2.2749667782451866e-01 + 1.0361062664116858e+00 -4.3262366666844798e-01 + 1.1776774235322449e+00 -3.7861713957742893e-01 + 1.1831333497049457e+00 -3.4126277034286545e-01 + 1.1267134948578814e+00 -4.3619734723105807e-01 + 1.0871138817367552e+00 -4.4748433416917521e-01 + 1.1694332774939724e+00 -4.1977914576746400e-01 + 1.1823906916558187e+00 -3.1398868467329066e-01 + 1.1799184782419871e+00 -2.8542338264374223e-01 + 9.4645269454048986e-01 -2.8110199040122552e-01 + 9.5604781433374342e-01 -2.5299270558480202e-01 + 9.0664062565324599e-01 -3.3792040009655011e-01 + 9.2377811211817118e-01 -4.3935748241608508e-01 + 8.7877514725633432e-01 -3.8623340537068884e-01 + 9.8537379964267302e-01 -4.6697226995424046e-01 + 9.1397111964808886e-01 -2.9366242133608011e-01 + 1.1236876333807402e+00 -1.8549887852074676e-01 + 1.1196544065634129e+00 -1.8836350680206237e-01 + 1.1286110697750829e+00 -1.8632496062431869e-01 + 1.1146155073559569e+00 -1.9191401723705326e-01 + 1.1253726858649884e+00 -1.9084228058972030e-01 + 1.1337096370741833e+00 -1.8523809276165082e-01 + 1.1320757670492512e+00 -1.9049072314513182e-01 + 1.1353001092018644e+00 -1.8049154201601425e-01 + 1.1203116950829113e+00 -1.9299013951406607e-01 + 1.1100406273117756e+00 -1.9690536995592822e-01 + 1.1180615776596099e+00 -1.9868492831881213e-01 + 1.1024432871336600e+00 -1.9525469260716477e-01 + 1.1238033111497288e+00 -1.9641539567670918e-01 + 1.1296121316685230e+00 -1.9641415434868748e-01 + 1.1364022410381764e+00 -1.7629970600648903e-01 + 1.1373443965448899e+00 -1.7245360393289388e-01 + 1.1384571538378907e+00 -1.8922387458728451e-01 + 1.1395539318520420e+00 -1.8328051326597006e-01 + 1.1370218735913156e+00 -1.9516354095526367e-01 + 1.1392258476434662e+00 -1.7905018542744244e-01 + 1.1126400707928639e+00 -2.0345591314759304e-01 + 1.1051649078402619e+00 -2.0335543686258006e-01 + 1.1250901126609563e+00 -2.0224612958492116e-01 + 1.1188483539950482e+00 -2.0800854964839743e-01 + 1.1332784632682404e+00 -2.0303024576477924e-01 + 1.1420640645392055e+00 -1.7590558714537963e-01 + 1.1405873729447009e+00 -1.6992901788569270e-01 + 1.1425050326761976e+00 -1.8036708518459932e-01 + 1.1433477484613874e+00 -1.8685843220320919e-01 + 1.1442167952846418e+00 -1.8341536031331884e-01 + 1.1447239090355836e+00 -1.9283040436246779e-01 + 8.7275066155598324e-01 8.0389998374847949e-02 + 8.7217805568704421e-01 8.8633884408167773e-02 + 8.7965446558551008e-01 9.3910857478419985e-02 + 3.0773655034944625e-01 1.6553401929962774e-01 + 3.1909097081054227e-01 1.6108736739400342e-01 + 3.0627369374353464e-01 1.5389683975148216e-01 + 3.1675531871773899e-01 1.7735801979743115e-01 + 2.9526075304909227e-01 1.6316553425065194e-01 + 3.0065188440005386e-01 1.7830470254644126e-01 + 3.1962165695436795e-01 1.4790573535804441e-01 + 3.3283328255196665e-01 1.7055109222052778e-01 + 3.3157292713168829e-01 1.5508646202955134e-01 + 2.9311347030682100e-01 1.4950584716914506e-01 + 3.0890235583931513e-01 1.8751795617610867e-01 + 3.3288194856815068e-01 1.8643899287090449e-01 + 3.1738142420508808e-01 1.9537130927538726e-01 + 2.8464338164610581e-01 1.7325900988851117e-01 + 2.7914553784859919e-01 1.5849278684871138e-01 + 2.9933487576091977e-01 1.9508160195125868e-01 + 2.8842020056688966e-01 1.8575975706769299e-01 + 3.4834306914932256e-01 1.7665594599380086e-01 + 2.8138614818619345e-01 1.4182903207233011e-01 + 3.1114943733755496e-01 2.1476323725926960e-01 + 2.7073681558194806e-01 1.7078951545586563e-01 + 2.6323317190011153e-01 1.6091312033641714e-01 + 2.6867067602803019e-01 1.4493206442470097e-01 + 2.7330736242446818e-01 1.8622098478792282e-01 + 2.8416349860302148e-01 1.9593248616429548e-01 + 2.8881266513145931e-01 2.1208935996022404e-01 + 2.5984312635675622e-01 1.7709528705877631e-01 + 2.6978582554274055e-01 2.0592818115366640e-01 + 2.5631333475374163e-01 1.9501415980559500e-01 + 2.5451833431942106e-01 1.4804065544863221e-01 + 2.4648454126605657e-01 1.6612841278180213e-01 + 2.4757592620868962e-01 1.8308699103289428e-01 + 2.7211805108323972e-01 2.2612423606187093e-01 +-6.4731628189051094e-02 2.1693034629919339e-03 +-6.7994845722822106e-02 -2.3280544696149263e-03 +-6.7764923000098065e-02 -1.8685802489159187e-02 +-6.7993866080911403e-02 -1.3707150903513821e-02 +-6.6091618400150765e-02 -2.2381289731143283e-02 +-7.3151822620900475e-02 -1.6883353318448258e-02 +-7.1140876442072454e-02 -2.2705702519374427e-02 +-7.2531318649552645e-02 -1.1020368383270807e-02 +-6.6379112751732805e-02 -2.7316790741465979e-02 +-6.5719702066331820e-02 9.6862578493812634e-03 +-1.1660002618050669e-01 -1.1686179594099144e-01 +-1.1421745891624369e-01 -1.2089287683667749e-01 +-1.1864532154847041e-01 -1.2067233690980572e-01 +-1.1173097484450523e-01 -1.1425802097735982e-01 +-1.2183505118700566e-01 -1.1664998192803466e-01 +-1.1860185582371230e-01 -1.1218009884818514e-01 +-1.1734314226660558e-01 -1.2597067519214988e-01 +-1.1085569486162683e-01 -1.2596789609709447e-01 +-1.0855165180940674e-01 -1.1982622253918862e-01 +-1.2338606502213167e-01 -1.2219229184941582e-01 +-1.2599858344412951e-01 -1.1047836780065268e-01 +-1.2836839298570624e-01 -1.1720188572846268e-01 +-1.2052613091235287e-01 -1.0644747113117603e-01 +-1.1509006077118045e-01 -1.0788879957556219e-01 +-1.1417415597992431e-01 -1.3105463760419411e-01 +-1.2360896488890205e-01 -1.2918213803631318e-01 +-1.1849996212413316e-01 -1.3011788198399188e-01 +-1.0588490408058249e-01 -1.2333401042748449e-01 +-1.0527012592753238e-01 -1.2804269490284526e-01 +-1.0907381822840989e-01 -1.3215319277590254e-01 +-1.0376634433623622e-01 -1.3396733034515762e-01 +-1.0093592843874433e-01 -1.2925262160432283e-01 +-1.3117043710487053e-01 -1.2408181520962103e-01 +-1.3226224755887017e-01 -1.1237319597424289e-01 +-1.3283492984747625e-01 -1.0670438962608841e-01 +-1.3582538635333208e-01 -1.1781078249656218e-01 +-1.1887358536104387e-01 -1.3426407710325350e-01 +-1.1301376532932750e-01 -1.3631490110589084e-01 +-1.3146032328890556e-01 -1.3112783102340586e-01 +-1.2567855867071387e-01 -1.3658683247059855e-01 +-1.0787314916836976e-01 -1.3669805611759500e-01 +-9.7996637876278214e-02 -1.3318904237809193e-01 +-1.3908017032726150e-01 -1.2377221024676999e-01 +-1.3523242191882900e-01 -1.2741259529411764e-01 +-1.3885692086296331e-01 -1.1060917816776339e-01 +-1.3269561604209912e-01 -1.0084710377334716e-01 +-1.3948837461241226e-01 -1.0142268938535892e-01 +-1.4523951639944244e-01 -1.1804528606400311e-01 +-1.1882550588869378e-01 -1.4138983315395137e-01 +-1.1054218785628223e-01 -1.4225725574479497e-01 +-1.3371141858776525e-01 -1.3891463790142211e-01 +-1.4017040892828447e-01 -1.3194611785432642e-01 +-1.2725320585116151e-01 -1.4448186650157879e-01 +-1.0498940691067560e-01 -1.3924921897643117e-01 +-9.9405159481349870e-02 -1.3927461907650240e-01 +-9.3728331023626765e-02 -1.3637680871825353e-01 +-1.4589330197661354e-01 -1.2640251714036310e-01 +-6.9490950141343433e-02 -1.4448089525191676e-01 +-7.3701744488815280e-02 -1.4423980907741907e-01 +-7.1314460100495580e-02 -1.4162054382556732e-01 +-7.1604816435581142e-02 -1.4873209312827385e-01 +-6.8273709982364039e-02 -1.4113068975424881e-01 +-6.6677000277095999e-02 -1.4833280139200156e-01 +-6.5759883951287179e-02 -1.4439138380843985e-01 +-7.4219305697653226e-02 -1.4001837136135009e-01 +-7.6273527848613298e-02 -1.4854969831785070e-01 +-7.7777737227066268e-02 -1.4364571261040737e-01 +-6.8315711542410895e-02 -1.5361959626498845e-01 +-7.4342579507728601e-02 -1.5293783548911222e-01 +-6.4661525337413650e-02 -1.4084841060855524e-01 +-6.2413302975599549e-02 -1.4724744046844762e-01 +-6.2152208861107283e-02 -1.4303522795971446e-01 +-6.3714597065100520e-02 -1.5108714140592383e-01 +-8.1102828936622018e-02 -1.4772665258094264e-01 +-7.9716258329369794e-02 -1.5247123287542763e-01 +-8.2677225969064239e-02 -1.4175718744044730e-01 +-5.8310413572300490e-02 -1.5079906126003095e-01 +-7.2643375430999413e-02 -1.5837748898530890e-01 +-6.2308138604564078e-02 -1.5612870714419103e-01 +-6.6980340524764870e-02 -1.6005837053327809e-01 +-7.7683785013292095e-02 -1.5671521904415897e-01 +-8.5801921782049817e-02 -1.5255587557865624e-01 +-8.6170759161745991e-02 -1.4689096102797805e-01 +-8.2235211527574847e-02 -1.5804807428624201e-01 +-8.7200950901163310e-02 -1.4247415413808540e-01 +-5.3865034063079520e-02 -1.5472424731859746e-01 +-5.7269487910588168e-02 -1.5625281663815827e-01 +-5.2828468162388731e-02 -1.6023819788624394e-01 +-5.8486966797033801e-02 -1.6006576908169734e-01 +-6.2121392829382671e-02 -1.6177828932650584e-01 +-5.1224207053238047e-02 -1.8692977981652348e-01 +-5.6376381536239251e-02 -1.9409281968532355e-01 +-4.1869528382491694e-02 -2.1252807381675609e-01 +-5.3806541787238871e-02 -2.0491513944131157e-01 +-5.2519925585514216e-02 -1.7831529807611446e-01 +-6.0578274957549638e-02 -1.8315598101690966e-01 +-2.6370509940278453e-02 -2.1883430067931897e-01 +-6.0679536974205917e-02 -1.9991294312848140e-01 +-6.7561917393234694e-02 -1.9304723367362442e-01 +-5.7892736180903626e-02 -2.2058724612762148e-01 +-4.1389672368978836e-02 -2.3012075659056563e-01 +-6.7661983336904541e-02 -2.0544581076251234e-01 +-5.2964732877470055e-02 -1.7124161636739643e-01 +-4.8860528632658884e-02 -1.6587581664444428e-01 +-5.9284185985106319e-02 -1.7343847478650787e-01 +-7.0580529722661822e-02 -1.8308201953597347e-01 +-6.7335838625382394e-02 -1.7518038444519846e-01 +-2.1097926513135690e-02 -2.3896026812761306e-01 +-7.6749266596067400e-02 -1.9659361827484645e-01 +-7.9012108002828541e-02 -1.8689385501394895e-01 +-5.7352027079360823e-02 -2.3697982969423492e-01 +-7.7045385906913566e-02 -2.1772514718946923e-01 +-7.2604153127187487e-02 -2.3339426812250963e-01 +-4.6441599714626136e-02 -2.5105822239301290e-01 +-8.1894185890433846e-02 -2.0477453805256118e-01 +-5.7547570934204373e-02 -1.6553787932822672e-01 +-6.5283947286374655e-02 -1.6710072054515024e-01 +-1.6836123450332252e-03 -2.3507295813475082e-01 +-7.8414509634313845e-02 -1.7713264353022851e-01 +-7.3186359417292124e-02 -1.6939791973125295e-01 +-6.9744952803162619e-02 -2.4889768410800173e-01 +-9.2450466685605193e-02 -2.2797406412476562e-01 +-8.9768790220389860e-02 -2.1417495594680247e-01 +-8.3729138545322712e-02 -2.4404845809470999e-01 +-2.5664786991001165e-02 -2.5965095872288657e-01 +-5.3218143453364064e-03 -2.5461310219479572e-01 +-4.2492112276505623e-02 -2.7429421297384238e-01 +-6.5702585937742697e-02 -2.6663888757043708e-01 +-8.9368992679254688e-02 -1.9208794913782867e-01 +-9.5404413559606382e-02 -2.0316388569715116e-01 +-8.7311223649180647e-02 -1.8118602335825074e-01 +-7.0909598292317355e-02 -1.6379927229345981e-01 + 1.3161914725621671e-02 -2.9930618512061358e-01 +-1.6509062035339639e-02 -3.0691358494222243e-01 +-1.2970482105274073e-02 -2.7932898792511196e-01 + 1.6612442329986266e-02 -2.6641810097932250e-01 + 2.5406943133162940e-02 -3.2878293510017897e-01 + 4.2710424863983576e-02 -2.7464858883149645e-01 + 5.5005401484429228e-02 -3.0431525478400090e-01 +-4.0490536692374235e-02 -2.9784376806209423e-01 + 3.9118702124135041e-02 -2.5254671665922501e-01 + 1.8495417823466198e-02 -2.4025800985967294e-01 + 6.8073584454879210e-02 -2.7504415579204533e-01 + 6.1451563876502746e-02 -2.5108983020788855e-01 + 9.0502476264440190e-02 -2.9246650401691454e-01 +-6.5603126152268487e-02 -2.8916889518653477e-01 + 4.5698839419841875e-02 -2.3026141785645393e-01 + 2.8021394946208034e-02 -2.1819241043090187e-01 + 9.4899220630317416e-02 -2.5410048623747628e-01 + 7.4304385109329019e-02 -2.2968912500374472e-01 +-9.3417731106541169e-02 -2.9389695064560328e-01 +-8.4360995483692136e-02 -2.7688712586177644e-01 +-8.5508830918087142e-02 -2.5854175423083348e-01 + 4.3312926609011981e-02 -2.1330514832894210e-01 + 6.3047178538234050e-02 -2.1097452768347580e-01 + 3.3003804995345831e-02 -2.0313434710142531e-01 + 9.8234915311181226e-02 -2.2874606130707775e-01 + 1.3068886857116269e-01 -2.5245478205917493e-01 + 1.1761756050439942e-01 -2.3108008264389923e-01 + 8.7971303239662291e-02 -2.1086069622803905e-01 +-1.2143785229612547e-01 -2.9382780248486995e-01 +-1.0648910299681802e-01 -2.6836392943046405e-01 +-1.0302620974186993e-01 -2.4641444031973947e-01 + 1.8921809841955906e-02 -1.2833752290187306e-01 + 1.5086336097482445e-02 -1.2185767902461464e-01 + 9.1266761238415484e-03 -1.1601181865394494e-01 +-5.7153516109735847e-03 -7.8161129153357933e-02 +-2.4192207554420975e-03 -8.0247331094241758e-02 +-5.4380167312473304e-03 -8.4061772393553724e-02 +-2.0669467105989270e-03 -7.6329174364559549e-02 +-8.8633155562689581e-03 -8.1068214700096064e-02 +-9.1414683426762622e-03 -6.8492924728403182e-02 +-4.9546439828844768e-03 -7.3309294143143688e-02 +-9.9082944635284775e-03 -7.5966459958308974e-02 +-7.0203399431534308e-05 -8.5065778093294853e-02 + 2.8647508325079230e-03 -7.7701225703805221e-02 +-1.0676816771905351e-02 -8.6208061875211683e-02 + 6.1634711252338548e-03 -8.4479338956711558e-02 + 2.6378582217603253e-03 -9.0131899080148514e-02 + 9.7660700997437289e-03 -7.9305062645474322e-02 + 9.3473452640253640e-03 -9.1492859737812182e-02 + 1.4416450994346519e-02 -8.5239484911681984e-02 + 4.8797495439316663e-03 -9.6028880650862902e-02 +-4.2300630894089863e-03 -9.3773101331336761e-02 + 1.5698280091399397e-02 -7.7401971348265874e-02 + 8.9635761796423452e-01 4.1195758125994075e-02 + 8.9435112339121048e-01 4.2786735193949710e-02 + 8.9843178301644855e-01 4.0086905610934309e-02 + 8.9934063087312666e-01 3.7756182956108830e-02 + 8.9670872307474525e-01 4.3884530183049719e-02 + 8.9865719250564524e-01 4.2094567667653848e-02 + 9.0112685882775168e-01 4.0445300989823352e-02 + 1.0703131922800679e+00 -1.3566183095068141e-01 + 1.0651702649648414e+00 -1.3645798999402814e-01 + 1.0683304659469712e+00 -1.3248553408401165e-01 + 1.0691473929864941e+00 -1.3987168768703384e-01 + 1.0640051490795912e+00 -1.3174072631750278e-01 + 1.0647927491539804e+00 -1.4059574055042390e-01 + 1.0612264239361053e+00 -1.3498412977349972e-01 + 1.0610450108886127e+00 -1.3901948587212587e-01 + 1.0673978948830793e+00 -1.2841637118486915e-01 + 1.0673757481072101e+00 -1.4438381605458517e-01 + 1.0594052656438890e+00 -1.3085792752504233e-01 + 1.0618453019661516e+00 -1.4367940111114308e-01 + 1.0573794933809211e+00 -1.3604662664165801e-01 + 1.0557678658364935e+00 -1.4175036002814068e-01 + 1.0629739229182320e+00 -1.4904089327760062e-01 + 1.0553809722862724e+00 -1.3253611304772051e-01 + 1.0588082610642218e+00 -1.2513541015943019e-01 + 1.0633559722046471e+00 -1.2706485609081142e-01 + 1.0572062593275291e+00 -1.4781774221715693e-01 + 1.0583695371806527e+00 -1.5404592409703355e-01 + 1.0503403725736078e+00 -1.5187621712119892e-01 + 1.0582397585586634e+00 -1.6062932356877013e-01 + 1.0522206653799913e+00 -1.5897389345526847e-01 + 1.0520497458625684e+00 -1.4586801095437352e-01 + 1.0526944892234553e+00 -1.3616500667633602e-01 + 1.0494836706155510e+00 -1.4055856639663489e-01 + 1.0453011314290421e+00 -1.4476083453951105e-01 + 1.0448702522871756e+00 -1.5753212091357227e-01 + 1.0430681370778032e+00 -1.5096329470163994e-01 + 1.0550365194073947e+00 -1.6551828825132020e-01 + 1.0472100991034523e+00 -1.6749026580293958e-01 + 1.0476344605076306e+00 -1.3495898019210983e-01 + 1.0447944445561390e+00 -1.3822877106294129e-01 + 1.0516854682966112e+00 -1.3050235419179046e-01 + 1.1920510577691914e+00 -2.1965508899111796e-01 + 1.1761798357812623e+00 -2.1715487293475633e-01 + 1.1841477140086027e+00 -2.0869352581922840e-01 + 1.1798904672986765e+00 -2.3006791070821464e-01 + 1.1955738900136907e+00 -2.0348844035761715e-01 + 1.1931891286557743e+00 -2.3383064805607034e-01 + 1.2116148730250629e+00 -2.1342312941219177e-01 + 1.2090404748671659e+00 -2.3017806529293239e-01 + 1.1739126461946370e+00 -2.0463717235861623e-01 + 1.1675685369522455e+00 -2.2580077021109446e-01 + 1.1640691204838021e+00 -2.1327262398651214e-01 + 1.1835371219444610e+00 -1.9975353057539280e-01 + 1.1811637646456887e+00 -2.4600542459762664e-01 + 1.1691904799879751e+00 -2.3796065945875000e-01 + 1.2122278190879143e+00 -1.9704581064787874e-01 + 1.1910561592065250e+00 -1.9149827441431455e-01 + 1.2005403411127986e+00 -1.9303010234395401e-01 + 1.2030528244356731e+00 -2.4639691036216504e-01 + 1.2294564280596489e+00 -2.2359481827294303e-01 + 1.2291777143988654e+00 -2.0653232627387297e-01 + 1.2238462512127484e+00 -2.4390261685579162e-01 + 1.1639683279965851e+00 -2.0169633766579409e-01 + 1.1758203354571108e+00 -1.9537800852299370e-01 + 1.1696660676906419e+00 -1.9651130700555086e-01 + 1.1582183033581543e+00 -2.2344942549483449e-01 + 1.1570824161491089e+00 -2.3474783470601324e-01 + 1.1561872095242549e+00 -2.0600554493130119e-01 + 1.1529649652396898e+00 -2.1538572043054671e-01 + 1.1815186694622568e+00 -1.8943503871534517e-01 + 1.1627586128979033e+00 -2.4826666837761024e-01 + 1.1923909403270869e+00 -2.6353316487927714e-01 + 1.1701072106539883e+00 -2.6374384918327110e-01 + 1.2071129915422034e+00 -1.8583783698565526e-01 + 1.2303349560754810e+00 -1.8853086567301602e-01 + 1.2170725304639376e+00 -1.8188148289183914e-01 + 1.1977921727510932e+00 -1.8182290854912253e-01 + 1.1868970053678680e+00 -1.8077225003989383e-01 + 1.2159182897695544e+00 -2.6234103181133150e-01 + 1.2469216741545921e+00 -2.3902777941678721e-01 + 1.2470753185772381e+00 -2.1705646039700355e-01 + 1.2386878159897918e+00 -2.6187709597859055e-01 + 1.2463794289895915e+00 -1.9602449562782454e-01 + 1.1639200422505596e+00 -1.9298805203608538e-01 + 1.1566958479633058e+00 -1.9726591713654784e-01 + 1.1724177480023030e+00 -1.8909210097699258e-01 + 1.1494336084361620e+00 -2.2571356104633367e-01 + 1.1433166286855680e+00 -2.3604203531978385e-01 + 1.1507825695008194e+00 -2.4576984609787189e-01 + 1.1467672588478450e+00 -2.0851605570689458e-01 + 1.1448846838693001e+00 -2.1754423154102653e-01 + 1.1493129776208661e+00 -1.9991329539989522e-01 + 1.1782375951550534e+00 -1.8056662428675452e-01 + 1.1385674724980746e+00 -2.2463517281704526e-01 + 1.1530623532332029e+00 -2.5942417196412748e-01 + 1.1565674566176085e+00 -1.8816843379872239e-01 + 1.1513268991189634e+00 -1.9279746137762288e-01 + 1.1642048052328349e+00 -1.8519421563283345e-01 + 1.1409340782241912e+00 -2.0164966248825067e-01 + 1.1371569522533562e+00 -2.1256385818007573e-01 + 1.2041850742156868e+00 -2.7728839067768263e-01 + 1.2246157363523764e+00 -2.8637431899043975e-01 + 1.2018807554316098e+00 -2.9637124632290579e-01 + 1.1703901356535482e+00 -1.7937623811053527e-01 + 1.1485874054007610e+00 -1.8640275128409201e-01 + 1.1585819706090206e+00 -1.8128783224631206e-01 + 1.1523830153106687e+00 -1.8118874136769136e-01 + 1.1637555588167601e+00 -1.7795126354633339e-01 + 1.1287298708412550e+00 -2.2164813519016491e-01 + 1.1269368382245375e+00 -2.1092350375221258e-01 + 1.1902696076482897e+00 -1.7085826547129557e-01 + 1.2079320942953444e+00 -1.7540888049555292e-01 + 1.1993966282532398e+00 -1.7029839303992844e-01 + 1.1831238768225703e+00 -1.7349962250735018e-01 + 1.2272957331389378e+00 -1.7244084273281146e-01 + 1.2423782523458584e+00 -1.7588197888888146e-01 + 1.2162874187504755e+00 -1.6764614403808764e-01 + 1.1750781356218596e+00 -1.7122449537041007e-01 + 1.0576451291215818e+00 -1.9721256624509920e-01 + 1.0444199452365908e+00 -2.0029382088968362e-01 + 1.0881136541754799e+00 -1.9625874308137270e-01 + 1.0693969859379351e+00 -1.8951294972571020e-01 + 1.1196010165695256e+00 -2.1801676531363512e-01 + 1.1584706357434840e+00 -1.6731364942906168e-01 + 1.1613338862056608e+00 -1.7258412566827985e-01 + 1.1557554456389880e+00 -1.7152993955706108e-01 + 1.1636113939125252e+00 -1.6720123226672001e-01 + 1.1599323032973388e+00 -1.6293003206443757e-01 + 1.1587781726486241e+00 -1.7584557702379300e-01 + 1.1675009194521238e+00 -1.7267928537421540e-01 + 1.1499742967217301e+00 -1.7100965108119226e-01 + 1.1539724793728041e+00 -1.7617853948351581e-01 + 1.1642056031484671e+00 -1.6212394820286136e-01 + 1.1689901908046068e+00 -1.6549189844648993e-01 + 1.1483070093784136e+00 -1.7611655943493076e-01 + 1.1449737261169304e+00 -1.6750351891869286e-01 + 1.1447278542778321e+00 -1.7190529525862530e-01 + 1.1681946025111500e+00 -1.5876710257029458e-01 + 1.1745592365996629e+00 -1.6279554145279462e-01 + 1.1651551856931093e+00 -1.5475933993607782e-01 + 1.1816628232028137e+00 -1.6611343574493276e-01 + 1.1467203460481699e+00 -1.8051154227313759e-01 + 1.1400367068537776e+00 -1.6493079991010973e-01 + 1.1736676690781565e+00 -1.5692917889685987e-01 + 1.1691569622335933e+00 -1.5245483136651217e-01 + 1.1804411913516901e+00 -1.5778684576781643e-01 + 1.1649194336973423e+00 -1.5171991459700962e-01 + 1.1871972904481325e+00 -1.6160811978707557e-01 + 1.1403370038076872e+00 -1.5476053133862422e-01 + 1.1613392857856013e+00 -1.3389728291873837e-01 + 1.1624675197106171e+00 -1.3035215464579153e-01 + 1.1647737539974798e+00 -1.3685245115242139e-01 + 1.1621946517264945e+00 -1.4029902345836831e-01 + 1.1650289913988345e+00 -1.3321716054196031e-01 + 1.1642132350955876e+00 -1.2571404444297229e-01 + 1.1608007610484421e+00 -1.2189668423633293e-01 + 1.1676431750510261e+00 -1.2987723859171751e-01 + 1.1598601843665719e+00 -1.4326382655431757e-01 + 1.1662297797694876e+00 -1.4131834333178972e-01 + 1.1694555356387326e+00 -1.3427708652844217e-01 + 1.1696827212652749e+00 -1.3880273584535985e-01 + 1.1633238505076591e+00 -1.4362771938472463e-01 + 1.1577616331967135e+00 -1.1872383249193774e-01 + 1.1431408830569865e+00 -1.0831305964565274e-01 + 1.1408204710194951e+00 -1.0365864402483282e-01 + 1.1480756298949331e+00 -1.0855064841823037e-01 + 1.1449261960176642e+00 -1.1248064246616707e-01 + 1.1485248254623670e+00 -1.1359270091807616e-01 + 1.1529438915683130e+00 -1.1137764747022061e-01 + 1.1462943265066272e+00 -1.1587664505830730e-01 + 1.1432805408837297e+00 -1.1626472382471320e-01 + 1.1591207969473061e+00 -1.0981943991475873e-01 + 1.1518407261341537e+00 -1.1525163638441427e-01 + 1.1561519853819533e+00 -1.1481825604280971e-01 + 8.4880214301106349e-01 -6.0932625898573178e-03 + 8.5628301683134822e-01 -3.4859198827462023e-02 + 8.5904588067096199e-01 -2.9741377211365716e-02 + 8.5921555810405437e-01 -2.4885143396133458e-02 + 8.6249823985952645e-01 -3.2964151141598563e-02 + 8.5897947768625471e-01 -4.1744110013084423e-02 + 8.6135952827559947e-01 -3.7738228371040350e-02 + 8.7121002945946202e-01 9.8760574319115335e-02 + 8.8231236940990954e-01 1.0614255784206250e-01 + 8.7007655743324364e-01 1.0996718905402503e-01 + 8.5692279311268038e-01 9.7845911107917516e-02 + 8.7893145437660536e-01 1.1721562601450586e-01 + 8.9340560835815808e-01 1.0779958478123319e-01 + 8.9047125882009937e-01 1.1756225564469247e-01 + 8.5680896847515697e-01 1.1300361650970814e-01 + 8.6690385856587682e-01 1.2530757619744293e-01 + 8.4555327051120344e-01 1.0457258266001190e-01 + 8.8328828637050805e-01 1.2757482449916324e-01 + 8.5222885451956643e-01 1.2328525869726548e-01 + 8.4199252897123955e-01 1.1489667573439277e-01 + 8.7620033325428892e-01 1.3684010242091205e-01 + 8.5444172343547109e-01 1.3268898778298421e-01 + 8.6325469066209592e-01 1.4188500460104336e-01 + 8.4000147035602879e-01 1.2916802341153755e-01 + 8.2685868696498943e-01 1.1722894569449949e-01 + 8.4821480179039099e-01 1.4427534917241047e-01 + 8.7392857769601306e-01 1.5324031331660137e-01 + 8.5741632298989146e-01 1.5665343595158987e-01 + 8.2104822117774034e-01 1.2976164656289768e-01 + 8.3084730234613602e-01 1.4403930271131316e-01 + 8.1376591999082137e-01 1.4389461897357592e-01 + 8.0180855740795209e-01 1.3044373975110091e-01 + 8.4011252300204120e-01 1.5811308540282454e-01 + 8.1761627726449859e-01 1.5995057413045544e-01 + 7.9864570946510582e-01 1.4917645080327446e-01 + 7.8493656834740477e-01 1.3562337110026590e-01 + 8.3121438662205804e-01 1.7302533672525300e-01 + 8.5131031831627979e-01 1.7705264075645744e-01 + 7.9724579424905784e-01 1.6897762439320729e-01 + 8.1448666590238616e-01 1.7973027470259240e-01 + 8.6642881505835589e-01 1.6776556044170832e-01 + 7.7650113953085054e-01 1.5616877647105554e-01 + 2.4135346826162873e-01 1.5050857487022284e-01 + 2.3495354472763808e-01 1.7694312149622249e-01 + 5.4873183866692443e-01 -5.9051302424951757e-01 + 5.5168876117585341e-01 -5.1557957434246759e-01 + 5.7901716570427197e-01 -6.7467061837970732e-01 + 4.3309727441132395e-01 -2.2525178014352321e-01 + 4.5919177850316117e-01 -2.3595032926544945e-01 + 4.1700929697400113e-01 -2.0961177461933289e-01 + 4.8643000514601198e-01 -2.5636446429567172e-01 + 4.5067754136113081e-01 -2.1532094190996531e-01 + 4.3503897540085035e-01 -2.0945850891739326e-01 + 4.8764153388193421e-01 -2.2906135429283836e-01 + 4.7293989129843794e-01 -2.0978026453336440e-01 + 4.0962822105448993e-01 -1.9223746760549432e-01 + 4.2725553730114996e-01 -1.9325945471291561e-01 + 5.1319576519949806e-01 -2.7707469560412790e-01 + 5.1036521279538505e-01 -2.3494500747067093e-01 + 5.2437939036426684e-01 -2.5881374634379029e-01 + 5.1516186090140081e-01 -3.0066867431536082e-01 + 5.3537021093762149e-01 -3.2939501460586484e-01 + 5.2310829248116875e-01 -3.7212420932971213e-01 + 4.5033072886791814e-01 -1.9564944293678366e-01 + 5.0352096041475392e-01 -2.0829085270624148e-01 + 4.7029422131510756e-01 -1.9203807189171584e-01 + 4.8643925648588038e-01 -1.9167053393259437e-01 + 4.5999205096377693e-01 -1.7803211695708399e-01 + 4.3637646484116743e-01 -1.7460186900774488e-01 + 5.3613866724030856e-01 -2.3842968989144708e-01 + 5.2460332255357400e-01 -2.1937563662427806e-01 + 5.4309868905927772e-01 -2.8572328774238542e-01 + 5.5152620464771474e-01 -2.5739752800095062e-01 + 5.0436274881202792e-01 -1.8469933573827291e-01 + 4.7553290607972798e-01 -1.7969574446182435e-01 + 4.8648970835094474e-01 -1.7372097873240477e-01 + 6.8813813725753903e-01 -7.2306072881318073e-02 + 6.7910971430643485e-01 -7.1498034094091167e-02 +-7.1149075616247615e-02 -2.7548059163720495e-02 +-7.5773706076276426e-02 -2.6383425355945178e-02 +-7.6026417824408554e-02 -2.1145889771702286e-02 +-7.3557991703239622e-02 -3.1004526350869810e-02 +-8.0947503879883698e-02 -2.2489253411109189e-02 +-7.7473423024883914e-02 -3.1413894936349607e-02 +-8.1460509754577970e-02 -2.7968041803461574e-02 +-7.9118180103023406e-02 -1.7267714253691224e-02 +-7.6799034665427257e-02 -1.3361477174044012e-02 +-8.6622455406399013e-02 -2.4280453957643999e-02 +-8.2121054563245366e-02 -3.2502104414973587e-02 +-7.8764724858899626e-02 -3.5786079293018247e-02 +-8.6597120033331976e-02 -2.9493526486632504e-02 +-8.3519459626742787e-02 -3.7409863880853322e-02 +-8.6204132178465898e-02 -3.3881510516778235e-02 +-9.0836898678333000e-02 -2.6239440790703839e-02 +-9.2111671429435660e-02 -3.2165602368223745e-02 +-8.8090189835526189e-02 -3.6691778828995325e-02 +-8.7978969191766510e-02 -4.0818972449372382e-02 +-8.2528758516502876e-02 -4.2053574973792252e-02 +-9.8614643098770216e-02 -3.1680083906707068e-02 +-9.2837332767700786e-02 -4.7251146433126223e-02 +-8.9254610337860640e-02 -4.8409469115483716e-02 +-9.3918293436999534e-02 -4.1953212176238708e-02 +-9.0037281463594354e-02 -4.4814302548147111e-02 +-9.2019349866419020e-02 -3.7587117963283845e-02 +-9.6854703382348362e-02 -3.6619635637222814e-02 +-8.5469074084329577e-02 -4.6224992839370316e-02 +-1.0293576393543447e-01 -3.5937841263375958e-02 +-2.6193771665636234e-01 -8.7535777435903128e-03 +-2.8541294942381512e-01 1.5022230948844140e-02 +-4.8456839682243924e-01 1.1053161684912993e-02 +-5.3794837911129889e-01 -2.0834315455502406e-02 +-4.0302571971537304e-01 5.7558608826298041e-02 +-4.2288080495707447e-01 6.4363901243424948e-03 +-4.5958647594196123e-01 -5.3481418854673279e-02 +-5.1485238758502305e-01 -1.0429079804598018e-01 +-3.8706306597497075e-01 2.4164464591059698e-02 +-3.9831343775796313e-01 -5.1711473579430844e-02 +-3.6454890622769653e-01 -6.6387825898033270e-03 +-4.5466506235413817e-01 -1.1659095491570781e-01 +-4.1116594120074978e-01 -9.9110678422505316e-02 +-5.7868289753469071e-01 -1.6144544126917992e-01 +-4.7860419088812023e-01 -1.7585510852347852e-01 +-1.3449725929277179e-01 -9.5281532002587710e-02 +-2.5035441324089902e-01 -1.1634511793182867e-01 +-2.6248642335166039e-01 -9.0789025396290413e-02 +-2.2826414269796658e-01 -1.3028207350622267e-01 +-2.8500133598871003e-01 -7.8957046352641669e-02 +-2.8578523185915117e-01 -4.2911219552593138e-02 +-2.8061039424677858e-01 -1.0867870813902414e-01 +-2.4760610162113039e-01 -1.4600093839537465e-01 +-2.7500158516065198e-01 -1.3867248264187992e-01 +-2.1198676734887556e-01 -1.3502275403334352e-01 +-2.2039414637549726e-01 -1.5139884396182879e-01 +-3.2019089690645330e-01 -6.8761093972256049e-02 +-3.0471526846623931e-01 -9.7952407891426674e-02 +-2.9272269315964650e-01 -1.0844630358860741e-02 +-3.2169100952999941e-01 -2.7691635252224955e-02 +-3.0610333927256761e-01 -1.2935616862019117e-01 +-2.6628541236613046e-01 -1.7173313276489921e-01 +-2.3875018696739403e-01 -1.6724464961360752e-01 +-3.0220020484503607e-01 -1.6088337917543072e-01 +-1.9534804404304396e-01 -1.4226556750162445e-01 +-2.1969049656610196e-01 -1.7498216109960651e-01 +-2.0111328538403939e-01 -1.6399376358315010e-01 +-3.3628403387719175e-01 -1.0750714065279965e-01 +-3.4664259379059104e-01 -1.5015552506905294e-01 +-2.9536035569154251e-01 -1.8766240766092324e-01 +-2.4258538198569113e-01 -1.9010543808538216e-01 +-2.6810687292623925e-01 -2.1097686102167756e-01 +-3.2129704796219016e-01 -1.8245599094444742e-01 +-3.5263730946624605e-01 -4.6491152882097708e-02 +-3.6626204767850368e-01 -8.3659169385526866e-02 +-3.1647346803831056e-01 1.3869554458089794e-02 +-1.7807465149948598e-01 -1.4106518663325573e-01 +-1.6966002238919486e-01 -1.3049114378638649e-01 +-1.8431399543005966e-01 -1.5841902113474760e-01 +-1.5313099864469848e-01 -1.2472621008669194e-01 +-1.6174853056446636e-01 -1.2437315464325138e-01 +-1.5956331846000182e-01 -1.3210556672510165e-01 +-1.4973326097572226e-01 -1.3319513219380497e-01 +-1.6641122712161405e-01 -1.4085294006039817e-01 +-1.5465486490836611e-01 -1.4163009138390237e-01 +-1.4336322095880405e-01 -1.4102298648190015e-01 +-5.5411747371061892e-01 -2.9665251715549346e-01 +-5.3749735661338605e-01 -2.2389987481606966e-01 +-4.8549987938243078e-01 -2.5639468758484441e-01 +-4.6706765932071903e-01 -3.2833864606419638e-01 +-4.3892931963299020e-01 -2.7652865845220731e-01 +-4.4186847629092085e-01 -2.3577283208369693e-01 +-3.9813281385841037e-01 -3.1385365139801991e-01 +-4.0446915288524110e-01 -2.0775697664110737e-01 +-4.0350910127448003e-01 -1.5250056122144429e-01 +-4.0183983866583617e-01 -2.6232872921686123e-01 +-3.4895296370822848e-01 -2.8682782365461890e-01 +-3.5592600828775289e-01 -1.9917593877642048e-01 +-3.6763328140783358e-01 -2.4058363503469593e-01 +-3.7309075951475279e-01 -1.1885874620200809e-01 +-3.0276729153212045e-01 -3.1803026440719862e-01 +-3.2840130467458550e-01 -2.4599905127497834e-01 +-3.0540496731484268e-01 -2.7745880865700201e-01 +-3.0635607719592883e-01 -2.1440270404028183e-01 +-1.5892588759855641e-01 -1.5263886867576559e-01 +-1.4698034838589535e-01 -1.5114149118345210e-01 +-1.7101106499414698e-01 -1.5178429841904517e-01 +-1.4830729301849033e-01 -1.6365000290429066e-01 +-1.6619052716286831e-01 -1.6677438810344825e-01 +-1.3611383083664919e-01 -1.4800194299748171e-01 +-1.3756933383065473e-01 -1.5784485439822049e-01 +-1.5362305003795029e-01 -1.7869533762588219e-01 +-1.3611686466985873e-01 -1.6815014460622990e-01 +-1.4027917358073694e-01 -1.7877244421005400e-01 +-1.8043091325196770e-01 -1.7636456666166112e-01 +-1.6568059139373759e-01 -1.8543880347611719e-01 +-1.2891128862999324e-01 -1.5315395211679572e-01 +-1.2777114447031579e-01 -1.6260100618559648e-01 +-1.9172087328560394e-01 -1.7066793571910921e-01 +-1.4884641425041423e-01 -1.9284342207966176e-01 +-1.2487620158840684e-01 -1.7501380872170103e-01 +-1.3185062700992489e-01 -1.8955646100226886e-01 +-1.8028949302514263e-01 -1.9648170959970912e-01 +-1.9802276068151059e-01 -1.8422631832099512e-01 +-1.6401850879350377e-01 -2.0066680760977817e-01 +-1.2165556574501579e-01 -1.4944785724026133e-01 +-1.2310465104623347e-01 -1.5654618537760712e-01 +-1.1796733737860166e-01 -1.6291227427230126e-01 +-9.0710616405402789e-02 -1.4501327768114436e-01 +-9.4172115703997861e-02 -1.5026558462389517e-01 +-9.5419347194507509e-02 -1.4578483156456912e-01 +-8.9572360441053434e-02 -1.4989530238163695e-01 +-9.4727722225115940e-02 -1.4145566556108236e-01 +-8.9881473977243331e-02 -1.3974121450438304e-01 +-9.9126313382484454e-02 -1.4902391830011652e-01 +-9.1431629272975101e-02 -1.5486500707569917e-01 +-9.7171658026681484e-02 -1.5552997407129965e-01 +-9.8529218359587389e-02 -1.4374502958507662e-01 +-8.2224362593805722e-02 -1.3544164874579678e-01 +-7.8218806669241303e-02 -1.3803142216944764e-01 +-1.0431551870789235e-01 -1.5435959177497693e-01 +-1.0381152642730740e-01 -1.4530987651353655e-01 +-9.3832671083816876e-02 -1.6000513158417107e-01 +-8.8648093685421259e-02 -1.5973545222382768e-01 +-9.9857938491538789e-02 -1.6312215862883761e-01 +-1.1014658457760618e-01 -1.4986118228597434e-01 +-1.0853718630497156e-01 -1.6301976945558749e-01 +-1.1093845732436591e-01 -1.5687792445434923e-01 +-9.2054035942311430e-02 -1.6677306592126229e-01 +-8.4436506280368917e-02 -1.6493937487116739e-01 +-1.0501348371977315e-01 -1.6878647212260489e-01 +-9.8690060740409535e-02 -1.7217838348136638e-01 +-7.7179759277697713e-02 -1.6322104330856746e-01 +-1.1616934475516416e-01 -1.5333082497116379e-01 +-1.1513537669219431e-01 -1.4697772206038451e-01 +-1.1231859094228014e-01 -1.7078979829619811e-01 +-9.2291839916015306e-02 -1.7504487232115196e-01 +-8.5722523994988364e-02 -1.7285614971723362e-01 +-1.0558114462976675e-01 -1.7508099847546532e-01 +-9.9057367667512608e-02 -1.8310067042914113e-01 +-7.9994503387652571e-02 -1.6995345426499853e-01 +-2.6338990121435302e-01 -3.2617534429249417e-01 +-2.6978905367363382e-01 -2.8861097448232442e-01 +-2.4215039729330101e-01 -3.0170705092344008e-01 +-2.7711422298553146e-01 -2.4782592946580451e-01 +-2.3505530238264782e-01 -2.6383082625642373e-01 +-2.1255791909227639e-01 -2.9280414419574186e-01 +-2.4421577879969902e-01 -2.3503176739724552e-01 +-1.9770062026555024e-01 -2.5925012152053739e-01 +-2.1410518058719674e-01 -2.3763483196975699e-01 +-1.6381575200719567e-01 -3.1152527915733685e-01 +-1.7684533827301152e-01 -2.8281583213858141e-01 +-1.4686698288618061e-01 -2.8928273461644949e-01 +-1.6930578273228036e-01 -2.4896151092239904e-01 +-1.5377946852817104e-01 -2.6819491564037889e-01 +-1.8856165551596860e-01 -2.3676234417085595e-01 +-1.3257948488184468e-01 -2.7009439317639306e-01 +-1.4329975386741012e-01 -2.4982010734804305e-01 +-1.7384802137036104e-01 -2.2013009066796485e-01 +-1.5146279565951204e-01 -2.3016171358604254e-01 + 1.3223437649849501e+00 7.0095400626613014e-02 + 1.2897723152515752e+00 1.0127258054480137e-01 + 1.2579464401382694e+00 1.2861027845701756e-01 + 1.3263066472904512e+00 3.5142020364915538e-02 + 1.2742564097032982e+00 6.8379269285379962e-02 + 1.2903157929449165e+00 3.9325616194261670e-02 + 1.2467834801578874e+00 9.7074727419141027e-02 + 1.2212104837881697e+00 1.5132299961639717e-01 + 1.1961589164726689e+00 1.8849736371614512e-01 + 1.2138746055449943e+00 1.1825451790105745e-01 + 1.3037624853474128e+00 1.3031726430938306e-02 + 1.2536257319282953e+00 3.8939697070276225e-02 + 1.2332873188358562e+00 6.2649033618590977e-02 + 1.2708256528854918e+00 1.5146259838253684e-02 + 1.3205254704473290e+00 -1.6503907766022508e-02 + 1.2025202555140524e+00 8.1404693603303713e-02 + 1.2195834431473997e+00 2.8334901386067202e-02 + 1.2406768944190603e+00 1.0852556675786218e-02 + 1.2041975324036827e+00 5.3828168865528880e-02 + 1.2861485393233565e+00 -1.1900775269779729e-02 + 1.3301347156863841e+00 -4.8777202072784576e-02 + 1.3002944630109141e+00 -3.4315658805496696e-02 + 1.2583830477426972e+00 -1.2980129473248780e-02 + 1.1779811266538971e+00 2.3572808644429699e-01 + 1.1847293733803994e+00 1.4009864261232963e-01 + 1.1513546086550832e+00 1.5915461418847343e-01 + 1.1449629211568393e+00 1.9801474810165587e-01 + 1.1835032727471031e+00 1.0848774671377015e-01 + 1.1793562743438670e+00 5.7712643959483501e-02 + 1.1669432854213042e+00 8.5245049308014131e-02 + 8.5485646337009769e-01 3.9435295534508441e-01 + 8.2240625562858582e-01 3.7029457975908997e-01 + 9.4090024084833601e-01 3.6104050198311199e-01 + 8.6228348953956413e-01 3.5859218635165035e-01 + 9.0168044162267336e-01 3.4583146489628547e-01 + 7.7923267294990239e-01 3.3430855414805194e-01 + 8.2518092930287423e-01 3.3251937872624637e-01 + 9.3932872918023236e-01 3.2206619985235818e-01 + 1.0148881475319342e+00 3.1029616277467653e-01 + 9.7453612121692146e-01 2.8696611492968316e-01 + 1.0603922335398650e+00 3.0332657851457867e-01 + 8.6349236907789617e-01 3.1577961433275448e-01 + 9.0222528695449711e-01 3.0367859162136313e-01 + 1.0422366320904999e+00 -1.1968990394223056e-01 + 1.0411408274807172e+00 -1.2557912218673550e-01 + 1.0372215564872462e+00 -1.2199478243897488e-01 + 1.0461176750912671e+00 -1.2272767753846381e-01 + 1.0384235268552473e+00 -1.1602323140068904e-01 + 1.0360018325851215e+00 -1.2768386116762542e-01 + 1.0455166263347095e+00 -1.2917143203701187e-01 + 1.0400491072039273e+00 -1.3162979077877424e-01 + 1.0317998761409939e+00 -1.2364704413272420e-01 + 1.0508205287406582e+00 -1.2507364842076640e-01 + 1.0340966139124816e+00 -1.3300524264418812e-01 + 1.0308979824877014e+00 -1.2831970630780631e-01 + 1.0434349655740647e+00 -1.3420132448608513e-01 + 1.0392624563792765e+00 -1.3825790543235428e-01 + 1.0544539048138120e+00 -1.2635992882766800e-01 + 1.0263228889681386e+00 -1.2509002347901799e-01 + 1.0269899140625327e+00 -1.1900933050766582e-01 + 1.0331060438192807e+00 -1.1835226144675914e-01 + 1.0312721465102399e+00 -1.4009653945484501e-01 + 1.0262687008317499e+00 -1.3217236011557532e-01 + 1.0370772600140228e+00 -1.4638109432156909e-01 + 1.0669484938288534e+00 -1.2454363306906657e-01 + 1.0635707687282547e+00 -1.2169506828902854e-01 + 1.0683193136394067e+00 -1.2075678126379330e-01 + 1.0211920689726668e+00 -1.2743081034162174e-01 + 1.0211449322265622e+00 -1.2176815249934236e-01 + 1.0264425586001522e+00 -1.1192639614532141e-01 + 1.0222320707766386e+00 -1.1617626585956486e-01 + 1.0295572863838629e+00 -1.4983511613004907e-01 + 1.0230455163347898e+00 -1.3774759743317588e-01 + 1.0244125585897805e+00 -1.4400727549976011e-01 + 1.0377516690851394e+00 -1.5426620661230572e-01 + 1.0172976532315090e+00 -1.3275087289498799e-01 + 1.0553530180068265e+00 -1.7394918283854111e-01 + 1.0456080474445173e+00 -1.8012284300296244e-01 + 1.0385539675601549e+00 -1.6269375248811002e-01 + 1.0367020587365587e+00 -1.7318367909120980e-01 + 1.0538751193609812e+00 -1.8499246833034988e-01 + 1.0620162896746663e+00 -1.8269061858501345e-01 + 1.0337324242237926e+00 -1.9043528187233960e-01 + 1.0467755652354924e+00 -1.9068618008242311e-01 + 1.0292909544379398e+00 -1.6551340776769052e-01 + 1.0320892538993789e+00 -1.5786063382903137e-01 + 1.0249445814347808e+00 -1.7680399617296416e-01 + 1.0168076707408034e+00 -1.9076163066368679e-01 + 1.0223494776366024e+00 -2.0475162010377801e-01 + 1.0241520082979108e+00 -1.5717465818140397e-01 + 1.0182546847509926e+00 -1.6605298559360904e-01 + 1.0119116152327052e+00 -1.7734229908256793e-01 + 1.0213563013928848e+00 -1.4957669075025137e-01 + 9.6754739781012233e-01 -7.9484452679976414e-01 + 8.4098379442381344e-01 -7.7746478634011851e-01 + 1.0107189823027412e+00 -6.8026889524023204e-01 + 9.2348260711231234e-01 -7.1347813048004127e-01 + 7.7990022138935444e-01 1.8392362319502809e-01 + 7.5921962952133271e-01 1.7142158385930628e-01 + 7.5152839265425087e-01 1.4551922688381325e-01 + 7.9964381870156842e-01 1.8867936373944616e-01 + 8.3242991748240058e-01 1.9089994944891941e-01 + 8.1457773732375927e-01 2.0559291026074789e-01 + 7.6015274840534630e-01 1.9439308049595638e-01 + 7.9200867464330571e-01 2.0517238614569067e-01 + 7.7449069563761697e-01 2.0487720444099011e-01 + 7.3371439590113852e-01 1.6462714074257434e-01 + 7.3946857964490675e-01 1.8639444721988241e-01 + 8.3544113619571903e-01 2.1162396170692688e-01 + 8.5026378917812906e-01 2.0132288795234388e-01 + 8.0181378059397446e-01 2.2885264640982683e-01 + 8.2520284031902946e-01 2.2946938320536958e-01 + 8.6967065372257935e-01 2.1148751994022064e-01 + 9.2960047101612986e-01 2.7904246174934144e-01 + 8.9477943394150117e-01 2.6750991754364861e-01 + 8.5203969503203325e-01 2.2836480564443917e-01 + 8.6407829685483506e-01 2.5799099094361111e-01 + 1.0294240407612847e+00 2.7406189733699193e-01 + 8.7688310893801713e-01 2.8624959052432075e-01 + 8.3573197989976222e-01 2.5287923167454096e-01 + 8.4642235369920371e-01 2.8170971083270047e-01 + 7.8141730544039945e-01 2.2450765089187996e-01 + 8.1248355839933595e-01 2.4602561987587279e-01 + 7.9178756566366104e-01 2.4951446875379446e-01 + 7.5910912300985700e-01 2.1772966984624986e-01 + 7.6875005926311957e-01 2.4456353539319764e-01 + 8.1124636221352375e-01 2.7375072238760367e-01 + 7.8133717397864899e-01 2.7013133708397419e-01 + 7.4351548074837126e-01 2.0453934638619842e-01 + 7.4936730659336348e-01 2.3662079849022177e-01 + 7.3723774115150320e-01 2.2116416063997235e-01 + 7.5341006819682832e-01 2.6190842937333514e-01 + 7.9733384077628955e-01 3.0193023537872676e-01 + 8.2977097348847195e-01 3.0187637737678585e-01 + 7.6495121392753163e-01 2.9278463685560752e-01 + 7.1654493852265944e-01 1.8201968771431609e-01 + 7.2577301179065756e-01 2.0325075141066407e-01 + 7.0954612542035278e-01 1.5506942643902022e-01 + 6.7812106457324717e-02 -1.0068123844386889e-01 + 5.9441088728320324e-02 -1.0620610101311456e-01 + 5.7475933838347260e-02 -9.7920683136877074e-02 + 6.7848918743138142e-02 -1.1091720893618628e-01 + 6.5588907504178451e-02 -8.9873016587702637e-02 + 7.6008021459280428e-02 -1.0400445258483160e-01 + 5.1058685435855011e-02 -1.0480182554391604e-01 + 5.5579898337796863e-02 -1.1552881802823833e-01 + 4.9797433544846115e-02 -9.6295450051712805e-02 + 7.8876348514192784e-02 -1.1488658000629925e-01 + 6.7793421776485729e-02 -1.2182569047777747e-01 + 4.1276799433191513e-02 -1.0040293203243777e-01 + 4.2780958732627994e-02 -1.1245696900127200e-01 + 7.8812398822101670e-02 -1.2842419047973408e-01 + 9.1273838523498796e-02 -1.2027081991962518e-01 + 5.7377565399185926e-02 -1.2705529330185072e-01 + 4.6196431611065236e-02 -1.2243476298290545e-01 + 6.7877894175708775e-02 -1.3145661516163898e-01 + 3.6483461157814645e-02 -9.2213272460327289e-02 + 4.8939063883764788e-02 -1.3291651145907224e-01 + 5.0116996437935768e-02 -1.4498798997502149e-01 + 4.0314137869870592e-02 -1.3929578876688709e-01 + 6.0545722467097107e-02 -1.3783090965947054e-01 + 4.0457278975672750e-02 -1.2997139910717692e-01 + 3.9814052324985028e-02 -1.5183881660831844e-01 + 6.3081636321456358e-02 -1.5011704547619331e-01 + 5.1424332757292746e-02 -1.5565625010331985e-01 + 3.2348853918691134e-02 -1.3337884730105998e-01 + 3.1135554733637605e-02 -1.4306534528509474e-01 + 7.4860362413680548e-02 -1.4214699188934787e-01 + 3.4487907595021738e-02 -1.2183108502588880e-01 + 4.6278390624770793e-02 -1.6477211861193553e-01 + 5.9687504253716384e-02 -1.6456398865332744e-01 + 7.3717999430400027e-02 -1.5945574856496592e-01 + 2.6523141503716374e-02 -1.2793031397731625e-01 + 8.9150262319904527e-02 -1.5240411610777471e-01 + 8.9770798197946533e-02 -1.3630349929923113e-01 + 3.3651571488640286e-02 -1.0933460474819867e-01 + 2.3003836406090272e-02 -1.2075630476499555e-01 + 2.7128117991772172e-02 -1.1391057614237354e-01 + 5.4637635345621050e-02 -1.8032247278939906e-01 + 7.0362232607763531e-02 -1.7340009908913601e-01 + 8.5592784132245470e-02 -1.7090486163152718e-01 + 1.0235612705465513e-01 -1.4611962346337748e-01 + 1.0177717107550421e-01 -1.6461621132296500e-01 + 1.0325436418291645e-01 -1.2835832209515274e-01 + 2.5674103908741586e-02 -1.0610546205647609e-01 + 3.2147495570505669e-02 -9.9656664740237488e-02 + 1.8034879563266770e-02 -1.1310796275502355e-01 + 7.6699313716048323e-02 -1.9069140189893119e-01 + 5.1067868895948720e-02 -1.9761873551189524e-01 + 9.6068740678461495e-02 -1.7960609473406919e-01 + 1.1883295150010298e-01 -1.1875440808347548e-01 + 1.0393064933312246e-01 -1.1085879617633054e-01 + 1.1401184777484019e-01 -1.3730023916295409e-01 + 1.2922541860405090e-01 -1.3892881413418934e-01 + 1.1587136826994993e-01 -1.5422289771397857e-01 + 1.3197573629705772e-01 -1.6139903609996509e-01 + 1.4329576011917311e-01 -1.4901484726215131e-01 + 1.4967448239011816e-01 -1.2751364911426322e-01 + 1.1588190881353455e-01 -1.7697346210043463e-01 + 1.3609442930538762e-01 -1.8067377698787368e-01 + 1.2260161106584633e-01 -1.9530383430443976e-01 + 1.0039252565496781e-01 -1.9484453671644530e-01 + 1.5404996781340685e-01 -1.8584928704514425e-01 + 1.3957990978443746e-01 -1.9585037710469066e-01 + 5.5002839622994770e-01 -4.0532010636296434e-01 + 5.7423379455703127e-01 -4.4777713562434940e-01 + 5.5358223326669531e-01 -3.6548626538842655e-01 + 5.8645567082569272e-01 -4.1415030552265364e-01 + 5.8930292239423920e-01 -3.7491373201525846e-01 + 5.7081981922519276e-01 -3.4001408660506627e-01 + 5.7191460266928118e-01 -3.0700861655310518e-01 + 6.2117736094288745e-01 -4.8354777826344275e-01 + 5.8811509799041062e-01 -5.6329198011805204e-01 + 6.2389344006309955e-01 -5.4122345763276769e-01 + 6.2252657375341869e-01 -4.1988787365549740e-01 + 6.0392912685820477e-01 -3.2326680446269052e-01 + 6.3491136685686200e-01 -3.6330434384680643e-01 + 5.7379403960054276e-01 -2.7494336170882150e-01 + 5.9501719630162597e-01 -2.8788162919619253e-01 + 6.2814635205585745e-01 -6.0585186424742687e-01 + 7.0611762770004560e-01 -5.1116282043000183e-01 + 6.6934168183648524e-01 -4.4918145202386484e-01 + 6.7463690466532000e-01 -5.6551826260086102e-01 + 6.7448566563389534e-01 -3.9748794580998492e-01 + 4.8606085192961501e-01 -1.5446755002335522e-01 + 5.4708695995877576e-01 -2.2050770791557284e-01 + 4.7047134712236272e-01 -1.6245046847859612e-01 + 4.5261329536036499e-01 -1.6308545615635239e-01 + 4.3841877254776307e-01 -1.4947513010088187e-01 + 5.7238625623872252e-01 -2.2256872586257259e-01 + 5.5593862497535440e-01 -2.3741441930982887e-01 + 5.9799608252522063e-01 -2.3705242407224603e-01 + 5.7580781664662339e-01 -2.4906066300960106e-01 + 1.1989906525002425e-02 -1.0750636644287681e-01 + 1.7765675302619854e-02 -1.0454607304937724e-01 + 1.2532471100314524e-02 -9.9088845240174805e-02 + 8.6699528976979678e-01 -3.7191985184762189e-02 + 8.6696943121786774e-01 -3.1309127292047378e-02 + 8.6420671456192366e-01 -4.1656690227114268e-02 + 8.6347431480837145e-01 -4.7366308602178719e-02 + 9.1906647912878725e-01 -1.3518591930167645e-01 + 9.2520887178562106e-01 -1.5025944939236524e-01 + 9.0893768680702181e-01 -1.4626076687784462e-01 + 9.3507457204150057e-01 -1.3889743881645700e-01 + 9.0337330222969570e-01 -1.2890219422790494e-01 + 9.2835625876261219e-01 -1.2442479221621738e-01 + 9.1558596075773835e-01 -1.2358944173168140e-01 + 9.1512522917793149e-01 -1.6079286073305354e-01 + 9.3691096342232072e-01 -1.5312055502327837e-01 + 9.3046331814802841e-01 -1.6846950642749903e-01 + 8.9604829810283348e-01 -1.4158946527065552e-01 + 8.9715709482061357e-01 -1.6211125724127839e-01 + 9.4034448896906753e-01 -1.2840174809410598e-01 + 9.4780708425550131e-01 -1.4659164197604468e-01 + 9.4782785796657976e-01 -1.3429796571156771e-01 + 9.0636394217897731e-01 -1.1447452689371573e-01 + 8.8920730850013996e-01 -1.2989710143430955e-01 + 8.9483118578889531e-01 -1.1897842198105479e-01 + 9.2078741018999466e-01 -1.1252876537393774e-01 + 9.4160537546040501e-01 -1.1870198607957150e-01 + 9.3173350557714940e-01 -1.1387799028763368e-01 + 9.1264083372671934e-01 -1.7761352125521057e-01 + 9.4816546425491310e-01 -1.6211230336260485e-01 + 9.2750240379764648e-01 -1.9288931023690736e-01 + 9.4737537398249572e-01 -1.8429698341350331e-01 + 8.8108153181028115e-01 -1.4375407672613960e-01 + 8.9982999106902639e-01 -1.8023341197185516e-01 + 8.7777697029950019e-01 -1.6173412633966677e-01 + 8.8486728442289575e-01 -1.8258390233498289e-01 + 9.4894118359482604e-01 -1.2501540768955977e-01 + 9.6016032886862490e-01 -1.3895821297390398e-01 + 9.6469375570544713e-01 -1.5469998039984034e-01 + 9.5814517361414175e-01 -1.2832653420018403e-01 + 8.9159612712599312e-01 -1.0691860213731275e-01 + 9.1337020345221731e-01 -1.0547603584963383e-01 + 9.0444502950767713e-01 -1.0193646485569730e-01 + 8.8329544169555163e-01 -1.1778018256292455e-01 + 8.7661409137353274e-01 -1.2837826783714945e-01 + 9.2977304921522830e-01 -1.0544414896652654e-01 + 9.2142822844996175e-01 -1.0109853502474664e-01 + 9.3814543425752106e-01 -1.0829025880194365e-01 + 9.5526206263555480e-01 -1.1827619794536304e-01 + 9.4879143548114087e-01 -1.1032755077648915e-01 + 9.0576696534698442e-01 -2.0118478092058467e-01 + 9.5981451963435660e-01 -1.7117261967503339e-01 + 9.4402370324245055e-01 -2.0800082246751117e-01 + 9.2379529519047310e-01 -2.1544232051617485e-01 + 9.6873233282325089e-01 -1.8408352384891202e-01 + 9.6335053168471774e-01 -2.0411789369313738e-01 + 8.6391923210838684e-01 -1.5291139082947325e-01 + 8.6195959949917267e-01 -1.3363006855097126e-01 + 8.6392085552530062e-01 -1.7219774485201356e-01 + 8.8269169992640428e-01 -2.1155320076753981e-01 + 8.6601204752135175e-01 -1.9428371570695901e-01 + 9.7253850627362937e-01 -1.4146856535545282e-01 + 9.6865448732038573e-01 -1.3156251191334434e-01 + 9.7285623980113911e-01 -1.6887529566399451e-01 + 9.7806409738597466e-01 -1.4945615179487959e-01 + 9.7814380516942379e-01 -1.5896505239670944e-01 + 9.6544496736593288e-01 -1.2330264009416680e-01 + 8.9576639185447959e-01 -9.5952790765835516e-02 + 8.7712595476067889e-01 -1.0658236510019492e-01 + 8.8532069291353110e-01 -9.7089283313380292e-02 + 9.1382640693451833e-01 -9.7341887100071744e-02 + 9.0585329314511398e-01 -9.1774238303230504e-02 + 8.6785136729317003e-01 -1.1664876284424963e-01 + 9.2895530482765309e-01 -9.5556694191913039e-02 + 9.3684368531029349e-01 -1.0020426038630603e-01 + 9.2066726698359957e-01 -9.3099889826248727e-02 + 9.4582993968346329e-01 -1.0213097491457290e-01 + 9.5802751378140272e-01 -1.1013858901432627e-01 + 9.5419488685784160e-01 -1.0438944238654813e-01 + 9.6499355253688890e-01 -1.1445262735635708e-01 + 9.0575569521062960e-01 -2.3204854423264010e-01 + 9.6067058201391831e-01 -2.2755341673891394e-01 + 9.3558849294673507e-01 -2.3294300381674304e-01 + 9.8604770218479842e-01 -1.9445500698813589e-01 + 9.8203110510536362e-01 -1.7905060773806269e-01 + 9.8165881873138261e-01 -2.1765146078608666e-01 + 8.4952647367479983e-01 -1.4565179082516977e-01 + 8.4534365048213544e-01 -1.6084994294271837e-01 + 8.5461770137239057e-01 -1.2012931073431332e-01 + 8.4434878345378195e-01 -1.3077280365837396e-01 + 8.4337648378411956e-01 -1.8793370526236686e-01 + 8.5520391394803852e-01 -2.1715002531792038e-01 + 8.7544676773260477e-01 -2.3978123442098820e-01 + 9.1396919295526402e-01 -9.0432852356869375e-02 + 9.2512833089931235e-01 -8.8724780212615428e-02 + 9.1896270364738086e-01 -8.4903521704859486e-02 + 9.3118623923656685e-01 -8.5780376372127876e-02 + 9.3774691540276933e-01 -9.1925307620741137e-02 + 9.1118359229216139e-01 -8.4142824168068842e-02 + 9.0521331625660650e-01 -8.3558724741394030e-02 + 8.9913954450486955e-01 -8.7030333734375631e-02 + 9.2507615877043037e-01 -8.3067564880536793e-02 + 9.1610896068157643e-01 -7.9367060629508046e-02 + 9.2233537873163129e-01 -7.7635105635962987e-02 + 9.4526105475604538e-01 -9.4952615419245490e-02 + 9.3850914711185851e-01 -8.4229391855231484e-02 + 9.2917888962478656e-01 -7.9267825004322390e-02 + 9.3430268897260049e-01 -8.0203289241154607e-02 + 9.4557684461564406e-01 -8.6910253716851571e-02 + 9.0988892789680165e-01 -7.5538281182886635e-02 + 8.9083882280058191e-01 -8.8227665375839592e-02 + 9.0086552426192412e-01 -7.6912434667733010e-02 + 8.9431013081245680e-01 -8.1840854836386256e-02 + 9.1719026848041096e-01 -7.4620433122106533e-02 + 9.2758124624685223e-01 -7.3832163364841108e-02 + 9.2269970330661977e-01 -6.9950811953560788e-02 + 9.5248142254892798e-01 -9.7555377481214123e-02 + 9.5083473465751922e-01 -9.1211361780437983e-02 + 9.1536749943985285e-01 -6.8809034517727241e-02 + 9.0386533305546379e-01 -7.0620035913719903e-02 + 9.0828725097064478e-01 -6.5406973857506046e-02 + 9.3434241561206477e-01 -7.3965322795814359e-02 + 9.3980700790800142e-01 -7.8054685703506266e-02 + 9.4421503889272884e-01 -8.0973631999313511e-02 + 9.4975393538757658e-01 -7.9870812085587772e-02 + 9.5310365277109099e-01 -8.5242941560068175e-02 + 8.7222438341338204e-01 -9.4549052114018650e-02 + 8.8265224511856388e-01 -8.7449706913034220e-02 + 8.6713746693023097e-01 -1.0333803737076153e-01 + 8.8830305334169424e-01 -8.1740586108807634e-02 + 8.9114259848775390e-01 -7.4175300237840247e-02 + 8.9720231626363045e-01 -6.8571294322268272e-02 + 8.9054362547203425e-01 -6.5564988928187518e-02 + 8.9744431204191244e-01 -6.2100869139598558e-02 + 8.8249433084873630e-01 -6.8304430554576356e-02 + 8.8257146948910048e-01 -7.7009403180909430e-02 + 8.9240449724810844e-01 -5.8992254052043336e-02 + 8.8626261325451594e-01 -6.0251014678982528e-02 + 8.7460890594192620e-01 -7.3193359216276122e-02 + 8.7985726947309217e-01 -6.1732259931716271e-02 + 8.7426462001228344e-01 -6.4932898865606603e-02 + 8.7419089517579351e-01 -8.2098291839358239e-02 + 9.5547215683906472e-01 -7.8777386861474952e-02 + 9.5813767188393228e-01 -9.2200820201014722e-02 + 9.6063024745473768e-01 -1.0044705018542288e-01 + 9.5946224576979944e-01 -8.4261600925430002e-02 + 9.6507244265627179e-01 -8.7872291126160462e-02 + 9.6583283074218684e-01 -9.5100780906307136e-02 + 9.5964352569619393e-01 -1.0527461775581060e-01 + 9.6414892500157379e-01 -1.0708673310453776e-01 + 9.6816909697766107e-01 -1.0224798139451252e-01 + 9.7080923129968255e-01 -1.0958024787368004e-01 + 9.7263854511059122e-01 -9.7938137157328242e-02 + 9.7241842744016793e-01 -9.0312040442483976e-02 + 9.7378684957747197e-01 -1.0449430426098161e-01 + 9.7301398642556336e-01 -1.1693555935949007e-01 + 9.7912473432293723e-01 -1.1004470648711617e-01 + 9.7852235235436069e-01 -1.0131398704709227e-01 + 9.8175333153515254e-01 -1.1891570773028093e-01 + 9.8560028501737662e-01 -1.0387753692724289e-01 + 9.8734394114834600e-01 -1.1274296933527239e-01 + 9.7595810149270790e-01 -1.2531742661548151e-01 + 9.8201275573884317e-01 -9.5960081000100672e-02 + 9.8804399610061466e-01 -9.6390487655085622e-02 + 9.9163879693803381e-01 -1.0104099937117894e-01 + 9.9272876513779096e-01 -1.0715415298967912e-01 + 9.7971765654897069e-01 -1.3303075758729221e-01 + 9.8464137407314922e-01 -1.2635040404977360e-01 + 9.8983406680832076e-01 -1.2113001067103824e-01 + 9.9183180963051853e-01 -1.3182302667026136e-01 + 9.8468166050325578e-01 -1.4166261091949650e-01 + 9.9499948697594220e-01 -1.1432949855517904e-01 + 9.9708986084463191e-01 -1.2180457617149898e-01 + 9.8968182963034224e-01 -1.5231537694265285e-01 + 9.9511522664347751e-01 -1.4153608136237494e-01 + 9.8799670026482289e-01 -1.6552064232881492e-01 + 1.0032184213589161e+00 -1.3636903757317498e-01 + 1.0009048653152206e+00 -1.2813110999937294e-01 + 1.0015644054862349e+00 -1.4723619783686104e-01 + 9.9929252604761132e-01 -1.5848454645987431e-01 + 9.9671244992707386e-01 -1.7689101523737349e-01 + 9.9728327180172016e-01 -1.6635150929387521e-01 + 1.0033609814680844e+00 -1.8884841041223410e-01 + 1.0045469444489825e+00 -2.0638817633829376e-01 + 1.0066775576438189e+00 -1.6592260772148393e-01 + 1.0125513914588353e+00 -1.5356094463561476e-01 + 1.0168315423270755e+00 -1.4278043373052185e-01 + 1.0095513634072262e+00 -1.4344010747825564e-01 + 1.0111183275541293e+00 -1.3672865100750187e-01 + 1.0153327771064369e+00 -1.2506667149314410e-01 + 1.0086926574459625e+00 -1.2830280336062572e-01 + 1.0097488435104864e+00 -1.1925378364441030e-01 + 1.0169278381646834e+00 -1.1771148237187390e-01 + 1.0037350632686852e+00 -1.2249240755463120e-01 + 8.7554515439646963e-01 -2.9875501762458612e-01 + 8.5225845891495311e-01 -3.4026556665172336e-01 + 8.8989095339972835e-01 -2.6512510554131552e-01 + 9.2323786768920257e-01 -2.6162021336034513e-01 + 8.3213866370463307e-01 -2.9898321138671236e-01 + 8.4225371692342321e-01 -2.5633291702371253e-01 + 8.1911750135744654e-01 -3.8205549972168740e-01 + 8.0540393234677765e-01 -3.3384165080958894e-01 + 8.3953317268873207e-01 -4.3386449121967985e-01 + 7.6513314910148011e-01 -3.7473883779748007e-01 + 7.7360114783644462e-01 -4.2338904648097753e-01 + 8.7039381590223996e-01 -4.9178735711819854e-01 + 9.3476140941302077e-01 -4.9679572724288334e-01 + 7.8709251916604472e-01 -4.7752516574895765e-01 + 7.2718093933758610e-01 -4.0214474524265142e-01 + 7.2325991651638333e-01 -4.4265129103872880e-01 + 7.1456544644131981e-01 -3.5578594934750640e-01 + 9.0994689682811725e-01 -5.5584988371391830e-01 + 8.0448854041845408e-01 -5.3891153785193069e-01 + 9.8524414159175677e-01 -5.2296749108013785e-01 + 1.0395971064519642e+00 -4.8436431710662475e-01 + 1.2068225741801797e+00 -4.9546825194951793e-02 + 1.1838873752652077e+00 -2.8106471437553182e-02 + 1.2009788790449250e+00 -3.1468048781079005e-02 + 1.2113088664041882e+00 -6.6185905233965059e-02 + 1.2188349686758713e+00 -3.6535581377378890e-02 + 1.2242653249441915e+00 -5.4931424447147492e-02 + 1.1945546501163236e+00 -1.0386961057633926e-02 + 1.1771964471285798e+00 -1.3925648358707576e-02 + 1.2134769562384022e+00 -1.9226167502893077e-02 + 1.2126356239669391e+00 -8.2788287706861752e-02 + 1.2278976863343871e+00 -7.3919683363541822e-02 + 1.1645961739847976e+00 -5.9465527224631387e-03 + 1.1515590139821796e+00 -1.4376850444932643e-02 + 1.2334618025811110e+00 -4.2093123486267814e-02 + 1.2326898036294409e+00 -2.0342372997802727e-02 + 1.2452854609655475e+00 -6.0576531596453265e-02 + 1.1776333385373903e+00 -5.2031126476492773e-04 + 1.2165588169501191e+00 3.4641445807892524e-04 + 1.1846625392636057e+00 1.2085299475970146e-02 + 1.2022643290298305e+00 1.1326609047316083e-02 + 1.2119322915722535e+00 -9.8995871742118879e-02 + 1.1908722660963562e+00 -9.7251168808483612e-02 + 1.1974142786860966e+00 -1.0526130594439564e-01 + 1.2263634709934337e+00 -8.9126602633626817e-02 + 1.1835297645887621e+00 -9.6972951189854939e-02 + 1.2435569859911126e+00 -8.7401024854784737e-02 + 1.1523871911796419e+00 2.5113865045653938e-03 + 1.1668133195985675e+00 9.6153881076972425e-03 + 1.1393656278892692e+00 -6.9288942642629081e-03 + 1.1924945144864552e+00 3.1571200383133657e-02 + 1.1718433947406339e+00 2.9189068683862729e-02 + 1.2513419315303125e+00 -3.7820692069033157e-02 + 1.2646193200831846e+00 -5.4299909375245647e-02 + 1.2667772252404390e+00 -7.7082691761916067e-02 + 1.1762278290899317e+00 -1.0246144712701266e-01 + 1.2072916818913413e+00 -1.1421619778364800e-01 + 1.2306874077099010e+00 -1.0351664569066088e-01 + 1.2188953705882071e+00 -1.1233711941282820e-01 + 1.1859531786232083e+00 -1.0390532235533101e-01 + 1.1878647573443715e+00 -1.1303049340456539e-01 + 1.1964246724396972e+00 -1.1718093092301274e-01 + 1.2736121541798582e+00 -3.6632085485138077e-02 + 1.2935877222928127e+00 -6.6404855931921247e-02 + 1.2612742390950586e+00 -9.7816510984984006e-02 + 1.2837863033455221e+00 -9.5612856955156644e-02 + 1.2466134115990073e+00 -1.0976850795233872e-01 + 1.3047047568070553e+00 -8.6889305369567182e-02 + 1.3258729514922152e+00 -8.1491621975516182e-02 + 1.2657287448035461e+00 -1.1706177381890370e-01 + 1.3109781216362251e+00 -1.0840954990669616e-01 + 1.2887796903657147e+00 -1.2557769273905706e-01 + 1.2304079067893809e+00 -1.2042733952364415e-01 + 1.2455571184222975e+00 -1.3247827586461369e-01 + 1.3450015944494709e+00 -1.0879380322205634e-01 + 7.4755105227176699e-01 -8.5151938152023376e-02 + 7.5861409953965619e-01 -8.2120365368950843e-02 + 7.6816457667155902e-01 -8.7211911712614665e-02 + 7.8073895485711375e-01 -9.2608989498444316e-02 + 7.9796261394076851e-01 -9.9782293464173222e-02 + 8.2192203382114570e-01 -9.5064761758393956e-02 + 8.1021936082229473e-01 -9.7412846543036835e-02 + 8.6179425363236817e-01 -5.4518403904538104e-02 + 8.7022496226958879e-01 -4.4242818964605135e-02 + 8.6938419089721464e-01 -5.2742041296824027e-02 + 8.7428446640532087e-01 -3.7534641135124502e-02 + 8.5960680302007120e-01 -6.2421565742397433e-02 + 8.6766430405711503e-01 -6.0314843943288565e-02 + 8.5524777704132049e-01 -6.8842546963949758e-02 + 8.4561249655905613e-01 -7.3289682630942821e-02 + 8.7602175168606067e-01 -5.0094891985267509e-02 + 8.7778817806116649e-01 -4.3072857766134121e-02 + 8.7509812639564188e-01 -5.7117553105669572e-02 + 7.3693972898921345e-01 2.7801288509012068e-01 + 7.4391946824645316e-01 3.1067324696171994e-01 + 7.0886619825159869e-01 2.6591775732401857e-01 + 7.2792714635922096e-01 2.4614480929136562e-01 + 6.9893020505871561e-01 2.3579277741929161e-01 + 6.8792573723035844e-01 2.5697405761923164e-01 + 7.1732967162708405e-01 2.2051622924833936e-01 + 6.7313965620473226e-01 2.3964444012858621e-01 + 7.0054165904932830e-01 2.0487063725529708e-01 + 6.7595613923575115e-01 2.1465946308079253e-01 + 6.8042299271564843e-01 1.9439249839511774e-01 + 6.9438965958994459e-01 1.7814110090020563e-01 + 6.6749896982274493e-01 1.7613285768325682e-01 + 1.0933478472632174e-01 -2.1209936642641480e-01 + 1.4652127242935364e-01 -2.2823229342354523e-01 + 1.3235657186163508e-01 -2.1136298250007712e-01 + 1.6336805444530000e-01 -2.4609601882544041e-01 + 1.5279696887581906e-01 -2.0606200468590430e-01 + 1.6937927010755516e-01 -2.1870809709116656e-01 + 1.8474531760066526e-01 -2.2860092605814941e-01 + 6.0027340374541183e-01 -2.6286342541966690e-01 + 2.9452305605801143e-02 -9.2650368783523618e-02 + 2.2922898149261073e-02 -9.7239016305422865e-02 + 3.2429027990310999e-02 -8.6119879638403063e-02 + 2.3278645161099121e-02 -8.8023010773113697e-02 + 1.6208558759508662e-02 -9.2481717187411050e-02 + 2.0664941912301060e-02 -8.1162974170240432e-02 + 1.1307244373547150e+00 -1.4914522700721022e-02 + 1.1174233059224932e+00 -2.9484793252464669e-02 + 1.1208258157905746e+00 -1.6868183078472043e-02 + 1.1239844639388252e+00 -3.2202619728565196e-03 + 1.1362128784283954e+00 1.0069376338869063e-02 + 1.1525305227239002e+00 2.1403160298916646e-02 + 1.1108532511238280e+00 -2.0548435852290936e-02 + 1.1090659920856965e+00 -3.7983568677063317e-02 + 1.1034627739691345e+00 -2.7682454128353129e-02 + 1.1102319018745561e+00 -9.8863707841445603e-03 + 1.1128844920133361e+00 -4.6095415974477305e-02 + 1.1110463184709687e+00 -5.3499207524794201e-02 + 1.1168504339996446e+00 1.1379148662292948e-02 + 1.1100884038723606e+00 1.7721417269669359e-03 + 1.1365799138273900e+00 3.1570483843125885e-02 + 1.1247483989796123e+00 2.3864700257796301e-02 + 1.1552031980275004e+00 4.2746719877960970e-02 + 1.1006756721587863e+00 -1.6824347119282379e-02 + 1.0986289116048198e+00 -3.7298456604005992e-02 + 1.1033806988453136e+00 -4.7015227480443400e-02 + 1.0914538717491240e+00 -2.6206894088772970e-02 + 1.0982659371787520e+00 -4.1440118372833012e-03 + 1.1096348378484322e+00 -6.0106503637740616e-02 + 1.1088794104634445e+00 -6.6842963340960182e-02 + 1.1035789594919194e+00 -5.9815774748926742e-02 + 1.0988960154636871e+00 9.7975801693337417e-03 + 1.1096708681840326e+00 2.5204650025742126e-02 + 1.1202612952285023e+00 3.8405966138363112e-02 + 1.1325249472193022e+00 5.4304041297356775e-02 + 1.0875289950928533e+00 -3.7004499026579651e-02 + 1.0938403780888066e+00 -4.4308189090685346e-02 + 1.0800272673461748e+00 -2.8666738419317994e-02 + 1.0891182868280040e+00 -1.3490473061438024e-02 + 1.0805323694618494e+00 -1.9548662887061141e-02 + 1.0708004236294073e+00 -1.9839798606952286e-02 + 1.0752363344763012e+00 -9.0555672741459148e-03 + 1.0862448291723155e+00 -2.1917588935451704e-03 + 1.0926064508816040e+00 1.8151451011476638e-03 + 1.0626500111182935e+00 -1.1118533517816331e-02 + 1.0747111027515786e+00 5.1292787309265009e-03 + 1.0651837048990416e+00 -9.4949179286629715e-04 + 1.0868628526883271e+00 5.5825179429263017e-03 + 1.0839741210701277e+00 1.6667786375364813e-02 + 1.0946149103161389e+00 2.6688430936573582e-02 + 1.0534813350940837e+00 -2.1345222319837376e-03 + 1.0526600137646298e+00 -1.3371048076521674e-02 + 1.0618657597233039e+00 9.2177650229032793e-03 + 1.0709370310598985e+00 1.9352704783820229e-02 + 1.0474879514222692e+00 1.2033334110014948e-02 + 1.0388502380959821e+00 2.9476231191694069e-04 + 1.1037715771926884e+00 3.9441984421394238e-02 + 1.1105180328280113e+00 5.5013365519307911e-02 + 1.1539455159869831e+00 6.4569406150958741e-02 + 1.1159773682335441e+00 7.0138545712218558e-02 + 1.1356998749229774e+00 8.2838576311900169e-02 + 1.0935903187483689e+00 5.1285932709475901e-02 + 1.0886280468241765e+00 3.9970548580249954e-02 + 1.0896384464883226e+00 7.1059125062227224e-02 + 1.0803443256356360e+00 3.1522267777276625e-02 + 1.1070636322790719e+00 8.8488763461029407e-02 + 1.1494488438746657e+00 1.1743583014426662e-01 + 1.1188071315194037e+00 1.1254592440312194e-01 + 1.0753954904085887e+00 5.0944639964200178e-02 + 1.0899417180687223e+00 9.1315645934450629e-02 + 1.0699769543576281e+00 9.1180634257952420e-02 + 1.0705053893563843e+00 6.9529038986814840e-02 + 1.0665123258388576e+00 3.4022288721942573e-02 + 1.0905232793962583e+00 1.0995329201968218e-01 + 1.1265156414973916e+00 1.4000597094053546e-01 + 1.1004838820276532e+00 1.3597113139536532e-01 + 1.0575438265903472e+00 2.2212729887080229e-02 + 1.0465409045765952e+00 2.4851519185062898e-02 + 1.0350643393000070e+00 1.0329245166126100e-02 + 1.0363114841103638e+00 2.2026712602446707e-02 + 1.0524330445047241e+00 3.5709892012391720e-02 + 1.0411760566157966e+00 3.4367707909744638e-02 + 1.0281981692088280e+00 1.3197046554140002e-02 + 1.0228955238903126e+00 2.2450802100671297e-02 + 1.0283800512803509e+00 3.2995731918475713e-02 + 1.0583079867782317e+00 4.8072751152631099e-02 + 1.0446787159750315e+00 4.7391459470304653e-02 + 1.0181081897541659e+00 9.0153144980291700e-03 + 1.0313141695958095e+00 4.4691124301550644e-02 + 1.0160712924526365e+00 3.1251260760953414e-02 + 1.0113601220301547e+00 2.0897363009311221e-02 + 1.0198428190265147e+00 4.0882391605137514e-02 + 1.0748652900749249e+00 1.5511441530580328e-01 + 1.0625502529902420e+00 1.3602696643859247e-01 + 1.0790696922428964e+00 1.3084271464882136e-01 + 1.0778419377130035e+00 1.8850834644119630e-01 + 1.1117302295504885e+00 1.6918690226397359e-01 + 1.0669257567254036e+00 1.1714776808468486e-01 + 1.0477600548120591e+00 1.0706223616438848e-01 + 1.1096594648841389e+00 2.0449511929693642e-01 + 1.0786342151694797e+00 2.2268579991104787e-01 + 1.0442872907130436e+00 8.8746132171856118e-02 + 1.1226967441443989e+00 2.4162361037713254e-01 + 1.0749268281376629e+00 2.6428567586536644e-01 + 1.0554143997513847e+00 7.3788188604005711e-02 + 1.0276153513277180e+00 8.4432004312958497e-02 + 1.0396763478414783e+00 7.4009198375705409e-02 + 1.0114512845290733e+00 7.8056196332127570e-02 + 1.1101079173929307e+00 2.8870339160037872e-01 + 1.1571938869579057e+00 2.8117855176829210e-01 + 1.0621016557760896e+00 6.0672607045610505e-02 + 1.0491733481550440e+00 6.0766751630850990e-02 + 1.0039365639967173e+00 3.0988640251365496e-02 + 1.0100126744916835e+00 3.9292635680688193e-02 + 1.0001162165435886e+00 4.2266789899137791e-02 + 9.9366041134774008e-01 3.4229198899907942e-02 + 1.0093593749028642e+00 5.0178696889162211e-02 + 1.0227006820161364e+00 5.2346986377386884e-02 + 9.8690354278488712e-01 4.3831549573269513e-02 + 9.9625049675089627e-01 5.3368909044955615e-02 + 9.8411812405021237e-01 3.0508532264690302e-02 + 1.0327287389993600e+00 5.8930252962589691e-02 + 1.0039807017899136e+00 6.3867024591267807e-02 + 1.0176361571285781e+00 6.2704651132122535e-02 + 9.7635774829767286e-01 3.7192481341236316e-02 + 1.0255961605340005e+00 7.2848749640385790e-02 + 9.3748180392512381e-01 3.4043226002644644e-02 + 9.3088863807243172e-01 3.1661334948765330e-02 + 9.3206575261450553e-01 3.5489138705187884e-02 + 8.8171911165913741e-01 -5.4897067667425858e-02 + 8.6586478335719619e-01 -6.8934946442212208e-02 + 8.6756283617685170e-01 -7.6770431196337086e-02 + 8.5769542226101692e-01 -7.8021894366827382e-02 + 8.4816708725158918e-01 -8.5222196878333989e-02 + 8.3657264561773559e-01 -8.2608394131270302e-02 + 8.6511359290686585e-01 -8.5508201332032741e-02 + 8.5629938253411808e-01 -8.7585255123912020e-02 + 8.3745330459204581e-01 -9.5865939918994059e-02 + 8.5032975469309946e-01 -9.6709291283758603e-02 + 8.3028080514682046e-01 -8.8723765875684535e-02 + 8.6177043544327603e-01 -9.5553948372071318e-02 + 8.5687152244902620e-01 -1.0665855865352114e-01 + 8.4306688257125728e-01 -1.1206170221764467e-01 + 8.2819774762683096e-01 -1.2346570870953144e-01 + 8.2882734502202027e-01 -1.0751016349500730e-01 + 8.1349675649884290e-01 -1.1109270487045819e-01 + 7.3949340185040313e-01 -6.1071236607993740e-01 + 8.3623094193310266e-01 -5.9721353282975542e-01 + 8.3581808048605666e-01 -6.7199909898803867e-01 + 6.6840368457398114e-01 -6.9031537260107712e-01 + 7.5620651143842821e-01 -7.0642351827818572e-01 + 9.1849254747171472e-01 -6.3497290381927485e-01 + 9.9475777616796535e-01 -5.9102788166366338e-01 + 7.1322344311449370e-01 -7.8545105379980384e-01 + 6.7149341682392816e-01 -3.4170761075935729e-01 + 1.0470278610469421e+00 -5.4279486679942579e-01 + 1.0705941042475970e+00 -6.0001215666957819e-01 + 1.0835160719428814e+00 -4.9617452054263822e-01 + 1.1055331042111760e+00 -5.3842275900620962e-01 + 1.2378328075263028e+00 -4.9108595354002205e-01 + 1.1241097161254459e+00 -4.8658122143467608e-01 + 1.1963861656646202e+00 -4.5443939715762838e-01 + 1.1571463009785958e+00 -4.6329874317173392e-01 + 1.2699878837730552e+00 -4.5917969407685177e-01 + 1.3134643499049616e+00 -4.4497047835062631e-01 + 1.2347860573470726e+00 -4.4037567356811280e-01 + 1.2132943220237138e+00 -4.0149652472777575e-01 + 1.2628034614975903e+00 -4.0701804883201476e-01 + 1.3080302185755670e+00 -3.9504618270886738e-01 + 1.4108535262840718e+00 -3.2173065111992116e-01 + 1.4059608700304338e+00 -3.6563997528573111e-01 + 1.3849352960529018e+00 -2.8251982617084082e-01 + 1.3658165645979778e+00 -3.3492455993192038e-01 + 1.3780091208281604e+00 -2.4209234216873199e-01 + 1.3472637814180857e+00 -2.9408174078210436e-01 + 1.3434217304934251e+00 -2.5765953629326077e-01 + 1.3220606967450834e+00 -3.5340012358820161e-01 + 1.3255598326180902e+00 -3.1727441640563825e-01 + 1.3466151957998562e+00 -2.1869901545260007e-01 + 1.3472674380913929e+00 -1.8870104084643913e-01 + 1.3063400968288477e+00 -2.8360024808171147e-01 + 1.3120099315846545e+00 -2.2577351778234345e-01 + 1.2996230935597737e+00 -2.5039831541059243e-01 +-2.3062142330627466e-01 -2.1374660793978251e-01 +-1.9973616265974670e-01 -2.1206367086175248e-01 +-2.1813124503987069e-01 -1.9502483926150660e-01 +-1.5190348603822201e-01 -2.1124290178882177e-01 +-1.3202755183220916e-01 -2.3177884033634655e-01 +-1.2362807871878090e-01 -2.4942068410776130e-01 +-1.3617660053843395e-01 -2.1575318757012951e-01 + 1.2133686845143572e+00 -3.5756124359411956e-01 + 1.2401455396470382e+00 -3.7092983923255929e-01 + 1.3198563142225623e+00 -1.4133930219891511e-01 + 1.3432349503939989e+00 -1.6268948087302704e-01 + 1.3137244836017388e+00 -1.7459541774556442e-01 + 1.2899358783769515e+00 -1.5417991448721580e-01 + 1.3212795995248285e+00 -2.0046077931240802e-01 + 1.2850778519957586e+00 -1.7498794364068715e-01 + 1.2894193526066999e+00 -1.9980946286005974e-01 + 1.2683617059936978e+00 -1.4111679841720104e-01 + 1.2709717620259582e+00 -1.6252016072411379e-01 + 1.2126332415825516e+00 -3.1919804535040441e-01 + 1.2498083453000177e+00 -3.0706916083353519e-01 + 1.2476719792637283e+00 -3.3909013932061782e-01 + 1.2863180235005061e+00 -3.2036540964423921e-01 + 1.2499145292390565e+00 -2.8016599323622415e-01 + 1.2725757538910329e+00 -2.8946001529887155e-01 + 1.2750299942814749e+00 -3.6308434983543236e-01 + 1.2679841454781808e+00 -2.5912224099172931e-01 + 1.2750731490632106e+00 -2.2788454521604251e-01 + 1.2624785274813348e+00 -2.0400403965371083e-01 + 1.2641205975803018e+00 -1.8198218221759532e-01 + 1.2515428192659783e+00 -1.5595767106461267e-01 + 1.1620436465701900e+00 -1.1613982855465110e-01 + 1.1659335287117472e+00 -1.1133275929617525e-01 + 1.1712293326714516e+00 -1.1658856165273335e-01 + 1.1657740585569201e+00 -1.2097962481568914e-01 + 1.1717194752255224e+00 -1.0882658713281046e-01 + 1.1705833173989717e+00 -1.2455900519168495e-01 + 1.1789522052330881e+00 -1.1037493914831487e-01 + 1.1763748576301793e+00 -1.2257198654106105e-01 + 1.1807186584440643e+00 -1.1743722321746475e-01 + 1.1745211791539276e+00 -1.2967998660877811e-01 + 1.1831995095639201e+00 -1.2624451067527787e-01 + 1.1882624858882025e+00 -1.2041422854726136e-01 +-1.1457703964626376e-01 -3.6112194586308988e-02 +-1.2187330322751677e-01 -3.9813401339742427e-02 + 1.2298931609024777e+00 -1.3434300314807501e-01 + 1.2359273889782969e+00 -1.4820093864101125e-01 + 1.2158284606126273e+00 -1.2816931485174621e-01 + 1.2220460686141195e+00 -1.4532702499356276e-01 + 1.2360811628030035e+00 -1.6116743099135533e-01 + 1.2249284350708223e+00 -1.5846593309905188e-01 + 1.2092509871070547e+00 -1.4309608185618572e-01 + 1.2034770175743219e+00 -1.3352537180988122e-01 + 1.2032550174490027e+00 -1.2335264382772948e-01 +-1.1350276788384406e-01 -2.3196909107234376e-01 +-1.2186451046690649e-01 -2.1932181160106268e-01 +-1.3799913083853710e-01 -2.0233204593913001e-01 +-1.2121852635569041e-01 -2.0226425725476815e-01 +-1.0639710572425543e-01 -2.1484368177172541e-01 +-1.1987965457657879e-01 -1.8677867315301455e-01 +-1.0965489249112181e-01 -1.9196380586367923e-01 +-1.0655838729934430e-01 -2.0139387737627601e-01 +-1.1193619203211824e-01 -1.7992546672944343e-01 +-1.0011699836611854e-01 -1.9473375629418399e-01 + 1.2131867168111796e+00 -1.5524639478175573e-01 + 1.2011825588307659e+00 -1.5291419211720836e-01 + 1.2054248324937049e+00 -1.6402899258652326e-01 + 1.2010389788703577e+00 -1.4262737016733240e-01 + 1.1934204508618791e+00 -1.2691295299984517e-01 + 1.1942242441206048e+00 -1.3647366146798845e-01 + 1.1958174566923390e+00 -1.6189312863092198e-01 + 1.1931894015200015e+00 -1.4581326498895919e-01 + 1.1893656495610969e+00 -1.5461455935253809e-01 + 1.0026911387350808e+00 -1.1551927936852735e-01 + 6.6613726642531645e-01 -8.4530293503462417e-02 + 6.7552547303921529e-01 -8.1725635490982995e-02 + 6.7220856976524601e-01 -9.1299847687579927e-02 + 1.1820475199885720e+00 -1.5133912406919592e-01 + 1.1859741575801976e+00 -1.4745805552729507e-01 + 1.1791693873919016e+00 -1.4519792588201597e-01 + 1.1759503260527993e+00 -1.5182476356272900e-01 + 1.1853351209733631e+00 -1.3976697582947395e-01 + 1.1724393644803541e+00 -1.4672213354056396e-01 + 1.1785165511177880e+00 -1.3910302515971296e-01 + 1.1740409986663636e+00 -1.4118852545506400e-01 + 1.1872322520935583e+00 -1.3219501065731265e-01 + 1.1805999666398037e+00 -1.3379612291485898e-01 + 1.1698043673647192e+00 -1.4274605278623653e-01 + 1.1662499497375620e+00 -1.4672448237573121e-01 + 1.1744694920803127e+00 -1.3614124708537645e-01 + 1.1614360225049012e+00 -1.4645905185857089e-01 + 9.9932440350190888e-01 -1.0904521843450254e-01 + 9.9746567724510271e-01 -1.0188869531452838e-01 + 1.0092250579177033e+00 -1.1364913494375628e-01 + 1.0140814864936161e+00 -1.1401040773826310e-01 + 8.9913933921250333e-01 3.2656727100096816e-02 + 8.9737662165555321e-01 3.0687297171738237e-02 + 8.9723509303073001e-01 3.2363108670232066e-02 + 1.5007668860131673e-01 -9.3544548740226219e-02 + 1.6613994104902474e-01 -1.0816298307105399e-01 + 1.4846320073653629e-01 -1.0494608062577981e-01 +-5.9283373693119756e-02 -1.2906114751558562e-01 +-5.6478235378392583e-02 -1.3141597242943703e-01 +-5.9186806410707504e-02 -1.3155524798891349e-01 + 1.1108258143187726e+00 -1.4822387859383923e-01 + 1.1101895576916263e+00 -1.4727749295330739e-01 + 1.1166375507957014e+00 -1.5504230708614841e-01 + 1.1166136366824588e+00 -1.5638684332162711e-01 + 1.1397241968120966e+00 -1.2840723454529268e-01 + 1.1409774153236967e+00 -1.3015959710500624e-01 + 1.1394934688226357e+00 -1.2956879365425777e-01 + 4.8886551403411715e-01 9.8366616305199273e-02 + 5.0806831809195785e-01 9.7990898811922023e-02 + 3.3316548300646787e-02 1.7970535898967910e-02 + 4.1428752945478209e-02 1.7299468282701014e-02 +-1.8736766352105860e-02 -1.1349369027952605e-01 +-1.5975636309576657e-02 -1.0772275757071270e-01 +-1.6850292375437448e-02 -1.1410059108526127e-01 +-4.6527854968729798e-02 -2.5757050029056927e-02 +-4.7398681204882109e-02 -2.9886287123275679e-02 +-4.9074604790845910e-02 -2.7951831342946321e-02 +-2.5012393676689726e-02 -8.2361890100827395e-02 +-2.4321832931249787e-02 -7.9325208884682752e-02 +-2.0917323174899138e-02 -8.0236829664968923e-02 + 9.7220711928270731e-01 7.1896953126753260e-03 + 9.6509543378370211e-01 1.1180272876387676e-02 + 1.0761797666199726e+00 -1.2620490425108244e-01 + 1.0801237955059690e+00 -1.2577139718828789e-01 + 1.0785914772531839e+00 -1.2791974657481830e-01 + 1.1105135850225665e+00 -1.0068677236672841e-01 + 1.1145528489432124e+00 -1.0422452185373743e-01 + 4.3962507062828138e-01 -9.0257143790651639e-02 + 4.5290562899055686e-01 -9.6634508169955780e-02 + 4.3994748570059272e-01 -9.7317265602939074e-02 +-2.5247009753613270e-02 -8.2067828793128683e-03 +-2.5820234656421803e-02 -1.1950502790654127e-02 +-2.7425457192705949e-02 -9.9496007752719606e-03 +-4.2352240664769170e-02 -2.5563150374480870e-02 +-4.1519479980550500e-02 -2.1509245594600657e-02 +-3.9872357273864623e-02 -2.3471679980502813e-02 + 8.6496597473877301e-01 8.3938848663933641e-04 + 8.6475589333201697e-01 6.2100588426901027e-03 + 9.0006731490836245e-01 -3.6509227499848862e-02 + 9.0365140185717507e-01 -4.1302293536816137e-02 + 8.9886552909907635e-01 -3.8611439294044203e-02 + 1.1269463862399434e+00 -1.5682549724961348e-01 + 1.1302856779256842e+00 -1.5687967739229691e-01 + 1.1269431416641993e+00 -1.5911326381170454e-01 + 8.6270698114485356e-01 -5.6441477100435122e-03 + 8.6278800595944460e-01 -1.2329223722232996e-02 + 8.6028355282987690e-01 -6.4526266588131875e-03 + 7.3058085217592605e-01 8.4329757973733876e-02 + 7.1091645565954309e-01 9.3408471179856178e-02 + 7.3140829383096673e-01 9.0937346996511792e-02 + 4.8897182998463506e-01 1.0521612207352860e-01 + 5.0822767852150719e-01 1.0483476502956535e-01 +-1.0822773175409850e-01 -8.9845974195355893e-02 +-1.0554691153791396e-01 -8.5312570930469178e-02 +-1.0823310429138644e-01 -1.0121629363773366e-01 +-1.0799739789597140e-01 -9.5901789667607318e-02 +-1.0317269861897671e-01 -9.9443577006113060e-02 +-8.4130512607686114e-02 -1.2637772370545974e-01 +-8.2073033667512618e-02 -1.3083986970006833e-01 +-8.5622606463985562e-02 -1.2905809784500377e-01 + 1.1031283550176880e+00 -9.0701169418849759e-02 + 1.0962458579793832e+00 -8.8211253059256478e-02 + 1.0979694107924303e+00 -8.6259745901628548e-02 + 1.0852820477044105e+00 -6.5369538002329364e-02 + 1.0759429579206312e+00 -6.2878842553899972e-02 + 1.0787102232917078e+00 -5.9694840910793801e-02 + 8.8767218435732786e-01 -2.6951340248515976e-02 + 8.9035303805168553e-01 -3.1941634495083804e-02 + 8.8653437968274318e-01 -2.8365055545862106e-02 +-1.1175536197796987e-02 -1.1580498645012938e-01 +-1.3389546589095858e-02 -1.0756132021232645e-01 +-1.0026679695982921e-02 -1.0736727241980759e-01 + 7.1760472946259313e-01 -1.9870754277647507e-02 + 7.1600119818000252e-01 -2.2928721894743376e-02 + 7.1587253805936513e-01 -1.7445892042601940e-02 + 7.1675965838772981e-01 -1.3974135115915942e-02 + 7.1776715635228783e-01 -1.0032503787286373e-02 + 7.1884144824295504e-01 -5.8238158273979934e-03 + 7.1991349495502277e-01 -1.6146642612255846e-03 + 7.2207109692939753e-01 1.3610489790231384e-02 + 7.2485796053942408e-01 1.2808038888628914e-02 + 7.3243964162374908e-01 1.2644299963824324e-02 + 7.3945067465812997e-01 1.3218788884294952e-02 + 7.4880512482279471e-01 1.3953453521168058e-02 + 7.6020147850038455e-01 1.4812238570485192e-02 + 7.7264272095676745e-01 1.5717071109428105e-02 + 7.8469858353533795e-01 1.6570337460009910e-02 + 7.9510471468038446e-01 1.7292846413894836e-02 + 8.0322709513447421e-01 1.7849334989350041e-02 + 8.1306790472932278e-01 1.8514380538853459e-02 + 8.0908314470401166e-01 1.8246475926360972e-02 + 8.1319911747965534e-01 1.5847512113523976e-02 + 8.1567370777448645e-01 1.8688976348052222e-02 + 8.1954032369995389e-01 1.8902656042328658e-02 + 8.2246965149595752e-01 1.9035658366966857e-02 + 8.1963714541995358e-01 1.6367659192894735e-02 + 8.2619619192460192e-01 1.9216140991161978e-02 + 8.3076836575811797e-01 1.9462537974661132e-02 + 8.3613533596138723e-01 1.9794710081654898e-02 + 8.3089184330122379e-01 1.7037597908910129e-02 + 8.3627714042748380e-01 1.7424785903287443e-02 + 8.4211749284480675e-01 2.0231300831611065e-02 + 8.4841218855969913e-01 2.0785676041811030e-02 + 8.5464592565492126e-01 2.1461718478185787e-02 + 8.6045782846492358e-01 2.2251607896883741e-02 + 8.6557698746090495e-01 2.3137708999954043e-02 + 8.6986140483958252e-01 2.4098936490723588e-02 + 8.6997910811794554e-01 2.1391788557558300e-02 + 8.6782718880476750e-01 1.9103761797055085e-02 + 8.7187421034729340e-01 2.2853382300851877e-02 + 8.7337912997747935e-01 2.3818432655858146e-02 + 8.7329046803898080e-01 2.5119877288943826e-02 + 8.7592667837945015e-01 2.6201450173097385e-02 + 8.7451826898000462e-01 2.4477723858495892e-02 + 8.7786979610670812e-01 2.7365134003886737e-02 + 8.7919107428478327e-01 2.8653326448861094e-02 + 8.7947904705218605e-01 3.1637940040596391e-02 + 8.7987427970627152e-01 3.0216932463233093e-02 + 8.7902984590191124e-01 3.2858395194047318e-02 + 8.7841340741679375e-01 3.4264840491239568e-02 + 8.7756358719940408e-01 3.5862061706467330e-02 + 8.7641119197392214e-01 3.7647216926053773e-02 + 8.7804346957488377e-01 3.9029192557691772e-02 + 8.7488567081265245e-01 3.9610652124515866e-02 + 8.7659272725448290e-01 4.1307529846861257e-02 + 8.7291325084044757e-01 4.1740455430947065e-02 + 8.7042126778877105e-01 4.4020061440129155e-02 + 8.6732973704674521e-01 4.6436481513524086e-02 + 8.6355673204936778e-01 4.8975362932800692e-02 + 8.5901351987239138e-01 5.1624108213587760e-02 + 8.5360405211140744e-01 5.4370946294596934e-02 + 8.4722598873584332e-01 5.7204164537793645e-02 + 8.3977264128980522e-01 6.0112205190193890e-02 + 8.3114304103779091e-01 6.3081122536736700e-02 + 8.2124490215630885e-01 6.6135222546314765e-02 + 8.0996882385843350e-01 6.9281468665536750e-02 + 7.9721225809123553e-01 7.2471676193217149e-02 + 7.9849884833425477e-01 7.8275200845538961e-02 + 8.1133380037283587e-01 7.4805651720524224e-02 + 7.8290635457937441e-01 7.5643964668287822e-02 + 7.8409797790614277e-01 8.1703222583215052e-02 + 7.6701687105305894e-01 7.8727837356041164e-02 + 7.6809846075734356e-01 8.5011110645126564e-02 + 7.4955397552566438e-01 8.1647952807486490e-02 + 7.1022100087046880e-01 8.6706327803256045e-02 + 6.8867012870154554e-01 8.8739524926367608e-02 + 6.8925077627465470e-01 9.5496437342625029e-02 + 6.6618170429963186e-01 9.0501517073448667e-02 + 6.4303494546993534e-01 9.2060573308671678e-02 + 6.1953968455355835e-01 9.3448249970933261e-02 + 5.9602671621650671e-01 9.4678153266244180e-02 + 5.7282797436971578e-01 9.5753872147220420e-02 + 5.5025730647718518e-01 9.6672053205033137e-02 + 5.2859326147344632e-01 9.7423365310007171e-02 + 4.7110906223318239e-01 9.8572769443407537e-02 + 4.5486415373906652e-01 9.8621326719680269e-02 + 4.7116054033918431e-01 1.0542059409884530e-01 + 4.5485779073606381e-01 1.0545838516895145e-01 + 4.4014807096596087e-01 9.8528926176619791e-02 + 4.4008103181698743e-01 1.0534480624308173e-01 + 4.2693582709461708e-01 9.8315891190281945e-02 + 4.1516898008755021e-01 9.8004720049210903e-02 + 4.0476457113537379e-01 9.7618427902084193e-02 + 3.9562332712849013e-01 9.7179269622834852e-02 + 3.9530267389183393e-01 1.0381221253834383e-01 + 3.8725464786885766e-01 1.0327757880492072e-01 + 3.7468094588885492e-01 9.5765710093644429e-02 + 3.6988337498582524e-01 9.5380031577867896e-02 + 3.6505118257066727e-01 9.5737137278263162e-02 + 3.5933929713614532e-01 9.6143563614958794e-02 + 3.5310386377109637e-01 9.6558244807631866e-02 + 3.3898552511936941e-01 9.7350099260289369e-02 + 3.3107960105027701e-01 9.7695119553513621e-02 + 3.3127909422198343e-01 1.0474924925389928e-01 + 3.2260712291202509e-01 9.7982635021793385e-02 + 3.1357827808356831e-01 9.8192982702570930e-02 + 3.0401412770558522e-01 9.8305157537716070e-02 + 2.9394764672422014e-01 9.8297180861919742e-02 + 2.8342352997603371e-01 9.8146932887232197e-02 + 2.7249884808146163e-01 9.7833362640812993e-02 + 2.6124204596484191e-01 9.7337527271918134e-02 + 2.4973146239049271e-01 9.6643594222399543e-02 + 2.3805363196742491e-01 9.5740037902999120e-02 + 2.2630093770621329e-01 9.4620769240776781e-02 + 2.1456861031626318e-01 9.3285934322082653e-02 + 2.0295164954163880e-01 9.1742298355313778e-02 + 1.9154163585775308e-01 9.0003320185019220e-02 + 1.8042364902898811e-01 8.8089551555121659e-02 + 1.6967345347782015e-01 8.6029934831387322e-02 + 1.5935484809553913e-01 8.3862103911656050e-02 + 1.4951859740440909e-01 8.1628172361760676e-02 + 1.4020283559728597e-01 7.9367027162717818e-02 + 1.3143470806640778e-01 7.7109761189973369e-02 + 1.2323120736146365e-01 7.4880730693706710e-02 + 1.1559875672946163e-01 7.2700287421753274e-02 + 1.2157299800550447e-01 8.0930057070958128e-02 + 1.1386210883684811e-01 7.8694213511845135e-02 + 1.0202704904067161e-01 6.8555964444755091e-02 + 1.0853436596983101e-01 7.0586596150029379e-02 + 1.0672002827838867e-01 7.6542762634531414e-02 + 9.6058837263370833e-02 6.6620344202647175e-02 + 9.0609229982902662e-02 6.4783526090813837e-02 + 8.5613089908470386e-02 6.3037375074685542e-02 + 7.9477027572615100e-02 6.0659333247301106e-02 + 7.3680640828555966e-02 5.7565633762749258e-02 + 6.8495682718776152e-02 5.4002763912521345e-02 + 6.3919534851905269e-02 5.0141303606963561e-02 + 5.9910996080780876e-02 4.6126646040633545e-02 + 5.6411419688267017e-02 4.2073511013711595e-02 + 5.3356838808483076e-02 3.8066583152740918e-02 + 5.0686390161438055e-02 3.4166312221323381e-02 + 4.8345546926896077e-02 3.0414384164828334e-02 + 4.6286865339077110e-02 2.6838383563102752e-02 + 4.4469793891664722e-02 2.3455376194149835e-02 + 4.2860044064724434e-02 2.0274614448133832e-02 + 3.7982036088635596e-02 9.5815618332864005e-03 + 3.7057930803300110e-02 7.3904739094743377e-03 + 3.4576463531067247e-02 7.2536658858766145e-03 + 3.6223932897598843e-02 5.3756060264973371e-03 + 2.0676686201966277e-02 -1.2972850107686895e-02 + 2.3768733014087218e-02 -1.2492572382171829e-02 + 2.2685318307686941e-02 -1.4740890119114169e-02 + 2.6361455831093394e-02 -2.3205929007133363e-02 + 2.6966386565376865e-02 -2.2464366998903529e-02 + 2.7285506155614314e-02 -2.3465834901784888e-02 + 2.6252694948958322e-02 -2.4389740185398523e-02 + 2.9852730048162357e-02 -2.3119612368674325e-02 + 2.9341209785464173e-02 -2.2782678108555388e-02 + 2.9820305931004043e-02 -2.2526219992769825e-02 + 2.9160770921393464e-02 -2.3595217530939294e-02 + 3.0015946737059096e-02 -2.3866164672540435e-02 + 2.6449178793889416e-02 -2.5542963124436824e-02 + 2.9531584859661564e-02 -2.5220612247665031e-02 + 3.0326283181878466e-02 -2.4901762645257008e-02 + 3.0394134095651282e-02 -2.5400778907027188e-02 + 2.7866171222086678e-02 -2.7804503281686266e-02 + 2.8804811224198090e-02 -2.7120429969173188e-02 + 2.8779429051944305e-02 -2.8250578209636501e-02 + 2.8881467078285539e-02 -2.4934734158094329e-02 + 2.8816701418094226e-02 -2.5529782152489133e-02 + 2.8276336743616071e-02 -2.5152112476902744e-02 + 3.0094104650494558e-02 -2.6422224378478631e-02 + 2.9268010939048850e-02 -2.6170266599081060e-02 + 2.9982358718655178e-02 -2.5838327129079630e-02 + 3.0834514741812313e-02 -2.6552523871288258e-02 + 3.0623959048412530e-02 -2.5977753513160451e-02 + 2.6200886354814656e-02 -2.6498950090314111e-02 + 2.7033380541013230e-02 -2.7261148744827324e-02 + 2.6881311387640494e-02 -2.8287518031106629e-02 + 2.9603337478491198e-02 -2.7731187550216418e-02 + 2.9642193469875622e-02 -2.8785327034299257e-02 + 3.1622128499762425e-02 -2.8217876708197309e-02 + 3.0092092629494971e-02 -2.9702225305697993e-02 + 2.9242303264332747e-02 -2.9598152854106274e-02 + 3.1930315068777304e-02 -2.9576467800325190e-02 + 3.1752556059444714e-02 -2.8710637143845474e-02 + 3.1267970600467265e-02 -2.9083629046752435e-02 + 3.1093324538559841e-02 -2.8498426607427518e-02 + 2.9226796271807132e-02 -3.0582879282007980e-02 + 2.8960714852985348e-02 -3.1725107920024698e-02 + 2.8230369565747537e-02 -3.1051276562052976e-02 + 3.1395797080257637e-02 -3.0483002632038847e-02 + 3.2248443453234188e-02 -3.0470219359656880e-02 + 3.2918243925664115e-02 -3.0369497556918645e-02 + 3.2645064661025458e-02 -2.9938017820882123e-02 + 3.3455037283189881e-02 -3.1420993569327038e-02 + 3.1404027515684163e-02 -3.3609840317666340e-02 + 3.0924039060359121e-02 -3.2955378777927535e-02 + 3.1952814057646606e-02 -3.2878143065133258e-02 + 3.2424012002380209e-02 -3.3920829492217308e-02 + 3.1365781514587354e-02 -3.4362508710316320e-02 + 3.0573932920262337e-02 -3.3887321181978791e-02 + 2.9944625568774086e-02 -3.3078051100247308e-02 + 3.2819533943211354e-02 -3.2785739317603202e-02 + 3.3868427408222601e-02 -3.3076090484101428e-02 + 3.1718265659804956e-02 -3.5287888045616000e-02 + 3.3608419042579385e-02 -3.4349310188574123e-02 + 3.4455010674598441e-02 -3.4060668876506384e-02 + 3.6317303912760224e-02 -3.5069807162031452e-02 + 3.5415956663285897e-02 -3.4392930481899953e-02 + 3.3137201113440540e-02 -3.5236696252923139e-02 + 3.5091711922099478e-02 -3.6686196129153359e-02 + 3.3728593014437536e-02 -3.7574161586434229e-02 + 3.3838984785845128e-02 -3.6247280130353943e-02 + 3.7000585510675421e-02 -3.9153920464428893e-02 + 3.5758891004213922e-02 -3.8698555228293685e-02 + 3.6311953696284149e-02 -3.7543554109916499e-02 + 3.5050971623910243e-02 -3.7919492229733009e-02 + 3.7346302164039002e-02 -3.6548265471438413e-02 + 3.8026721611025494e-02 -3.7617778639841504e-02 + 3.5604723997522569e-02 -3.9695186955299278e-02 + 4.0398550151380164e-02 -3.9158357876416972e-02 + 3.8620849948067359e-02 -4.2188486434497463e-02 + 3.8826480539285058e-02 -3.9110123662851493e-02 + 4.1638612202532954e-02 -4.0806662103960889e-02 + 3.7869445401248925e-02 -4.0671104067854458e-02 + 4.0388596758916151e-02 -4.2374279369028045e-02 + 3.9664939948330868e-02 -4.0823478612963982e-02 + 4.2158983805990147e-02 -4.2744837981388173e-02 + 4.0986158776057380e-02 -4.3899280890698833e-02 + 4.3261669832006078e-02 -4.1511496252411462e-02 + 4.4057206507623903e-02 -4.2837080146313156e-02 + 4.6022482949808818e-02 -4.3041634929608108e-02 + 4.4686271244486875e-02 -4.4944080823910326e-02 + 4.6622536679578275e-02 -4.4593719071059468e-02 + 5.1109315917599929e-02 -4.6741604238860646e-02 + 4.8164324569036410e-02 -4.7800539350049576e-02 + 4.8495295786587178e-02 -4.5517287805836304e-02 + 5.3784732512021094e-02 -4.8020096148093216e-02 + 5.7079016087875800e-02 -4.9500991766720404e-02 + 6.1119516724389200e-02 -5.1191207264025707e-02 + 5.9845977180373211e-02 -5.4626040584395241e-02 + 5.5781072220206340e-02 -5.2754617413569349e-02 + 6.6045876158177919e-02 -5.3090328694779032e-02 + 7.2009943834501655e-02 -5.5190735591111206e-02 + 7.9166079810327972e-02 -5.7474822947114035e-02 + 8.7662422414879870e-02 -5.9914317773376524e-02 + 9.7627081602560395e-02 -6.2470409917168013e-02 + 9.6604199619108044e-02 -6.6942725713559526e-02 + 8.6573171275723837e-02 -6.4176859838525502e-02 + 1.0915004864050104e-01 -6.5095388011641830e-02 + 1.0819888291034374e-01 -6.9768554944701577e-02 + 1.2226330955155618e-01 -6.7735444573685299e-02 + 1.3692181448891461e-01 -7.0333975159215356e-02 + 1.5298841151452791e-01 -7.2835464361858726e-02 + 1.7022743275617813e-01 -7.5189752520230968e-02 + 1.8831079478705703e-01 -7.7356497547228287e-02 + 2.0683843120934142e-01 -7.9308457525812059e-02 + 2.2537134481306964e-01 -8.1031722350388691e-02 + 2.4347180729920836e-01 -8.2524665373668427e-02 + 2.6074314482933403e-01 -8.3796851551440454e-02 + 2.7686189846061637e-01 -8.4866251301292550e-02 + 2.9159711598829574e-01 -8.5755095893375710e-02 + 3.1647350426410270e-01 -8.7085578315253542e-02 + 3.0481535322871878e-01 -8.6487011783646039e-02 + 3.0451594379603364e-01 -9.2552278345053196e-02 + 2.9127297888735626e-01 -9.1749457035405158e-02 + 3.2660300513256857e-01 -8.7572535586971867e-02 + 3.3529066291304588e-01 -8.7966760667924859e-02 + 3.4265892330434866e-01 -8.8286578554232165e-02 + 3.4242322057067298e-01 -9.4581231023340706e-02 + 3.3504331462093262e-01 -9.4212131210099415e-02 + 3.4884909452141954e-01 -8.8551371453561956e-02 + 3.5392966930138670e-01 -8.8774722736289391e-02 + 3.5908767476492187e-01 -8.9166129967296115e-02 + 3.6497643913386923e-01 -8.9565810537337143e-02 + 3.7155508828409012e-01 -8.9952980804739013e-02 + 3.7886996798292216e-01 -9.0309490776377288e-02 + 3.8696114615432009e-01 -9.0612374886617886e-02 + 3.8679953304762194e-01 -9.7411112852839210e-02 + 3.7863733226294727e-01 -9.7024949052794796e-02 + 3.9585956608019046e-01 -9.0834382311498985e-02 + 4.0558284886423479e-01 -9.0944445998999868e-02 + 4.1613322727286572e-01 -9.0908440043818928e-02 + 4.2749363358765891e-01 -9.0691012663029369e-02 + 4.5246596264711059e-01 -8.9573968576431184e-02 + 4.6593046614174938e-01 -8.8612868132486255e-02 + 4.7990989403486850e-01 -8.7351841766405869e-02 + 4.9427550634320738e-01 -8.5778260719109767e-02 + 5.0888300243521201e-01 -8.3891471172023557e-02 + 4.9507554291753308e-01 -9.2699900647417621e-02 + 5.0979711699891794e-01 -9.0715257037871311e-02 + 5.2357786393763206e-01 -8.1703948670423188e-02 + 5.2459854055531707e-01 -8.8404746238950338e-02 + 5.3820189156885334e-01 -7.9240624170267893e-02 + 5.3931928234230497e-01 -8.5795138443359065e-02 + 5.5260019024846940e-01 -7.6538064645291115e-02 + 5.5380263916346451e-01 -8.2925910004959746e-02 + 5.6662772320361654e-01 -7.3642476649254718e-02 + 5.6790247029399410e-01 -7.9847310695583928e-02 + 5.8015501505235534e-01 -7.0605948692644915e-02 + 5.8148875797968458e-01 -7.6615358669982925e-02 + 5.9307218035240794e-01 -6.7483136844288083e-02 + 5.9445155112048553e-01 -7.3288209791101622e-02 + 6.0529145027685161e-01 -6.4328621627396387e-02 + 6.0670355253830621e-01 -6.9924001554781512e-02 + 6.1674862267813069e-01 -6.1194012607842296e-02 + 6.1818149748136619e-01 -6.6577861413577466e-02 + 6.2740310952590761e-01 -5.8125456557959865e-02 + 6.3723513934235143e-01 -5.5162529791473958e-02 + 6.4624480895874825e-01 -5.2336968506537573e-02 + 6.5444763435749564e-01 -4.9672682998519235e-02 + 6.6187264390519829e-01 -4.7185625503331607e-02 + 6.6855784799076901e-01 -4.4885026336885403e-02 + 6.7454873416524919e-01 -4.2773990540723617e-02 + 6.7989471515404176e-01 -4.0850870287101770e-02 + 6.7175048189188402e-01 -5.4628778715212434e-02 + 6.7591580635027526e-01 -4.6856604462334417e-02 + 6.7769204788888260e-01 -5.2164321345827602e-02 + 6.8464708679993436e-01 -3.9110262863630396e-02 + 6.8885777919250302e-01 -3.7543803963046685e-02 + 6.9257760337284680e-01 -3.6141168453411865e-02 + 6.9585523545723760e-01 -3.4890827382554335e-02 + 6.9873653974367045e-01 -3.3780657576485851e-02 + 7.0616540121573479e-01 -3.1667289977235669e-02 + 7.0290743932756072e-01 -3.2285694290919764e-02 + 7.0443087006408689e-01 -3.0346771960111596e-02 + 7.0827887496712094e-01 -2.8509247745120092e-02 + 7.0743585642706108e-01 -2.9916733270113127e-02 + 7.0574292914665193e-01 -2.9733118962994354e-02 + 7.0864820569917697e-01 -3.1541569741449393e-02 + 7.0987062377021459e-01 -2.8612236676849534e-02 + 7.1045073012535198e-01 -3.1372054892244705e-02 + 7.1283784215380308e-01 -2.6512751559778280e-02 + 7.1143486107450826e-01 -2.7194190458729395e-02 + 7.1378722381226112e-01 -2.8072241265959974e-02 + 7.1471565800278825e-01 -2.9981382996226102e-02 + 7.1225222765682616e-01 -2.5057994095391223e-02 + 7.1276974214966060e-01 -2.3741510789079712e-02 + 7.1169463503294139e-01 -2.8678452838605040e-02 + 7.1242336364959158e-01 -2.7528301634205832e-02 + 8.6902465768404369e-01 2.2394113720466180e-02 + 8.8118059173142882e-01 2.8691403683453132e-02 + 8.8019210149416693e-01 3.5690007592137363e-02 + 8.4884787677367513e-01 6.1450594346808884e-02 + 8.5528753311535155e-01 5.8260481475898018e-02 + 8.3263160177027373e-01 6.7997760058574386e-02 + 8.4132679078747685e-01 6.4701667251291894e-02 + 8.2267362428613211e-01 7.1363055384345842e-02 + 4.1497546259476081e-01 1.0474651650191902e-01 + 4.0450711246754167e-01 1.0430929442712511e-01 + 3.2274424698622539e-01 1.0514646353829704e-01 + 3.1364506780694512e-01 1.0546013217366124e-01 + 1.3674835705545973e-01 9.3707710443666770e-02 + 1.2985483812134646e-01 8.3237333357800480e-02 + 1.2780232538848679e-01 9.1203516929624584e-02 + 1.0013626724309432e-01 7.4488771507233764e-02 + 8.8393372459506736e-02 6.8871888987601437e-02 + 8.2538088941404908e-02 6.7893139395863500e-02 + 3.0195615354145389e-02 1.5207708651523433e-02 + 7.8017637526990313e-02 -6.1523661369619731e-02 + 2.7650828901276725e-01 -9.0785080966242049e-02 + 3.7125990008455290e-01 -9.6583547878225318e-02 +-6.8248914633528557e-03 2.9332174963130342e-03 +-4.5933068273740219e-03 4.7433416922402216e-03 +-2.8094862800145393e-03 5.4095946255046101e-03 +-7.8899593873416052e-05 7.9748020001773057e-03 +-8.4436083604941814e-03 1.6884242728210097e-03 +-1.0123937169794317e-02 3.9215445570306429e-04 +-1.1866763981743134e-02 -9.5682705618571617e-04 +-1.3673161582474336e-02 -2.3600045410319126e-03 +-1.7477041672407267e-02 -5.3325338650154208e-03 +-1.9472871096695599e-02 -6.9026284371034308e-03 +-2.1062017760897334e-02 -4.8873894832865972e-03 +-2.3647557224180105e-02 -1.0212775202433022e-02 +-2.1530555818600305e-02 -8.5296149927529541e-03 +-2.3124635424792928e-02 -6.5188336700430227e-03 +-2.8046499216301868e-02 -1.3742382383767904e-02 +-3.0323238069328795e-02 -1.5587143655537261e-02 +-3.2646358603955150e-02 -1.7482730886939635e-02 +-3.5013824100673219e-02 -1.9428860656105940e-02 +-3.7424368234027838e-02 -2.1426100819738281e-02 +-4.4862367985913920e-02 -2.7701607297203168e-02 +-4.4008137430637362e-02 -2.3609255757577330e-02 +-4.9953530518976663e-02 -3.2113266985035693e-02 +-5.2518938663439485e-02 -3.4378042826702426e-02 +-5.5085543874682230e-02 -3.6674630811759812e-02 +-5.7647396758810032e-02 -3.9000217413970972e-02 +-6.0204921323546046e-02 -4.1358600971321380e-02 +-6.2758438155114504e-02 -4.3754930879657650e-02 +-6.5300885185820334e-02 -4.6188836270573574e-02 +-6.7822292146203722e-02 -4.8657846956842832e-02 +-7.0315563282179028e-02 -5.1162289046501996e-02 +-7.2769884746449520e-02 -5.3698402222892128e-02 +-7.5170356220070289e-02 -5.6257701109927893e-02 +-7.7511418634713891e-02 -5.8841876059844367e-02 +-7.9795681401279239e-02 -6.1463802479821084e-02 +-8.2021330063341225e-02 -6.4134933261172478e-02 +-8.4179768392530718e-02 -6.6862118037207097e-02 +-8.6254503834268803e-02 -6.9644831500880855e-02 +-8.8225942970552751e-02 -7.2480108506923102e-02 +-9.0082475367651682e-02 -7.5379717245468214e-02 +-9.1817567909814102e-02 -7.8372616286728203e-02 +-9.3415372381230100e-02 -8.1488502337521140e-02 +-9.4839627010102845e-02 -8.4737265877450341e-02 +-9.6048347524828159e-02 -8.8135241353072047e-02 +-9.6994372067712220e-02 -9.1716863760836986e-02 +-9.7608541808995142e-02 -9.5485273246865177e-02 +-9.7809554198818205e-02 -9.9388178916640868e-02 +-9.7528430116383902e-02 -1.0333358136620063e-01 +-9.6720383094350382e-02 -1.0724012556715934e-01 +-9.5377322014897459e-02 -1.1099116948953736e-01 +-9.3543416218949460e-02 -1.1445698830367235e-01 +-9.1311672989661474e-02 -1.1752582370056075e-01 +-8.8759394115271562e-02 -1.2018875019232667e-01 +-8.5956377471532619e-02 -1.2244912264611685e-01 +-8.2988234852805931e-02 -1.2431285266333703e-01 +-7.9917951824782563e-02 -1.2580911781124371e-01 +-7.6803784975624012e-02 -1.2697071133608517e-01 +-7.3683195634657750e-02 -1.2783797825622401e-01 +-7.0599275577919229e-02 -1.2844821467203360e-01 +-6.7610665678543569e-02 -1.2883725833931692e-01 +-6.4738704166629191e-02 -1.2904597822560504e-01 +-6.1971788096201408e-02 -1.2911121566247630e-01 +-6.1972887650640018e-02 -1.3159553466580576e-01 +-6.4852042067812476e-02 -1.3151414208613232e-01 +-5.6659808961370572e-02 -1.2891654173486700e-01 +-5.4114364944666704e-02 -1.2869558521039437e-01 +-5.1663156997150850e-02 -1.2841522439273945e-01 +-4.9313903469993647e-02 -1.2809017457996674e-01 +-4.7065874824539833e-02 -1.2773227228865380e-01 +-4.4911946375862044e-02 -1.2735031551321185e-01 +-4.0846382766744682e-02 -1.2653726130253062e-01 +-4.2841338349873581e-02 -1.2695037770835427e-01 +-3.7128440115708372e-02 -1.2538383003501963e-01 +-3.5265141865380656e-02 -1.2614841338827887e-01 +-3.8574929959878546e-02 -1.2657954463215049e-01 +-3.3197571481693444e-02 -1.2686632982776302e-01 +-3.3933689658013577e-02 -1.2455679735538183e-01 +-3.1669274913042500e-02 -1.2541566334870424e-01 +-2.9419449894604099e-02 -1.2487715765210794e-01 +-3.0760291350361513e-02 -1.2361414902585466e-01 +-2.7433628099700513e-02 -1.2381965364554048e-01 +-2.9356783337050274e-02 -1.2280620896312655e-01 +-2.5358721752880342e-02 -1.2156618039219325e-01 +-2.3262300737812325e-02 -1.2002632226476351e-01 +-2.0918605012496982e-02 -1.1753844551857640e-01 +-2.1851676132570219e-02 -1.2166837580238621e-01 +-1.9256771459993161e-02 -1.1873832993323674e-01 +-1.7964277344873381e-02 -1.0785707726864757e-01 +-1.9416255076805555e-02 -1.0246747375099119e-01 +-2.1736880532301939e-02 -9.8903039182800967e-02 +-2.3669634596927835e-02 -9.6874623951094918e-02 +-2.8318552464824620e-02 -8.7233776502003479e-02 +-2.8145559374252116e-02 -8.4733638939070488e-02 +-2.7691114234826841e-02 -8.1832757395346789e-02 +-2.5410802121982101e-02 -8.5051570108333863e-02 +-2.6939191574541610e-02 -7.8618402526146269e-02 +-2.5898037262550133e-02 -7.5182454420300360e-02 +-2.4584502264104913e-02 -7.1595143530046812e-02 +-2.3014714108683165e-02 -6.7903344716185643e-02 +-2.1202851814194901e-02 -6.4138643468012901e-02 +-1.9170843211810507e-02 -6.0338962170874311e-02 +-1.6949339898587823e-02 -5.6547139550701786e-02 +-1.4565725493170589e-02 -5.2792568127472350e-02 +-1.2057129688216150e-02 -4.9117306864886245e-02 +-9.4773668551653145e-03 -4.5584066246647126e-02 +-6.8665482912138032e-03 -4.2229663914625348e-02 +-4.2376178945460197e-03 -3.9049056766629064e-02 +-1.5963725970493670e-03 -3.6022759534176885e-02 + 1.0452099802620296e-03 -3.3132944613996074e-02 + 3.6627608207808748e-03 -3.0371584685752850e-02 + 6.2202819613403904e-03 -2.7742202610781419e-02 + 8.6874698643413240e-03 -2.5245411502879733e-02 + 1.1041033480687190e-02 -2.2880304714121280e-02 + 1.3263551270668472e-02 -2.0646293598588272e-02 + 1.7272915826069379e-02 -1.6568113260731820e-02 + 1.7167780260180621e-02 -2.0340081525844766e-02 + 1.5343124715947454e-02 -1.8542833863961050e-02 + 1.9050256805087429e-02 -1.4716449717809610e-02 + 2.2161166397111742e-02 -1.1303268505642450e-02 + 2.3520368447506712e-02 -9.6462837915822774e-03 + 2.4779024630980473e-02 -7.8966172724364014e-03 + 2.5538044301988805e-02 -1.0820111767358753e-02 + 2.5983126813343915e-02 -1.2805293598873391e-02 + 2.9888639652092763e-02 -1.1112831937978740e-02 + 2.8545851887500362e-02 -1.1824415500768737e-02 + 2.8062361530423630e-02 -9.7727030489238587e-03 + 2.5956421363780180e-02 -5.8795686032340200e-03 + 2.7968257577967393e-02 -6.9337073183106668e-03 + 3.0543298717461198e-02 -9.8115213241527499e-03 + 2.7013571889561661e-02 -3.3211387830220929e-03 + 2.9051380646230029e-02 -3.9746385968157938e-03 + 3.1716128283548528e-02 -4.7739244491964428e-03 + 2.7714154083831488e-02 1.7255574772434557e-04 + 3.2319896698666639e-02 -4.1199282563297857e-05 + 2.9715511418032747e-02 5.5774621472437502e-05 + 3.1510613786146280e-02 6.2330831100041451e-03 + 2.9140718944589139e-02 5.4836039124666058e-03 + 2.7307601943618920e-02 4.9401200214660435e-03 + 2.4529508839677305e-02 1.0188002388311190e-02 + 1.9667057943244970e-02 1.3606367292567256e-02 + 1.1561878244577883e-02 1.4326367462444978e-02 + 1.5160435720112275e-02 1.6650359714859064e-02 + 2.0447145857460214e-02 1.5401872316154197e-02 + 1.5024097183328422e-02 1.4592337289997204e-02 + 9.0504338746555391e-03 1.3631248681633679e-02 + 5.6568280319595488e-03 1.1112382812960675e-02 + 6.2550612662306548e-03 1.3148853025953144e-02 + 3.6827287876519677e-03 1.2161180879374456e-02 + 2.5292653357098516e-03 9.8530610719365086e-03 + 4.2045981018787870e-03 1.0245627553970849e-02 + 7.3814685860895679e-04 1.0128516556250133e-02 + 1.5517415771029164e-03 8.5785762226109341e-03 +-2.0184373036613579e-03 8.3496065116008822e-03 +-1.6117042311805108e-03 6.6353495595308232e-03 +-6.7852739400350970e-02 -1.3128048605916831e-01 +-2.4755474444035031e-02 -1.2501453177223709e-01 + 3.0566866491554379e-02 -7.8835844984723735e-03 + 1.1161517155024114e-02 1.6468127675182131e-02 + 1.1013679222414581e+00 -9.2688830030652980e-02 + 1.1079239779262622e+00 -9.4817131881342220e-02 + 1.1061223215755831e+00 -9.6845808202971284e-02 + 1.0907563315668085e+00 -8.3414202477456456e-02 + 1.0849054265363378e+00 -7.8304763927391718e-02 + 1.0787056604445482e+00 -7.2896664595262450e-02 + 1.0721759040740153e+00 -6.7211270720335392e-02 + 1.0653408797032000e+00 -6.1278499888899773e-02 + 1.0669755388738054e+00 -5.9387212618588592e-02 + 1.0738138958606740e+00 -6.5327730022090691e-02 + 1.0582302143317577e+00 -5.5137476245818107e-02 + 1.0508764718643420e+00 -4.8837323769802765e-02 + 1.0525160555205559e+00 -4.6902614881815907e-02 + 1.0598666756251660e+00 -5.3228675861106467e-02 + 1.0433107159420274e+00 -4.2438961546650944e-02 + 1.0449484368349999e+00 -4.0470893611384895e-02 + 1.0355533905306871e+00 -3.6025005399324073e-02 + 1.0371770636216695e+00 -3.4016923503102703e-02 + 1.0276205792264719e+00 -2.9702355928520774e-02 + 1.0292152971768047e+00 -2.7651912181639204e-02 + 1.0195562501748583e+00 -2.3551333807020569e-02 + 1.0211058566491360e+00 -2.1460409368273758e-02 + 1.0113961641979614e+00 -1.7665654485867321e-02 + 1.0032073392835272e+00 -1.2114698759816633e-02 + 1.0128862555409839e+00 -1.5538445434231107e-02 + 1.0046378415088242e+00 -9.9596335718104001e-03 + 9.9510730320152874e-01 -6.8937837644966748e-03 + 9.9649734844196303e-01 -4.7221835298216774e-03 + 9.8722762984524337e-01 -1.9115916533678501e-03 + 9.7959564083726747e-01 2.8140237904139553e-03 + 9.5828371552169500e-01 1.4763641302323549e-02 + 9.5179098437493792e-01 1.7927672658004212e-02 + 9.4562816362255120e-01 2.0669846591125918e-02 + 9.5287528934944987e-01 2.0242923537708180e-02 + 9.4661459505921641e-01 2.2993889004212065e-02 + 9.3980345747998939e-01 2.2969334253900797e-02 + 9.4068453456240775e-01 2.5288738561243918e-02 + 9.3435236510183017e-01 2.4874228185673530e-02 + 9.3513394806824124e-01 2.7173155960880990e-02 + 9.2929292744688041e-01 2.6449971450347221e-02 + 9.2998562981092903e-01 2.8716113785144159e-02 + 9.2462627275226339e-01 2.7751719777754147e-02 + 9.2524015246105762e-01 2.9978632690472296e-02 + 9.2034428513965594e-01 2.8823951455528629e-02 + 9.1643186613825378e-01 2.9700865348424088e-02 + 9.1285909155210732e-01 3.0409549982543638e-02 + 9.0957249057598943e-01 3.0931423339623620e-02 + 9.0655482509384910e-01 3.1192082740815863e-02 + 9.0383278228669184e-01 3.1229199028359744e-02 + 9.0140712860384298e-01 3.1109486204684345e-02 + 8.9926402406082673e-01 3.0907423060170913e-02 + 9.0133499092809188e-01 3.2942728011867928e-02 + 8.9571270666406377e-01 3.0491973714084963e-02 + 8.9424204427326259e-01 3.0342358532330138e-02 + 8.9293959394014166e-01 3.0241670732081616e-02 + 8.9009631872804107e-01 2.9831784197163813e-02 + 8.8905091453239748e-01 2.9903336280192150e-02 + 8.8874528186454427e-01 2.9072374913198473e-02 + 8.8800872351734483e-01 2.9632728127424457e-02 + 8.8722021525101979e-01 3.0164484103089251e-02 + 8.8683680956283695e-01 2.9059320148924428e-02 + 8.8557441195511899e-01 2.8942678519953802e-02 + 8.8440161975701415e-01 2.8685422471227184e-02 + 8.8336069924887539e-01 2.8442431004151558e-02 + 8.6604073161392137e-01 1.5643045506699593e-02 + 8.6508684931782653e-01 1.1219264896453751e-02 + 8.6337082364970996e-01 6.2193304847113495e-03 + 8.6374645009679085e-01 1.1417313501326021e-02 + 8.6353136265543640e-01 6.5046477031671657e-04 + 8.6600830160746511e-01 -4.5533827480568334e-03 + 8.6457253855122929e-01 -5.0263981625704446e-03 + 8.6684195067506664e-01 -1.0081028804137304e-02 + 8.6819293601990921e-01 -9.3204430376943037e-03 + 8.7083955741135100e-01 -1.3205115319749439e-02 + 8.7367830126567014e-01 -1.6069980712714482e-02 + 8.7633847059605330e-01 -1.7931345364772255e-02 + 8.7838639752476411e-01 -1.9276100349188141e-02 + 8.7754194844227129e-01 -2.0468148459912072e-02 + 8.7984503364671696e-01 -2.0386357449567072e-02 + 8.7547212758300930e-01 -1.9124172144586282e-02 + 8.8380504382944025e-01 -2.3593796329393513e-02 + 8.9158832897204832e-01 -3.0325644423172093e-02 + 8.9568684570075163e-01 -3.3565678619055461e-02 + 8.9442349117198461e-01 -3.5424015966299294e-02 + 9.0473292820190210e-01 -3.9003330174452344e-02 + 9.0955867060175422e-01 -4.1076305225132614e-02 + 9.0859685431836112e-01 -4.3496922321835996e-02 + 9.1444141307875526e-01 -4.2866202421564026e-02 + 9.1932704132540266e-01 -4.4507650764032292e-02 + 9.2417523972425641e-01 -4.6121845590278099e-02 + 9.2896132889782734e-01 -4.7825903332665121e-02 + 9.3354101937409695e-01 -4.9605094231253588e-02 + 9.3820735444423065e-01 -5.1444624909791514e-02 + 9.4293118694806566e-01 -5.3329802613433230e-02 + 9.4770201179096603e-01 -5.5273132369052291e-02 + 9.5251937802206754e-01 -5.7259396538981377e-02 + 9.5736897583119429e-01 -5.9290228859239846e-02 + 9.6224434717654361e-01 -6.1373322281355058e-02 + 9.6714152991488334e-01 -6.3477645539634864e-02 + 9.7203609113552858e-01 -6.5634379626771988e-02 + 9.7693262351739207e-01 -6.7806723921052026e-02 + 9.8180439069919601e-01 -7.0015599370719883e-02 + 9.8665106657342960e-01 -7.2247920301521162e-02 + 9.9145924879478287e-01 -7.4502085423461040e-02 + 9.9622119265074360e-01 -7.6789149057844952e-02 + 1.0009382684856760e+00 -7.9083874899026796e-02 + 1.0055937520230742e+00 -8.1407566848895385e-02 + 1.0101928523620956e+00 -8.3717116832161764e-02 + 1.0147069993561502e+00 -8.6053367766666611e-02 + 1.0191513483719490e+00 -8.8359065000275905e-02 + 1.0234908182872147e+00 -9.0686659978501893e-02 + 1.0277477516748306e+00 -9.2970090304405062e-02 + 1.0318824269706042e+00 -9.5272113609709663e-02 + 1.0359253641594890e+00 -9.7519661579767103e-02 + 1.0398333907659207e+00 -9.9783897133505661e-02 + 1.0436463038383010e+00 -1.0199175240683189e-01 + 1.0473226980688537e+00 -1.0420441838681427e-01 + 1.0508990040379302e+00 -1.0635972386464232e-01 + 1.0543390968338429e+00 -1.0850672963408670e-01 + 1.0576747001307680e+00 -1.1059647795681826e-01 + 1.0608774694816958e+00 -1.1266402968777811e-01 + 1.0639725370770847e+00 -1.1467556536611312e-01 + 1.0669408466241492e+00 -1.1665215262163997e-01 + 1.0698003489155994e+00 -1.1857405772181551e-01 + 1.0725410368251005e+00 -1.2045105271835155e-01 + 1.0751749879025851e+00 -1.2227658497064908e-01 + 1.0777012124242660e+00 -1.2404908778546542e-01 + 1.0824475079885758e+00 -1.2743511676271169e-01 + 1.0809054738519848e+00 -1.2957694755766624e-01 + 1.0846698714396936e+00 -1.2904584100876093e-01 + 1.0831188348257044e+00 -1.3118186046972369e-01 + 1.0867966696083542e+00 -1.3059462607296268e-01 + 1.0888239534340656e+00 -1.3208805898982234e-01 + 1.0907578060216991e+00 -1.3351796677729055e-01 + 1.0925949156302721e+00 -1.3489347282201436e-01 + 1.0943433410132855e+00 -1.3620637052540019e-01 + 1.0959999458649605e+00 -1.3746750495309357e-01 + 1.0982191243057002e+00 -1.3922193027394769e-01 + 1.0962231896697929e+00 -1.4062170642573335e-01 + 1.0999467611694840e+00 -1.4062598282347949e-01 + 1.1032456005354589e+00 -1.4217673461494940e-01 + 1.1017286766790590e+00 -1.4160131208176097e-01 + 1.1021062131140056e+00 -1.4383728114803773e-01 + 1.1034552393711152e+00 -1.4506573209924056e-01 + 1.1045792277733000e+00 -1.4344271071746562e-01 + 1.1049447321713259e+00 -1.4540341871015983e-01 + 1.1061907742247570e+00 -1.4445196779941227e-01 + 1.1055097088373458e+00 -1.4700719774282334e-01 + 1.1066260377276151e+00 -1.4574903009828688e-01 + 1.1081950819744151e+00 -1.4585509889910497e-01 + 1.1096513225682116e+00 -1.4868809739768096e-01 + 1.1061373009424216e+00 -1.4829328149367882e-01 + 1.1078009996967992e+00 -1.4890200811720433e-01 + 1.1087983239424091e+00 -1.4727385758408218e-01 + 1.1072006769909351e+00 -1.4716488597289867e-01 + 1.1087124219000586e+00 -1.4984637354567099e-01 + 1.1099686606118340e+00 -1.5021366673404657e-01 + 1.1118768009474707e+00 -1.4851530962150150e-01 + 1.1122671312687942e+00 -1.4995022712646744e-01 + 1.1109426095859050e+00 -1.4933779259153823e-01 + 1.1110659278003325e+00 -1.5043557607569369e-01 + 1.1134889626067519e+00 -1.5064478203467502e-01 + 1.1134606213091303e+00 -1.4967742834360820e-01 + 1.1114961630465814e+00 -1.5115416909776513e-01 + 1.1114693424940896e+00 -1.5228325532744691e-01 + 1.1105342776970417e+00 -1.5145279282538127e-01 + 1.1143467707823120e+00 -1.5317123309219483e-01 + 1.1131844853679240e+00 -1.5334501415409818e-01 + 1.1136429795102103e+00 -1.5204066104843150e-01 + 1.1150502359146728e+00 -1.5183991710581779e-01 + 1.1144116510798625e+00 -1.5098733708119028e-01 + 1.1124928445446898e+00 -1.5138867679867474e-01 + 1.1149994962710537e+00 -1.5443454112414656e-01 + 1.1137857628268506e+00 -1.5425090149021514e-01 + 1.1154492448427504e+00 -1.5310504942942771e-01 + 1.1163108228140786e+00 -1.5210972449361293e-01 + 1.1165345557566297e+00 -1.5298838041751139e-01 + 1.1173753373972630e+00 -1.5357490491598469e-01 + 1.1184607132877460e+00 -1.5466512007138533e-01 + 1.1193314316346843e+00 -1.5643214609652034e-01 + 1.1177979054318641e+00 -1.5590715322457527e-01 + 1.1214064534424395e+00 -1.5570318257503857e-01 + 1.1200685447041323e+00 -1.5475649558203486e-01 + 1.1187619545071072e+00 -1.5828038638046849e-01 + 1.1242242888434362e+00 -1.5676459114668262e-01 + 1.1336630098162459e+00 -1.5532907621432912e-01 + 1.1346389993543511e+00 -1.5742375781593410e-01 + 1.1307655342854375e+00 -1.5911183894081660e-01 + 1.1362214293214947e+00 -1.5402533550494013e-01 + 1.1379342613108534e+00 -1.5254393396672583e-01 + 1.1426431573199665e+00 -1.4943562709538583e-01 + 1.1424455852700675e+00 -1.4446173563135289e-01 + 1.1417059636696223e+00 -1.4707388448452718e-01 + 1.1446309870582851e+00 -1.4682485548338775e-01 + 1.1425903638283614e+00 -1.4202372673830155e-01 + 1.1437975857020675e+00 -1.3571560314224485e-01 + 1.1433204882863919e+00 -1.3716527081768959e-01 + 1.1423271100052759e+00 -1.3610250303200644e-01 + 1.1451180916495503e+00 -1.3834591878182323e-01 + 1.1448205698546232e+00 -1.3661790026900178e-01 + 1.1416886083400613e+00 -1.3751683549564575e-01 + 1.1428636187984509e+00 -1.3880454805776310e-01 + 1.1410022907340789e+00 -1.3645902684388034e-01 + 1.1407586689735183e+00 -1.3729020248190693e-01 + 1.1411245304141886e+00 -1.3525134237586656e-01 + 1.1402265914752050e+00 -1.3425002507784711e-01 + 1.1427314187964299e+00 -1.3467779522804335e-01 + 1.1428770575839238e+00 -1.3307378502662459e-01 + 1.1401103600751696e+00 -1.3300356040210204e-01 + 1.1415742046870321e+00 -1.3215507789774961e-01 + 1.1391648066175861e+00 -1.3198910908768369e-01 + 1.1390260117447326e+00 -1.3058143551907619e-01 + 1.1382462514100453e+00 -1.2912690744767019e-01 + 1.1349300810365577e+00 -1.2450034934171583e-01 + 1.1333394948854689e+00 -1.2277977665317508e-01 + 1.1316226795096256e+00 -1.2074655476459384e-01 + 1.1296113197279354e+00 -1.1843460259632366e-01 + 1.1318352361271735e+00 -1.1640274666507366e-01 + 1.1272585172039484e+00 -1.1595753452847646e-01 + 1.1294130628264725e+00 -1.1386164800322263e-01 + 1.1245837132565413e+00 -1.1332981735149872e-01 + 1.1215825015360039e+00 -1.1051845011741079e-01 + 1.1182424652870182e+00 -1.0749137475133352e-01 + 8.6669338716880873e-01 1.9894233121036109e-02 + 8.6476322410473472e-01 1.6116576936013871e-02 + 8.7267807107561168e-01 -1.7208240617136994e-02 + 1.0594458688846871e+00 -1.1487664386241647e-01 + 1.0625236536622467e+00 -1.1687806922834909e-01 + 1.0710452704093711e+00 -1.2262421676022939e-01 + 7.1342130433511386e-01 -2.2658846322158865e-02 + 7.1591627150334602e-01 -2.5548110264409729e-02 + 7.1781268754365612e-01 -2.5043902482394742e-02 + 7.2282084686242598e-01 1.0273056686955329e-02 + 7.2155036387798788e-01 6.6332993247186778e-03 + 7.2030903658799872e-01 8.9404156125851841e-03 + 7.3269228433747458e-01 7.5093959675456290e-03 + 7.2867666273730691e-01 1.1625638780145664e-02 + 7.2470327460943196e-01 2.5881640487384061e-03 + 7.2606157276221950e-01 8.8139797438273604e-03 + 7.4902561175676396e-01 9.4721082183681915e-03 + 7.3968867121705273e-01 8.3815645546536643e-03 + 7.6040294635490824e-01 1.0717451604520534e-02 + 7.7282551187369819e-01 1.2001888526008031e-02 + 7.7306314006573729e-01 7.1721511675519878e-03 + 7.6066485456575350e-01 5.3942285487877939e-03 + 7.8486477794499621e-01 1.3192475001055470e-02 + 7.9525747669521962e-01 1.4187994234745815e-02 + 8.0355542780464617e-01 1.1176050352368350e-02 + 7.9545606731444707e-01 1.0151686401897564e-02 + 7.8508083067751500e-01 8.8012538044495159e-03 + 8.0336984846931614e-01 1.4947906886334295e-02 + 8.1890802319294664e-01 1.2024837525984822e-02 + 8.1627545700970927e-01 1.4901557278221844e-02 + 8.2630574968388260e-01 1.6747594574916036e-02 + 8.2256873416662302e-01 1.6531710373001829e-02 + 8.2270033115403862e-01 1.3276689560733246e-02 + 8.4228307831542537e-01 1.7930013023494951e-02 + 8.4860811366358035e-01 1.8567798229440768e-02 + 8.4250149090551929e-01 1.4938567301115313e-02 + 8.4886686359774899e-01 1.5684917470963455e-02 + 8.5488004162021980e-01 1.9342150797882596e-02 + 8.6073971988864173e-01 2.0244379040505578e-02 + 8.6111314464753264e-01 1.7635969291013964e-02 + 8.6591895892946980e-01 2.1255628988939179e-02 + 8.8247913549658819e-01 2.9513681551165405e-02 + 8.8237459618105873e-01 2.8181710571494989e-02 + 8.8036206501529790e-01 3.2727500298776135e-02 + 8.8370817985274641e-01 2.9350457829615095e-02 + 8.8359546050313043e-01 3.0300591175269176e-02 + 8.8266559201531436e-01 3.1057403973079545e-02 + 8.8127029601115225e-01 3.1762941576289450e-02 + 8.8009319422015153e-01 3.3796507127703990e-02 + 8.8202592155520421e-01 3.7853209799649790e-02 + 8.7467165503088040e-01 4.3779643016762293e-02 + 8.7220613157926863e-01 4.6420318160400598e-02 + 8.6532619634499497e-01 5.2123238109864189e-02 + 8.6911737237753783e-01 4.9208568563948063e-02 + 8.6763260133044895e-01 5.6212040167125110e-02 + 8.6074719326748550e-01 5.5146092524196888e-02 + 8.6300750129220916e-01 5.9721450699939282e-02 + 8.5096363831375044e-01 6.6968156672508883e-02 + 8.5748274985440531e-01 6.3313975743781725e-02 + 7.8564760604483297e-01 8.9580156020858226e-02 + 8.0017159817121808e-01 8.5819742427979406e-02 + 7.5051289972975610e-01 8.8115777114708749e-02 + 7.3248703590981989e-01 9.9526827985499722e-02 + 7.5176090396173834e-01 9.6523740619318232e-02 + 7.1182807983189633e-01 1.0212047261366308e-01 + 6.9001539298865566e-01 1.0427957801210397e-01 + 6.6667610278442169e-01 9.7284299669503582e-02 + 6.4346523688585222e-01 9.8853021765236804e-02 + 6.1991873604740277e-01 1.0024430849611576e-01 + 6.2041357794559104e-01 1.0907906860332162e-01 + 6.4402847286145715e-01 1.0768295956919616e-01 + 5.9636174787299723e-01 1.0147836881282046e-01 + 5.7312243202299129e-01 1.0256209102576719e-01 + 5.7350520217151768e-01 1.1141277664047777e-01 + 5.9679824788811686e-01 1.1031860173021357e-01 + 5.5051117339715461e-01 1.0349208935689092e-01 + 5.5084004753036453e-01 1.1235817919304480e-01 + 5.2880269787983991e-01 1.0425642952146319e-01 + 5.2907320872468944e-01 1.1313946665953978e-01 + 5.0843395614425191e-01 1.1373181181346581e-01 + 4.8910950057044289e-01 1.1412048793999929e-01 + 4.2680608713790491e-01 1.0509980117254258e-01 + 4.2663679244659392e-01 1.1391887202569251e-01 + 4.1472347371588114e-01 1.1351083993567102e-01 + 3.6958939086213149e-01 1.0173950502806406e-01 + 3.7693126634769669e-01 1.0540760787856129e-01 + 3.6547788448770291e-01 9.8795552650202012e-02 + 3.6296633199057737e-01 1.0403326303087113e-01 + 3.0400237117071782e-01 1.0566595721779493e-01 + 2.9384913358641995e-01 1.0573843595557264e-01 + 2.8323035999370916e-01 1.0565182347680491e-01 + 2.7220378109720400e-01 1.0538174839567205e-01 + 2.6083887534332462e-01 1.0490628197651120e-01 + 2.4921540357752292e-01 1.0420687680807816e-01 + 2.3742169407501024e-01 1.0326977945034344e-01 + 2.2555223214769171e-01 1.0208745165900268e-01 + 2.1370455779692321e-01 1.0065955324593290e-01 + 2.0197606184991201e-01 9.8993370650866552e-02 + 1.9046063381341582e-01 9.7104026067846405e-02 + 1.7924523193274666e-01 9.5015931161924527e-02 + 1.6840630263085643e-01 9.2766724085265651e-02 + 1.7771338308837414e-01 1.0402024053755099e-01 + 1.6675941433211250e-01 1.0152462681078589e-01 + 1.5800626489487968e-01 9.0409341274657606e-02 + 1.4809267734318610e-01 8.8003939654797136e-02 + 1.5625379781797477e-01 9.8920892164969132e-02 + 1.3870038990972944e-01 8.5601986764373805e-02 + 9.2204250329373849e-02 7.5541498343170588e-02 + 7.5715587463051293e-02 7.0806103137428522e-02 + 6.7404658161585473e-02 6.0930295693147229e-02 + 7.2211962879535463e-02 6.4315552020751454e-02 + 5.5327462524701332e-02 5.2252407904973097e-02 + 5.3505762822823044e-02 4.6395941366206728e-02 + 6.3943306068530603e-02 5.6776554747628438e-02 + 4.9192964017343854e-02 4.2808203681587997e-02 + 4.5288592313070808e-02 3.4608774667084674e-02 + 4.8124247680853216e-02 3.7925621102758100e-02 + 4.4097948683052834e-02 3.0918447390988035e-02 + 4.1574853723709282e-02 2.8707426434777972e-02 + 4.1656286338763948e-02 2.4738015811550440e-02 + 4.5989186388382564e-02 -4.6752647220145604e-02 + 4.9670903912549136e-02 -5.0067417977061268e-02 + 4.8031882201328813e-02 -5.3642651003784181e-02 + 5.2099169979356930e-02 -5.3161994357139974e-02 + 5.0097091418251694e-02 -5.6959706791218423e-02 + 6.4804973399745336e-02 -5.6720836696186439e-02 + 7.0810746627280707e-02 -5.9027302760611633e-02 + 1.0695991714909781e-01 -7.5843172712126261e-02 + 9.5272583236109654e-02 -7.2756308281711313e-02 + 1.2138694327754962e-01 -7.2596770208690486e-02 + 1.3612096497550397e-01 -7.5368265616290842e-02 + 1.3507665530336510e-01 -8.1912332509148200e-02 + 1.2024476657492045e-01 -7.8915969956355525e-02 + 1.5226160896430230e-01 -7.8026125757475029e-02 + 1.5131353427422312e-01 -8.4773532321918310e-02 + 1.6957136904206749e-01 -8.0519758403013952e-02 + 1.6871532985032189e-01 -8.7448376807998329e-02 + 1.8772068648765128e-01 -8.2809858715165774e-02 + 1.8695050183350759e-01 -8.9898898195698962e-02 + 2.0630840204399448e-01 -8.4871960155822990e-02 + 2.0561644573071192e-01 -9.2104234947925079e-02 + 2.2489495426025030e-01 -8.6694994127114455e-02 + 2.2427285063491809e-01 -9.4057011712436633e-02 + 2.4304253826930022e-01 -8.8279197293786638e-02 + 2.4248180500394056e-01 -9.5759888123765791e-02 + 2.6035467670382673e-01 -8.9635954232093695e-02 + 2.5984725956018906e-01 -9.7226627093277784e-02 + 2.7604646647279196e-01 -9.8479431966453035e-02 + 3.1619469779225540e-01 -9.3216761620652733e-02 + 3.2634141842827802e-01 -9.3764086508485889e-02 + 3.6291512069313114e-01 -9.6895107889139354e-02 + 3.6669604161536284e-01 -1.0592902351554301e-01 + 3.5831517283615710e-01 -1.0408985028587381e-01 + 3.9577786431688367e-01 -9.7710980084940502e-02 + 4.0559003930919602e-01 -9.7889576221206198e-02 + 3.9567395329748933e-01 -1.0665058423587936e-01 + 4.1623797859297440e-01 -9.7908866278203277e-02 + 4.2770385705750869e-01 -9.7730508308330855e-02 + 4.6649049352556915e-01 -9.5651798363235230e-02 + 4.8059096284573855e-01 -9.4345062325984941e-02 + 6.2884606580995239e-01 -6.3299182134244347e-02 + 6.3867901272946881e-01 -6.0130586022324906e-02 + 6.4768210989268482e-01 -5.7106573085874857e-02 + 6.5587256162491059e-01 -5.4253239882413595e-02 + 6.6328088936467822e-01 -5.1588068489394345e-02 + 6.8123945872955716e-01 -4.4792653913049207e-02 + 6.6994641836524949e-01 -4.9121286840843936e-02 + 6.6511039730764310e-01 -5.7311631651870698e-02 + 6.8596947824154597e-01 -4.2924016819057442e-02 + 6.9015841858079341e-01 -4.1242049589399699e-02 + 6.9526660184630629e-01 -4.0162287481095404e-02 + 6.9952652529455150e-01 -3.8006241794292350e-02 + 7.0282314180186489e-01 -3.5987977214915645e-02 + 8.0921894199406097e-01 1.5486427805257108e-02 + 8.2644955548521892e-01 1.3538545809510083e-02 + 8.5518963586539343e-01 1.6587297032067738e-02 + 8.6310898546038572e-01 1.6749482615452393e-02 + 7.6950541991371324e-01 9.3179212230552366e-02 + 6.6732580427716215e-01 1.0610140523803580e-01 + 4.0417224031772037e-01 1.1300741414014226e-01 + 3.8334674048713424e-01 1.1401816650531060e-01 + 2.8297718786332382e-01 1.1540812823242419e-01 + 2.9371899987530981e-01 1.1541203999684058e-01 + 2.2457769864054455e-01 1.1179401676573519e-01 + 2.1258037840575383e-01 1.1024515103695620e-01 + 3.0412510669952297e-01 -1.0043704548920118e-01 + 3.1535626125994298e-01 -1.1154878049886463e-01 + 4.0560166888982963e-01 -1.0691824285909490e-01 + 4.4091789300583173e-01 -1.1842673711629459e-01 + 4.2921062080662864e-01 -1.3401019443296036e-01 + 4.1965935222516748e-01 -1.2144213761250455e-01 + 6.5772362610382373e-01 -6.0208380816717977e-02 +-6.7085563729278874e-03 7.0017172455720811e-03 +-1.0042032205888063e-02 4.3381617730915423e-03 +-8.7659037391034644e-03 5.8140643195940811e-03 +-1.1796476556014568e-02 2.4647851517940467e-03 +-1.3624226917514193e-02 1.0752670728635394e-03 +-1.1912955901962619e-02 7.6592590524171555e-04 +-1.4460635824576684e-02 3.7025500868921313e-03 +-2.4203876726033968e-02 -2.6548006833593263e-03 +-2.2384394027596954e-02 -5.5975534266394789e-05 +-1.9629208809945453e-02 -2.0384172947274237e-04 +-2.9657834695640872e-02 -1.1746859537623777e-02 +-3.0179858234390622e-02 -4.3245270957896764e-03 +-3.1940991161320653e-02 -1.3597307842260875e-02 +-3.4270832856151401e-02 -1.5498946159937077e-02 +-3.6645368075923557e-02 -1.7451582404405031e-02 +-3.9063420005263083e-02 -1.9455900234419232e-02 +-4.2291309250330755e-02 -1.6590762943707205e-02 +-4.4936493433752389e-02 -1.9900725477441483e-02 +-5.1640656628492820e-02 -3.0189639414544445e-02 +-5.4217893262020311e-02 -3.2466017599773522e-02 +-5.6796883770616091e-02 -3.4775190292251068e-02 +-5.6426797109708104e-02 -2.9980618405716086e-02 +-5.9021974271644240e-02 -3.2306231772523120e-02 +-5.9371813551123864e-02 -3.7114722687590529e-02 +-6.1614047391813642e-02 -3.4664029612173408e-02 +-6.1943480339067492e-02 -3.9488885845415211e-02 +-6.4512709537069668e-02 -4.1903267011946355e-02 +-6.7072874949971606e-02 -4.4357791390964962e-02 +-6.9614199967944046e-02 -4.6850134209449834e-02 +-6.9377285432352664e-02 -4.1978230543577411e-02 +-7.1944502386045883e-02 -4.4500922983928604e-02 +-7.2129508340140092e-02 -4.9380731766504482e-02 +-7.4488461044992960e-02 -4.7065546713028539e-02 +-8.1717225901286383e-02 -5.9824594939570375e-02 +-7.9402801275051615e-02 -5.7159772123611674e-02 +-7.4607775376748009e-02 -5.1946082103043523e-02 +-7.6997925531998135e-02 -4.9669002225343206e-02 +-7.7033999009756826e-02 -5.4538247548890695e-02 +-7.9457788883786407e-02 -5.2304101114543755e-02 +-8.3975920269438120e-02 -6.2545334279434428e-02 +-8.6170523750723760e-02 -6.5330098327095243e-02 +-8.8284453041950428e-02 -6.8179845278407925e-02 +-9.0297775813354519e-02 -7.1093536104186228e-02 +-9.2198410903876038e-02 -7.4085503061127156e-02 +-9.2993630814703465e-02 -6.9294691621138327e-02 +-9.4951962299901993e-02 -7.2407668740794406e-02 +-9.3979202001975182e-02 -7.7187972942382999e-02 +-9.6792512589175317e-02 -7.5653764943183432e-02 +-9.5623267599549422e-02 -8.0434465825305779e-02 +-9.7092457230971263e-02 -8.3838839988800373e-02 +-9.8496932279743987e-02 -7.9071365090925383e-02 +-9.8341598209017889e-02 -8.7420928209638760e-02 +-9.9318746227851307e-02 -9.1217456611119019e-02 +-1.0132575711520531e-01 -8.6501790272478729e-02 +-1.0234256292713440e-01 -9.0578222697971000e-02 +-9.9948314946402661e-02 -9.5231745501749288e-02 +-1.0014139351248730e-01 -9.9408580038925720e-02 +-9.9821455741889054e-02 -1.0364931260241406e-01 +-9.8938079228716447e-02 -1.0786245288780094e-01 +-1.0280151271243199e-01 -1.0406607820894465e-01 +-9.7481047157089051e-02 -1.1191886490409786e-01 +-1.0182009730247898e-01 -1.0867498706747369e-01 +-9.5496606908710646e-02 -1.1567569363221253e-01 +-9.3081690436406461e-02 -1.1900769260196853e-01 +-9.5385900379426403e-02 -1.2093030873928967e-01 +-9.8037048043110531e-02 -1.1725793603123691e-01 +-9.0328199598957326e-02 -1.2190209418648124e-01 +-9.2372628043364102e-02 -1.2412487002811190e-01 +-8.7312836729950050e-02 -1.2435664588161899e-01 +-8.9082559924946736e-02 -1.2683191531957050e-01 +-8.0851670807405185e-02 -1.2799780271819827e-01 +-7.7540067584536132e-02 -1.2925436904950516e-01 +-7.4237017444687581e-02 -1.3019272994260689e-01 +-7.8504914865987985e-02 -1.3222063699970477e-01 +-7.0988036094504992e-02 -1.3085480021359785e-01 +-5.2870021618659280e-02 -1.3216408460495188e-01 +-5.0020668501304044e-02 -1.3081442044702385e-01 +-4.6332559633825099e-02 -1.3379745427691603e-01 +-4.6419121733947577e-02 -1.2896068390527660e-01 +-4.6943524603008768e-02 -1.3124390385920037e-01 +-4.2147684429849619e-02 -1.2827832396696692e-01 +-4.4253284082515165e-02 -1.2980539333720742e-01 +-3.9528825775775545e-02 -1.2849558389673632e-01 +-1.7068997516190620e-02 -1.2025952477854673e-01 +-1.1764959494414029e-02 -9.9262257398052611e-02 +-1.7518338075262818e-02 -1.0161800391693987e-01 +-1.7728786903873583e-02 -9.5783569856237705e-02 +-1.5027684992602985e-02 -1.0056744223537351e-01 +-2.0012780748629666e-02 -9.7522991719358743e-02 +-2.3342924967280965e-02 -7.6040408451959252e-02 +-2.2091001732093218e-02 -7.2584108327646391e-02 +-2.0581915787758476e-02 -6.9007689623830970e-02 +-1.8829582020813973e-02 -6.5345423888018672e-02 +-1.6855290714829607e-02 -6.1636981928728574e-02 +-1.4689044848523736e-02 -5.7926954589220259e-02 +-9.9010229232590063e-03 -5.0640725293533251e-02 +-1.2358242735643898e-02 -5.4246843756359908e-02 +-7.3726671389238163e-03 -4.7172323406400096e-02 +-4.8140095559290330e-03 -4.3877841683226393e-02 +-2.1446536900668889e-03 -4.6019157651912224e-02 +-4.6359241822955255e-03 -4.9236218186663905e-02 +-2.2370307698196257e-03 -4.0750270478540074e-02 + 3.6549257765017273e-04 -4.2959776814711859e-02 + 3.5501717760411111e-04 -3.7767865253783839e-02 + 2.9532358925195012e-03 -3.4911342310081750e-02 + 5.5356682256615386e-03 -3.2172510661879983e-02 + 8.0674216469986959e-03 -2.9555841037705477e-02 + 1.0518058412742448e-02 -2.7063503480505346e-02 + 1.2863335431568146e-02 -2.4696287929756977e-02 + 1.5084423385893331e-02 -2.2455078186155220e-02 + 1.9105057583246321e-02 -1.8348568481087568e-02 + 2.9794244486382127e-02 -1.4142635952694604e-02 + 2.9504077119220540e-02 -1.5138124083222237e-02 + 2.7684316563750144e-02 -1.3068594324394667e-02 + 2.9146394021864808e-02 -1.3202006150734746e-02 + 2.8440219250349230e-02 -1.4408319681379567e-02 + 2.7264002127878939e-02 -1.7702490630071566e-02 + 2.6944251635462990e-02 -1.6561711524630596e-02 + 2.8160138833143833e-02 -1.6801215219643950e-02 + 2.9284802500527007e-02 -1.6648162887179296e-02 + 2.9063531899964801e-02 -1.7490558508853837e-02 + 2.5949231171267684e-02 1.1446474208241852e-02 + 7.1066778867958647e-03 1.6230348569862940e-02 + 9.2340808392847862e-03 1.9540571102979243e-02 + 4.1453604519148257e-03 1.5207250232009528e-02 + 1.1234581151619238e-02 2.2813676645888847e-02 + 1.5393084981049299e-02 1.9321541012111254e-02 +-3.9035800364771944e-02 -1.5852165550711561e-02 +-9.0925558279792540e-02 -6.6278375413119761e-02 +-1.0002448451501778e-01 -8.2679316762053645e-02 +-6.2000937282334689e-02 -1.3403058869042184e-01 +-7.0974692467871137e-03 -5.2620298716419711e-02 + 2.7795281388222293e-02 1.3082023584686908e-02 + 1.0924482732154956e+00 -8.1492605552313080e-02 + 1.1002099510986056e+00 -8.3722717400192437e-02 + 1.0946476740139843e+00 -7.8994420951403299e-02 + 1.0865720033429938e+00 -7.6405404591582737e-02 + 1.0887383807453261e+00 -7.3936086154148484e-02 + 1.0803540975655039e+00 -7.1010358718552880e-02 + 1.0824968335485536e+00 -6.8557958114453754e-02 + 9.8859278621036850e-01 2.7375809594332168e-04 + 9.8092966940157567e-01 5.0226986490642389e-03 + 9.7349669430257535e-01 9.4295601984413224e-03 + 9.7517059962255814e-01 1.2342846717174893e-02 + 9.8266004463357604e-01 7.8963049927907036e-03 + 9.6632944305960677e-01 1.3451193620923618e-02 + 9.6793119506312308e-01 1.6404726046012286e-02 + 9.5944993022409619e-01 1.7060666894394672e-02 + 9.6096314865599197e-01 2.0048250827791492e-02 + 9.5428128449595562e-01 2.3254433667524665e-02 + 9.2088769541540927e-01 3.1009661282851653e-02 + 9.1690741315375845e-01 3.1844979656781902e-02 + 9.1325196463372293e-01 3.2511345719058227e-02 + 9.0985085135784516e-01 3.2986239117342109e-02 + 9.0669814750811639e-01 3.3186886902626611e-02 + 9.0385210824619833e-01 3.3147846561732308e-02 + 8.9186998088345604e-01 3.1942698526599145e-02 + 8.9333179952323860e-01 3.1675093539632826e-02 + 8.9477061993552809e-01 3.2148911599115593e-02 + 8.9106891011397238e-01 3.0487525130752147e-02 + 8.6964215026988967e-01 -1.4187964165202516e-02 + 8.6808184133455768e-01 -1.5461171526709450e-02 + 8.7135305932658724e-01 -1.8665891527888334e-02 + 8.6508092616441701e-01 -1.1061316893943740e-02 + 8.7642865459509522e-01 -2.2006706257769793e-02 + 8.7893939186344028e-01 -2.1590635208497133e-02 + 8.8279136236201339e-01 -2.4868243334040585e-02 + 8.8148221448832231e-01 -2.6531858426750432e-02 + 8.8506941531369421e-01 -3.0214209732577046e-02 + 9.1356153017812858e-01 -4.5340024482399599e-02 + 9.1848016025500101e-01 -4.6988498557624325e-02 + 9.2331307347367186e-01 -4.8584336672220729e-02 + 9.2805621997942467e-01 -5.0261530998113813e-02 + 9.3260143146265762e-01 -5.2020451891451103e-02 + 9.3725152022172153e-01 -5.3850514398831706e-02 + 9.4196323451143371e-01 -5.5730131610502553e-02 + 9.4672103580819567e-01 -5.7668685328138736e-02 + 9.5152529545304532e-01 -5.9650693049164261e-02 + 9.5636093966193414e-01 -6.1677180640415941e-02 + 9.6122331340626488e-01 -6.3756513687366123e-02 + 9.6610680620987921e-01 -6.5857049318069016e-02 + 9.7098703368020267e-01 -6.8009872876103827e-02 + 9.7586885003634904e-01 -7.0178298971441677e-02 + 9.8072416207847368e-01 -7.2382356053083186e-02 + 9.8555359659268049e-01 -7.4609199949122740e-02 + 9.9034316829967395e-01 -7.6856806717856330e-02 + 9.9508677110708277e-01 -7.9136956788474322e-02 + 9.9978618896053462e-01 -8.1424850369273827e-02 + 1.0044250679658973e+00 -8.3742042175515508e-02 + 1.0090072792470366e+00 -8.6045042148938933e-02 + 1.0135045354608110e+00 -8.8374700794688010e-02 + 1.0179315433319545e+00 -9.0673771109905488e-02 + 1.0222533317804618e+00 -9.2994456184499086e-02 + 1.0264917616737179e+00 -9.5270627130815910e-02 + 1.0306073166408609e+00 -9.7564649208322862e-02 + 1.0346300115516200e+00 -9.9803408005044503e-02 + 1.0385174828596035e+00 -1.0205796998296535e-01 + 1.0423100449343963e+00 -1.0425601721753708e-01 + 1.0459664981934580e+00 -1.0645845480732419e-01 + 1.0405729550858211e+00 -1.0719958904665816e-01 + 1.0442035051720495e+00 -1.0938874235492335e-01 + 1.0495231342223903e+00 -1.0860349983497031e-01 + 1.0477346063681452e+00 -1.1152047169521495e-01 + 1.0529440985508884e+00 -1.1074003122652698e-01 + 1.0511307433287556e+00 -1.1364341233081632e-01 + 1.0562610700012129e+00 -1.1281944988540715e-01 + 1.0544235045006829e+00 -1.1570941110711885e-01 + 1.0575849864606468e+00 -1.1775317061697876e-01 + 1.0654755066296957e+00 -1.1884466535032345e-01 + 1.0736657509176624e+00 -1.2444074274722539e-01 + 1.0847604585329549e+00 -1.3330696037041889e-01 + 1.0875345422276510e+00 -1.3362082837298317e-01 + 1.0886708649703323e+00 -1.3586451404793820e-01 + 1.0909625554969082e+00 -1.3671119530008013e-01 + 1.0941569941766858e+00 -1.3957276420893550e-01 + 1.0921281219267343e+00 -1.3884178271713665e-01 + 1.0903364208428741e+00 -1.3961485624956538e-01 + 1.1224434722385936e+00 -1.6134793738338260e-01 + 1.1210624679757544e+00 -1.5818375697310216e-01 + 1.1254403077374704e+00 -1.6522397635675645e-01 + 1.1313955781239144e+00 -1.6201230254284837e-01 + 1.1414575414974024e+00 -1.5219132364066468e-01 + 1.1405909496909032e+00 -1.4852930580009627e-01 + 1.1398853076479654e+00 -1.5022760183137507e-01 + 1.1449505778660765e+00 -1.4214511143006803e-01 + 1.1377376943245778e+00 -1.2740620761374544e-01 + 1.1398973753104187e+00 -1.2623393478035894e-01 + 1.1366050203742688e+00 -1.2234985818477639e-01 + 1.1372452436683389e+00 -1.2523702742475962e-01 + 1.1402237796828985e+00 -1.2310675523819725e-01 + 1.1266659911988341e+00 -1.1119278886428674e-01 + 1.1235986003161855e+00 -1.0836959378829647e-01 + 1.1201967033943916e+00 -1.0535320388218850e-01 + 1.1164501860475795e+00 -1.0211387137198358e-01 + 1.1123603435631466e+00 -9.8614975283652484e-02 + 9.9036502150242711e-01 3.1162529935926386e-03 + 9.1375132514181701e-01 3.5245781843180168e-02 + 9.1020422915818244e-01 3.5658636174829894e-02 + 9.0247236841382517e-01 3.6233867260691000e-02 + 8.9751701713121435e-01 3.5354697647406397e-02 + 8.9996086931175512e-01 3.4988840595225668e-02 + 8.5975253113845440e-01 1.2096361539136069e-02 + 1.0606403139408584e+00 -1.1974146154021525e-01 + 7.4931224477095526e-01 3.6463593247475501e-03 + 7.3999806674367363e-01 2.0931729261235432e-03 + 8.0939547847114568e-01 1.1898365247851928e-02 + 8.2362666628441161e-01 8.1292091574525216e-03 + 8.3126779220874880e-01 9.7873743494076848e-03 + 8.2851295933694047e-01 1.4072092462242836e-03 + 8.1395929118146881e-01 1.1578801210646361e-02 + 8.3105422731576084e-01 1.3885271249712616e-02 + 8.3646393360163529e-01 1.4344031885286768e-02 + 8.7823963989528409e-01 4.5491420383292791e-02 + 8.7557815753374513e-01 4.8978075645280228e-02 + 8.8154769805132815e-01 4.0249067971608099e-02 + 8.7990898081697821e-01 4.2406825977252538e-02 + 8.7382698100762468e-01 5.3866154424909496e-02 + 8.7815716252406162e-01 5.7227223998921772e-02 + 8.4335582246634999e-01 7.0665036061036801e-02 + 8.3457521660218248e-01 7.4386813500808557e-02 + 8.2453549858172437e-01 7.8157996926258022e-02 + 8.1310909854322233e-01 8.1986884876464217e-02 + 8.1541913812500866e-01 9.1321955722229120e-02 + 8.2696206954091167e-01 8.6989737767197539e-02 + 4.7122647201920387e-01 1.1432277353713971e-01 + 4.5484850392723075e-01 1.1434656015052980e-01 + 4.3999303445119153e-01 1.1420544196334959e-01 + 4.3987755223377434e-01 1.2572425756671635e-01 + 4.2641588816010056e-01 1.2538364834153981e-01 + 3.9338429622884519e-01 1.1453798592788189e-01 + 3.5148253870049473e-01 1.1467271783891420e-01 + 3.5495690621450393e-01 1.0437287661797967e-01 + 3.6140732527396580e-01 1.1661043250252590e-01 + 3.5939263558287138e-01 1.1035374865200254e-01 + 3.4071797109072577e-01 1.2053821953124100e-01 + 3.3052085584417057e-01 1.1322438010569869e-01 + 3.4034385929635391e-01 1.0991043902357234e-01 + 3.1737522864128209e-01 1.1696883520706791e-01 + 3.0398504675581961e-01 1.1523499332452047e-01 + 2.7181820584639382e-01 1.1519457195751670e-01 + 2.6031288017404108e-01 1.1474556312384721e-01 + 2.4854282229607350e-01 1.1403902769718854e-01 + 2.3659869083338947e-01 1.1305831880459749e-01 + 2.0070721671745417e-01 1.0841968642886002e-01 + 1.8905509003954535e-01 1.0633490700511317e-01 + 1.4623991891937038e-01 9.6292646783801672e-02 + 9.7456821709272390e-02 8.3944881941704352e-02 + 1.0676815426396047e-01 8.7090758444858807e-02 + 1.1656936196367695e-01 9.0989329895094784e-02 + 6.3192615823119525e-02 -6.1440775930094560e-02 + 5.5090229165415394e-02 -5.7940960700065602e-02 + 4.5548786765564842e-02 -5.7365806340612835e-02 + 7.6524189506471885e-02 -6.6787017115970571e-02 + 6.9251990046055312e-02 -6.4014902524462514e-02 + 7.4582099756746345e-02 -7.3629207232556837e-02 + 6.7225870916786334e-02 -7.0498864851728626e-02 + 8.5155951544230390e-02 -6.9717859462741671e-02 + 8.3312049289055778e-02 -7.6920770902717095e-02 + 3.1583092629632148e-01 -1.0118723964238541e-01 + 3.2600019093320043e-01 -1.0181305341127711e-01 + 3.4532633900215615e-01 -1.0516646147085851e-01 + 3.3668249669519668e-01 -1.0518825335795157e-01 + 3.5715549572385896e-01 -9.6036285150489675e-02 + 3.5207220441252929e-01 -1.0949602304921768e-01 + 3.7634131944175664e-01 -1.0403942860935445e-01 + 3.3049977181055823e-01 -1.1495341212197729e-01 + 3.5128223439179607e-01 -9.8224683784877698e-02 + 3.6070707434291194e-01 -1.1344980880953415e-01 + 4.1637635020420305e-01 -1.0700938727470088e-01 + 4.2797918016033520e-01 -1.0688179172113621e-01 + 4.4036840171668956e-01 -1.0649534266269711e-01 + 4.5347868235013777e-01 -1.0581311691677797e-01 + 4.6721964034607311e-01 -1.0480231918494098e-01 + 4.8147703609154746e-01 -1.0343618243308583e-01 + 4.6816895901722688e-01 -1.1669788239423440e-01 + 4.8262981030217844e-01 -1.1525455286778197e-01 + 4.9611582108396135e-01 -1.0169800589511624e-01 + 5.1098524306198101e-01 -9.9586208516214469e-02 + 5.2592476926301401e-01 -9.7115882198593795e-02 + 5.1252952054535683e-01 -1.1111848379310629e-01 + 5.2764802999407578e-01 -1.0844048628116809e-01 + 5.4077085990689255e-01 -9.4316182600266529e-02 + 5.5536447870306205e-01 -9.1230361864006682e-02 + 5.6955805995317377e-01 -8.7913919716200439e-02 + 5.8322088340533185e-01 -8.4427977701253099e-02 + 5.9624290891704135e-01 -8.0835237846216046e-02 + 5.8547040354358160e-01 -9.4584879455808846e-02 + 5.9856932094589865e-01 -9.0646932551763371e-02 + 6.0853744418999156e-01 -7.7198459897147131e-02 + 6.1091912581264296e-01 -8.6655854798550536e-02 + 6.2004243147693927e-01 -7.3577344534712097e-02 + 6.3072018592310997e-01 -7.0025505707292268e-02 + 6.4055443479934127e-01 -6.6589527789304270e-02 + 6.4954912816001809e-01 -6.3307502714678776e-02 + 6.5197433716500086e-01 -7.1369287487868860e-02 + 6.6012826889054566e-01 -6.7950604990997476e-02 + 6.9439881258657721e-01 -5.1753744533215240e-02 + 6.8938237516445611e-01 -4.9155728608155869e-02 + 8.1310291515652011e-01 2.1938922411379735e-04 + 8.6200798025039660e-01 1.1700831237781983e-02 + 8.4600431444109603e-01 7.8413749243473774e-02 + 8.3711182253798455e-01 8.2689562813854423e-02 + 8.0517572512850677e-01 1.0837734401151522e-01 + 4.9746847909074177e-01 -1.1339550844733992e-01 + 6.2245931486508255e-01 -8.2677291957793386e-02 + 6.4299039831301741e-01 -7.4986757258940884e-02 +-2.5657667787271521e-02 -4.7122089625304397e-03 +-2.7593353046896141e-02 -5.2797456717570412e-03 +-2.8806669432768217e-02 -7.2462057650710676e-03 +-3.1422044264715510e-02 -6.5115868502232388e-03 +-3.3661853695278410e-02 -7.5929206473972499e-03 +-3.0874641361094746e-02 -9.7264780498278469e-03 +-3.3862197675219363e-02 -1.0616619325404031e-02 +-3.4913370170357894e-02 -1.2779583888985258e-02 +-3.7278515514003630e-02 -1.3674383152491032e-02 +-5.1253566885876012e-02 -2.5437265346056392e-02 +-4.8298723825254797e-02 -2.1499386213335470e-02 +-5.3834162828067633e-02 -2.7689136066356923e-02 +-6.4204258090327926e-02 -3.7058861707080837e-02 +-6.6794034291234539e-02 -3.9496835573586964e-02 +-8.1862882781123858e-02 -5.4974481692184440e-02 +-8.4216759588855439e-02 -5.7695415083003354e-02 +-8.6518628697874078e-02 -6.0480998399754071e-02 +-8.8760446394218206e-02 -6.3340997028092261e-02 +-1.0299105760360305e-01 -9.4911880086272049e-02 +-1.0021566074900079e-01 -1.1312538832108032e-01 +-7.0778843668250602e-02 -1.3786745810295997e-01 +-7.1201301859090904e-02 -1.3340175431807211e-01 +-6.8685383489508922e-02 -1.3488602034351516e-01 +-7.4665791057270781e-02 -1.3532903124654183e-01 +-6.6478082299383345e-02 -1.3404413448952823e-01 +-6.4486569187522491e-02 -1.3510112408371810e-01 +-6.6513677351665024e-02 -1.3743889987512148e-01 +-5.8818662894452700e-02 -1.3486573294511572e-01 +-5.5261712910947836e-02 -1.3522627347884963e-01 +-2.4596983264800087e-02 -1.2932068959577236e-01 +-2.7439203141227608e-02 -1.2663245474838902e-01 +-2.1843332979301522e-02 -1.2624741765203851e-01 +-1.4387432167254133e-02 -1.1485632912062727e-01 +-2.8072547826795358e-02 -9.5027276181738785e-02 +-2.7665584349833239e-02 -9.5380760949382193e-02 +-2.5921670561203314e-02 -8.8258786263835987e-02 +-2.7601968481974382e-02 -8.9741153862789247e-02 +-2.7068447806200879e-02 -9.1689937595162974e-02 +-2.8757106280465905e-02 -9.1000100694898833e-02 +-2.8487271595196262e-02 -9.2379446642880225e-02 +-2.8798983316249860e-02 -9.3500753558572569e-02 +-2.8154471763429001e-02 -9.4229046483903289e-02 +-2.7427143262215736e-02 -9.3963599060103320e-02 +-2.7407653794369935e-02 -9.4753742723355572e-02 +-2.6521796970072842e-02 -9.4302777080130795e-02 +-2.4950306717798298e-02 -9.4404251805258355e-02 +-2.5946243747085873e-02 -9.5861535340574733e-02 +-2.7044211430876430e-02 -9.5492526509730169e-02 +-2.0872719279680041e-02 -9.4590092339316811e-02 +-2.3473795274313147e-02 -8.8058498229997895e-02 +-1.8847820616045396e-02 -7.3865644106248851e-02 +-2.0019461544436012e-02 -7.7150321409277467e-02 +-1.7417758608630152e-02 -7.0439986234006824e-02 +-1.5742851134987745e-02 -6.6911324138217765e-02 +-1.3843663355089575e-02 -6.3321891415412779e-02 +-1.1749454797140402e-02 -5.9718736280387930e-02 +-9.4876301089072967e-03 -5.6136057960742392e-02 +-3.4519515597963846e-03 -5.5192472041241558e-02 +-5.7546552197749179e-03 -5.8590244828536697e-02 + 5.4365791770010219e-03 -3.7220133690794910e-02 + 2.8942884269866909e-03 -4.0033743804059441e-02 + 7.9734415963841343e-03 -3.4510597039613344e-02 + 1.0471479437228481e-02 -3.1910740178332730e-02 + 1.2900208248566969e-02 -2.9424619512070649e-02 + 1.7121246633216458e-02 -2.6246222975231603e-02 + 2.0455237207883670e-02 -2.6817444230843535e-02 + 1.8451463670778878e-02 -2.8987540730952333e-02 + 2.2638961395365698e-02 -2.3252520804092569e-02 + 1.9863758883708726e-02 -2.1839896156294003e-02 + 2.2270628875702414e-02 -2.0507594844616506e-02 + 2.6526650884179048e-02 -2.1661102080457795e-02 + 2.5338940169092439e-02 -2.1598751159473295e-02 + 2.6028915013128540e-02 -2.0593723874824832e-02 + 2.2649065431707527e-02 -2.5275845057848301e-02 + 2.9601343113235146e-02 -2.2069729439792241e-02 + 2.9048430177610385e-02 -1.8276066688628134e-02 + 2.9484440328033656e-02 -1.9662806941127542e-02 + 2.9380571143164502e-02 -1.8949416197727942e-02 + 2.8322498686520703e-02 -2.0848978483854808e-02 + 2.7251489000605034e-02 -2.0073828891057133e-02 + 2.8264849246937729e-02 -1.9723391302946425e-02 + 2.9130126414038671e-02 -2.1516557610979703e-02 + 2.9475871066708237e-02 -2.0814170206762128e-02 + 2.9086396381110546e-02 -2.0138894717263156e-02 + 2.4867999537875107e-02 -1.8146259188384306e-02 + 2.6142357555130502e-02 -1.7519754762489015e-02 + 2.6328628149300926e-02 -1.8730357559874733e-02 + 2.1504037355747130e-02 1.7716973795714352e-02 +-2.2149953094398711e-02 -9.1454447780321857e-02 +-2.3312321349109766e-02 -9.4123292359498123e-02 +-1.6918483315691901e-02 -8.0454627991286998e-02 +-1.8223395584300306e-02 -8.3931049109168043e-02 + 1.1054168878136039e+00 -8.8117184218802436e-02 + 1.1102664494432020e+00 -9.2180135343454594e-02 + 1.0691000978250358e+00 -5.6928108854123138e-02 + 1.0619932201468458e+00 -5.0746502467220012e-02 + 1.0546458808932613e+00 -4.4386110017683222e-02 + 1.0574119392083787e+00 -4.1112358085612755e-02 + 1.0647562233885637e+00 -4.7518388600735761e-02 + 1.0470748934325798e+00 -3.7910260089518033e-02 + 1.0392853582803383e+00 -3.1404413442928103e-02 + 1.0420220751980125e+00 -2.8004873007787978e-02 + 1.0498353767517443e+00 -3.4578193147169145e-02 + 1.0312861636160946e+00 -2.4984573794398557e-02 + 1.0231184569711687e+00 -1.8740809326246222e-02 + 1.0148243073602004e+00 -1.2773727511500965e-02 + 1.0257325211213342e+00 -1.5203616324598102e-02 + 1.0339746019788691e+00 -2.1514173738296449e-02 + 1.0065023093051622e+00 -7.1612508606051506e-03 + 1.0037330480079305e+00 6.5255170353495373e-03 + 1.0120963003045205e+00 1.1930655306713334e-03 + 1.0006649682792528e+00 1.7635986136141923e-03 + 1.0173455988108202e+00 -9.1808735763265759e-03 + 1.0089320231236130e+00 -3.5272950221525434e-03 + 9.9830771860330714e-01 -1.9012255648931387e-03 + 9.9266667026177657e-01 6.8129026702905549e-03 + 9.4789561813573187e-01 2.6015711612380699e-02 + 9.4183222877627770e-01 2.8303091732638563e-02 + 9.3615317940611220e-01 3.0160681277060064e-02 + 9.2603990756193610e-01 3.2873147139341086e-02 + 9.2159404651695098e-01 3.3851104507832019e-02 + 9.1752001881307166e-01 3.4633565591917659e-02 + 9.2251093964942044e-01 3.7545319334284954e-02 + 9.1830896289268082e-01 3.8260354464611623e-02 + 9.0688528597823392e-01 3.5780073315720529e-02 + 9.0441831547951779e-01 3.9357799048772790e-02 + 8.9519149625026984e-01 3.4359306306285475e-02 + 8.5922950753503358e-01 6.2526269005473978e-03 + 8.5925044668647388e-01 2.4105223829451461e-05 + 8.5610826041501298e-01 -4.5865499453157099e-04 + 8.6157023917121478e-01 6.2322639943204194e-03 + 8.6166896533429593e-01 3.8588023042507302e-04 + 8.7431477996017293e-01 -2.0651774423726010e-02 + 8.6960364800670931e-01 -2.0536035891993265e-02 + 8.7277702922550304e-01 -2.2612062736584448e-02 + 8.8876323746862340e-01 -3.4054614689011942e-02 + 8.9279443421428795e-01 -3.7848845572568734e-02 + 8.9730448167901500e-01 -4.1345042624271855e-02 + 9.0223200309243623e-01 -4.4284598324679791e-02 + 9.0037247042285173e-01 -4.8154749341819070e-02 + 8.9527683976054107e-01 -4.4899708466985544e-02 + 9.0732689348273254e-01 -4.6635865898139173e-02 + 9.1239863688004164e-01 -4.8549155430890778e-02 + 9.1736263858985012e-01 -5.0207894439267875e-02 + 9.2218330362102563e-01 -5.1782426133613058e-02 + 9.2688260048968374e-01 -5.3428968373125940e-02 + 9.3138626562610938e-01 -5.5162859714727119e-02 + 9.3601052315759148e-01 -5.6978800935326035e-02 + 9.4070473145409750e-01 -5.8850492808574018e-02 + 9.3440024417847667e-01 -6.1046769068212825e-02 + 9.2981214011072666e-01 -5.9250147165712974e-02 + 9.4544580560717861e-01 -6.0782919971714477e-02 + 9.5023274726531781e-01 -6.2759278378919703e-02 + 9.5505082922741025e-01 -6.4780360078216859e-02 + 9.5989578186402724e-01 -6.6854582117258587e-02 + 9.6476148165277209e-01 -6.8950194320848368e-02 + 9.5816991829515530e-01 -7.0882039981455591e-02 + 9.6301234780690947e-01 -7.2971190645148454e-02 + 9.6962316189674880e-01 -7.1097971221192324e-02 + 9.7448537354166831e-01 -7.3261090364312054e-02 + 9.6784981998285957e-01 -7.5112362763150031e-02 + 9.7268635927967750e-01 -7.7268497076488529e-02 + 9.7931958174055467e-01 -7.5459010498548196e-02 + 9.8412639433100679e-01 -7.7678635104092564e-02 + 9.8889229854605532e-01 -7.9917960937336829e-02 + 9.9361222049986253e-01 -8.2189202210557255e-02 + 9.9828881040532025e-01 -8.4468278318553303e-02 + 1.0029057048925551e+00 -8.6776823153741134e-02 + 1.0074660354304541e+00 -8.9071345688694237e-02 + 1.0099088009896562e+00 -9.5315296207488132e-02 + 1.0054623588851683e+00 -9.3005509944887876e-02 + 1.0119412204770484e+00 -9.1392375753329702e-02 + 1.0163456812290974e+00 -9.3682828156516962e-02 + 1.0206443542807904e+00 -9.5994459843637969e-02 + 1.0142838692521963e+00 -9.7594501520376298e-02 + 1.0248587290696705e+00 -9.8261190904040063e-02 + 1.0289492962584319e+00 -1.0054473579333489e-01 + 1.0329458626721362e+00 -1.0277217030342456e-01 + 1.0368068421438323e+00 -1.0501428757991960e-01 + 1.0708963546894097e+00 -1.2633118820617995e-01 + 1.0713960808940755e+00 -1.2967534273417414e-01 + 1.0751287102190190e+00 -1.3076410522539561e-01 + 1.0743955972511827e+00 -1.2754377338002598e-01 + 1.0722274623747481e+00 -1.3251108432453407e-01 + 1.0789272736079880e+00 -1.3203819743532108e-01 + 1.0816046140014706e+00 -1.3524336441733453e-01 + 1.1362194138543913e+00 -1.6198145817222098e-01 + 1.1398696905254013e+00 -1.5921902944855049e-01 + 1.1484793699927351e+00 -1.4816574071308253e-01 + 1.1475631433190543e+00 -1.4477254751065516e-01 + 1.1339268262733242e+00 -1.1766532043387201e-01 + 1.1328752834011908e+00 -1.1318870009930038e-01 + 1.1369280676922102e+00 -1.1381252489665883e-01 + 1.1293784216324880e+00 -1.0841999133585034e-01 + 1.1389567365352633e+00 -1.2036891568770614e-01 + 1.1366446084526629e+00 -1.1902293330373936e-01 + 1.1411578579788824e+00 -1.1249461786320580e-01 + 1.1401115049554562e+00 -1.1716120396619090e-01 + 1.1262236019970828e+00 -1.0557990776976567e-01 + 1.1227405414773273e+00 -1.0257662762467135e-01 + 1.1189195101088529e+00 -9.9372532580531470e-02 + 1.1221330330544674e+00 -9.5811859223857709e-02 + 1.1147627184728606e+00 -9.5923056147867669e-02 + 1.0718611881904110e+00 -5.3730551649252334e-02 + 9.2708147135430607e-01 3.6635495374454763e-02 + 8.5713546803177820e-01 -7.5107328862031864e-03 + 8.7623058583415059e-01 -2.5190720044975023e-02 + 8.7776257381335654e-01 -2.3156584406166303e-02 + 8.9069174485391045e-01 -4.1011206087475216e-02 + 9.2070443428521287e-01 -5.5936336259705399e-02 + 9.1588998107290820e-01 -5.4386155545074644e-02 + 9.3906909749616574e-01 -6.2907131741710032e-02 + 9.8595313659347283e-01 -9.0028094986621454e-02 + 7.3126769886731324e-01 -2.9227977740333699e-03 + 7.4040028092824173e-01 -6.0817361909499823e-03 + 7.3519846488294860e-01 -1.2240529763289487e-02 + 7.1960661408662929e-01 -1.5953810924017375e-02 + 7.2393009995415980e-01 -2.7676349421597024e-03 + 7.2492458309593388e-01 -6.0650608969297082e-03 + 7.2785896674435691e-01 -9.5148255462049747e-03 + 7.4968486768940323e-01 -3.9271142370012058e-03 + 7.6100533523987224e-01 -1.5259614236668995e-03 + 7.7337205671535258e-01 8.9349260158400057e-04 + 7.6144796011620741e-01 -1.0522208387868659e-02 + 7.7377364835986384e-01 -7.2687635342134627e-03 + 7.8536169922982424e-01 3.0926662488326429e-03 + 7.8349770112690464e-01 -1.6850106554599620e-02 + 7.9571423511944772e-01 4.9044862191536254e-03 + 8.0379668094055035e-01 6.2726368582346481e-03 + 8.0962443897828251e-01 7.2338575374999436e-03 + 8.1678736946512487e-01 6.7653898238262400e-03 + 8.3671000194144085e-01 1.0339249254791127e-02 + 8.4278961259952467e-01 1.1049995707125504e-02 + 8.4920863882094721e-01 1.1937661106571795e-02 + 8.5559916270850778e-01 1.3006786948096760e-02 + 8.7433852971833659e-01 6.0495142507242861e-02 + 8.7633545702797022e-01 6.7523113532843126e-02 + 8.7070047393100225e-01 7.4244974087207538e-02 + 8.6818885777201160e-01 6.5716369643865846e-02 + 8.6347439834641904e-01 7.4441820848498708e-02 + 8.0234673549460211e-01 9.5627521744845012e-02 + 7.8766280085969242e-01 9.9820036037442605e-02 + 7.9028356106429953e-01 1.1313168185395028e-01 + 7.7133566432328138e-01 1.0379753795112379e-01 + 7.7371667909288533e-01 1.1760106876795362e-01 + 7.5338549555571888e-01 1.0745376846750787e-01 + 7.5550083597922679e-01 1.2166230315845894e-01 + 7.3389427346183567e-01 1.1069254021610675e-01 + 7.1302238681890628e-01 1.1344510847932554e-01 + 7.3573052133500738e-01 1.2520710253890854e-01 + 7.2765901507037967e-01 1.4455586404595522e-01 + 6.9102121401578387e-01 1.1569662578857276e-01 + 6.6818024280861010e-01 1.1756291415487397e-01 + 6.9234265736514544e-01 1.3053755890926766e-01 + 6.8260618425286168e-01 1.5488428697284462e-01 + 6.4476671783043571e-01 1.1916149196052572e-01 + 6.2106012418517764e-01 1.2056407414659986e-01 + 5.9736713434336508e-01 1.2181083350667166e-01 + 5.7400272219229009e-01 1.2291867144980273e-01 + 5.7464945547186375e-01 1.3787633655030618e-01 + 5.9810865153627191e-01 1.3675063742528693e-01 + 5.5126617413467471e-01 1.2388414818695992e-01 + 5.5181860697208407e-01 1.3886796443091498e-01 + 5.2942305720065264e-01 1.2468747008644243e-01 + 5.2987579063051271e-01 1.3969993709712014e-01 + 5.0870079079206221e-01 1.2529800330573693e-01 + 5.0904591014938205e-01 1.4033409287672782e-01 + 4.8928750967755974e-01 1.2569617841005254e-01 + 4.8951749080261919e-01 1.4074459795437377e-01 + 4.7131103391407692e-01 1.2589561526169746e-01 + 4.7141949543043893e-01 1.4094032016543423e-01 + 4.5483517422558606e-01 1.2590118624500235e-01 + 4.5481630179081378e-01 1.4092219830750707e-01 + 3.2117105346139141e-01 1.3612311890359763e-01 + 3.1658476569566574e-01 1.2885304338420411e-01 + 3.0445405806423764e-01 1.2443575814379670e-01 + 3.0669609900489547e-01 1.3865403164472667e-01 + 2.8375052816932111e-01 1.2999093038183673e-01 + 2.9249296539935443e-01 1.2583299955843330e-01 + 2.9263272801226492e-01 1.3659603175659640e-01 + 2.9828833130490295e-01 1.3137239835069892e-01 + 2.4463945836632917e-01 1.3162541754432766e-01 + 2.5902955233700453e-01 1.3175371127915980e-01 + 2.7256782307601668e-01 1.2679956218504174e-01 + 2.5313117829335852e-01 1.2304092991112725e-01 + 2.3057545238160060e-01 1.2575710043117283e-01 + 2.1829460489921360e-01 1.2931017090589592e-01 + 2.0567334231974144e-01 1.2488388393714445e-01 + 1.9144081882144803e-01 1.2159106655022356e-01 + 1.7769937305288863e-01 1.1837872463222965e-01 + 1.5658041549848889e-01 1.1194715624286289e-01 + 1.4473457588493943e-01 1.0893215481807772e-01 + 1.3726217868931201e-01 1.0314504709190686e-01 + 1.3293773971550849e-01 1.1012113721328376e-01 + 1.2354961611029580e-01 1.1537538791582591e-01 + 5.7209154794243489e-02 -6.5475024005436921e-02 + 5.0942271438493947e-02 -6.8205882543139751e-02 + 6.3903914702237330e-02 -7.9667832653740334e-02 + 5.4410931445396216e-02 -7.9554451315615893e-02 + 5.7665758776664688e-02 -7.2907627796297447e-02 + 9.3539097685109596e-02 -8.0313419104996342e-02 + 1.0534612800863385e-01 -8.3739536029540318e-02 + 1.1875621743557474e-01 -8.7130256483476387e-02 + 1.1681634703676025e-01 -9.7807965923749407e-02 + 1.0324419382907735e-01 -9.4003988346443634e-02 + 1.3371497477997707e-01 -9.0418967703726594e-02 + 1.3193951729746800e-01 -1.0147674813534024e-01 + 1.6759806889739792e-01 -9.6455034777093829e-02 + 1.8594494503498993e-01 -9.9114179506770483e-02 + 2.0471279036001988e-01 -1.0150579783407920e-01 + 2.2346028752348701e-01 -1.0362731029567840e-01 + 2.2239900682068026e-01 -1.1606827729835345e-01 + 2.0353271209950208e-01 -1.1372731646574152e-01 + 2.4174941279073892e-01 -1.0548452781503670e-01 + 2.5918448379089654e-01 -1.0709429184773001e-01 + 2.7544332227233781e-01 -1.0848192132827705e-01 + 2.5831881482552888e-01 -1.1992198265606646e-01 + 2.4079279979403623e-01 -1.1812621946353374e-01 + 2.7465562056285364e-01 -1.2148493905746705e-01 + 2.8957552288829191e-01 -1.2284132983150187e-01 + 3.2453940803745240e-01 -1.2793345428980274e-01 + 4.0541141604757769e-01 -1.1578138256405168e-01 + 3.9066947141976982e-01 -1.2242854722924790e-01 + 3.8343310855159984e-01 -1.1139117340552218e-01 + 3.7940202094755193e-01 -1.2101369655734118e-01 + 4.0448770024896419e-01 -1.3023939617285407e-01 + 4.5422555795876463e-01 -1.1774518912122289e-01 + 5.4265658578604103e-01 -1.0539376563154690e-01 + 5.4510632554993066e-01 -1.1979491351806359e-01 + 5.5739314086908109e-01 -1.0202647435914969e-01 + 5.7170829009049129e-01 -9.8400929191413411e-02 + 6.3315431270001454e-01 -7.8770347203715119e-02 + 6.7887217981628822e-01 -6.0442265073504586e-02 + 6.8509475726737179e-01 -5.5511648878436404e-02 + 6.8387562345835562e-01 -4.8909673912916674e-02 + 6.7074715728968215e-01 -6.4514903430762160e-02 + 7.5016927748337281e-01 -1.3772629867233377e-02 + 8.0411012658251479e-01 -1.0180970669182443e-04 + 7.9604985326595568e-01 -1.9168740183772570e-03 + 7.1458637880048315e-01 1.2816592914091984e-01 + 4.3340850954393062e-01 1.4265093803447115e-01 + 1.7159352541085582e-01 -1.2771284274823813e-01 + 2.3142567322605601e-01 -1.3625338169563861e-01 + 4.5109926648343901e-01 -1.3567103458790086e-01 + 4.5840321263354156e-01 -1.4751112568407621e-01 + 5.6002817659218351e-01 -1.1606183853015750e-01 + 5.7450096693295905e-01 -1.1203457892361257e-01 + 6.6794260883455081e-01 -7.5014962249952077e-02 +-6.1959326746773513e-02 -2.4676667214123427e-02 +-5.2738684918722356e-02 -2.0951584780561916e-02 +-5.0551664791910866e-02 -1.8043743992649297e-02 +-5.6926175684736791e-02 -2.0269788891582152e-02 +-5.8670262008163832e-02 -2.3230856598502214e-02 +-5.5229932910307866e-02 -2.4079567240363531e-02 +-5.7902169178376539e-02 -2.6233141124720305e-02 +-6.5447010429679153e-02 -3.2855314878204922e-02 +-6.2710257152843951e-02 -3.1294154244520200e-02 +-6.0733272868503718e-02 -2.8634600583842484e-02 +-6.9306903744475790e-02 -3.1453610310705926e-02 +-7.1611079771486175e-02 -3.4764828124821179e-02 +-6.7913384465484228e-02 -3.5647363847246538e-02 +-7.0692325816182233e-02 -3.8926355435279447e-02 +-7.5263430733627956e-02 -3.4351040165773838e-02 +-7.5277422968767382e-02 -3.8398892780222127e-02 +-7.3200063085153033e-02 -4.2267210425720236e-02 +-7.7420380862534444e-02 -4.2733314098228448e-02 +-7.9495278783170420e-02 -3.9285797962932634e-02 +-8.1591332209058010e-02 -5.0260256410126658e-02 +-7.9551615894089878e-02 -4.6324090417044772e-02 +-8.6208706079148101e-02 -5.2064870172173983e-02 +-8.8062330366909691e-02 -5.5888259229860182e-02 +-9.1770339521204392e-02 -5.7963083318341546e-02 +-9.2501343280957826e-02 -6.1903449525146925e-02 +-9.6066228336269432e-02 -6.3734418362400902e-02 +-9.6593311615265520e-02 -6.7654776388522464e-02 +-9.9839570973188074e-02 -6.4956340632747356e-02 +-9.9586331677599560e-02 -7.1933528206500341e-02 +-1.0095386367970605e-01 -6.7872333954113628e-02 +-1.0446537966484470e-01 -6.9985857628267922e-02 +-1.0361056240493838e-01 -7.4264570866588997e-02 +-1.0647590726532030e-01 -8.0354229026042390e-02 +-1.0637466734380041e-01 -7.6651791581468842e-02 +-1.0271914340100352e-01 -7.8701182892658039e-02 +-1.0028437352573860e-01 -7.5680569907504491e-02 +-1.0321844076690923e-01 -8.2709817976748923e-02 +-1.0932981924524654e-01 -7.8149858504332315e-02 +-1.0838640311659731e-01 -1.0725325043600265e-01 +-1.0585096814213557e-01 -1.1159068837214647e-01 +-1.0586726391436230e-01 -1.1563105807336171e-01 +-1.0077893192904241e-01 -1.2345130916585845e-01 +-1.0275361423910567e-01 -1.1887347282306848e-01 +-9.6733875090919241e-02 -1.2696815012186846e-01 +-9.2505159299363982e-02 -1.3031092044479919e-01 +-8.8106708112036358e-02 -1.3067893310967804e-01 +-8.9325952758883886e-02 -1.3462070162961481e-01 +-8.6041512176294077e-02 -1.3784682643265000e-01 +-8.5565695962088739e-02 -1.3308101291045205e-01 +-1.4192337331238036e-02 -1.2218941671633843e-01 +-1.7358364695965633e-02 -1.2579923223793799e-01 +-1.6638218389005033e-02 -1.3072363118288877e-01 +-1.4099686770393305e-02 -1.3574143766663838e-01 +-2.2086931481624106e-02 -8.4643499530997701e-02 +-1.8065075216199489e-02 -9.1757702726027901e-02 +-1.5823613592175434e-02 -8.7473414291636686e-02 +-1.2653244668470620e-02 -9.2137001367120774e-02 +-1.4976129016872619e-02 -8.3549607831287176e-02 +-1.2657915889946025e-02 -8.0422824932298909e-02 +-1.5276777834628774e-02 -7.6788929241232040e-02 +-1.4389161833420872e-02 -7.2077544734398202e-02 +-7.9264453984677630e-03 -6.2045520248219077e-02 + 1.3522224781183922e-03 -5.0825353188344025e-02 + 2.0244885756852682e-03 -5.5775200198340258e-02 + 3.3724269522110717e-03 -4.5724516569649154e-02 + 4.6876581306563025e-03 -4.1607646628278872e-02 + 7.8300036653828897e-03 -4.4254078218358472e-02 + 8.7997957867429477e-03 -3.9297396544441199e-02 + 1.1456202253611991e-02 -3.6314897333042495e-02 + 1.9351622967889170e-02 -3.4243080408998594e-02 + 1.2433234836905172e-02 -4.2098735471768123e-02 + 1.4441161821196147e-02 -3.8560603059508480e-02 + 1.4902298179521267e-02 -3.4088896571077498e-02 + 1.7042443898944271e-02 -2.3343262296847911e-02 + 1.7396747828641423e-02 -3.1527390298208502e-02 + 1.1781450847315966e-02 -3.9075687429246386e-02 +-9.1788124180425257e-05 -1.1808822136826791e-01 +-6.8631668192722373e-03 -1.2303347770529172e-01 +-6.9895668003709943e-03 -1.1700210085567164e-01 + 2.2923799644225085e-02 2.0705271396138869e-02 + 1.1133123650147212e+00 -8.8752664099501999e-02 + 1.1083920364833801e+00 -8.4758053087625740e-02 + 1.1122599564597664e+00 -8.0391383418572104e-02 + 1.1031225523420787e+00 -8.0424491017851096e-02 + 1.1069088326328753e+00 -7.6136707244131685e-02 + 1.0975067330961537e+00 -7.5746638391592569e-02 + 1.0952149928605408e+00 -6.6552072860289968e-02 + 1.1012232951055267e+00 -7.1524331984946343e-02 + 1.0915544367410845e+00 -7.0725766357867315e-02 + 9.8490486864047000e-01 1.1634797633547578e-02 + 9.8016151729675727e-01 2.1061634886294200e-02 + 9.7270801870722323e-01 2.5242508260973295e-02 + 9.7734279741857222e-01 1.6132345400983183e-02 + 9.7001011542402438e-01 2.0246136991687536e-02 + 9.6292650152582837e-01 2.3934048025225252e-02 + 9.5610536374626065e-01 2.7171128865859373e-02 + 9.4955965000426090e-01 2.9944631058860693e-02 + 9.4332633024879442e-01 3.2220951033977485e-02 + 9.1450882598816463e-01 4.0025068556111876e-02 + 9.1091793418596723e-01 3.8801300642575143e-02 + 9.0752125547169982e-01 4.1122337040192747e-02 + 8.6604238574926740e-01 -1.7102701403459264e-02 + 8.6400118151323824e-01 -2.7000332695280349e-02 + 8.7979060156877864e-01 -2.8702607735453967e-02 + 8.8318196819071915e-01 -3.2631485992155262e-02 + 8.8074873943881471e-01 -3.5789808172722815e-02 + 8.7760245767660194e-01 -3.1533083110957705e-02 + 8.8671609036497046e-01 -3.6816122294283105e-02 + 8.8407824969556259e-01 -4.0423348323784580e-02 + 8.8322510816388444e-01 -4.7530203610506305e-02 + 9.0565260951015603e-01 -5.0706973844967251e-02 + 9.1086266516762038e-01 -5.2712172885890141e-02 + 9.2535804576483116e-01 -5.7547063110007457e-02 + 9.4378789952529019e-01 -6.4831381265420873e-02 + 9.4855240016035935e-01 -6.6800424978580963e-02 + 9.5334776524824605e-01 -6.8814526946169963e-02 + 9.7749309806783202e-01 -7.9458419625169086e-02 + 9.8227063163161432e-01 -8.1668714904225226e-02 + 9.8700609566884623e-01 -8.3897427203083907e-02 + 9.7123941358495358e-01 -8.3598663336516665e-02 + 9.7744253312770013e-01 -8.5026680755589723e-02 + 9.9169555021011746e-01 -8.6157239851729628e-02 + 9.9634246936829385e-01 -8.8424858177432952e-02 + 1.0009305905991965e+00 -9.0722067313450339e-02 + 1.0185524067511977e+00 -9.9894316143775086e-02 + 1.0227354247443543e+00 -1.0214872614572812e-01 + 1.0267934830754939e+00 -1.0441863318952471e-01 + 1.0307562361839331e+00 -1.0663142913469414e-01 + 1.0345829885339768e+00 -1.0885748849000265e-01 + 1.0343221289895581e+00 -1.1286985443406650e-01 + 1.0433903949872345e+00 -1.1353427048189246e-01 + 1.0475392485291195e+00 -1.1689458051402823e-01 + 1.0511819808332632e+00 -1.1660499599825869e-01 + 1.0518567509835606e+00 -1.1957703601805747e-01 + 1.0558830458800514e+00 -1.2209466458170937e-01 + 1.0557401448864425e+00 -1.2910865020373308e-01 + 1.1346559488820915e+00 -1.6806381705198703e-01 + 1.1294327319521500e+00 -1.6776147236629413e-01 + 1.1343683820231476e+00 -1.0866004312106270e-01 + 1.1353589389177756e+00 -1.0319755377017259e-01 + 1.1387498650943542e+00 -1.0830409552487197e-01 + 1.1311091388760914e+00 -1.0532998045492548e-01 + 1.1298929410866592e+00 -9.3202916975727135e-02 + 1.1287586276148360e+00 -1.0050671327928740e-01 + 1.0932558168227047e+00 -5.4434819478572649e-02 + 1.0428600029614969e+00 -1.1065837222560049e-02 + 1.0206255946130796e+00 -4.5117902187570280e-03 + 9.6547406616525677e-01 2.8988003808677831e-02 + 9.5847257410728304e-01 3.2264736654227022e-02 + 9.5427936701818084e-01 4.0136966583894207e-02 + 9.4527079480188547e-01 3.7313354318357028e-02 + 9.4119173640199705e-01 4.4975544130650746e-02 + 9.1686191233706893e-01 4.4033553760996824e-02 + 9.6630224136390552e-01 -8.1021174756898517e-02 + 9.8247857178225928e-01 -8.6235242097458809e-02 + 9.7700267449072697e-01 -9.5168395839493769e-02 + 9.9944629621531789e-01 -9.4749076911057273e-02 + 7.2262815418216775e-01 -8.9704751663077786e-03 + 7.3911651142945800e-01 -2.1081762450222641e-02 + 7.2671726080803012e-01 -2.4357398046049639e-02 + 7.3010023160360049e-01 -1.9904171027619100e-02 + 7.2111574982988458e-01 -1.9827031956992869e-02 + 7.2354245687014185e-01 -1.2867809926063956e-02 + 7.2855136531271114e-01 -1.4680571376274543e-02 + 7.5870921143248893e-01 -2.1779737318198045e-02 + 7.8572682834778362e-01 -4.3284975734820819e-03 + 8.0203633961023257e-01 -8.4164701171687284e-03 + 8.3703417874469466e-01 5.1332970755879614e-03 + 8.4316973359429426e-01 5.9952678848986807e-03 + 8.5614106739447493e-01 8.3532225456224296e-03 + 8.4481593954018308e-01 1.4569452200419164e-03 + 8.5111462417150818e-01 1.6513564728057872e-03 + 8.4966016587642912e-01 7.0668916734888398e-03 + 8.5618661201482382e-01 6.2848630549510176e-03 + 8.5632544285397216e-01 7.2524958551525742e-02 + 8.6183304275770922e-01 6.7376045664090611e-02 + 8.5710262196021603e-01 8.3860551245422243e-02 + 8.6667714111845839e-01 8.2421748800570072e-02 + 8.6486460043911961e-01 9.0635910125811847e-02 + 8.4762981144422156e-01 8.7357473952970111e-02 + 8.4100750516913791e-01 9.3977595354203913e-02 + 8.3050392300060594e-01 1.0212162743336251e-01 + 7.6682107858610493e-01 1.3580643942133008e-01 + 6.6930321519761549e-01 1.3246196105893659e-01 + 6.1852242353808151e-01 1.6293094593194724e-01 + 6.4918982358769739e-01 1.5396464763341555e-01 + 6.4573461537664656e-01 1.3408305577814872e-01 + 6.2190517790599387e-01 1.3549432487766211e-01 + 4.9480826780842335e-01 1.6015832054806367e-01 + 4.0378215118151672e-01 1.2850847487680994e-01 + 4.1679661959312142e-01 1.4032709855299430e-01 + 7.8120816759764011e-02 -9.2662435613192429e-02 + 7.2216716073128850e-02 -8.2261565482141918e-02 + 8.8962341925338251e-02 -1.0383200538191772e-01 + 9.1282525058360875e-02 -9.0136965026658800e-02 + 1.3572387704967070e-01 -1.1795755404830288e-01 + 1.8463213916768240e-01 -1.1109343479297706e-01 + 3.0670265829628107e-01 -1.2920774932462109e-01 + 4.4277442216045415e-01 -1.3106565707187201e-01 + 4.2166616482882091e-01 -1.4652046783459127e-01 + 4.1590163506383249e-01 -1.3592539848903584e-01 + 4.6251192451279621e-01 -1.3147596094499647e-01 + 4.7420833267012341e-01 -1.2854357023415730e-01 + 4.8661301326214357e-01 -1.3333087155452006e-01 + 4.7262525264884658e-01 -1.4382155994775303e-01 + 5.0595396202741938e-01 -1.3002598919467800e-01 + 5.2389043257679901e-01 -1.2668824986033655e-01 + 5.6806466407284972e-01 -1.2858994060989914e-01 + 5.9458032076380363e-01 -1.1248438171296016e-01 + 6.0932189635350653e-01 -1.0389413817929949e-01 + 6.1900565567918875e-01 -9.6098257969458700e-02 + 6.3134406355327144e-01 -9.7619650114154410e-02 + 6.3664184866094331e-01 -1.0815691821245821e-01 + 6.3785499135070722e-01 -8.6749013306587131e-02 + 6.4871690658975467e-01 -8.7514661514902059e-02 + 6.5936345311069999e-01 -9.3403896157710165e-02 + 6.5600777305607494e-01 -7.9870301989473091e-02 + 7.3905029612159012e-01 -2.8346639532827567e-02 + 4.7786209296685200e-01 1.5707092762499997e-01 +-2.0241111482931728e-02 -1.2908167140363958e-01 +-1.0893602103408284e-02 -1.2920405540664603e-01 +-5.6538731965218858e-03 -1.0713447181367997e-01 + 4.1111362229671045e-03 -1.0565769786487067e-01 +-1.1026803629476944e-04 -7.2226891728263354e-02 + 5.9343538576683841e-04 -6.0377402208757758e-02 + 5.2604948100807292e-03 -5.8231842306113890e-02 + 3.5144203569203114e-02 2.7142837529410713e-02 + 2.7638282767668443e-02 3.1911534683864318e-02 + 3.8912541257381861e-02 2.1650362492096065e-02 + 1.0889023599143570e+00 -6.1224184664666836e-02 + 1.0823069513780723e+00 -5.5555015818242737e-02 + 1.0754494092067688e+00 -4.9572694441522458e-02 + 1.0855663771799868e+00 -4.6573271686639828e-02 + 1.0785387244783351e+00 -3.9294980096173049e-02 + 1.0683460042507420e+00 -4.3320024087790898e-02 + 1.0610043034252854e+00 -3.6853516040395107e-02 + 1.0696818147747109e+00 -3.1934675012820435e-02 + 1.0593741655182427e+00 -2.3632992826406962e-02 + 1.0534192657797732e+00 -3.0242584181763732e-02 + 1.0455746886652406e+00 -2.3581354778571040e-02 + 1.0374650833103018e+00 -1.6999180067614361e-02 + 1.0291286588386725e+00 -1.0603680492664580e-02 + 1.0286113089892908e+00 2.1631584034125240e-03 + 9.9565708153252785e-01 1.1619625286272139e-02 + 9.8781811908584416e-01 1.6497849319748070e-02 + 9.9911741397930598e-01 1.8568561811250106e-02 + 9.9219954922266140e-01 2.4882375965418646e-02 + 9.6724790651265380e-01 3.4929685442492087e-02 + 9.5172151965709162e-01 3.5052807116279894e-02 + 9.2807113331873126e-01 4.0787787914794649e-02 + 9.3419022302041554e-01 4.3113164494165801e-02 + 9.3921310311215933e-01 3.9089133599702564e-02 + 9.2289322205765956e-01 4.4752006366849173e-02 + 8.6337495312794488e-01 -1.9216480538531755e-02 + 8.5980302986224189e-01 -1.3969920932879631e-02 + 8.5315808500288881e-01 -1.3769906141831711e-02 + 8.5654755065387889e-01 -2.0025476586340574e-02 + 8.7423415721315223e-01 -2.7831441017170278e-02 + 8.6729782303176961e-01 -2.2937283115922469e-02 + 8.6959047647563636e-01 -2.7364913004674918e-02 + 8.7161271312638178e-01 -3.2127531790791863e-02 + 8.8797591743683313e-01 -4.5133968310565820e-02 + 8.9069287318297086e-01 -5.1876204319711405e-02 + 8.9830642751790180e-01 -5.5150668429320149e-02 + 9.0348075057477217e-01 -5.9335391401688753e-02 + 9.0196678610482195e-01 -6.4935318390169527e-02 + 9.0976246630625468e-01 -5.7323500230182844e-02 + 9.1440154054137679e-01 -6.1393333846041287e-02 + 9.3723666554763696e-01 -6.6894054200403730e-02 + 9.2027630106344560e-01 -6.2231084555975258e-02 + 9.1775985682124173e-01 -5.8652655223852435e-02 + 9.3030177585749385e-01 -6.6998967430748735e-02 + 9.2564302728504799e-01 -6.3328356980903777e-02 + 9.4073231361468856e-01 -7.1122371782777805e-02 + 9.5108055066131669e-01 -7.2789035180178985e-02 + 9.4513866757804976e-01 -7.5476503394156680e-02 + 9.4585836630795939e-01 -7.0203943320223061e-02 + 9.6171145500961330e-01 -7.7170959322245380e-02 + 9.7942129180970738e-01 -9.0317733550435264e-02 + 9.9101369484396429e-01 -9.1238453548371012e-02 + 9.9392148709691952e-01 -9.5215229631222087e-02 + 1.0025253941935546e+00 -9.8589290058782808e-02 + 1.0072509767835385e+00 -1.0882974915581656e-01 + 1.0070059067974171e+00 -9.9131243484436027e-02 + 1.0084956275527546e+00 -1.0388863861098230e-01 + 1.0036206454003747e+00 -1.0374193867487236e-01 + 1.0120226137631150e+00 -1.0024678740960269e-01 + 1.0133754702670075e+00 -1.0458513109547596e-01 + 1.0192259977163332e+00 -1.0530385092532413e-01 + 1.0200583762659861e+00 -1.1127064007962417e-01 + 1.0138408251938813e+00 -1.0950565889780250e-01 + 1.0311947622544224e+00 -1.1119866204616358e-01 + 1.0304110815451892e+00 -1.1467130091597255e-01 + 1.1351773093151181e+00 -9.6732540853480486e-02 + 7.2031462812265090e-01 1.1316586156667086e-02 + 7.1968512645826621e-01 -2.3023731491292665e-02 + 7.2412300565959242e-01 -2.1773417715607479e-02 +-1.9835707977506445e-02 -8.8115229885261215e-02 + 7.2458400964436009e-01 -1.7658549361527776e-02 + 2.2490859999273027e-02 -1.7501915138694812e-02 + 2.8526476661710376e-02 -1.8835107982397403e-02 + 2.8969224581473441e-02 -1.9477157248246613e-02 + 2.9590137421791951e-02 -1.5965689851228149e-02 +-2.5139942640109325e-02 -9.0803530167761437e-02 + 2.0154118799084131e-02 -2.4482007007819107e-02 + 2.8898442962997706e-02 -2.2132666185257222e-02 + 2.8640115182916759e-02 -2.2897895525602507e-02 + 2.3955861951435509e-02 -2.1842109284918365e-02 + 2.5101939783908733e-02 -1.6289259762245933e-02 + 7.1560376691499528e-01 -2.8514946450655998e-02 + 7.1402180248619374e-01 -2.4738521567655880e-02 + 2.8789929422828209e-02 -1.5661817051622506e-02 + 2.6459963464269265e-02 -1.5473056144173825e-02 + 2.5023434041756332e-02 -1.4472293606061726e-02 + 2.5241865428313304e-02 -1.9541592273228048e-02 + 2.3902346311295730e-02 -1.9294675633815928e-02 +-2.5900262048764944e-02 -9.2854496016627763e-02 +-2.4350109923858554e-02 -9.2732788754574358e-02 + 2.7000319039103715e-02 -1.1648743170596276e-02 + 2.9889165836685549e-02 -1.2298134803117478e-02 + 8.8140453820030018e-01 3.0278230567461151e-02 + 7.1050183557415636e-01 -2.7661342504956110e-02 + 2.5006321783344276e-02 -2.3039357323256127e-02 + 2.6086278633819404e-02 -2.2388025997059913e-02 + 7.0928741615510660e-01 -3.0037824522182177e-02 + 2.9974770808991025e-02 -2.4570043343885573e-02 + 2.4435411174110300e-02 -2.0607321576974869e-02 + 7.1541758987374493e-01 -2.7218111081054985e-02 + 1.1402595933493771e+00 -1.3158432671410480e-01 + 1.1414629338411757e+00 -1.3374816076786544e-01 + 7.1072739681697783e-01 -2.9887769447242363e-02 + 3.0363566156388799e-02 -2.7231919254688819e-02 + 3.1102304618300991e-02 -2.7066553676675653e-02 + 3.1152887371128202e-02 -2.7699361650945775e-02 + 2.6851696183122442e-02 -1.9335808021153866e-02 + 2.7499323583818125e-02 -1.8877225181327617e-02 + 2.7711866310042410e-02 -1.5539461186378389e-02 + 2.6883913919455438e-02 -1.4329446342671304e-02 + 7.1439614596587120e-01 -2.6417947147763243e-02 + 3.2738734621375443e-02 -3.6498275845787020e-02 + 3.7034776581002404e-02 -3.5660957494272338e-02 + 2.7687924933928798e-02 -2.1739034175155325e-02 + 2.8309166025401566e-02 -2.2225575854221802e-02 + 2.7895643427633843e-02 -2.2744486490822169e-02 + 2.8229906748109101e-02 -2.3557703777925099e-02 + 1.1124913436484576e+00 -1.5260342340435784e-01 + 3.4973123031463160e-02 -3.3373384855991617e-02 + 3.2769386486620533e-02 -3.1009893339245309e-02 + 2.9584576846581001e-02 -3.2260040298552894e-02 + 2.8449590267605629e-02 -2.9927232450631891e-02 + 2.8796236274622800e-02 -2.9111912385147320e-02 + 3.0405991749802297e-02 -2.8155653283548077e-02 + 2.7168588347421974e-02 -2.0977500080462619e-02 + 3.4409127227476688e-02 -3.5111628371936376e-02 + 3.5489170113123691e-02 -3.5434048158933251e-02 + 2.9290719430086654e-02 -2.4402966405773441e-02 + 3.0957710208980416e-02 -3.1329647542122530e-02 + 3.1497515264469200e-02 -3.2069720750030228e-02 + 3.0474445642816761e-02 -3.2201293476134651e-02 + 3.0435275771104386e-02 -3.0529681546582310e-02 + 3.0007145662537482e-02 -3.1372365262683388e-02 + 2.7867665319348589e-02 -2.8998271377133733e-02 + 2.7168522060776468e-02 -2.6212597961290385e-02 + 2.7361138345888492e-02 -2.5297038611469702e-02 + 1.1161752552831103e+00 -1.5384279355238561e-01 + 3.1901623214572794e-02 -3.1215552793057100e-02 + 3.3423813508662192e-02 -3.2168897500056914e-02 +-2.7128291743878208e-02 -9.3099912615656422e-02 + 2.6327343998701735e-02 -1.9661820452384404e-02 + 2.7830429808361146e-02 -2.6909073358325486e-02 + 3.6224303714341488e-02 -3.6109345882294974e-02 + 2.9584527167195063e-02 -2.6922521221152351e-02 + 2.8243285972315846e-02 -1.8005811182675302e-02 +-2.7923502039357118e-02 -9.3432516397399468e-02 + 2.7749399474423342e-02 -2.4356994492691797e-02 + 2.8187712079095206e-02 -2.6076036987376483e-02 + 3.2540886793832158e-02 -3.1930833135248804e-02 + 2.8648005326616044e-02 -2.4285793725582039e-02 + 2.8445854293735806e-02 -2.1654877440468567e-02 + 3.0580641484391435e-02 -2.8987697603639617e-02 + 3.0932112773605525e-02 -2.9707969254914701e-02 + 8.8323386470511367e-01 -1.3540991840616046e-02 + 8.8180840393883386e-01 -1.2304865484031367e-02 + 8.8008514484505018e-01 -1.0634818904083094e-02 + 8.7812393719203230e-01 -8.4383127133325474e-03 + 8.7602645015995784e-01 -5.6911978338835727e-03 + 8.7399613847224600e-01 -2.4171964606274927e-03 + 8.7235174395911008e-01 1.2856952433402086e-03 + 8.7157395295170248e-01 5.2194611231422394e-03 + 8.7178853533244094e-01 8.9571055844752702e-03 + 8.7269048517579639e-01 1.2136414595834718e-02 + 8.7406437415357330e-01 1.4548863399652716e-02 + 8.7547956727360376e-01 1.6284040774188286e-02 + 8.7672954065577891e-01 1.7501453391681514e-02 + 8.7776342904473570e-01 1.8327254626960755e-02 + 8.7857089303644642e-01 1.8889223858667828e-02 + 8.7918547171707007e-01 1.9265735121539455e-02 + 8.7981484056957437e-01 1.9616941671011762e-02 + 8.8047243127236829e-01 1.9947145473554140e-02 + 8.8115315361098057e-01 2.0259805676946189e-02 + 8.8186179050034719e-01 2.0535973855782205e-02 + 8.8258208978591435e-01 2.0807519785218977e-02 + 8.8332681914355882e-01 2.1028245955289702e-02 + 8.8408122279507662e-01 2.1232052785092059e-02 + 8.8484242574486893e-01 2.1418378720182207e-02 + 8.8561109763263435e-01 2.1572200361210696e-02 + 8.8638151663469744e-01 2.1702048690846219e-02 + 8.8715004969202260e-01 2.1815122200192896e-02 + 8.8791519862963264e-01 2.1896949830400712e-02 + 8.8867277330258043e-01 2.1964223993189237e-02 + 8.8942020313732739e-01 2.2012183967102729e-02 + 8.9015563582349266e-01 2.2038849954302799e-02 + 8.8322959070466944e-01 -1.3545883372306449e-02 + 8.8180349744389119e-01 -1.2309633975399649e-02 + 8.8007940345067659e-01 -1.0639442635798026e-02 + 8.7811747094466364e-01 -8.4423901654682582e-03 + 8.7601954240136359e-01 -5.6942873041833106e-03 + 8.7398914287769469e-01 -2.4189984176560529e-03 + 8.7234536022569154e-01 1.2853808539560398e-03 + 8.7156810638154381e-01 5.2204606328491764e-03 + 8.7178277361515355e-01 8.9592603835079790e-03 + 8.7268472876802594e-01 1.2139617038666903e-02 + 8.7405891526133728e-01 1.4552865840888596e-02 + 8.7547470521810944e-01 1.6288431619691277e-02 + 8.7672522760236471e-01 1.7506028528074702e-02 + 8.7775952690782966e-01 1.8331956059973311e-02 + 8.7856728720480604e-01 1.8894023896936250e-02 + 8.7918207105141855e-01 1.9270622842557875e-02 + 8.7981163725646483e-01 1.9621929749505163e-02 + 8.8046941929049760e-01 1.9952255390899586e-02 + 8.8115032766764356e-01 2.0265058454919917e-02 + 8.8185913510517988e-01 2.0541414360994183e-02 + 8.8257961780021521e-01 2.0813130923943660e-02 + 8.8332453938216648e-01 2.1034027635817337e-02 + 8.8407915184919850e-01 2.1237970748256473e-02 + 8.8484057550358985e-01 2.1424402832150195e-02 + 8.8560947185704963e-01 2.1578322223544756e-02 + 8.8638011802530248e-01 2.1708259926027221e-02 + 8.8714887848824975e-01 2.1821417198357975e-02 + 8.8791425111700473e-01 2.1903348347160092e-02 + 8.8867204503506902e-01 2.1970739322934345e-02 + 8.8941968757585743e-01 2.2018843978524667e-02 + 8.9015532369263173e-01 2.2045692970646177e-02 + 8.8322446190511306e-01 -1.3551753209169067e-02 + 8.8179760965108989e-01 -1.2315356163884470e-02 + 8.8007251377876949e-01 -1.0644991112798865e-02 + 8.7810971144931838e-01 -8.4472831070675231e-03 + 8.7601125309261296e-01 -5.6979946678252825e-03 + 8.7398074816586235e-01 -2.4211607656772186e-03 + 8.7233769974703490e-01 1.2850035867180830e-03 + 8.7156109049876629e-01 5.2216600442810913e-03 + 8.7177585955574366e-01 8.9618461418345639e-03 + 8.7267782108006708e-01 1.2143459969343363e-02 + 8.7405236459187163e-01 1.4557668769405986e-02 + 8.7546887075262880e-01 1.6293700633249211e-02 + 8.7672005193924063e-01 1.7511518690662201e-02 + 8.7775484434441087e-01 1.8337597778533766e-02 + 8.7856296020769431e-01 1.8899783941681039e-02 + 8.7917799025341414e-01 1.9276488106623836e-02 + 8.7980779328148040e-01 1.9627915442521383e-02 + 8.8046580491294579e-01 1.9958387290503903e-02 + 8.8114693653630261e-01 2.0271361787290807e-02 + 8.8185594863159811e-01 2.0547942965972673e-02 + 8.8257665141798469e-01 2.0819864289120197e-02 + 8.8332180366908042e-01 2.1040965651121749e-02 + 8.8407666671458596e-01 2.1245072302702141e-02 + 8.8483835521452359e-01 2.1431631765165694e-02 + 8.8560752092674100e-01 2.1585668456926926e-02 + 8.8637843969435204e-01 2.1715713406825588e-02 + 8.8714747304397990e-01 2.1828971194713023e-02 + 8.8791311410203844e-01 2.1911026565740430e-02 + 8.8867117111421812e-01 2.1978557717158283e-02 + 8.8941906890220057e-01 2.2026835990668431e-02 + 8.9015494913563042e-01 2.2053904588719732e-02 + 8.8321830734709084e-01 -1.3558797011801616e-02 + 8.8179054430137749e-01 -1.2322222788492701e-02 + 8.8006424617440582e-01 -1.0651649283651159e-02 + 8.7810040005709344e-01 -8.4531546356303930e-03 + 8.7600130592447611e-01 -5.7024435031711607e-03 + 8.7397067451408450e-01 -2.4237555827006626e-03 + 8.7232850717482202e-01 1.2845508661508851e-03 + 8.7155267144135240e-01 5.2230993376412276e-03 + 8.7176756268639222e-01 8.9649490510997302e-03 + 8.7266953185647544e-01 1.2148071485068232e-02 + 8.7404450379038490e-01 1.4563432282299065e-02 + 8.7546186939569692e-01 1.6300023448052234e-02 + 8.7671384114494633e-01 1.7518106884231509e-02 + 8.7774922526960786e-01 1.8344367839154434e-02 + 8.7855776781235462e-01 1.8906695993779962e-02 + 8.7917309329697624e-01 1.9283526421833043e-02 + 8.7980318051252138e-01 1.9635098272452637e-02 + 8.8046146766091160e-01 1.9965745568322573e-02 + 8.8114286717962065e-01 2.0278925784320122e-02 + 8.8185212486420017e-01 2.0555777290129872e-02 + 8.8257309176010335e-01 2.0827944325456982e-02 + 8.8331852081412099e-01 2.1049291267548221e-02 + 8.8407368455377344e-01 2.1253594166008787e-02 + 8.8483569086822189e-01 2.1440306482706593e-02 + 8.8560517981090570e-01 2.1594483934902337e-02 + 8.8637642569767694e-01 2.1724657581626734e-02 + 8.8714578651129139e-01 2.1838035988215064e-02 + 8.8791174968443487e-01 2.1920240425928678e-02 + 8.8867012240943932e-01 2.1987939787972522e-02 + 8.8941832649398500e-01 2.2036426402986777e-02 + 8.9015449966735882e-01 2.2063758528044593e-02 + 8.8321092187959005e-01 -1.3567249572524089e-02 + 8.8178206588416608e-01 -1.2330462735644070e-02 + 8.8005432505200309e-01 -1.0659639086363956e-02 + 8.7808922638957188e-01 -8.4602004678804039e-03 + 8.7598936932611571e-01 -5.7077821040585281e-03 + 8.7395858613531829e-01 -2.4268693622154164e-03 + 8.7231747609129873e-01 1.2840076016371387e-03 + 8.7154256857535983e-01 5.2248264891890106e-03 + 8.7175760644600842e-01 8.9686725411164108e-03 + 8.7265958479093164e-01 1.2153605302368673e-02 + 8.7403507083130838e-01 1.4570348495798902e-02 + 8.7545346776975452e-01 1.6307610823664713e-02 + 8.7670638819392721e-01 1.7526012714290867e-02 + 8.7774248238178609e-01 1.8352491909629804e-02 + 8.7855153693974508e-01 1.8914990453959505e-02 + 8.7916721695090816e-01 1.9291972397697945e-02 + 8.7979764519141790e-01 1.9643717665942709e-02 + 8.8045626295993307e-01 1.9974575499170887e-02 + 8.8113798395302334e-01 2.0288002578214025e-02 + 8.8184753634459578e-01 2.0565178476454941e-02 + 8.8256882017186167e-01 2.0837640366276677e-02 + 8.8331458138931740e-01 2.1059282004439937e-02 + 8.8407010596180535e-01 2.1263820399123941e-02 + 8.8483249365359407e-01 2.1450716140837399e-02 + 8.8560237047268964e-01 2.1605062505483424e-02 + 8.8637400890236206e-01 2.1735390588436987e-02 + 8.8714376267261963e-01 2.1848913737319942e-02 + 8.8791011238373263e-01 2.1931297054984443e-02 + 8.8866886396407696e-01 2.1999198269792176e-02 + 8.8941743560442177e-01 2.2047934894511820e-02 + 8.9015396030560534e-01 2.2075583251907744e-02 + 8.8320205932156726e-01 -1.3577392641984189e-02 + 8.8177189178692839e-01 -1.2340350668918233e-02 + 8.8004241970916863e-01 -1.0669226846425607e-02 + 8.7807581799311973e-01 -8.4686554637165238e-03 + 8.7597504541292714e-01 -5.7141884229189996e-03 + 8.7394408008574720e-01 -2.4306058963696675e-03 + 8.7230423879554764e-01 1.2833556844252230e-03 + 8.7153044514026379e-01 5.2268990703426927e-03 + 8.7174565896162937e-01 8.9731407276908131e-03 + 8.7264764831639785e-01 1.2160245880866328e-02 + 8.7402375128420451e-01 1.4578647949182915e-02 + 8.7544338582209202e-01 1.6316715671313792e-02 + 8.7669744465572386e-01 1.7535499707099913e-02 + 8.7773439091912708e-01 1.8362240790898224e-02 + 8.7854405989515627e-01 1.8924943802760621e-02 + 8.7916016533801256e-01 1.9302107565311515e-02 + 8.7979100280833500e-01 1.9654060934570027e-02 + 8.8045001732087802e-01 1.9985171412608166e-02 + 8.8113212408306663e-01 2.0298894727149661e-02 + 8.8184203012297813e-01 2.0576459896171524e-02 + 8.8256369426775305e-01 2.0849275611335621e-02 + 8.8330985408114548e-01 2.1071270884600531e-02 + 8.8406581165293385e-01 2.1276091874664529e-02 + 8.8482865699732627e-01 2.1463207726352677e-02 + 8.8559899926803509e-01 2.1617756785912004e-02 + 8.8637110874893754e-01 2.1748270192124535e-02 + 8.8714133406706597e-01 2.1861967031822114e-02 + 8.8790814762363168e-01 2.1944565005377913e-02 + 8.8866735383011530e-01 2.2012708443365853e-02 + 8.8941636653726275e-01 2.2061745079649506e-02 + 8.9015331307172385e-01 2.2089772915709023e-02 + 8.8319142425633701e-01 -1.3589564320319608e-02 + 8.8175968287525763e-01 -1.2352216183952710e-02 + 8.8002813330358054e-01 -1.0680732153724452e-02 + 8.7805972792395226e-01 -8.4788014545870791e-03 + 8.7595785672415383e-01 -5.7218760024306129e-03 + 8.7392667283340320e-01 -2.4350897354900782e-03 + 8.7228835404719673e-01 1.2825733841065024e-03 + 8.7151589702415089e-01 5.2293861667453197e-03 + 8.7173132198621783e-01 8.9785025493406175e-03 + 8.7263332455282516e-01 1.2168214571803677e-02 + 8.7401016783328933e-01 1.4588607289173858e-02 + 8.7543128748985022e-01 1.6327641484002162e-02 + 8.7668671241431007e-01 1.7546884093831022e-02 + 8.7772468116793023e-01 1.8373939443611459e-02 + 8.7853508744529407e-01 1.8936887816453401e-02 + 8.7915170340602200e-01 1.9314269761447074e-02 + 8.7978303195189089e-01 1.9666472851866658e-02 + 8.8044252255709965e-01 1.9997886503511902e-02 + 8.8112509224203017e-01 2.0311965300544840e-02 + 8.8183542265972259e-01 2.0589997594323353e-02 + 8.8255754318532220e-01 2.0863237899663802e-02 + 8.8330418131366673e-01 2.1085657534892947e-02 + 8.8406065848439686e-01 2.1290817639279341e-02 + 8.8482405301172484e-01 2.1478197622780804e-02 + 8.8559495382404851e-01 2.1632989916153665e-02 + 8.8636762856626061e-01 2.1763725710284051e-02 + 8.8713841974157426e-01 2.1877630978804276e-02 + 8.8790578991240032e-01 2.1960486539307413e-02 + 8.8866554167013623e-01 2.2028920644973755e-02 + 8.8941508365721367e-01 2.2078317295036162e-02 + 8.9015253639137204e-01 2.2106800505329982e-02 + 8.8317866218430074e-01 -1.3604170327091601e-02 + 8.8174503218848355e-01 -1.2366454794925574e-02 + 8.8001098962535851e-01 -1.0694538515687404e-02 + 8.7804041985051884e-01 -8.4909766375750526e-03 + 8.7593723030779702e-01 -5.7311010933084171e-03 + 8.7390578414089493e-01 -2.4404703398396457e-03 + 8.7226929235856077e-01 1.2816346241816482e-03 + 8.7149843929339288e-01 5.2323706808994020e-03 + 8.7171411762425022e-01 8.9849367321556423e-03 + 8.7261613604501398e-01 1.2177776996199138e-02 + 8.7399386770021459e-01 1.4600558491256970e-02 + 8.7541676949828628e-01 1.6340752452732435e-02 + 8.7667383373094165e-01 1.7560545351151098e-02 + 8.7771302947227559e-01 1.8387977819918244e-02 + 8.7852432051078222e-01 1.8951220625767946e-02 + 8.7914154909262521e-01 1.9328864389594903e-02 + 8.7977346692888148e-01 1.9681367145259976e-02 + 8.8043352884501080e-01 2.0013144605067479e-02 + 8.8111665403694206e-01 2.0327649980851403e-02 + 8.8182749370775437e-01 2.0606242824075003e-02 + 8.8255016189005109e-01 2.0879992637399696e-02 + 8.8329737399604713e-01 2.1102921506734387e-02 + 8.8405447468517351e-01 2.1308488548083131e-02 + 8.8481852823170193e-01 2.1496185489621296e-02 + 8.8559009929367360e-01 2.1651269663391343e-02 + 8.8636345234917069e-01 2.1782272322899525e-02 + 8.8713492255266757e-01 2.1896427705894662e-02 + 8.8790296066036056e-01 2.1979592370549857e-02 + 8.8866336707925397e-01 2.2048375277332229e-02 + 8.8941354420190255e-01 2.2098203943637817e-02 + 8.9015160437542917e-01 2.2127233602720054e-02 + 8.8316334770704075e-01 -1.3621697524747432e-02 + 8.8172745137489095e-01 -1.2383541117881086e-02 + 8.7999041722378923e-01 -1.0711106140143664e-02 + 8.7801725017624499e-01 -8.5055868484578898e-03 + 8.7591247862299693e-01 -5.7421711956968900e-03 + 8.7388071772484921e-01 -2.4469270611625080e-03 + 8.7224641834586525e-01 1.2805081129454194e-03 + 8.7147749002901531e-01 5.2359520957299373e-03 + 8.7169347240219619e-01 8.9926577469165679e-03 + 8.7259550984794054e-01 1.2189251898649641e-02 + 8.7397430755224970e-01 1.4614899925160562e-02 + 8.7539934791886120e-01 1.6356485605831018e-02 + 8.7665837932014534e-01 1.7576938850132545e-02 + 8.7769904744577731e-01 1.8404823861443573e-02 + 8.7851140019710650e-01 1.8968419986693696e-02 + 8.7912936392384367e-01 1.9346377932914525e-02 + 8.7976198890813972e-01 1.9699240286641134e-02 + 8.8042273639694846e-01 2.0031454315991813e-02 + 8.8110652819689639e-01 2.0346471585982760e-02 + 8.8181797897107572e-01 2.0625737088134026e-02 + 8.8254130434099232e-01 2.0900098310657544e-02 + 8.8328920521979604e-01 2.1123638260550835e-02 + 8.8404705413055285e-01 2.1329693625997178e-02 + 8.8481189849964237e-01 2.1517770916983280e-02 + 8.8558427386070548e-01 2.1673205347011098e-02 + 8.8635844089160687e-01 2.1804528244740995e-02 + 8.8713072592853115e-01 2.1918983764888600e-02 + 8.8789956555990002e-01 2.2002519354381321e-02 + 8.8866075757169605e-01 2.2071720822200235e-02 + 8.8941169685666721e-01 2.2122067907761740e-02 + 8.9015048595690160e-01 2.2151753304977963e-02 + 8.8314497034760586e-01 -1.3642730146791342e-02 + 8.8170635441376111e-01 -1.2404044690708098e-02 + 8.7996573035974235e-01 -1.0730987275160949e-02 + 8.7798944658713673e-01 -8.5231190888639501e-03 + 8.7588277662261160e-01 -5.7554553090332578e-03 + 8.7385063804733154e-01 -2.4546751211480234e-03 + 8.7221896955044098e-01 1.2791563004098091e-03 + 8.7145235092989715e-01 5.2402497904882987e-03 + 8.7166869815360626e-01 9.0019229579363664e-03 + 8.7257075842933030e-01 1.2203021771628434e-02 + 8.7395083539160467e-01 1.4632109633457270e-02 + 8.7537844203861681e-01 1.6375365375933901e-02 + 8.7663983404057577e-01 1.7596611034732111e-02 + 8.7768226902613200e-01 1.8425039096696474e-02 + 8.7849589583188037e-01 1.8989059204935776e-02 + 8.7911474173184978e-01 1.9367394169736516e-02 + 8.7974821529316949e-01 1.9720688040841379e-02 + 8.8040978546861537e-01 2.0053425953265862e-02 + 8.8109437719759642e-01 2.0369057495871801e-02 + 8.8180656129527901e-01 2.0649130188092515e-02 + 8.8253067528983487e-01 2.0924225101150138e-02 + 8.8327940269534000e-01 2.1148498347197890e-02 + 8.8403814947143800e-01 2.1355139701110873e-02 + 8.8480394282691732e-01 2.1543673411099119e-02 + 8.8557728334618802e-01 2.1699528148322208e-02 + 8.8635242714686557e-01 2.1831235331686530e-02 + 8.8712568998322061e-01 2.1946051016212453e-02 + 8.8789549144233393e-01 2.2030031715098090e-02 + 8.8865762616492827e-01 2.2099735455849635e-02 + 8.8940948004395326e-01 2.2150704643986753e-02 + 8.9014914385567634e-01 2.2181176926447908e-02 + 8.8312291753554772e-01 -1.3667969271174573e-02 + 8.8168103808252574e-01 -1.2428648956582434e-02 + 8.7993610614872864e-01 -1.0754844616308785e-02 + 8.7795608230937683e-01 -8.5441577589907957e-03 + 8.7584713425330774e-01 -5.7713962310733113e-03 + 8.7381454246581736e-01 -2.4639727850134002e-03 + 8.7218603102467651e-01 1.2775341268535338e-03 + 8.7142218403730154e-01 5.2454070196423343e-03 + 8.7163896908127836e-01 9.0130412014853747e-03 + 8.7254105675292859e-01 1.2219545604788919e-02 + 8.7392266882342762e-01 1.4652761265385429e-02 + 8.7535335500420108e-01 1.6398021080268745e-02 + 8.7661757972451093e-01 1.7620217635651535e-02 + 8.7766213494013823e-01 1.8449297357803048e-02 + 8.7847729060984803e-01 1.9013826245158981e-02 + 8.7909719511676498e-01 1.9392613631910288e-02 + 8.7973168696964055e-01 1.9746425323418571e-02 + 8.8039424436818225e-01 2.0079791894930501e-02 + 8.8107979601116027e-01 2.0396160564027838e-02 + 8.8179286009628199e-01 2.0677201883574456e-02 + 8.8251792043954358e-01 2.0953177224487141e-02 + 8.8326763967629141e-01 2.1178330425154282e-02 + 8.8402746388981379e-01 2.1385674964587743e-02 + 8.8479439602797882e-01 2.1574756376875500e-02 + 8.8556889473606526e-01 2.1731115482336427e-02 + 8.8634521065947913e-01 2.1863283808014413e-02 + 8.8711964685409073e-01 2.1978531689424843e-02 + 8.8789060250549401e-01 2.2063046519194024e-02 + 8.8865386848007977e-01 2.2133352986852237e-02 + 8.8940681987104531e-01 2.2185068697491764e-02 + 8.9014753333564167e-01 2.2216485241382814e-02 + 8.8309645418904625e-01 -1.3698256188397481e-02 + 8.8165065851722879e-01 -1.2458174044350678e-02 + 8.7990055713314075e-01 -1.0783473395428412e-02 + 8.7791604521843991e-01 -8.5694041363953179e-03 + 8.7580436345537016e-01 -5.7905253172850979e-03 + 8.7377122781382865e-01 -2.4751299698568246e-03 + 8.7214650483561995e-01 1.2755875205996982e-03 + 8.7138598380451482e-01 5.2515956881072513e-03 + 8.7160329423222316e-01 9.0263830795873443e-03 + 8.7250541477895804e-01 1.2239374183553708e-02 + 8.7388886897735685e-01 1.4677543197447518e-02 + 8.7532325059479033e-01 1.6425207896722010e-02 + 8.7659087457350304e-01 1.7648545526767107e-02 + 8.7763797406250155e-01 1.8478407240343123e-02 + 8.7845496436705484e-01 1.9043546661985319e-02 + 8.7907613920094052e-01 1.9422876954481871e-02 + 8.7971185300238830e-01 1.9777310029802087e-02 + 8.8037559506738183e-01 2.0111430991471457e-02 + 8.8106229860596952e-01 2.0428684211433346e-02 + 8.8177641867490686e-01 2.0710887882496330e-02 + 8.8250261463543600e-01 2.0987919735712433e-02 + 8.8325352406836344e-01 2.1214128880795925e-02 + 8.8401464120544937e-01 2.1422317242002723e-02 + 8.8478293988136636e-01 2.1612055896394776e-02 + 8.8555882841460354e-01 2.1769020243046198e-02 + 8.8633655088377339e-01 2.1901741938973363e-02 + 8.8711239510683759e-01 2.2017508456014231e-02 + 8.8788473578749094e-01 2.2102664242106121e-02 + 8.8864935926301836e-01 2.2173693981383007e-02 + 8.8940362766687864e-01 2.2226305518049137e-02 + 8.9014560071360083e-01 2.2258855174466612e-02 + 8.8306469821408728e-01 -1.3734600442367883e-02 + 8.8161420308567451e-01 -1.2493604104174862e-02 + 8.7985789836927519e-01 -1.0817827886221452e-02 + 8.7786800077099592e-01 -8.5996997503768914e-03 + 8.7575303856385778e-01 -5.8134801912543606e-03 + 8.7371925029823627e-01 -2.4885185744849873e-03 + 8.7209907346970383e-01 1.2732515961008525e-03 + 8.7134254358096375e-01 5.2590220807354942e-03 + 8.7156048446836087e-01 9.0423933127481461e-03 + 8.7246264446516830e-01 1.2263168447535279e-02 + 8.7384830921424361e-01 1.4707281477730448e-02 + 8.7528712534996611e-01 1.6457832034502774e-02 + 8.7655882843347011e-01 1.7682538952377647e-02 + 8.7760898104660823e-01 1.8513339054477877e-02 + 8.7842817291007558e-01 1.9079211116358349e-02 + 8.7905087213448097e-01 1.9459192894895120e-02 + 8.7968805227229330e-01 1.9814371629855998e-02 + 8.8035321593522320e-01 2.0149397858533376e-02 + 8.8104130174671702e-01 2.0467712538144320e-02 + 8.8175668899459947e-01 2.0751311029232111e-02 + 8.8248424769407074e-01 2.1029610695609328e-02 + 8.8323658536060801e-01 2.1257086972329760e-02 + 8.8399925400400270e-01 2.1466287918382745e-02 + 8.8476919252312491e-01 2.1656815262251185e-02 + 8.8554674884437490e-01 2.1814505897435915e-02 + 8.8632615916631807e-01 2.1947891636754011e-02 + 8.8710369302126935e-01 2.2064280515860762e-02 + 8.8787769573498687e-01 2.2150205448547979e-02 + 8.8864394820954429e-01 2.2222103112600557e-02 + 8.8939979702686545e-01 2.2275789639148575e-02 + 8.9014328157016698e-01 2.2309699028827089e-02 + 8.8302659110371240e-01 -1.3778213478918735e-02 + 8.8157045663623312e-01 -1.2536120109481070e-02 + 8.7980670793267524e-01 -1.0859053210685561e-02 + 8.7781034752429687e-01 -8.6360544302815125e-03 + 8.7569144879032790e-01 -5.8410259969316897e-03 + 8.7365687737708653e-01 -2.5045848749014272e-03 + 8.7204215591959222e-01 1.2704484910617730e-03 + 8.7129041539423946e-01 5.2679337379267386e-03 + 8.7150911283207810e-01 9.0616055625030237e-03 + 8.7241132016889456e-01 1.2291721519627846e-02 + 8.7379963757457435e-01 1.4742967358221927e-02 + 8.7524377512390672e-01 1.6496980938639778e-02 + 8.7652037312558095e-01 1.7723330999380789e-02 + 8.7757418948192656e-01 1.8555257165892465e-02 + 8.7839602321207300e-01 1.9122008394698856e-02 + 8.7902055170212745e-01 1.9502771955234734e-02 + 8.7965949144083855e-01 1.9858845480364609e-02 + 8.8032636101860184e-01 2.0194958027753371e-02 + 8.8101610555505017e-01 2.0514546456974959e-02 + 8.8173301341527621e-01 2.0799818729453537e-02 + 8.8246220739892567e-01 2.1079639769236640e-02 + 8.8321625894309308e-01 2.1308636601606434e-02 + 8.8398078939112168e-01 2.1519052647530772e-02 + 8.8475269571901483e-01 2.1710526417291501e-02 + 8.8553225338278774e-01 2.1869088597353353e-02 + 8.8631368912485387e-01 2.2003271187505623e-02 + 8.8709325053497423e-01 2.2120406899870691e-02 + 8.8786924768514408e-01 2.2207254807065400e-02 + 8.8863745495551461e-01 2.2280193979217381e-02 + 8.8939520026601693e-01 2.2335170491575854e-02 + 8.9014049860237332e-01 2.2370711558639473e-02 + 8.8298086265847231e-01 -1.3830549022909675e-02 + 8.8151796099705682e-01 -1.2587139218497670e-02 + 8.7974527952594261e-01 -1.0908523505647754e-02 + 8.7774116376021993e-01 -8.6796799629735299e-03 + 8.7561754120309876e-01 -5.8740809006510384e-03 + 8.7358203001449664e-01 -2.5238643985810113e-03 + 8.7197385498974656e-01 1.2670847714732444e-03 + 8.7122786168951172e-01 5.2786277061373250e-03 + 8.7144746698615605e-01 9.0846602182124737e-03 + 8.7234973113086489e-01 1.2325985140818901e-02 + 8.7374123171839846e-01 1.4785790333164628e-02 + 8.7519175495190471e-01 1.6543959533970445e-02 + 8.7647422684416554e-01 1.7772281362370607e-02 + 8.7753243968398043e-01 1.8605558803629338e-02 + 8.7835744364799440e-01 1.9173365030671977e-02 + 8.7898416725267414e-01 1.9555066727880099e-02 + 8.7962521850847653e-01 1.9912213999150729e-02 + 8.8029413518015465e-01 2.0249630126510466e-02 + 8.8098587018269192e-01 2.0570747052328805e-02 + 8.8170460277428142e-01 2.0858027858683396e-02 + 8.8243575909519611e-01 2.1139674543061902e-02 + 8.8319186728859334e-01 2.1370496038717841e-02 + 8.8395863189795820e-01 2.1582370201682528e-02 + 8.8473289959188040e-01 2.1774979680370947e-02 + 8.8551485886201975e-01 2.1934587712271612e-02 + 8.8629872510364938e-01 2.2069726521634265e-02 + 8.8708071957528034e-01 2.2187758432179801e-02 + 8.8785911004467843e-01 2.2275713906646132e-02 + 8.8862966306549451e-01 2.2349902886173965e-02 + 8.8938968416349851e-01 2.2406427378537711e-02 + 8.9013715904740154e-01 2.2443926454758636e-02 + 8.8292598865234462e-01 -1.3893351529151778e-02 + 8.8145496637710108e-01 -1.2648362006409277e-02 + 8.7967156560992288e-01 -1.0967887721056037e-02 + 8.7765814343711346e-01 -8.7320304799453092e-03 + 8.7552885230543365e-01 -5.9137466925866678e-03 + 8.7349221338903982e-01 -2.5469997730617712e-03 + 8.7189189406530410e-01 1.2630483173546045e-03 + 8.7115279741904106e-01 5.2914604380884835e-03 + 8.7137349214371063e-01 9.1123257405058018e-03 + 8.7227582445774776e-01 1.2367101390229599e-02 + 8.7367114485465347e-01 1.4837177783112838e-02 + 8.7512933089122391e-01 1.6600333716766009e-02 + 8.7641885143569964e-01 1.7831021660832433e-02 + 8.7748234004340486e-01 1.8665920627987997e-02 + 8.7831114827918932e-01 1.9234992850019644e-02 + 8.7894050601528162e-01 1.9617820308599980e-02 + 8.7958409108565028e-01 1.9976256072205684e-02 + 8.8025546426426937e-01 2.0315236491891382e-02 + 8.8094958782053845e-01 2.0638187609345712e-02 + 8.8167051008466368e-01 2.0927878650719954e-02 + 8.8240402120478545e-01 2.1211716103497237e-02 + 8.8316259737156411e-01 2.1444727189941056e-02 + 8.8393204296818728e-01 2.1658351089354006e-02 + 8.8470914429474456e-01 2.1852323415541365e-02 + 8.8549398548584723e-01 2.2013186466712849e-02 + 8.8628076832011182e-01 2.2149472736420997e-02 + 8.8706568245877548e-01 2.2268580082273656e-02 + 8.8784694490452276e-01 2.2357864634409381e-02 + 8.8862031281935627e-01 2.2433553379241414e-02 + 8.8938306485595731e-01 2.2491935443287314e-02 + 8.9013315159076312e-01 2.2531784125003285e-02 + 8.8286014003360336e-01 -1.3968714320687678e-02 + 8.8137937304971781e-01 -1.2721829141421013e-02 + 8.7958310916412552e-01 -1.1039124575424898e-02 + 8.7755851933484186e-01 -8.7948509203519716e-03 + 8.7542242593318309e-01 -5.9613455064667859e-03 + 8.7338443374731445e-01 -2.5747621428455405e-03 + 8.7179354123773845e-01 1.2582045863053428e-03 + 8.7106272055260436e-01 5.3068596722385449e-03 + 8.7128472258713263e-01 9.1455242720874848e-03 + 8.7218713670412906e-01 1.2416440748179297e-02 + 8.7358704085909089e-01 1.4898842546356345e-02 + 8.7505442223303109e-01 1.6667982542293500e-02 + 8.7635240113595070e-01 1.7901509817029225e-02 + 8.7742222064691022e-01 1.8738354609687351e-02 + 8.7825559399578224e-01 1.9308946021328762e-02 + 8.7888811268051159e-01 1.9693124389664737e-02 + 8.7953473831965845e-01 2.0053106339652883e-02 + 8.8020905929816262e-01 2.0393963904746588e-02 + 8.8090604911073411e-01 2.0719116045862934e-02 + 8.8162959897434490e-01 2.1011699360978593e-02 + 8.8236593584547052e-01 2.1298165728306839e-02 + 8.8312747357173782e-01 2.1533804316188440e-02 + 8.8390013634390752e-01 2.1749527893252713e-02 + 8.8468063801987118e-01 2.1945135631793195e-02 + 8.8546893750621358e-01 2.2107504701819214e-02 + 8.8625922024161852e-01 2.2245167919988418e-02 + 8.8704763797067443e-01 2.2365565784537460e-02 + 8.8783234677818101e-01 2.2456445225260694e-02 + 8.8860909255612386e-01 2.2533933683317617e-02 + 8.8937512170962807e-01 2.2594544827004192e-02 + 8.9012834265662677e-01 2.2637213027184109e-02 + 8.8278112197004455e-01 -1.4059149351301861e-02 + 8.8128866137711326e-01 -1.2809989392203973e-02 + 8.7947696180390589e-01 -1.1124608498895242e-02 + 8.7743897083407307e-01 -8.8702351827540955e-03 + 8.7529471473730491e-01 -6.0184638815487940e-03 + 8.7325509863373962e-01 -2.6080768689982397e-03 + 8.7167551826131096e-01 1.2523921295566978e-03 + 8.7095462869439844e-01 5.3253386880388913e-03 + 8.7117819949525621e-01 9.1853623694170394e-03 + 8.7208071177544444e-01 1.2475647768720809e-02 + 8.7348611642064589e-01 1.4972840001069474e-02 + 8.7496453216049797e-01 1.6749160846365307e-02 + 8.7627266105775603e-01 1.7986095305878899e-02 + 8.7735007762582906e-01 1.8825275080899172e-02 + 8.7818892909107238e-01 1.9397689513641844e-02 + 8.7882524090073411e-01 1.9783488967956158e-02 + 8.7947551520952838e-01 2.0145326335097469e-02 + 8.8015337353543599e-01 2.0488436466694255e-02 + 8.8085380284338755e-01 2.0816229826901140e-02 + 8.8158050581524416e-01 2.1112283858232557e-02 + 8.8232023357558176e-01 2.1401904911864986e-02 + 8.8308532516071692e-01 2.1640696490361846e-02 + 8.8386184852992722e-01 2.1858939671755735e-02 + 8.8464643061074033e-01 2.2056509898139554e-02 + 8.8543888003678162e-01 2.2220686184394680e-02 + 8.8623336263868913e-01 2.2360001734886403e-02 + 8.8702598466136229e-01 2.2481948216407002e-02 + 8.8781482908836740e-01 2.2574741516686477e-02 + 8.8859562828775940e-01 2.2654389622983429e-02 + 8.8936558996771042e-01 2.2717675652802780e-02 + 8.9012257195599387e-01 2.2763727263256286e-02 + 8.8268630070792020e-01 -1.4167670914080981e-02 + 8.8117980784534089e-01 -1.2915781231165343e-02 + 8.7934958552792697e-01 -1.1227188759099074e-02 + 8.7729551325973820e-01 -8.9606959025575160e-03 + 8.7514146197153131e-01 -6.0870056322838905e-03 + 8.7309989717528813e-01 -2.6480543657951806e-03 + 8.7153389130805514e-01 1.2454172119394211e-03 + 8.7082491903104542e-01 5.3475134101440124e-03 + 8.7105037234324378e-01 9.2331678774140204e-03 + 8.7195300241874107e-01 1.2546695883063978e-02 + 8.7336500762348646e-01 1.5061636558909719e-02 + 8.7485666454453137e-01 1.6846574385865294e-02 + 8.7617697338173262e-01 1.8087597449202370e-02 + 8.7726350637858397e-01 1.8929579190867137e-02 + 8.7810893155471814e-01 1.9504181239373097e-02 + 8.7874979509447992e-01 1.9891925988400269e-02 + 8.7940444778773463e-01 2.0255989846326993e-02 + 8.8008655091194687e-01 2.0601803045972245e-02 + 8.8079110759639756e-01 2.0932765855188142e-02 + 8.8152159428163568e-01 2.1232984727812723e-02 + 8.8226539109122692e-01 2.1526391388522730e-02 + 8.8303474728840003e-01 2.1768966539216460e-02 + 8.8381590335381399e-01 2.1990233232568473e-02 + 8.8460538189905891e-01 2.2190158434125376e-02 + 8.8540281123092490e-01 2.2356503370344099e-02 + 8.8620233365068224e-01 2.2497801710988322e-02 + 8.8700000080369201e-01 2.2621606524720592e-02 + 8.8779380795240770e-01 2.2716696446488691e-02 + 8.8857947123625913e-01 2.2798936119384570e-02 + 8.8935415192738299e-01 2.2865431998507289e-02 + 8.9011564714549840e-01 2.2915543683512736e-02 + 8.8257251581094653e-01 -1.4297896082613028e-02 + 8.8104918431618240e-01 -1.3042730748871086e-02 + 8.7919673482634586e-01 -1.1350284403268164e-02 + 8.7712336510480782e-01 -9.0692481771533356e-03 + 8.7495755965072619e-01 -6.1692552867656878e-03 + 8.7291365643598640e-01 -2.6960271015514232e-03 + 8.7136393988660898e-01 1.2370473562197662e-03 + 8.7066926827982249e-01 5.3741229322540711e-03 + 8.7089698059337661e-01 9.2905341756650446e-03 + 8.7179975202249116e-01 1.2631953157577685e-02 + 8.7321967785566368e-01 1.5168191849986164e-02 + 8.7472722410793879e-01 1.6963469998777795e-02 + 8.7606214879379596e-01 1.8209399360152895e-02 + 8.7715962144574577e-01 1.9054743443454772e-02 + 8.7801293503215339e-01 1.9631970616626023e-02 + 8.7865926061836763e-01 2.0022049706608373e-02 + 8.7931916734443660e-01 2.0388785339016623e-02 + 8.8000636419900724e-01 2.0737842202701411e-02 + 8.8071587370831028e-01 2.1072608330139422e-02 + 8.8145090082494637e-01 2.1377824985154587e-02 + 8.8219958046718594e-01 2.1675774349691899e-02 + 8.8297405417104091e-01 2.1922889762397296e-02 + 8.8376076944169013e-01 2.2147784650418438e-02 + 8.8455612371241255e-01 2.2350535806812569e-02 + 8.8535952889884195e-01 2.2519483108906065e-02 + 8.8616509906716245e-01 2.2663160784771562e-02 + 8.8696882034371805e-01 2.2789195585116970e-02 + 8.8776858272617254e-01 2.2887041437678963e-02 + 8.8856008287975641e-01 2.2972390973562733e-02 + 8.8934042635347166e-01 2.3042738650996476e-02 + 8.9010733741800407e-01 2.3097722399046269e-02 + 8.8243597486018777e-01 -1.4454165225443415e-02 + 8.8089243714387455e-01 -1.3195069137326709e-02 + 8.7901331522791426e-01 -1.1497998174775093e-02 + 8.7691678871938150e-01 -9.1995100235290513e-03 + 8.7473687836185809e-01 -6.2679542030089005e-03 + 8.7269016906395214e-01 -2.7535939942122411e-03 + 8.7115999956348256e-01 1.2270035974382564e-03 + 8.7048248864462852e-01 5.4060541422955959e-03 + 8.7071291174143206e-01 9.3593732668592871e-03 + 8.7161585279371057e-01 1.2734261193350953e-02 + 8.7304528331655540e-01 1.5296057332428380e-02 + 8.7457189663706780e-01 1.7103743783296290e-02 + 8.7592436022237408e-01 1.8355560662380140e-02 + 8.7703496037147244e-01 1.9204939528330359e-02 + 8.7789773998605458e-01 1.9785316829780766e-02 + 8.7855061998354744e-01 2.0178197109876689e-02 + 8.7921683150625884e-01 2.0548138849948529e-02 + 8.7991014079579644e-01 2.0901088084098261e-02 + 8.8062559365469140e-01 2.1240418162431628e-02 + 8.8136606925208394e-01 2.1551632115670977e-02 + 8.8212060825373517e-01 2.1855032687828627e-02 + 8.8290122292393947e-01 2.2107596378004017e-02 + 8.8369460919568454e-01 2.2336845070097904e-02 + 8.8449701428919469e-01 2.2542987349351812e-02 + 8.8530759045244667e-01 2.2715057469275338e-02 + 8.8612041786986906e-01 2.2861590328110814e-02 + 8.8693140404540050e-01 2.2990301094230472e-02 + 8.8773831265991976e-01 2.3091454041301872e-02 + 8.8853681700965292e-01 2.3180535387474322e-02 + 8.8932395577641465e-01 2.3255505191546316e-02 + 8.9009736581259047e-01 2.3316335375571148e-02 + 8.8227212711432434e-01 -1.4641686600297753e-02 + 8.8070434213849269e-01 -1.3377873647133142e-02 + 8.7879321358374185e-01 -1.1675253191500368e-02 + 8.7666889916741142e-01 -9.3558229083866868e-03 + 8.7447206306986824e-01 -6.3863918941267413e-03 + 8.7242198650076452e-01 -2.8226736772609382e-03 + 8.7091527325928852e-01 1.2149511895573047e-03 + 8.7025835499064330e-01 5.4443712681380169e-03 + 8.7049203099966144e-01 9.4419794729866165e-03 + 8.7139517559799118e-01 1.2857029791076533e-02 + 8.7283601165133651e-01 1.5449494605034681e-02 + 8.7438550525887537e-01 1.7272070891605977e-02 + 8.7575901534440403e-01 1.8530952731778422e-02 + 8.7688536835594844e-01 1.9385173295700664e-02 + 8.7775950710758532e-01 1.9969330718845751e-02 + 8.7842025233170606e-01 2.0365572398548130e-02 + 8.7909402954599314e-01 2.0739361435010418e-02 + 8.7979467369505571e-01 2.1096981473923321e-02 + 8.8051725851266116e-01 2.1441788246732190e-02 + 8.8126427223127324e-01 2.1760198896614406e-02 + 8.8202584240444470e-01 2.2070140862182799e-02 + 8.8281382617151272e-01 2.2329242429669518e-02 + 8.8361521757641914e-01 2.2563715642170613e-02 + 8.8442608358515418e-01 2.2773927234190184e-02 + 8.8524526484742561e-01 2.2949744703665946e-02 + 8.8606680088958822e-01 2.3099703752840664e-02 + 8.8688650486968157e-01 2.3231625650537671e-02 + 8.8770198888965990e-01 2.3336747077233957e-02 + 8.8850889820320056e-01 2.3430306557671882e-02 + 8.8930419125223215e-01 2.3510822866452886e-02 + 8.9008539998799341e-01 2.3578668713954965e-02 + 8.8207551193346323e-01 -1.4866709830496710e-02 + 8.8047863055908837e-01 -1.3597236700107063e-02 + 8.7852909445075456e-01 -1.1887956924395232e-02 + 8.7637143490362035e-01 -9.5433963532582343e-03 + 8.7415428813647189e-01 -6.5285155952456188e-03 + 8.7210017088539526e-01 -2.9055684055628401e-03 + 8.7062160485202367e-01 1.2004884555496674e-03 + 8.6998939749787241e-01 5.4903513246869450e-03 + 8.7022697695960383e-01 9.5411058544310548e-03 + 8.7113036581060788e-01 1.3004350524192028e-02 + 8.7258488835337711e-01 1.5633617352273137e-02 + 8.7416183801016789e-01 1.7474061249581656e-02 + 8.7556060362432242e-01 1.8741420951878807e-02 + 8.7670585986754390e-01 1.9601451490908629e-02 + 8.7759362943709107e-01 2.0190145011311937e-02 + 8.7826381283165578e-01 2.0590420327145368e-02 + 8.7894666877819771e-01 2.0968826069679276e-02 + 8.7965611466404292e-01 2.1332051014052920e-02 + 8.8038725774011961e-01 2.1683429749540888e-02 + 8.8114211711989754e-01 2.2010476342498583e-02 + 8.8191212460802881e-01 2.2328267895806057e-02 + 8.8270895119629966e-01 2.2595214831694091e-02 + 8.8351994865767935e-01 2.2835957401282157e-02 + 8.8434096765559733e-01 2.3051052116079138e-02 + 8.8517047492558010e-01 2.3231366356666987e-02 + 8.8600246120507542e-01 2.3385436790063389e-02 + 8.8683262643814542e-01 2.3521212004196299e-02 + 8.8765840083402758e-01 2.3631095555283761e-02 + 8.8847539599569969e-01 2.3730028739039427e-02 + 8.8928047407824318e-01 2.3817200781902931e-02 + 8.9007104115284630e-01 2.3893465335066311e-02 + 8.8183957693945414e-01 -1.5136734017956954e-02 + 8.8020778036386671e-01 -1.3860468767690958e-02 + 8.7821215582083900e-01 -1.2143197917041351e-02 + 8.7601448266336612e-01 -9.7684814122468294e-03 + 8.7377296342557065e-01 -6.6990617067812517e-03 + 8.7171399742241029e-01 -3.0050407206499569e-03 + 8.7026920757737014e-01 1.1831334118383940e-03 + 8.6966665291558809e-01 5.5455266388164670e-03 + 8.6990891645652713e-01 9.6600558872223449e-03 + 8.7081259840670866e-01 1.3181132988968124e-02 + 8.7228354451245349e-01 1.5854561630668691e-02 + 8.7389344097825850e-01 1.7716446367978537e-02 + 8.7532251281276563e-01 1.8993979365868389e-02 + 8.7649045262412095e-01 1.9860981779780199e-02 + 8.7739457895175621e-01 2.0455118542549080e-02 + 8.7807608799610770e-01 2.0860234155583818e-02 + 8.7876983827250421e-01 2.1244179869706552e-02 + 8.7948984609819469e-01 2.1614130608764028e-02 + 8.8023125894417320e-01 2.1973395591754163e-02 + 8.8099553298865396e-01 2.2310805174836582e-02 + 8.8177566511652838e-01 2.2638016104740137e-02 + 8.8258310294524100e-01 2.2914377354081455e-02 + 8.8340562751696672e-01 2.3162643049400827e-02 + 8.8423882993540726e-01 2.3383597431544743e-02 + 8.8508072824539274e-01 2.3569307723674222e-02 + 8.8592525463838989e-01 2.3728311750764244e-02 + 8.8676797320357259e-01 2.3868710881464195e-02 + 8.8760609588182970e-01 2.3984308903716636e-02 + 8.8843519389592507e-01 2.4089690443370289e-02 + 8.8925201385824282e-01 2.4184849258052962e-02 + 8.9005381078609580e-01 2.4271216119951301e-02 + 8.8155645988936648e-01 -1.5460757386050118e-02 + 8.7988276580373448e-01 -1.4176341734256873e-02 + 8.7783183610461157e-01 -1.2449481761094505e-02 + 8.7558614745297336e-01 -1.0038578767643372e-02 + 8.7331538176103973e-01 -6.9037134677474498e-03 + 8.7125059735694521e-01 -3.1244054148631848e-03 + 8.6984633823030755e-01 1.1623077229680426e-03 + 8.6927936617813251e-01 5.6117358599202111e-03 + 8.6952725051602020e-01 9.8027934346366623e-03 + 8.7043128417911630e-01 1.3393268243199046e-02 + 8.7192193821631292e-01 1.6119690136137409e-02 + 8.7357137016272868e-01 1.8007303432229334e-02 + 8.7503680882674117e-01 1.9297044171731410e-02 + 8.7623196844466666e-01 2.0172412689385483e-02 + 8.7715572253929763e-01 2.0773081228987810e-02 + 8.7785082212615739e-01 2.1184005097232655e-02 + 8.7855764537020875e-01 2.1574598661270084e-02 + 8.7929032730244217e-01 2.1952620213017623e-02 + 8.8004406365710530e-01 2.2321348527779273e-02 + 8.8081963510204864e-01 2.2671193481909230e-02 + 8.8161191658547822e-01 2.3009707466390403e-02 + 8.8243208768045200e-01 2.3297365694685778e-02 + 8.8326844454306130e-01 2.3554658983291381e-02 + 8.8411626681091093e-01 2.3782644843434241e-02 + 8.8497303410935557e-01 2.3974830284457217e-02 + 8.8583260837583500e-01 2.4139754520560022e-02 + 8.8669039067653577e-01 2.4285702254309014e-02 + 8.8754333103495997e-01 2.4408157522241441e-02 + 8.8838695221842490e-01 2.4521276953879970e-02 + 8.8921786219050647e-01 2.4626019727411345e-02 + 8.9003313470696999e-01 2.4724509148201894e-02 + 8.8121672705305776e-01 -1.5849576702504056e-02 + 8.7949275708358854e-01 -1.4555380788279441e-02 + 8.7737546268638011e-01 -1.2817014126310167e-02 + 8.7507215673474015e-01 -1.0362688320932179e-02 + 8.7276629608535450e-01 -7.1492900701131358e-03 + 8.7069452975681128e-01 -3.2676398336762102e-03 + 8.6933890640087053e-01 1.1373174571554210e-03 + 8.6881463252204882e-01 5.6911851423668775e-03 + 8.6906926166487863e-01 9.9740746479072447e-03 + 8.6997371737399731e-01 1.3647824835886595e-02 + 8.7148802039827644e-01 1.6437837203293199e-02 + 8.7318489385680120e-01 1.8356324077120265e-02 + 8.7469397173697261e-01 1.9660713777805920e-02 + 8.7592179438980733e-01 2.0546121394739915e-02 + 8.7686910127630424e-01 2.1154627890610556e-02 + 8.7758050914816899e-01 2.1572521508781015e-02 + 8.7830301960135626e-01 2.1971092313595352e-02 + 8.7905091012017167e-01 2.2358798623284153e-02 + 8.7981943435342558e-01 2.2738882681349663e-02 + 8.8060856237471774e-01 2.3103649745853608e-02 + 8.8141542275763518e-01 2.3455727091499616e-02 + 8.8225087342920439e-01 2.3756941390301087e-02 + 8.8310382866844006e-01 2.4025067547745065e-02 + 8.8396919436190979e-01 2.4261490992158272e-02 + 8.8484380404605045e-01 2.4461446437447878e-02 + 8.8572143535553705e-01 2.4633474764995542e-02 + 8.8659729373321494e-01 2.4786080673001819e-02 + 8.8746801490883420e-01 2.4916764451088688e-02 + 8.8832906350445251e-01 2.5039169144709716e-02 + 8.8917688110878490e-01 2.5155412410801773e-02 + 8.9000832396874163e-01 2.5268448575809781e-02 + 8.8080905947282384e-01 -1.6316146350542116e-02 + 8.7902476019242659e-01 -1.5010214461863495e-02 + 8.7682783046717494e-01 -1.3258040173762224e-02 + 8.7445538576066628e-01 -1.0751608505237228e-02 + 8.7210741238373990e-01 -7.4439734463789481e-03 + 8.7002726798884233e-01 -3.4395161514106940e-03 + 8.6873000586507843e-01 1.1073300078478221e-03 + 8.6825696830832122e-01 5.7865215162999266e-03 + 8.6851969098242054e-01 1.0179606142935690e-02 + 8.6942465313205364e-01 1.3953283888087814e-02 + 8.7096733411780336e-01 1.6819602611735967e-02 + 8.7272113573977994e-01 1.8775136704444917e-02 + 8.7428257916062579e-01 2.0097104648702357e-02 + 8.7554959631857499e-01 2.0994558835351507e-02 + 8.7652516573564143e-01 2.1612470606017939e-02 + 8.7725614298196419e-01 2.2038727681514162e-02 + 8.7799747754017166e-01 2.2446870897678748e-02 + 8.7876361783359191e-01 2.2846198579797115e-02 + 8.7954988700650694e-01 2.3239909134629085e-02 + 8.8035528244757288e-01 2.3622582212310075e-02 + 8.8117963700256674e-01 2.3990935119284931e-02 + 8.8203342263432527e-01 2.4308416230943083e-02 + 8.8290629534780962e-01 2.4589541454004715e-02 + 8.8379271254145519e-01 2.4836089705884981e-02 + 8.8468873246751045e-01 2.5045368885897507e-02 + 8.8558803160013722e-01 2.5225921875942824e-02 + 8.8648558064116079e-01 2.5386517361254645e-02 + 8.8737763817863347e-01 2.5527075065217921e-02 + 8.8825959906229490e-01 2.5660621750091539e-02 + 8.8912770523698847e-01 2.5790665207010531e-02 + 8.8997855194632269e-01 2.5921156958817752e-02 + 8.8031987680226087e-01 -1.6876008840220072e-02 + 8.7846318507558463e-01 -1.5555994312514386e-02 + 8.7617069655600399e-01 -1.3787251497198184e-02 + 8.7371528846861024e-01 -1.1218295148001907e-02 + 8.7131678172210425e-01 -7.7975801788078610e-03 + 8.6922658402618902e-01 -3.6457599642195754e-03 + 8.6799935274325601e-01 1.0713464240512968e-03 + 8.6758779645719730e-01 5.9009208559755210e-03 + 8.6786023100297915e-01 1.0426234647338259e-02 + 8.6876580085832811e-01 1.4319820944548600e-02 + 8.7034253411521090e-01 1.7277703846864365e-02 + 8.7216464696031126e-01 1.9277692927722617e-02 + 8.7378892666309771e-01 2.0620753969808451e-02 + 8.7510297545573457e-01 2.1532663495648263e-02 + 8.7611245863204656e-01 2.2161861170942029e-02 + 8.7686691824327845e-01 2.2598154017173574e-02 + 8.7763084087666221e-01 2.3017783694300496e-02 + 8.7841888007475921e-01 2.3431056498140975e-02 + 8.7922644237321557e-01 2.3841118233165867e-02 + 8.8005135798278888e-01 2.4245277717363962e-02 + 8.8089670475351989e-01 2.4633160562304315e-02 + 8.8177249150880566e-01 2.4970161114170632e-02 + 8.8266926429118786e-01 2.5266884628381652e-02 + 8.8358094233357654e-01 2.5525582191664169e-02 + 8.8450265358220992e-01 2.5746049431911392e-02 + 8.8542795312332512e-01 2.5936831631620912e-02 + 8.8635152997992117e-01 2.6107014248639978e-02 + 8.8726919018720851e-01 2.6259420217330399e-02 + 8.8817624487137914e-01 2.6406336788139837e-02 + 8.8906869641347297e-01 2.6552939850278501e-02 + 8.8994282686505899e-01 2.6704377517323338e-02 + 8.7973288642927372e-01 -1.7547810830424941e-02 + 8.7778932803370135e-01 -1.6210897966007984e-02 + 8.7538217459302059e-01 -1.4422273894498398e-02 + 8.7282721533829244e-01 -1.1778291613552811e-02 + 8.7036807152655771e-01 -8.2218874166957289e-03 + 8.6826581046204265e-01 -3.8932403839304739e-03 + 8.6712261206060481e-01 1.0281682443339425e-03 + 8.6678482967573189e-01 6.0381933210993909e-03 + 8.6706891789511464e-01 1.0722174316744404e-02 + 8.6797521696154578e-01 1.4759643809226201e-02 + 8.6959281093681484e-01 1.7827398329251929e-02 + 8.7149689322348134e-01 1.9880730775774600e-02 + 8.7319657276120133e-01 2.1249102292053585e-02 + 8.7456705674340285e-01 2.2178357372965959e-02 + 8.7561723443203587e-01 2.2821097468650825e-02 + 8.7639987149708087e-01 2.3269432648299119e-02 + 8.7719089848941512e-01 2.3702845401609905e-02 + 8.7800521508239171e-01 2.4132851529524216e-02 + 8.7883832787658978e-01 2.4562533717153993e-02 + 8.7968666653786431e-01 2.4992475622734010e-02 + 8.8055720273025695e-01 2.5403793242165174e-02 + 8.8145938953704028e-01 2.5764215971828836e-02 + 8.8238484099345282e-01 2.6079656516177267e-02 + 8.8332683056550199e-01 2.6352932536990802e-02 + 8.8427936988706102e-01 2.6586824790126137e-02 + 8.8523586838585999e-01 2.6789881438592695e-02 + 8.8619067708715837e-01 2.6971568048591472e-02 + 8.8713905898924350e-01 2.7138191236662980e-02 + 8.8807622475504910e-01 2.7301150882559536e-02 + 8.8899788930313040e-01 2.7467624494993195e-02 + 8.8989995887314222e-01 2.7644196025775211e-02 + 1.1390704922475303e+00 -1.3891915989195952e-01 + 1.1388135416174567e+00 -1.3839472180517201e-01 + 1.1385282645105110e+00 -1.3780045405587918e-01 + 1.1382101481564137e+00 -1.3712814501242720e-01 + 1.1378531127641860e+00 -1.3636902771163903e-01 + 1.1374485191922949e+00 -1.3551411951076020e-01 + 1.1369835351963014e+00 -1.3455487001028890e-01 + 1.1364372053971830e+00 -1.3348552947469727e-01 + 1.1357748821061375e+00 -1.3230654531305466e-01 + 1.1349536238181672e+00 -1.3102436808606044e-01 + 1.1339327368768171e+00 -1.2965363862672205e-01 + 1.1325914955550922e+00 -1.2827636233424899e-01 + 1.1310849957549274e+00 -1.2674155752742566e-01 + 1.1294360572393916e+00 -1.2499577496947867e-01 + 1.1276749126127601e+00 -1.2298119255602698e-01 + 1.1256935147707501e+00 -1.2075985758595309e-01 + 1.1234116441626469e+00 -1.1837038468925490e-01 + 1.1208170135396482e+00 -1.1579317167704060e-01 + 1.1179029855485965e+00 -1.1300096442360333e-01 + 1.1146582291256795e+00 -1.0997079183096142e-01 + 1.1110684079158215e+00 -1.0668448927762698e-01 + 1.1071273991715591e+00 -1.0311816235231676e-01 + 1.1028314937914090e+00 -9.9250394968266764e-02 + 1.0981691935846576e+00 -9.5075714103985784e-02 + 1.0931327410661702e+00 -9.0593601930068046e-02 + 1.0877220240542091e+00 -8.5805969660313189e-02 + 1.0819443263375552e+00 -8.0718815342785188e-02 + 1.0758096359984455e+00 -7.5348890137533125e-02 + 1.0693352753525991e+00 -6.9719536150758002e-02 + 1.0625460555285058e+00 -6.3860902706709077e-02 + 1.0554742192128359e+00 -5.7809697397389934e-02 + 1.0481575506925080e+00 -5.1610406879505494e-02 + 1.0406340725855012e+00 -4.5319997967096341e-02 + 1.0329334978448521e+00 -3.9016303427018791e-02 + 1.0250769353069402e+00 -3.2797167660019347e-02 + 1.0171086053591192e+00 -2.6738908704858122e-02 + 1.0090653371918281e+00 -2.0930597688889968e-02 + 1.0010028212677486e+00 -1.5435552719795098e-02 + 9.9301489452171399e-01 -1.0251879459362215e-02 + 9.8522409926690702e-01 -5.3128368764150296e-03 + 9.7767746114736886e-01 -6.4995433047143614e-04 + 9.7038299550749429e-01 3.6583550650333045e-03 + 9.6337438416301469e-01 7.5916222301215339e-03 + 9.5667653740388114e-01 1.1132511897804259e-02 + 9.5030931679619879e-01 1.4272819526217801e-02 + 9.4428743915033631e-01 1.7012251011179379e-02 + 9.3861015982061724e-01 1.9331293288131046e-02 + 9.3329980135200641e-01 2.1282214278711624e-02 + 9.2836935191326986e-01 2.2921216929516472e-02 + 9.2381959092596799e-01 2.4294523331034913e-02 + 9.1964285281883296e-01 2.5439942219163708e-02 + 9.1582407686959688e-01 2.6383838501095401e-02 + 9.1234775509564980e-01 2.7158269425554011e-02 + 9.0918801044913411e-01 2.7752124093636376e-02 + 9.0631611744285745e-01 2.8110087808860602e-02 + 9.0372247427748165e-01 2.8269831423491824e-02 + 9.0139454011186682e-01 2.8289355699462004e-02 + 8.9931247811808634e-01 2.8222412638248536e-02 + 8.9745355717635222e-01 2.8120054630916280e-02 + 8.9579477144044717e-01 2.8020854489112283e-02 + 8.9431461132097356e-01 2.7935676586123618e-02 + 8.9299563686370587e-01 2.7880433111395379e-02 + 8.9182153123776831e-01 2.7847907374122512e-02 + 1.1375887423676898e+00 -1.3911583971070413e-01 + 1.1373087669518342e+00 -1.3861140261085314e-01 + 1.1369966564516105e+00 -1.3804005764017258e-01 + 1.1366475732675878e+00 -1.3739390068370902e-01 + 1.1362553075842627e+00 -1.3666439715502027e-01 + 1.1358113803788277e+00 -1.3584271521691371e-01 + 1.1353036847781925e+00 -1.3492024846402825e-01 + 1.1347123941615613e+00 -1.3389136563973308e-01 + 1.1340061606097085e+00 -1.3275545392980451e-01 + 1.1331478232366490e+00 -1.3151550021841663e-01 + 1.1321022517009667e+00 -1.3018073623063209e-01 + 1.1307675410289912e+00 -1.2881632363798176e-01 + 1.1292695608970187e+00 -1.2729473848348949e-01 + 1.1276245719939118e+00 -1.2556899809685712e-01 + 1.1258546175645445e+00 -1.2358855901031969e-01 + 1.1238675440043129e+00 -1.2140160072222689e-01 + 1.1215938132759207e+00 -1.1903715287073309e-01 + 1.1190199390585556e+00 -1.1647616197514993e-01 + 1.1161370089181928e+00 -1.1369340211713717e-01 + 1.1129319404754106e+00 -1.1066769601973629e-01 + 1.1093885589076642e+00 -1.0738287483679156e-01 + 1.1054976706515391e+00 -1.0381849895931583e-01 + 1.1012526253630082e+00 -9.9956553661617653e-02 + 1.0966403765472210e+00 -9.5793385839987893e-02 + 1.0916513510214998e+00 -9.1330599676160362e-02 + 1.0862857731775475e+00 -8.6569887056090269e-02 + 1.0805525496849198e+00 -8.1515436141586142e-02 + 1.0744601961797597e+00 -7.6185548351891508e-02 + 1.0680250525413397e+00 -7.0604508505189997e-02 + 1.0612716407212111e+00 -6.4802528076490437e-02 + 1.0542331368745081e+00 -5.8814809652026505e-02 + 1.0469493111409309e+00 -5.2682939675270893e-02 + 1.0394599041144221e+00 -4.6461170621999150e-02 + 1.0317972303287741e+00 -4.0223451526723089e-02 + 1.0239852491546433e+00 -3.4063202328216649e-02 + 1.0160676448938128e+00 -2.8056151107129799e-02 + 1.0080823775279497e+00 -2.2288359718722641e-02 + 1.0000851717353789e+00 -1.6821091034580068e-02 + 9.9216482642909165e-01 -1.1658141888241529e-02 + 9.8443386675733424e-01 -6.7474946196823416e-03 + 9.7693837818041895e-01 -2.1220256063060753e-03 + 9.6969293021652148e-01 2.1505657308492575e-03 + 9.6273438486665441e-01 6.0560078437798381e-03 + 9.5608780175674857e-01 9.5782396447299089e-03 + 9.4977300305240031e-01 1.2710235560339060e-02 + 9.4380486044339085e-01 1.5453403638941224e-02 + 9.3818094388646478e-01 1.7786462536219391e-02 + 9.3292367498860795e-01 1.9762642325187846e-02 + 9.2804387515354492e-01 2.1433206825276017e-02 + 9.2354110973822157e-01 2.2840899576242218e-02 + 9.1940702591595613e-01 2.4020822013828477e-02 + 9.1562509914141399e-01 2.4993334732887569e-02 + 9.1218160306319429e-01 2.5794456239350210e-02 + 9.0905195341510681e-01 2.6418882867421854e-02 + 9.0620816589781183e-01 2.6820318733843950e-02 + 9.0363932531105828e-01 2.7033389970665241e-02 + 9.0133261023863409e-01 2.7113954921443428e-02 + 8.9926762226005230e-01 2.7105647652508412e-02 + 8.9742267702111134e-01 2.7054366208322196e-02 + 8.9577590348095892e-01 2.6998069266970109e-02 + 8.9430596747221935e-01 2.6939668745786641e-02 + 8.9299629588966911e-01 2.6903295163684515e-02 + 8.9183048184172431e-01 2.6877786886283492e-02 + 1.1363615585449720e+00 -1.3928329683404828e-01 + 1.1360625037894445e+00 -1.3879543282046894e-01 + 1.1357281574476226e+00 -1.3824308236692276e-01 + 1.1353534124979165e+00 -1.3761859634338294e-01 + 1.1349319510482037e+00 -1.3691363293611003e-01 + 1.1344554263441806e+00 -1.3611948554521824e-01 + 1.1339123321057898e+00 -1.3522750169072895e-01 + 1.1332837765352977e+00 -1.3423214869305899e-01 + 1.1325411456338905e+00 -1.3313193560991765e-01 + 1.1316520685628122e+00 -1.3192697939704628e-01 + 1.1305860255291023e+00 -1.3062202922413810e-01 + 1.1292567100732975e+00 -1.2926828707540108e-01 + 1.1277657714094911e+00 -1.2775766899286695e-01 + 1.1261240336224057e+00 -1.2604855226086514e-01 + 1.1243467509411202e+00 -1.2409642754844769e-01 + 1.1223549421147991e+00 -1.2193798102897388e-01 + 1.1200879235509773e+00 -1.1959429701125465e-01 + 1.1175312162939464e+00 -1.1704677577674316e-01 + 1.1146740232262677e+00 -1.1427187162707567e-01 + 1.1115018113274959e+00 -1.1124989335250333e-01 + 1.1079968826673872e+00 -1.0796632585469972e-01 + 1.1041474982470347e+00 -1.0440359364496730e-01 + 1.0999445689019041e+00 -1.0054650279860318e-01 + 1.0953737637575602e+00 -9.6392910422405720e-02 + 1.0904240027747170e+00 -9.1946182361976297e-02 + 1.0850957884114441e+00 -8.7207830618462975e-02 + 1.0793993728793214e+00 -8.2180543722180144e-02 + 1.0733420490859789e+00 -7.6883911621176346e-02 + 1.0669393402089173e+00 -7.1343004331549428e-02 + 1.0602155265707136e+00 -6.5588088189227206e-02 + 1.0532045578757130e+00 -5.9653119551666134e-02 + 1.0459478525551580e+00 -5.3577279138533870e-02 + 1.0384865784313975e+00 -4.7412566401442632e-02 + 1.0308552128007304e+00 -4.1229704048477631e-02 + 1.0230800866664163e+00 -3.5118433824545152e-02 + 1.0152044432921561e+00 -2.9153989802520864e-02 + 1.0072671872087990e+00 -2.3419928242416403e-02 + 9.9932407668841106e-01 -1.7975797891791365e-02 + 9.9145972606496424e-01 -1.2830122458437166e-02 + 9.8377833134041748e-01 -7.9431274335615039e-03 + 9.7632519413279806e-01 -3.3488131623028296e-03 + 9.6912033520884155e-01 8.9403129558875930e-04 + 9.6220326358829189e-01 4.7762923765490078e-03 + 9.5559916476842877e-01 8.2829722874336268e-03 + 9.4932782942552441e-01 1.1408029736985143e-02 + 9.4340425912084891e-01 1.4154292697562954e-02 + 9.3782462119838328e-01 1.6499010520136602e-02 + 9.3261141957709415e-01 1.8496216412487946e-02 + 9.2777367090582064e-01 2.0193062909535368e-02 + 9.2330992837762038e-01 2.1629396811961007e-02 + 9.1921126538069020e-01 2.2838064090294971e-02 + 9.1545993654788715e-01 2.3834422889792362e-02 + 9.1204369798311513e-01 2.4657789618545034e-02 + 9.0893904113479229e-01 2.5307697492579731e-02 + 9.0611859815477469e-01 2.5745364390211720e-02 + 9.0357035865174018e-01 2.6002880750845444e-02 + 9.0128126642150852e-01 2.6134320337207050e-02 + 8.9923045414118941e-01 2.6174886714529218e-02 + 8.9739710875095380e-01 2.6166182145346453e-02 + 8.9576030409650009e-01 2.6145652457743435e-02 + 8.9429885158367972e-01 2.6109581718409342e-02 + 8.9299689994749398e-01 2.6088947856972144e-02 + 8.9183796680057548e-01 2.6069301186224875e-02 + 1.1353456595274298e+00 -1.3942511426641724e-01 + 1.1350308028963616e+00 -1.3895097781298357e-01 + 1.1346780399223384e+00 -1.3841436092892123e-01 + 1.1342820402131155e+00 -1.3780782584626805e-01 + 1.1338363960669879e+00 -1.3712319063817954e-01 + 1.1333328699089362e+00 -1.3635185271240979e-01 + 1.1327604524570636e+00 -1.3548512176998811e-01 + 1.1321010257006008e+00 -1.3451754718094164e-01 + 1.1313282395870208e+00 -1.3344691113790855e-01 + 1.1304136905205284e+00 -1.3227095389133700e-01 + 1.1293306777815171e+00 -1.3099071179319002e-01 + 1.1280058166560574e+00 -1.2964582300652841e-01 + 1.1265206941248220e+00 -1.2814430616247000e-01 + 1.1248816301925890e+00 -1.2644897922487675e-01 + 1.1230982535583847e+00 -1.2452033306721118e-01 + 1.1211024948029751e+00 -1.2238553314176780e-01 + 1.1188410068234287e+00 -1.2005908075496929e-01 + 1.1162984894191048e+00 -1.1752275125360989e-01 + 1.1134625850258311e+00 -1.1475439022753069e-01 + 1.1103175596880444e+00 -1.1173553701264974e-01 + 1.1068444542955396e+00 -1.0845304622947080e-01 + 1.1030294209059279e+00 -1.0489171579677879e-01 + 1.0988613490283505e+00 -1.0103869017991933e-01 + 1.0943248427759904e+00 -9.6893079266394969e-02 + 1.0894075720158272e+00 -9.2459710944155879e-02 + 1.0841102687552735e+00 -8.7739949907159970e-02 + 1.0784443003013680e+00 -8.2735242725501895e-02 + 1.0724159445075161e+00 -7.7466250032386857e-02 + 1.0660400457619705e+00 -7.1958695724135449e-02 + 1.0593406824364608e+00 -6.6242894498032820e-02 + 1.0523524449280290e+00 -6.0351771202221773e-02 + 1.0451181192800671e+00 -5.4322511646333699e-02 + 1.0376800586571169e+00 -4.8205245619682369e-02 + 1.0300745379086456e+00 -4.2068016148668036e-02 + 1.0223298609136982e+00 -3.5997507599317358e-02 + 1.0144889085106505e+00 -3.0068540001892279e-02 + 1.0065913743169841e+00 -2.4362583332788727e-02 + 9.9869304914084644e-01 -1.8937756414246529e-02 + 9.9087507258390073e-01 -1.3806507559252546e-02 + 9.8323471640956850e-01 -8.9392408578706801e-03 + 9.7581662870386754e-01 -4.3708944203476223e-03 + 9.6864536335966245e-01 -1.5284791361151279e-04 + 9.6176263237794601e-01 3.7100775007770062e-03 + 9.5519372742059971e-01 7.2037715030004723e-03 + 9.4895841412284732e-01 1.0323014697412536e-02 + 9.4307180299085525e-01 1.3071819645347064e-02 + 9.3752889423942465e-01 1.5426215127369742e-02 + 9.3235226017587713e-01 1.7440904805915994e-02 + 9.2754941430494864e-01 1.9159619342779800e-02 + 9.2311806596535695e-01 2.0619793416571438e-02 + 9.1904880943861822e-01 2.1852393963314353e-02 + 9.1532288116370464e-01 2.2868611442142108e-02 + 9.1192927060521400e-01 2.3710507565070295e-02 + 9.0884536418329143e-01 2.4381643911070217e-02 + 9.0604430667797642e-01 2.4849497927128539e-02 + 9.0351317444736912e-01 2.5144048346987812e-02 + 9.0123871476058381e-01 2.5317882419358301e-02 + 8.9919966873652313e-01 2.5399179327358495e-02 + 8.9737594848992130e-01 2.5425961057834543e-02 + 8.9574741455183149e-01 2.5435245042956866e-02 + 8.9429299909904170e-01 2.5417791442088316e-02 + 8.9299745191700841e-01 2.5410283141007621e-02 + 8.9184422730970225e-01 2.5395529860430768e-02 + 1.1345050400264316e+00 -1.3954464954153908e-01 + 1.1341771026274781e+00 -1.3908187943379496e-01 + 1.1338090939560428e+00 -1.3855829013299734e-01 + 1.1333954985075541e+00 -1.3796661901975590e-01 + 1.1329298339698382e+00 -1.3729881675147385e-01 + 1.1324039528195113e+00 -1.3654636711489465e-01 + 1.1318072568155566e+00 -1.3570054883875995e-01 + 1.1311222680924486e+00 -1.3475597961087191e-01 + 1.1303245104097996e+00 -1.3370984032865316e-01 + 1.1293888643227998e+00 -1.3255790402562306e-01 + 1.1282917910413039e+00 -1.3129813335422710e-01 + 1.1269706050812820e+00 -1.2996059194995863e-01 + 1.1254902835984375e+00 -1.2846663016191562e-01 + 1.1238534168479699e+00 -1.2678274335013967e-01 + 1.1220649742167712e+00 -1.2487356400186519e-01 + 1.1200659212037440e+00 -1.2275837474110153e-01 + 1.1178089866769734e+00 -1.2044622519536950e-01 + 1.1152781913952150e+00 -1.1791920057782920e-01 + 1.1124598864856965e+00 -1.1515629798373440e-01 + 1.1093373443168295e+00 -1.1214007524046601e-01 + 1.1058905620278214e+00 -1.0885852093236204e-01 + 1.1021039451932624e+00 -1.0529839890708090e-01 + 1.0979647087546736e+00 -1.0144879133676810e-01 + 1.0934565740657876e+00 -9.7309846991369797e-02 + 1.0885661742821364e+00 -9.2887606758130264e-02 + 1.0832944307594392e+00 -8.8183314893189729e-02 + 1.0776536345090977e+00 -8.3197389898729587e-02 + 1.0716492209823723e+00 -7.7951381835507497e-02 + 1.0652954705127009e+00 -7.2471559028717200e-02 + 1.0586162926414020e+00 -6.6788278754334435e-02 + 1.0516468081449986e+00 -6.0933612439857489e-02 + 1.0444309373885245e+00 -5.4943092169682843e-02 + 1.0370120177071909e+00 -4.8865296574420777e-02 + 1.0294278176337153e+00 -4.2766043451148490e-02 + 1.0217082819597569e+00 -3.6729476162578122e-02 + 1.0138959940468328e+00 -3.0830067418807078e-02 + 1.0060313068111495e+00 -2.5147550003427051e-02 + 9.9817004220865024e-01 -1.9738849654376049e-02 + 9.9039045533658676e-01 -1.4619672084551592e-02 + 9.8278406273989616e-01 -9.7688818519988847e-03 + 9.7539496759150657e-01 -5.2221994132696905e-03 + 9.6825149277921785e-01 -1.0248441194293946e-03 + 9.6139718352949755e-01 2.8219346203840760e-03 + 9.5485742110348382e-01 6.3047673411050281e-03 + 9.4865195133433267e-01 9.4191210689575661e-03 + 9.4279597615348942e-01 1.2169996704513563e-02 + 9.3728352471168463e-01 1.4532409335777699e-02 + 9.3213722613063510e-01 1.6561622366437864e-02 + 9.2736334204160775e-01 1.8298518648172307e-02 + 9.2295887823772327e-01 1.9778524371545207e-02 + 9.1891402890239604e-01 2.1031041045091042e-02 + 9.1520918124709394e-01 2.2063786957758225e-02 + 9.1183435073096786e-01 2.2921108860273487e-02 + 9.0876766827443078e-01 2.3609923085117782e-02 + 9.0598270488520805e-01 2.4102921573102953e-02 + 9.0346577537075945e-01 2.4428324493044100e-02 + 9.0120346245617289e-01 2.4637480859013107e-02 + 8.9917418025005558e-01 2.4752717141254123e-02 + 8.9735844437552958e-01 2.4809071339831186e-02 + 8.9573677028371979e-01 2.4843202935798891e-02 + 8.9428819031882778e-01 2.4841268217699441e-02 + 8.9299795470921528e-01 2.4844703018352739e-02 + 8.9184946465228920e-01 2.4834032731431775e-02 + 1.1338097413459109e+00 -1.3964498842008130e-01 + 1.1334709808034806e+00 -1.3919162632245285e-01 + 1.1330903573128757e+00 -1.3867882027785616e-01 + 1.1326622020226065e+00 -1.3809945276563984e-01 + 1.1321799706514528e+00 -1.3744558436648477e-01 + 1.1316355898978760e+00 -1.3670877060705330e-01 + 1.1310188012935061e+00 -1.3588026490635610e-01 + 1.1303126562918058e+00 -1.3495474185457537e-01 + 1.1294942288318426e+00 -1.3392888520922358e-01 + 1.1285411169013300e+00 -1.3279684051252150e-01 + 1.1274323983926999e+00 -1.3155402701301969e-01 + 1.1261142429073367e+00 -1.3022258443610721e-01 + 1.1246378822587126e+00 -1.2873489586504649e-01 + 1.1230028195084234e+00 -1.2706050069058486e-01 + 1.1212101666216847e+00 -1.2516746046160646e-01 + 1.1192083666373664e+00 -1.2306853403698366e-01 + 1.1169551783166789e+00 -1.2076825824127774e-01 + 1.1144340612713375e+00 -1.1824897417216447e-01 + 1.1116302985618893e+00 -1.1549063156164883e-01 + 1.1085263407826798e+00 -1.1247663085797774e-01 + 1.1051013216839320e+00 -1.0919589904259634e-01 + 1.1013382011485713e+00 -1.0563682772984147e-01 + 1.0972228073832395e+00 -1.0179010418145341e-01 + 1.0927381303158274e+00 -9.7656738405938540e-02 + 1.0878699436320580e+00 -9.3243777379364234e-02 + 1.0826193247595139e+00 -8.8552367041067323e-02 + 1.0769993295576004e+00 -8.3582075259319447e-02 + 1.0710146945503900e+00 -7.8355190766564456e-02 + 1.0646792314407387e+00 -7.2898435115525642e-02 + 1.0580167085962227e+00 -6.7242203018074737e-02 + 1.0510626856427909e+00 -6.1417860103268031e-02 + 1.0438620234623250e+00 -5.5459567963060695e-02 + 1.0364588763186058e+00 -4.9414618598010947e-02 + 1.0288922536760823e+00 -4.3346982279799641e-02 + 1.0211934649438594e+00 -3.7338690789301035e-02 + 1.0134048495894685e+00 -3.1463925265545305e-02 + 1.0055673114516224e+00 -2.5800971940075888e-02 + 9.9773670199278985e-01 -2.0405760900178881e-02 + 9.8998888237749816e-01 -1.5296700647301193e-02 + 9.8241058640165857e-01 -1.0459686798771262e-02 + 9.7504546286906513e-01 -5.9310924497595506e-03 + 9.6792496785458815e-01 -1.7510158560325145e-03 + 9.6109417196198044e-01 2.0822654242612167e-03 + 9.5457853211078803e-01 5.5560004824833607e-03 + 9.4839777856938567e-01 8.6662297153433359e-03 + 9.4256719001796696e-01 1.1418778687057051e-02 + 9.3707998775883083e-01 1.3787820796535658e-02 + 9.3195884810800089e-01 1.5829086793714076e-02 + 9.2720899013869862e-01 1.7581089668388714e-02 + 9.2282683306743152e-01 1.9077583281918851e-02 + 9.1880223692404595e-01 2.0346664981615515e-02 + 9.1511488059558110e-01 2.1393160366556363e-02 + 9.1175563293969553e-01 2.2263317933379101e-02 + 9.0870324413252213e-01 2.2966847619712780e-02 + 9.0593163952346578e-01 2.3480785098896693e-02 + 9.0342649885813886e-01 2.3831886094469779e-02 + 9.0117426706366088e-01 2.4070468193414414e-02 + 8.9915308511648939e-01 2.4213981438549328e-02 + 8.9734397085672235e-01 2.4294976786755611e-02 + 8.9572798492229200e-01 2.4349814552153109e-02 + 8.9428424271549856e-01 2.4360813923188510e-02 + 8.9299841111851974e-01 2.4373370415623322e-02 + 8.9185384676739776e-01 2.4366105365073162e-02 + 1.1332348373879437e+00 -1.3972891854758590e-01 + 1.1328871252535988e+00 -1.3928334127474643e-01 + 1.1324960679657010e+00 -1.3877945821584947e-01 + 1.1320558696817293e+00 -1.3821027202651126e-01 + 1.1315599346613947e+00 -1.3756793440917531e-01 + 1.1310002507398766e+00 -1.3684406047413097e-01 + 1.1303668401852052e+00 -1.3602988299866786e-01 + 1.1296431919441561e+00 -1.3512012398073500e-01 + 1.1288076618878189e+00 -1.3411105634804438e-01 + 1.1278400956415746e+00 -1.3299547976201451e-01 + 1.1267217357341175e+00 -1.3176670970994869e-01 + 1.1254060778430921e+00 -1.3044033053595980e-01 + 1.1239329832475389e+00 -1.2895785208612953e-01 + 1.1222994006137026e+00 -1.2729133260965675e-01 + 1.1205032495015890e+00 -1.2541167178791376e-01 + 1.1184991592503717e+00 -1.2332623152449917e-01 + 1.1162490510447345e+00 -1.2103581440747399e-01 + 1.1137359209951481e+00 -1.1852297275988387e-01 + 1.1109441691106965e+00 -1.1576844413991309e-01 + 1.1078555666643004e+00 -1.1275632586439284e-01 + 1.1044485335053298e+00 -1.0947632120193401e-01 + 1.1007048332494969e+00 -1.0591816909168483e-01 + 1.0966091461182919e+00 -1.0207388595318369e-01 + 1.0921438561908947e+00 -9.7945195581626190e-02 + 1.0872940248185297e+00 -9.3539979226132303e-02 + 1.0820608579895508e+00 -8.8859302679944796e-02 + 1.0764580446550718e+00 -8.3902030253220586e-02 + 1.0704897415812353e+00 -7.8691064020128459e-02 + 1.0641693711778972e+00 -7.3253502787403765e-02 + 1.0575205837433179e+00 -6.7619774127018528e-02 + 1.0505793018708447e+00 -6.1820660151490771e-02 + 1.0433911660519517e+00 -5.5889186958858098e-02 + 1.0360010085098899e+00 -4.9871579529230013e-02 + 1.0284488694865062e+00 -4.3830274420914465e-02 + 1.0207671931058051e+00 -3.7845548856073934e-02 + 1.0129981190714363e+00 -3.1991339054150102e-02 + 1.0051830116252753e+00 -2.6344726678834456e-02 + 9.9737774990257666e-01 -2.0960810803364233e-02 + 9.8965620868855053e-01 -1.5860241956891133e-02 + 9.8210114773603829e-01 -1.1034758018969594e-02 + 9.7475583696274348e-01 -6.5212764857033034e-03 + 9.6765433674995205e-01 -2.3556389090124193e-03 + 9.6084298682236713e-01 1.4663496986781473e-03 + 9.5434730800936662e-01 4.9324549427296844e-03 + 9.4818701842281894e-01 8.0391962201861178e-03 + 9.4237746118739618e-01 1.0793087231204477e-02 + 9.3691118559842679e-01 1.3167602633698403e-02 + 9.3181090717205972e-01 1.5218863404596649e-02 + 9.2708097677326373e-01 1.6983410533958777e-02 + 9.2271732455740152e-01 1.8493605494440190e-02 + 9.1870953145280621e-01 1.9776459131533607e-02 + 9.1503668553097839e-01 2.0834387144744355e-02 + 9.1169036542278459e-01 2.1715220644842322e-02 + 9.0864983633637519e-01 2.2430995767961499e-02 + 9.0588931816889418e-01 2.2962366451962951e-02 + 9.0339396107537262e-01 2.3334868924741594e-02 + 9.0115009456333417e-01 2.3597961608700320e-02 + 8.9913563145942998e-01 2.3765031582911090e-02 + 8.9733200750386755e-01 2.3866556920154190e-02 + 8.9572073714942746e-01 2.3938647845341467e-02 + 8.9428100465535976e-01 2.3960425491083414e-02 + 8.9299882378266793e-01 2.3980584105649325e-02 + 8.9185751376822908e-01 2.3976157907452847e-02 + 1.1327595973272520e+00 -1.3979891996113497e-01 + 1.1324044837147917e+00 -1.3935978305748675e-01 + 1.1320047991080100e+00 -1.3886328212255800e-01 + 1.1315546425249638e+00 -1.3830251933046706e-01 + 1.1310473754997479e+00 -1.3766972191247451e-01 + 1.1304750362023042e+00 -1.3695655446825653e-01 + 1.1298278787816942e+00 -1.3615423296867818e-01 + 1.1290897536672346e+00 -1.3525751891840487e-01 + 1.1282400765209624e+00 -1.3426234586282210e-01 + 1.1272605514980931e+00 -1.3316040080562216e-01 + 1.1261342113087636e+00 -1.3194325963463929e-01 + 1.1248206110496628e+00 -1.3062108499374897e-01 + 1.1233502086149789e+00 -1.2914293469360444e-01 + 1.1217178396954139e+00 -1.2748295073382124e-01 + 1.1199187825051560e+00 -1.2561438124635060e-01 + 1.1179127830077942e+00 -1.2354012462243673e-01 + 1.1156652060411623e+00 -1.2125789430233032e-01 + 1.1131586650057248e+00 -1.1875041692092757e-01 + 1.1103768300507455e+00 -1.1599908139143443e-01 + 1.1073009110647616e+00 -1.1298856120750010e-01 + 1.1039087377816166e+00 -1.0970920165595692e-01 + 1.1001810842081516e+00 -1.0615185660576885e-01 + 1.0961016804629782e+00 -1.0230964289088355e-01 + 1.0916524089068442e+00 -9.8184875777261524e-02 + 1.0868177406205126e+00 -9.3786128194833257e-02 + 1.0815989874394802e+00 -8.9114400679346284e-02 + 1.0760103622133750e+00 -8.4167975790416558e-02 + 1.0700555408786416e+00 -7.8970264801678666e-02 + 1.0637476224906164e+00 -7.3548680503673039e-02 + 1.0571101585893945e+00 -6.7933679253381521e-02 + 1.0501793718833929e+00 -6.2155560858324334e-02 + 1.0430015489655329e+00 -5.6246410786096247e-02 + 1.0356220846014479e+00 -5.0251569230319260e-02 + 1.0280818751441643e+00 -4.4232199666798144e-02 + 1.0204143081860932e+00 -3.8267121510037867e-02 + 1.0126613599422198e+00 -3.2430065158628008e-02 + 1.0048647794319265e+00 -2.6797109186111976e-02 + 9.9708047149063661e-01 -2.1422658985690800e-02 + 9.8938066293861748e-01 -1.6329224550579769e-02 + 9.8184481177349447e-01 -1.1513397697617425e-02 + 9.7451587196085854e-01 -7.0125500100078255e-03 + 9.6743006838927403e-01 -2.8589851036754052e-03 + 9.6063479663637752e-01 9.5354904916775791e-04 + 9.5415563152712624e-01 4.4132493993880445e-03 + 9.4801228173905694e-01 7.5170355422754763e-03 + 9.4222014451788016e-01 1.0271995412890266e-02 + 9.3677121018571796e-01 1.2651023675855329e-02 + 9.3168822681695340e-01 1.4710567153562028e-02 + 9.2697482227994643e-01 1.6485525976809908e-02 + 9.2262651896964798e-01 1.8007102332253836e-02 + 9.1863266468293281e-01 1.9301401892923332e-02 + 9.1497185468219389e-01 2.0368832681220039e-02 + 9.1163625788148150e-01 2.1258542764484318e-02 + 9.0860556781070434e-01 2.1984505200761898e-02 + 9.0585424919246393e-01 2.2530387819123341e-02 + 9.0336701054211876e-01 2.2920711340055622e-02 + 9.0113008468144751e-01 2.3204218507899044e-02 + 8.9912119385166334e-01 2.3390911219791689e-02 + 8.9732212151791491e-01 2.3509539838712835e-02 + 8.9571475987516502e-01 2.3596005495506080e-02 + 8.9427835025845948e-01 2.3626763868954424e-02 + 8.9299919520946136e-01 2.3653257265903740e-02 + 8.9186058257322409e-01 2.3651196956106638e-02 + 1.1323667924002823e+00 -1.3985716915798729e-01 + 1.1320055600304963e+00 -1.3942335983162338e-01 + 1.1315987430120755e+00 -1.3893296563759250e-01 + 1.1311403533267015e+00 -1.3837917115553366e-01 + 1.1306237170372091e+00 -1.3775426621948733e-01 + 1.1300409137426370e+00 -1.3704995653743759e-01 + 1.1293823890833852e+00 -1.3625744441357113e-01 + 1.1286322921130278e+00 -1.3537152428134924e-01 + 1.1277709144913295e+00 -1.3438784938631232e-01 + 1.1267814969097594e+00 -1.3329718704429039e-01 + 1.1256485523482760e+00 -1.3208967491213600e-01 + 1.1243366468976217e+00 -1.3077099225718167e-01 + 1.1228684631190093e+00 -1.2929643819714284e-01 + 1.1212370891319721e+00 -1.2764187828837067e-01 + 1.1194356180607010e+00 -1.2578250365379334e-01 + 1.1174280271225037e+00 -1.2371752175711286e-01 + 1.1151825297388631e+00 -1.2144209093338235e-01 + 1.1126814233751894e+00 -1.1893908164636881e-01 + 1.1099077750438633e+00 -1.1619042125593303e-01 + 1.1068423307951525e+00 -1.1318125957626232e-01 + 1.1034624326544529e+00 -1.0990247279438364e-01 + 1.0997480361005691e+00 -1.0634583727830151e-01 + 1.0956820850306572e+00 -1.0250538079002959e-01 + 1.0912460463708027e+00 -9.8383908664085945e-02 + 1.0864239021311315e+00 -9.3990567239468942e-02 + 1.0812170512669272e+00 -8.9326303962262002e-02 + 1.0756401401050795e+00 -8.4388920433931439e-02 + 1.0696964458327465e+00 -7.9202250633054236e-02 + 1.0633987989338169e+00 -7.3793968657307404e-02 + 1.0567706683378599e+00 -6.8194556016445015e-02 + 1.0498485248565046e+00 -6.2433913917368036e-02 + 1.0426791904807375e+00 -5.6543348682759106e-02 + 1.0353085267113802e+00 -5.0567466867369799e-02 + 1.0277781408995743e+00 -4.4566375245057799e-02 + 1.0201222050596945e+00 -3.8617682008853432e-02 + 1.0123825616772471e+00 -3.2794944553805418e-02 + 1.0046012813491090e+00 -2.7173406117006301e-02 + 9.9683429254962319e-01 -2.1806893008365448e-02 + 9.8915245499712690e-01 -1.6719457236040527e-02 + 9.8163248362371469e-01 -1.1911723194221246e-02 + 9.7431706891859826e-01 -7.4214412006096348e-03 + 9.6724423466892184e-01 -3.2779744400563923e-03 + 9.6046225485073178e-01 5.2664044472939913e-04 + 9.5399674990506256e-01 3.9809606433649494e-03 + 9.4786742123421008e-01 7.0822401253965647e-03 + 9.4208971153579069e-01 9.8380460215684810e-03 + 9.3665514619362933e-01 1.2220791602592209e-02 + 9.3158650032373247e-01 1.4287195779003132e-02 + 9.2688679973016375e-01 1.6070793384115059e-02 + 9.2255122683230883e-01 1.7601821402890062e-02 + 9.1856893469131662e-01 1.8905631398082993e-02 + 9.1491810750793146e-01 1.9980958805858876e-02 + 9.1159140509127734e-01 2.0878047549806475e-02 + 9.0856887717047419e-01 2.1612483441912585e-02 + 9.0582519195794997e-01 2.2170444746570501e-02 + 9.0334468967421255e-01 2.2575606543213125e-02 + 9.0111352214685692e-01 2.2876115415101150e-02 + 8.9910925240876383e-01 2.3079152796298893e-02 + 8.9731395325399010e-01 2.3212029028101523e-02 + 8.9570983129363269e-01 2.3310470407864520e-02 + 8.9427617517004099e-01 2.3348711057665134e-02 + 8.9299952783515657e-01 2.3380482571252807e-02 + 8.9186315078465839e-01 2.3380393460865956e-02 + 1.1320421197897752e+00 -1.3990555340054966e-01 + 1.1316758292174425e+00 -1.3947615122485688e-01 + 1.1312631158199777e+00 -1.3899080883639917e-01 + 1.1307979195298945e+00 -1.3844277905252761e-01 + 1.1302735369613988e+00 -1.3782440359894360e-01 + 1.1296820818103868e+00 -1.3712742233325298e-01 + 1.1290141578490624e+00 -1.3634302645563601e-01 + 1.1282541608200476e+00 -1.3546603784929787e-01 + 1.1273831064449062e+00 -1.3449187826890527e-01 + 1.1263855057167098e+00 -1.3341055486883371e-01 + 1.1252470955992395e+00 -1.3221101626730800e-01 + 1.1239365860782362e+00 -1.3089523435971515e-01 + 1.1224702306934229e+00 -1.2942366901727337e-01 + 1.1208396722341700e+00 -1.2777361140359980e-01 + 1.1190361962079627e+00 -1.2592186015831663e-01 + 1.1170272788513873e+00 -1.2386457074487332e-01 + 1.1147834898909239e+00 -1.2159478815583369e-01 + 1.1122868659926004e+00 -1.1909550153355004e-01 + 1.1095199757665035e+00 -1.1634908334511496e-01 + 1.1064631820334461e+00 -1.1334107717302011e-01 + 1.1030934237571253e+00 -1.1006279821624794e-01 + 1.0993899794058419e+00 -1.0650678611842503e-01 + 1.0953351422782507e+00 -1.0266782270890926e-01 + 1.0909100353142438e+00 -9.8549119374895855e-02 + 1.0860982353043582e+00 -9.4160297817710542e-02 + 1.0809012129034097e+00 -8.9502262312082359e-02 + 1.0753339730948941e+00 -8.4572416837062708e-02 + 1.0693994623846814e+00 -7.9394946270086447e-02 + 1.0631102881845182e+00 -7.3997742169369593e-02 + 1.0564898503221154e+00 -6.8411307960731541e-02 + 1.0495748247077599e+00 -6.2665215422528314e-02 + 1.0424124769916345e+00 -5.6790125482537063e-02 + 1.0350490559180212e+00 -5.0830036365127812e-02 + 1.0275267593202144e+00 -4.4844177722053680e-02 + 1.0198804114000550e+00 -3.8909151374796030e-02 + 1.0121517452802762e+00 -3.3098369295090385e-02 + 1.0043831003059351e+00 -2.7486379060037300e-02 + 9.9663042648924105e-01 -2.2126523547613325e-02 + 9.8896344943688208e-01 -1.7044133508222436e-02 + 9.8145660515528843e-01 -1.2243183539340669e-02 + 9.7415236441667075e-01 -7.7617398268478967e-03 + 9.6709024605983585e-01 -3.6267216940621162e-03 + 9.6031925483028002e-01 1.7125795209640984e-04 + 9.5386504969566055e-01 3.6210571565500060e-03 + 9.4774732648050497e-01 6.7202092634910627e-03 + 9.4198156604972338e-01 9.4766812868836859e-03 + 9.3655890706285172e-01 1.1862486939321239e-02 + 9.3150214709632351e-01 1.3934572325396452e-02 + 9.2681381059430357e-01 1.5725336256941801e-02 + 9.2248879651916449e-01 1.7264212101963272e-02 + 9.1851609527216793e-01 1.8575923158841851e-02 + 9.1487354818367905e-01 1.9657811434967531e-02 + 9.1155422330738722e-01 2.0561032725808417e-02 + 9.0853846659508797e-01 2.1302515677589774e-02 + 9.0580111539457053e-01 2.1870529626823908e-02 + 9.0332620279876341e-01 2.2288045456526989e-02 + 9.0109981279063034e-01 2.2602713139519823e-02 + 8.9909937540990237e-01 2.2819364154805965e-02 + 8.9730720419236965e-01 2.2964108603901020e-02 + 8.9570576745644959e-01 2.3072526595840363e-02 + 8.9427439305614120e-01 2.3117000668108900e-02 + 8.9299982408647638e-01 2.3153169512771386e-02 + 8.9186529992889318e-01 2.3154722425954326e-02 + 1.1317737216212498e+00 -1.3994569207413388e-01 + 1.1314032490831891e+00 -1.3951993616739067e-01 + 1.1309856605625712e+00 -1.3903877348927776e-01 + 1.1305148363430695e+00 -1.3849551337010493e-01 + 1.1299840485888231e+00 -1.3788254055485760e-01 + 1.1293854390621167e+00 -1.3719162327397991e-01 + 1.1287097421357084e+00 -1.3641394370815060e-01 + 1.1279415573648737e+00 -1.3554434662543702e-01 + 1.1270624990228137e+00 -1.3457806257790275e-01 + 1.1260581284271065e+00 -1.3350447033950455e-01 + 1.1249151947328158e+00 -1.3231153539239138e-01 + 1.1236058351717264e+00 -1.3099816358539040e-01 + 1.1221409868209911e+00 -1.2952908258064766e-01 + 1.1205110969679082e+00 -1.2788276284807551e-01 + 1.1187059555959089e+00 -1.2603733314898716e-01 + 1.1166959327868002e+00 -1.2398642497369497e-01 + 1.1144535475943118e+00 -1.2172133515665029e-01 + 1.1119606213712707e+00 -1.1922515078376106e-01 + 1.1091993108225877e+00 -1.1648061231954886e-01 + 1.1061496621005487e+00 -1.1347358891384816e-01 + 1.1027882810219791e+00 -1.1019575884067266e-01 + 1.0990938860297248e+00 -1.0664029335366994e-01 + 1.0950482319915082e+00 -1.0280259857132716e-01 + 1.0906321569913220e+00 -9.8686222356475783e-02 + 1.0858289020418539e+00 -9.4301180528758272e-02 + 1.0806399968143205e+00 -8.9648342257516667e-02 + 1.0750807430764044e+00 -8.4724782754247066e-02 + 1.0691538130765519e+00 -7.9554978204993104e-02 + 1.0628716289330857e+00 -7.4167001139653341e-02 + 1.0562575326764370e+00 -6.8591374017895362e-02 + 1.0493483697846910e+00 -6.2857396316469930e-02 + 1.0421917735820356e+00 -5.6995194292776864e-02 + 1.0348343141276384e+00 -5.1048261689780307e-02 + 1.0273186796794260e+00 -4.5075100031474524e-02 + 1.0196802367071098e+00 -3.9151474909808144e-02 + 1.0119606288880929e+00 -3.3350676076146883e-02 + 1.0042024201462729e+00 -2.7746671747529022e-02 + 9.9646157993703799e-01 -2.2392401227200064e-02 + 9.8880689295810753e-01 -1.7314255765831132e-02 + 9.8131090177996794e-01 -1.2518993415019683e-02 + 9.7401589395163746e-01 -8.0449437824845933e-03 + 9.6696263090416301e-01 -3.9169949244710995e-03 + 9.6020072535542267e-01 -1.2457522825975802e-04 + 9.5375586879541119e-01 3.3214246023724075e-03 + 9.4764775279504132e-01 6.4187713199966344e-03 + 9.4189189026151732e-01 9.1757656256247992e-03 + 9.3647909817439046e-01 1.1564089572641725e-02 + 9.3143219276707145e-01 1.3640878962097794e-02 + 9.2675328097800858e-01 1.5437587325676216e-02 + 9.2243702543869688e-01 1.6982978932430733e-02 + 9.1847228069186326e-01 1.8301253655165675e-02 + 9.1483660208402118e-01 1.9388592628166723e-02 + 9.1152339719339859e-01 2.0296910442765458e-02 + 9.0851325832737606e-01 2.1044253849168106e-02 + 9.0578116342246051e-01 2.1620633957396395e-02 + 9.0331088945821225e-01 2.2048435227431922e-02 + 9.0108846359641637e-01 2.2374893941175748e-02 + 8.9909120478953009e-01 2.2602883631307250e-02 + 8.9730162689435444e-01 2.2757514016667559e-02 + 8.9570241606955192e-01 2.2874242977053774e-02 + 8.9427293267403651e-01 2.2923909827895737e-02 + 8.9300008642720652e-01 2.2963741982725154e-02 + 8.9186709815490517e-01 2.2966662517451504e-02 + 1.1315517815673091e+00 -1.3997896224903450e-01 + 1.1311778506268235e+00 -1.3955622388044009e-01 + 1.1307562303319028e+00 -1.3907852026641662e-01 + 1.1302807515724440e+00 -1.3853920755143931e-01 + 1.1297446662103341e+00 -1.3793070615181371e-01 + 1.1291401391182887e+00 -1.3724480787512783e-01 + 1.1284580125627706e+00 -1.3647268757438952e-01 + 1.1276830545336793e+00 -1.3560920909794141e-01 + 1.1267973742314656e+00 -1.3464944502897633e-01 + 1.1257874016368012e+00 -1.3358225456274639e-01 + 1.1246407231617190e+00 -1.3239479008699795e-01 + 1.1233323112792160e+00 -1.3108342115503255e-01 + 1.1218687055223342e+00 -1.2961640565708116e-01 + 1.1202393640784203e+00 -1.2797318986155590e-01 + 1.1184328393191356e+00 -1.2613300338723032e-01 + 1.1164218952623939e+00 -1.2408738990341445e-01 + 1.1141806639944489e+00 -1.2182619981643046e-01 + 1.1116907890562437e+00 -1.1933260107077021e-01 + 1.1089340866425332e+00 -1.1658963845814199e-01 + 1.1058903411669052e+00 -1.1358345037925685e-01 + 1.1025358830142480e+00 -1.1030601545869229e-01 + 1.0988489672595532e+00 -1.0675102773188518e-01 + 1.0948109030658160e+00 -1.0291441027995221e-01 + 1.0904022925765167e+00 -9.8799989842592736e-02 + 1.0856060985135589e+00 -9.4418109058014357e-02 + 1.0804238991421413e+00 -8.9769608537709794e-02 + 1.0748712418730186e+00 -8.4851291586446928e-02 + 1.0689505714547765e+00 -7.9687876259712631e-02 + 1.0626741560740864e+00 -7.4307585697497333e-02 + 1.0560652894267311e+00 -6.8740958833515595e-02 + 1.0491609572182805e+00 -6.3017069998038897e-02 + 1.0420090975336400e+00 -5.7165602411116241e-02 + 1.0346565470829494e+00 -5.1229631375560011e-02 + 1.0271464014949909e+00 -4.5267053880361174e-02 + 1.0195144781506411e+00 -3.9352940582229386e-02 + 1.0118023475402580e+00 -3.3560478546642854e-02 + 1.0040527612331294e+00 -2.7963153467420152e-02 + 9.9632170608161486e-01 -2.2613567756289376e-02 + 9.8867718603887011e-01 -1.7538992311906313e-02 + 9.8119017034710410e-01 -1.2748498017266813e-02 + 9.7390279376772937e-01 -8.2806341508424586e-03 + 9.6685685059719795e-01 -4.1586002693693854e-03 + 9.6010245939420391e-01 -3.7083919875696773e-04 + 9.5366533908381412e-01 3.0719681667102155e-03 + 9.4756517800733919e-01 6.1677835646164261e-03 + 9.4181751596285712e-01 8.9251861299107782e-03 + 9.3641290233536756e-01 1.1315582577903981e-02 + 9.3137416885833813e-01 1.3396267083575495e-02 + 9.2670307478439073e-01 1.5197906567824911e-02 + 9.2239408570979264e-01 1.6748708181052539e-02 + 9.1843594271534856e-01 1.8072435708544613e-02 + 9.1480596262165803e-01 1.9164303142991557e-02 + 9.1149783540080387e-01 2.0076856524381879e-02 + 9.0849235825937680e-01 2.0829073612751027e-02 + 9.0576462600568675e-01 2.1412416362663902e-02 + 9.0329820205308320e-01 2.1848780871727567e-02 + 9.0107906598562981e-01 2.2185058797879936e-02 + 8.9908444397584275e-01 2.2422492330391581e-02 + 8.9729701657742200e-01 2.2585357388322420e-02 + 8.9569965128307505e-01 2.2709009667025545e-02 + 8.9427173540253102e-01 2.2763002274914321e-02 + 8.9300031737966090e-01 2.2805886135007076e-02 + 8.9186860247591382e-01 2.2809945639981535e-02 + 1.1313681853728130e+00 -1.4000652608193678e-01 + 1.1309913933317586e+00 -1.3958628583682131e-01 + 1.1305664374769635e+00 -1.3911144592368319e-01 + 1.1300871077836823e+00 -1.3857540127906420e-01 + 1.1295466392523028e+00 -1.3797060190592839e-01 + 1.1289372157958415e+00 -1.3728885920789349e-01 + 1.1282497688527653e+00 -1.3652134208064917e-01 + 1.1274692056671076e+00 -1.3566293028109266e-01 + 1.1265780448383829e+00 -1.3470856582771579e-01 + 1.1255634350368120e+00 -1.3364667813687789e-01 + 1.1244136554844040e+00 -1.3246374688429163e-01 + 1.1231060249988998e+00 -1.3115404278531947e-01 + 1.1216434443226180e+00 -1.2968874493241647e-01 + 1.1200145530177448e+00 -1.2804810728962251e-01 + 1.1182068789226656e+00 -1.2621227089901063e-01 + 1.1161951671589023e+00 -1.2417105176350397e-01 + 1.1139548850354148e+00 -1.2191310309042711e-01 + 1.1114675291877245e+00 -1.1942165960946269e-01 + 1.1087146342106060e+00 -1.1668001788212337e-01 + 1.1056757680943585e+00 -1.1367453906992440e-01 + 1.1023270334203663e+00 -1.1039745035150228e-01 + 1.0986463017350347e+00 -1.0684287861546399e-01 + 1.0946145131306895e+00 -1.0300717516797658e-01 + 1.0902120742661021e+00 -9.8894397951515139e-02 + 1.0854217171527560e+00 -9.4515160684924368e-02 + 1.0802450600898101e+00 -8.9870280729118693e-02 + 1.0746978538713421e+00 -8.4956336424385229e-02 + 1.0687823544869695e+00 -7.9798246684562701e-02 + 1.0625107022239590e+00 -7.4424359999043815e-02 + 1.0559061503647678e+00 -6.8865229508717193e-02 + 1.0490058006223295e+00 -6.3149743312422249e-02 + 1.0418578437628525e+00 -5.7307217410936105e-02 + 1.0345093378307095e+00 -5.1380379945198604e-02 + 1.0270037168944584e+00 -4.5426625880590578e-02 + 1.0193771733235639e+00 -3.9520448268287871e-02 + 1.0116712176806906e+00 -3.3734947939858650e-02 + 1.0039287582957110e+00 -2.8143208699129875e-02 + 9.9620579745702165e-01 -2.2797551754573358e-02 + 9.8856969112865312e-01 -1.7725977813435320e-02 + 9.8109010101225580e-01 -1.2939479833058411e-02 + 9.7380903446637246e-01 -8.4767902668329998e-03 + 9.6676914444052175e-01 -4.3597049075066174e-03 + 9.6002097039557288e-01 -5.7584648774021635e-04 + 9.5359025438072342e-01 2.8642792818252159e-03 + 9.4749668229362760e-01 5.9587970031838994e-03 + 9.4175581648985718e-01 8.7165181239429491e-03 + 9.3635798373062196e-01 1.1108620732652881e-02 + 9.3132602862864455e-01 1.3192531212834159e-02 + 9.2666142088413006e-01 1.4998261858932001e-02 + 9.2235846182451897e-01 1.6553555919441378e-02 + 9.1840579778545506e-01 1.7881813851315775e-02 + 9.1478054665433028e-01 1.8977443893588044e-02 + 9.1147663330439177e-01 1.9893517598424459e-02 + 9.0847502537930747e-01 2.0649787980295344e-02 + 9.0575091485599635e-01 2.1238925529970046e-02 + 9.0328768706789919e-01 2.1682419629512603e-02 + 9.0107128177280416e-01 2.2026874841890913e-02 + 8.9907884766383594e-01 2.2272174122050448e-02 + 8.9729320402245794e-01 2.2441898438756488e-02 + 8.9569736929608190e-01 2.2571318075286499e-02 + 8.9427075314628590e-01 2.2628914152129621e-02 + 8.9300051951924309e-01 2.2674340180490034e-02 + 8.9186986062649010e-01 2.2679348185424119e-02 + 1.1312162346966794e+00 -1.4002935823673165e-01 + 1.1308370745874372e+00 -1.3961118702041142e-01 + 1.1304093578756484e+00 -1.3913871895956298e-01 + 1.1299268406320473e+00 -1.3860538114780319e-01 + 1.1293827438502995e+00 -1.3800364813631022e-01 + 1.1287692671411285e+00 -1.3732534761905932e-01 + 1.1280774156808322e+00 -1.3656164364322393e-01 + 1.1272922119009330e+00 -1.3570742923005630e-01 + 1.1263965132135507e+00 -1.3475753842758320e-01 + 1.1253780631748027e+00 -1.3370004498333316e-01 + 1.1242257145522110e+00 -1.3252087174777694e-01 + 1.1229187287904407e+00 -1.3121255181568367e-01 + 1.1214569942995669e+00 -1.2974868262823686e-01 + 1.1198284728081149e+00 -1.2811018699629964e-01 + 1.1180198436481514e+00 -1.2627796087067072e-01 + 1.1160074921458008e+00 -1.2424038996445967e-01 + 1.1137679913515830e+00 -1.2198513613497029e-01 + 1.1112827164638446e+00 -1.1949548930535291e-01 + 1.1085329690815724e+00 -1.1675495442490848e-01 + 1.1054981381526277e+00 -1.1375007704014002e-01 + 1.1021541377558970e+00 -1.1047329011388783e-01 + 1.0984785218520348e+00 -1.0691907908035025e-01 + 1.0944519247936131e+00 -1.0308415010582876e-01 + 1.0900545912118855e+00 -9.8972752877615533e-02 + 1.0852690617877780e+00 -9.4595726033618252e-02 + 1.0800969878250248e+00 -8.9953867983070271e-02 + 1.0745542885826966e+00 -8.5043570852860254e-02 + 1.0686430633891457e+00 -7.9889920396595357e-02 + 1.0623753462403644e+00 -7.4521369437134860e-02 + 1.0557743566370148e+00 -6.8968483323827351e-02 + 1.0488772923073502e+00 -6.3259996036689609e-02 + 1.0417325535895161e+00 -5.7424919089908197e-02 + 1.0343873822955669e+00 -5.1505692510698094e-02 + 1.0268854937246235e+00 -4.5559294267386440e-02 + 1.0192633921395944e+00 -3.9659737236912185e-02 + 1.0115625389846110e+00 -3.3880049873113542e-02 + 1.0038259735243109e+00 -2.8292981233371716e-02 + 9.9610971163629225e-01 -2.2950617830539092e-02 + 9.8848057133015044e-01 -1.7881566041516757e-02 + 9.8100712745114238e-01 -1.3098416457942437e-02 + 9.7373128112639262e-01 -8.6400542663712873e-03 + 9.6669639924850048e-01 -4.5271080238418557e-03 + 9.5995337154061111e-01 -7.4651798553790111e-04 + 9.5352795952435321e-01 2.6913563900406562e-03 + 9.4743984725273367e-01 5.7847757176108976e-03 + 9.4170461599380484e-01 8.5427452589748546e-03 + 9.3631240727683585e-01 1.0936253216389686e-02 + 9.3128607641845007e-01 1.3022836325146246e-02 + 9.2662685196906802e-01 1.4831962040102970e-02 + 9.2232889830927789e-01 1.6390987306136404e-02 + 9.1838078267068279e-01 1.7723009865795374e-02 + 9.1475945703826833e-01 1.8821766649251791e-02 + 9.1145904170571435e-01 1.9740766596255857e-02 + 9.0846064610580546e-01 2.0500408310786859e-02 + 9.0573954301600035e-01 2.1094369007683588e-02 + 9.0327896928610318e-01 2.1543799334621982e-02 + 9.0106483134761450e-01 2.1895064678594915e-02 + 8.9907421320182002e-01 2.2146915467913610e-02 + 8.9729004959238268e-01 2.2322353455109259e-02 + 8.9569548464093351e-01 2.2456577545576173e-02 + 8.9426994655278824e-01 2.2517175421257224e-02 + 8.9300069544745708e-01 2.2564719155166123e-02 + 8.9187091260006668e-01 2.2570517030342432e-02 + 1.1310904059986759e+00 -1.4004827204169712e-01 + 1.1307092848448450e+00 -1.3963181531291713e-01 + 1.1302792817433189e+00 -1.3916131270293225e-01 + 1.1297941246569629e+00 -1.3863021797374905e-01 + 1.1292470229409437e+00 -1.3803102605171411e-01 + 1.1286301891585544e+00 -1.3735557817621982e-01 + 1.1279346894978246e+00 -1.3659503444279894e-01 + 1.1271456417256651e+00 -1.3574429893218776e-01 + 1.1262461838031692e+00 -1.3479811635304653e-01 + 1.1252245519567861e+00 -1.3374426595469702e-01 + 1.1240700740130269e+00 -1.3256820944133849e-01 + 1.1227636206155178e+00 -1.3126104059491478e-01 + 1.1213025851479046e+00 -1.2979835995386002e-01 + 1.1196743677986076e+00 -1.2816164447314574e-01 + 1.1178649448320381e+00 -1.2633241567780137e-01 + 1.1158520602383490e+00 -1.2429787456824933e-01 + 1.1136132032226942e+00 -1.2204486169489545e-01 + 1.1111296485365301e+00 -1.1955671262454963e-01 + 1.1083825048903007e+00 -1.1681710488033255e-01 + 1.1053510130291941e+00 -1.1381273671094697e-01 + 1.1020109309642061e+00 -1.1053621154116386e-01 + 1.0983395495432093e+00 -1.0698231194213127e-01 + 1.0943172497232851e+00 -1.0314803827622102e-01 + 1.0899241417814134e+00 -9.9037799313456049e-02 + 1.0851426076641755e+00 -9.4662620375848716e-02 + 1.0799743259069479e+00 -9.0023284402781234e-02 + 1.0744353553773252e+00 -8.5116029301877394e-02 + 1.0685276653389615e+00 -7.9966079445773261e-02 + 1.0622632014344109e+00 -7.4601974506256385e-02 + 1.0556651549331217e+00 -6.9054290286975850e-02 + 1.0487708030744447e+00 -6.3351633153648876e-02 + 1.0416287200800596e+00 -5.7522762046763133e-02 + 1.0342863003846330e+00 -5.1609877803077783e-02 + 1.0267874930337260e+00 -4.5669611926061442e-02 + 1.0191690617456377e+00 -3.9775578032990845e-02 + 1.0114724276584448e+00 -3.4000743867469561e-02 + 1.0037407393781625e+00 -2.8417579652756736e-02 + 9.9603002466034773e-01 -2.3077976046070765e-02 + 9.8840665477231926e-01 -1.8011042236994890e-02 + 9.8093830095143542e-01 -1.3230697054072186e-02 + 9.7366677575089444e-01 -8.7759530268153117e-03 + 9.6663603979430457e-01 -4.6664679730404795e-03 + 9.5989727431637262e-01 -8.8861412854347483e-04 + 9.5347625722008411e-01 2.5473711288040548e-03 + 9.4739267116716752e-01 5.6398619807878298e-03 + 9.4166211327376981e-01 8.3980253691735198e-03 + 9.3627457092860877e-01 1.0792691742735122e-02 + 9.3125290834629959e-01 1.2881489932225411e-02 + 9.2659815322907901e-01 1.4693433880025471e-02 + 9.2230435579230974e-01 1.6255558825078845e-02 + 9.1836001723358318e-01 1.7590710292935074e-02 + 9.1474195119070223e-01 1.8692065905539665e-02 + 9.1144444055584972e-01 1.9613498680335260e-02 + 9.0844871273499095e-01 2.0375944863779236e-02 + 9.0573010770709617e-01 2.0973920309628694e-02 + 9.0327173852198395e-01 2.1428293535094803e-02 + 9.0105948373440325e-01 2.1785230666594393e-02 + 8.9907037333986617e-01 2.2042538488633821e-02 + 8.9728743819064238e-01 2.2222736003563111e-02 + 8.9569392704427908e-01 2.2360962481535834e-02 + 8.9426928349614931e-01 2.2424060983923418e-02 + 8.9300084775028121e-01 2.2473368851837202e-02 + 8.9187179192145716e-01 2.2479824504824462e-02 + 1.1309861493363835e+00 -1.4006395368494548e-01 + 1.1306034032707488e+00 -1.3964891838147400e-01 + 1.1301715056259132e+00 -1.3918004528559130e-01 + 1.1296841610512438e+00 -1.3865081028551834e-01 + 1.1291345692286787e+00 -1.3805372522539672e-01 + 1.1285149534181707e+00 -1.3738064260953500e-01 + 1.1278164303223706e+00 -1.3662271930724665e-01 + 1.1270241966618932e+00 -1.3577486861941265e-01 + 1.1261216228374289e+00 -1.3483176128411037e-01 + 1.1250973533245128e+00 -1.3378093255940982e-01 + 1.1239411096524965e+00 -1.3260746202504128e-01 + 1.1226350961946134e+00 -1.3130125058733333e-01 + 1.1211746386258952e+00 -1.2983955885329695e-01 + 1.1195466716847904e+00 -1.2820432313419006e-01 + 1.1177365887728354e+00 -1.2637758361949208e-01 + 1.1157232599475437e+00 -1.2434555946517438e-01 + 1.1134849338891688e+00 -1.2209441042576447e-01 + 1.1110028022083343e+00 -1.1960750983985623e-01 + 1.1082578138344603e+00 -1.1686867822654240e-01 + 1.1052290867629246e+00 -1.1386474036936910e-01 + 1.1018922497138830e+00 -1.1058844097287739e-01 + 1.0982243754353738e+00 -1.0703480897901807e-01 + 1.0942056347660629e+00 -1.0320108876857220e-01 + 1.0898160265243404e+00 -9.9091821149942791e-02 + 1.0850378009110373e+00 -9.4718186451588984e-02 + 1.0798726589495542e+00 -9.0080954964720739e-02 + 1.0743367752616684e+00 -8.5176236802639207e-02 + 1.0684320110900360e+00 -8.0029371542324118e-02 + 1.0621702386167906e+00 -7.4668971158359826e-02 + 1.0555746255255902e+00 -6.9125620377902694e-02 + 1.0486825149375347e+00 -6.3427819838180813e-02 + 1.0415426254054292e+00 -5.7604118879636124e-02 + 1.0342024781602979e+00 -5.1696519695650499e-02 + 1.0267062165755561e+00 -4.5761365847407483e-02 + 1.0190908202393134e+00 -3.9871938903839096e-02 + 1.0113976771727984e+00 -3.4101155720359606e-02 + 1.0036700272725569e+00 -2.8521254251112151e-02 + 9.9596390860913797e-01 -2.3183961733914436e-02 + 9.8834532133403585e-01 -1.8118804930573600e-02 + 9.8088118526336854e-01 -1.3340807182565395e-02 + 9.7361323910305986e-01 -8.8890871881580468e-03 + 9.6658593733301601e-01 -4.7824952905046389e-03 + 9.5985070383298698e-01 -1.0069309120178417e-03 + 9.5343333027332122e-01 2.4274704558233506e-03 + 9.4735349826624704e-01 5.5191778019818777e-03 + 9.4162681820054395e-01 8.2774929278490988e-03 + 9.3624314917973561e-01 1.0673115186247138e-02 + 9.3122536281701340e-01 1.2763750256223609e-02 + 9.2657431952377889e-01 1.4578034545214070e-02 + 9.2228397434557052e-01 1.6142735365332894e-02 + 9.1834277336555303e-01 1.7480488095463338e-02 + 9.1472741486086584e-01 1.8584004355188873e-02 + 9.1143231703251515e-01 1.9507460250109382e-02 + 9.0843880545861111e-01 2.0272239799992230e-02 + 9.0572227601978961e-01 2.0873557500421577e-02 + 9.0326573855131531e-01 2.1332046871903827e-02 + 9.0105504829819916e-01 2.1693708030596059e-02 + 8.9906719017895187e-01 2.1955561488425132e-02 + 8.9728527505371525e-01 2.2139723903755390e-02 + 8.9569263880672967e-01 2.2281284735314315e-02 + 8.9426873781084548e-01 2.2346466461357767e-02 + 8.9300097896216446e-01 2.2397243995700911e-02 + 8.9187252670641826e-01 2.2404247479780807e-02 + 1.1308997163839014e+00 -1.4007696800677250e-01 + 1.1305156231361617e+00 -1.3966311177206228e-01 + 1.1300821547241795e+00 -1.3919559037179549e-01 + 1.1295929964510636e+00 -1.3866789805988997e-01 + 1.1290413399565880e+00 -1.3807256073262100e-01 + 1.1284194173423290e+00 -1.3740144026482107e-01 + 1.1277183871620406e+00 -1.3664569088635059e-01 + 1.1269235115646896e+00 -1.3580023358450030e-01 + 1.1260183536453388e+00 -1.3485967781079100e-01 + 1.1249918963690015e+00 -1.3381135655668777e-01 + 1.1238341877290265e+00 -1.3264003257425452e-01 + 1.1225285381319712e+00 -1.3133461758040318e-01 + 1.1210685587027580e+00 -1.2987374874372948e-01 + 1.1194407981646830e+00 -1.2823974336373137e-01 + 1.1176301664519153e+00 -1.2641507188034043e-01 + 1.1156164674342917e+00 -1.2438513927451797e-01 + 1.1133785797215043e+00 -1.2213554066840447e-01 + 1.1108976260606485e+00 -1.1964968067969403e-01 + 1.1081544229438014e+00 -1.1691149838372303e-01 + 1.1051279866344694e+00 -1.1390792347577230e-01 + 1.1017938386802415e+00 -1.1063181781894658e-01 + 1.0981288709426102e+00 -1.0707841473882133e-01 + 1.0941130799386434e+00 -1.0324516111274301e-01 + 1.0897263719789625e+00 -9.9136707386142858e-02 + 1.0849508878727128e+00 -9.4764362640054833e-02 + 1.0797883472308658e+00 -9.0128886806700628e-02 + 1.0742550207006945e+00 -8.5226284041131209e-02 + 1.0683526797800662e+00 -8.0081989692690453e-02 + 1.0620931355586301e+00 -7.4724675935459783e-02 + 1.0554995360209420e+00 -6.9184935091259989e-02 + 1.0486092789088088e+00 -6.3491180149883183e-02 + 1.0414712026256605e+00 -5.7671786439286887e-02 + 1.0341329337769190e+00 -5.1768591125238309e-02 + 1.0266387773331418e+00 -4.5837698397575198e-02 + 1.0190258925190612e+00 -3.9952113616790040e-02 + 1.0113356401093767e+00 -3.4184711012369716e-02 + 1.0036113362047652e+00 -2.8607535051289708e-02 + 9.9590902778178236e-01 -2.3272176636477647e-02 + 9.8829440659893864e-01 -1.8208509437963712e-02 + 9.8083376746769224e-01 -1.3432475476216085e-02 + 9.7356878752818166e-01 -8.9832819619536965e-03 + 9.6654433212301671e-01 -4.8791074403381719e-03 + 9.5981202712720382e-01 -1.1054577224235648e-03 + 9.5339767577021484e-01 2.3276167188242495e-03 + 9.4732095887170309e-01 5.4186640027557862e-03 + 9.4159749792984759e-01 8.1770984077021644e-03 + 9.3621704526694993e-01 1.0573510311597731e-02 + 9.3120247864931693e-01 1.2665669509981770e-02 + 9.2655451914088693e-01 1.4481898089638554e-02 + 9.2226704245493141e-01 1.6048740210888528e-02 + 9.1832844868208596e-01 1.7388656156289945e-02 + 9.1471533991221166e-01 1.8493969275785848e-02 + 9.1142224696243490e-01 1.9419108018480433e-02 + 9.0843057711766806e-01 2.0185829354060898e-02 + 9.0571577276889792e-01 2.0789929813246160e-02 + 9.0326075770376846e-01 2.1251847169984104e-02 + 9.0105136768359750e-01 2.1617443228875825e-02 + 8.9906455000896623e-01 2.1883083347538711e-02 + 8.9728348215147180e-01 2.2070548859417279e-02 + 8.9569157254907972e-01 2.2214887628266212e-02 + 8.9426828818700810e-01 2.2281804931097753e-02 + 8.9300109150466878e-01 2.2333806880655352e-02 + 8.9187314053045652e-01 2.2341266676516591e-02 + 1.1308280183128809e+00 -1.4008777283400001e-01 + 1.1304428075014701e+00 -1.3967489514443532e-01 + 1.1300080360205744e+00 -1.3920849557052656e-01 + 1.1295173731114909e+00 -1.3868208361766471e-01 + 1.1289640037261368e+00 -1.3808819685827489e-01 + 1.1283401672810065e+00 -1.3741870496327868e-01 + 1.1276370570255836e+00 -1.3666475999950234e-01 + 1.1268399893629726e+00 -1.3582128936164101e-01 + 1.1259326872268067e+00 -1.3488285169110004e-01 + 1.1249044143917439e+00 -1.3383661220347864e-01 + 1.1237454897105701e+00 -1.3266707081289728e-01 + 1.1224401413031515e+00 -1.3136231849962302e-01 + 1.1209805577897858e+00 -1.2990213453948879e-01 + 1.1193529675837259e+00 -1.2826915239096712e-01 + 1.1175418793873675e+00 -1.2644619958581055e-01 + 1.1155278718778379e+00 -1.2441800559181683e-01 + 1.1132903464223323e+00 -1.2216969698990991e-01 + 1.1108103686909503e+00 -1.1968470431862453e-01 + 1.1080686453368258e+00 -1.1694706500321173e-01 + 1.1050441082588580e+00 -1.1394379577242277e-01 + 1.1017121901135216e+00 -1.1066785569848663e-01 + 1.0980496326592690e+00 -1.0711464774561789e-01 + 1.0940362877171650e+00 -1.0328178691097453e-01 + 1.0896519847836779e+00 -9.9174014713447542e-02 + 1.0848787737999961e+00 -9.4802747219197472e-02 + 1.0797183897545080e+00 -9.0168735861090102e-02 + 1.0741871829947003e+00 -8.5267896891186676e-02 + 1.0682868504316763e+00 -8.0125745298592371e-02 + 1.0620291523364709e+00 -7.4771003384885584e-02 + 1.0554372202450237e+00 -6.9234269917163388e-02 + 1.0485484972097270e+00 -6.3543885183892035e-02 + 1.0414119211964952e+00 -5.7728079984131743e-02 + 1.0340752064096275e+00 -5.1828554334946708e-02 + 1.0265827922317154e+00 -4.5901213377049062e-02 + 1.0189719873968310e+00 -4.0018832664087282e-02 + 1.0112841302327049e+00 -3.4254250742461786e-02 + 1.0035626004380940e+00 -2.8679350891448387e-02 + 9.9586345263945564e-01 -2.3345610289392943e-02 + 9.8825212224187686e-01 -1.8283190909580676e-02 + 9.8079438408793695e-01 -1.3508799051089947e-02 + 9.7353186399348224e-01 -9.0617157127974909e-03 + 9.6650976918325049e-01 -4.9595604165164316e-03 + 9.5977989370746031e-01 -1.1875112578176290e-03 + 9.5336805049199813e-01 2.2444522223364232e-03 + 9.4729391975608013e-01 5.3349441770098489e-03 + 9.4157313229201900e-01 8.0934726844456070e-03 + 9.3619535152817479e-01 1.0490537510246180e-02 + 9.3118346034941979e-01 1.2583961936225819e-02 + 9.2653806374218384e-01 1.4401806330493620e-02 + 9.2225297129180661e-01 1.5970428982019717e-02 + 9.1831654471471358e-01 1.7312144278666928e-02 + 9.1470530590558707e-01 1.8418952060967036e-02 + 9.1141387942426644e-01 1.9345490894755360e-02 + 9.0842374056853781e-01 2.0113828397830782e-02 + 9.0571037043344704e-01 2.0720246007825058e-02 + 9.0325662107402294e-01 2.1185018438201850e-02 + 9.0104831197182023e-01 2.1553892256242126e-02 + 8.9906235903962117e-01 2.1822686911327320e-02 + 8.9728199521320717e-01 2.2012904271235343e-02 + 8.9569068935364138e-01 2.2159557474182880e-02 + 8.9426791726380672e-01 2.2227920760450524e-02 + 8.9300118764428560e-01 2.2280942826095634e-02 + 8.9187365315655809e-01 2.2288782720689876e-02 + 1.1307685101553178e+00 -1.4009674686618434e-01 + 1.1303823717529393e+00 -1.3968468170480491e-01 + 1.1299465186883961e+00 -1.3921921364112511e-01 + 1.1294546068619982e+00 -1.3869386485116142e-01 + 1.1288998156626746e+00 -1.3810118261274168e-01 + 1.1282743905637702e+00 -1.3743304308441212e-01 + 1.1275695535968022e+00 -1.3668059655696904e-01 + 1.1267706661796395e+00 -1.3583877576618630e-01 + 1.1258615839049484e+00 -1.3490209720279497e-01 + 1.1248318036326455e+00 -1.3385758683815879e-01 + 1.1236718690608118e+00 -1.3268952641926759e-01 + 1.1223667701658750e+00 -1.3138532559676461e-01 + 1.1209075147343697e+00 -1.2992571173489587e-01 + 1.1192800652535440e+00 -1.2829358078672881e-01 + 1.1174685972752838e+00 -1.2647205680252360e-01 + 1.1154543326910229e+00 -1.2444530848628337e-01 + 1.1132171069063121e+00 -1.2219807341682164e-01 + 1.1107379382526132e+00 -1.1971380362748618e-01 + 1.1079974422341197e+00 -1.1697661817575060e-01 + 1.1049744807462778e+00 -1.1397360603163001e-01 + 1.1016444126757441e+00 -1.1069780696640612e-01 + 1.0979838551587600e+00 -1.0714476481294354e-01 + 1.0939725398537508e+00 -1.0331223421072472e-01 + 1.0895902324464826e+00 -9.9205032360977413e-02 + 1.0848189073677870e+00 -9.4834664258989329e-02 + 1.0796603123386084e+00 -9.0201874351996447e-02 + 1.0741308638890699e+00 -8.5302505928046488e-02 + 1.0682321969209188e+00 -8.0162140218438524e-02 + 1.0619760294234419e+00 -7.4809541269094129e-02 + 1.0553854792014548e+00 -6.9275313303126432e-02 + 1.0484980269153459e+00 -6.3587736271247336e-02 + 1.0413626932713793e+00 -5.7774920883064018e-02 + 1.0340272653175095e+00 -5.1878453137661623e-02 + 1.0265362942622751e+00 -4.5954072613368972e-02 + 1.0189272132938447e+00 -4.0074363625321296e-02 + 1.0112413422225595e+00 -3.4312134866181961e-02 + 1.0035221138145496e+00 -2.8739135329698282e-02 + 9.9582558923799203e-01 -2.3406747341848354e-02 + 9.8821699073715608e-01 -1.8345372554260352e-02 + 9.8076166048104763e-01 -1.3572353225720637e-02 + 9.7350118150092857e-01 -9.1270318655542384e-03 + 9.6648104555588088e-01 -5.0265627320630057e-03 + 9.5975318672981436e-01 -1.2558510393528195e-03 + 9.5334342607534905e-01 2.1751828425148950e-03 + 9.4727144335533331e-01 5.2652081615621911e-03 + 9.4155287713347757e-01 8.0238112131163913e-03 + 9.3617731682587191e-01 1.0421416398396799e-02 + 9.3116764957640996e-01 1.2515891612107052e-02 + 9.2652438367317858e-01 1.4335079280069803e-02 + 9.2224127358210928e-01 1.5905182863218570e-02 + 9.1830664900679260e-01 1.7248395184350611e-02 + 9.1469696498393227e-01 1.8356446528043250e-02 + 9.1140692411656743e-01 1.9284150433810026e-02 + 9.0841805832418610e-01 2.0053833288200248e-02 + 9.0570588091547533e-01 2.0662180528495409e-02 + 9.0325318414917866e-01 2.1129331029398481e-02 + 9.0104577390876095e-01 2.1500935343346361e-02 + 8.9906053992159340e-01 2.1772358035277474e-02 + 8.9728076131051182e-01 2.1964868064386654e-02 + 8.9568995726127965e-01 2.2113449584921584e-02 + 8.9426761090581552e-01 2.2183017613798903e-02 + 8.9300126947763303e-01 2.2236889606264416e-02 + 8.9187408115167655e-01 2.2245046130397298e-02 + 1.1307190938860587e+00 -1.4010420325484307e-01 + 1.1303321851783465e+00 -1.3969281308267312e-01 + 1.1298954339119989e+00 -1.3922811885673386e-01 + 1.1294024849015591e+00 -1.3870365328361209e-01 + 1.1288465129074314e+00 -1.3811197171115308e-01 + 1.1282197684223552e+00 -1.3744495569767270e-01 + 1.1275134973677581e+00 -1.3669375407316237e-01 + 1.1267130985314955e+00 -1.3585330402538678e-01 + 1.1258025376645013e+00 -1.3491808705783886e-01 + 1.1247715051965466e+00 -1.3387501351705366e-01 + 1.1236107315662616e+00 -1.3270818396976622e-01 + 1.1223058395280647e+00 -1.3140444218660488e-01 + 1.1208468561607439e+00 -1.2994530295084167e-01 + 1.1192195230694404e+00 -1.2831388025788909e-01 + 1.1174077390560746e+00 -1.2649354449099506e-01 + 1.1153932602447278e+00 -1.2446799861743005e-01 + 1.1131562825860524e+00 -1.2222165709625792e-01 + 1.1106777851263270e+00 -1.1973798979660023e-01 + 1.1079383076894971e+00 -1.1700118356685173e-01 + 1.1049166540525850e+00 -1.1399838737063778e-01 + 1.1015881218488239e+00 -1.1072270800503475e-01 + 1.0979292246982548e+00 -1.0716980633385749e-01 + 1.0939195944259243e+00 -1.0333755303388743e-01 + 1.0895389436875920e+00 -9.9230828221529260e-02 + 1.0847691841428104e+00 -9.4861210836576393e-02 + 1.0796120740638926e+00 -9.0229439575430281e-02 + 1.0740840849633977e+00 -8.5331297131366862e-02 + 1.0681868001746808e+00 -8.0192419847568128e-02 + 1.0619319025005902e+00 -7.4841606536413904e-02 + 1.0553424982861446e+00 -6.9309466029029071e-02 + 1.0484560994225869e+00 -6.3624228173241912e-02 + 1.0413217954010665e+00 -5.7813903858091771e-02 + 1.0339874338600819e+00 -5.1919984265482159e-02 + 1.0264976590631225e+00 -4.5998071230200901e-02 + 1.0188900078110554e+00 -4.0120589895734748e-02 + 1.0112057846193916e+00 -3.4360323991064569e-02 + 1.0034884665270707e+00 -2.8788910632596480e-02 + 9.9579412027412550e-01 -2.3457653043106350e-02 + 9.8818779080927122e-01 -1.8397152190710996e-02 + 9.8073446019873922e-01 -1.3625279620365452e-02 + 9.7347567580966210e-01 -9.1814291148691052e-03 + 9.6645716624717037e-01 -5.0823676396664639e-03 + 9.5973098220850261e-01 -1.3127731629151264e-03 + 9.5332295155219826e-01 2.1174832984921441e-03 + 9.4725275369263406e-01 5.2071169535866206e-03 + 9.4153603368864869e-01 7.9657793149103678e-03 + 9.3616231932734384e-01 1.0363832085761167e-02 + 9.3115450129694965e-01 1.2459180367823262e-02 + 9.2651300732764952e-01 1.4279485081861212e-02 + 9.2223154594313839e-01 1.5850820712185378e-02 + 9.1829842014477503e-01 1.7195278787451935e-02 + 9.1469002923368004e-01 1.8304364987753875e-02 + 9.1140114079389434e-01 1.9233038574410905e-02 + 9.0841333388955159e-01 2.0003841498917787e-02 + 9.0570214864514376e-01 2.0613795800072447e-02 + 9.0325032747532419e-01 2.1082927186226907e-02 + 9.0104366490891452e-01 2.1456806209086684e-02 + 8.9905902883129474e-01 2.1730418391697232e-02 + 8.9727973683061668e-01 2.1924838587650666e-02 + 8.9568935000957794e-01 2.2075026764774706e-02 + 8.9426735759381815e-01 2.2145598568130673e-02 + 8.9300133891473055e-01 2.2200178708852599e-02 + 8.9187443839804514e-01 2.2208599003431015e-02 + 1.1306780386592064e+00 -1.4011040097302199e-01 + 1.1302904899626109e+00 -1.3969957176938236e-01 + 1.1298529924367398e+00 -1.3923552066780934e-01 + 1.1293591816808020e+00 -1.3871178913005514e-01 + 1.1288022286034134e+00 -1.3812093921610707e-01 + 1.1281743878599073e+00 -1.3745485697943013e-01 + 1.1274669252116920e+00 -1.3670469004635635e-01 + 1.1266652704857578e+00 -1.3586537931554515e-01 + 1.1257534809507095e+00 -1.3493137723408047e-01 + 1.1247214078641554e+00 -1.3388949809029610e-01 + 1.1235599368285298e+00 -1.3272369191774472e-01 + 1.1222552164014954e+00 -1.3142033228268499e-01 + 1.1207964587927652e+00 -1.2996158824185278e-01 + 1.1191692220590717e+00 -1.2833075498722946e-01 + 1.1173571750068210e+00 -1.2651140762887977e-01 + 1.1153425176743332e+00 -1.2448686214640917e-01 + 1.1131057456373679e+00 -1.2224126448660066e-01 + 1.1106278053220389e+00 -1.1975809932667016e-01 + 1.1078891736849841e+00 -1.1702160983775960e-01 + 1.1048686062275954e+00 -1.1401899482899112e-01 + 1.1015413496977440e+00 -1.1074341679169915e-01 + 1.0978838316935648e+00 -1.0719063385694522e-01 + 1.0938756010627961e+00 -1.0335861316095570e-01 + 1.0894963263740669e+00 -9.9252287139187420e-02 + 1.0847278670885141e+00 -9.4883296234620329e-02 + 1.0795719902284493e+00 -9.0252374401820559e-02 + 1.0740452130034186e+00 -8.5355253988601110e-02 + 1.0681490758491301e+00 -8.0217617199982702e-02 + 1.0618952322813247e+00 -7.4868291805590709e-02 + 1.0553067790827497e+00 -6.9337890520618173e-02 + 1.0484212540918427e+00 -6.3654601568830960e-02 + 1.0412878040016198e+00 -5.7846352838284563e-02 + 1.0339543268617459e+00 -5.1954556638421925e-02 + 1.0264655443857285e+00 -4.6034700180015729e-02 + 1.0188590796469492e+00 -4.0159076102496860e-02 + 1.0111762245133291e+00 -3.4400447270369956e-02 + 1.0034604929537128e+00 -2.8830357588373400e-02 + 9.9576795643812310e-01 -2.3500044317241880e-02 + 9.8816351241216738e-01 -1.8440274223063120e-02 + 9.8071184318611604e-01 -1.3669359433914145e-02 + 9.7345446639977029e-01 -9.2267364707451331e-03 + 9.6643730783855930e-01 -5.1288498618267415e-03 + 9.5971251531911861e-01 -1.3601883153524274e-03 + 9.5330592239566980e-01 2.0694183111454119e-03 + 9.4723720821504198e-01 5.1587235622407900e-03 + 9.4152202326241752e-01 7.9174333245880940e-03 + 9.3614984400182044e-01 1.0315857129159979e-02 + 9.3114356407170462e-01 1.2411931104583482e-02 + 9.2650354408774016e-01 1.4233164999122869e-02 + 9.2222345428182739e-01 1.5805525850194447e-02 + 9.1829157538558703e-01 1.7151020781807570e-02 + 9.1468426023895100e-01 1.8260968322036893e-02 + 9.1139633053731350e-01 1.9190449102742417e-02 + 9.0840940460311914e-01 1.9962184658224420e-02 + 9.0569904488656017e-01 2.0573477481944755e-02 + 9.0324795225569066e-01 2.1044259000403798e-02 + 9.0104191176067816e-01 2.1420033106479261e-02 + 8.9905777307015711e-01 2.1695469475225288e-02 + 8.9727888580950721e-01 2.1891481194983919e-02 + 8.9568884599765253e-01 2.2043008054169162e-02 + 8.9426714792854112e-01 2.2114416207842134e-02 + 8.9300139767225573e-01 2.2169586382200176e-02 + 8.9187473652301563e-01 2.2178226422053051e-02 + 1.1306439153331420e+00 -1.4011555426706301e-01 + 1.1302558346940497e+00 -1.3970519144879648e-01 + 1.1298177168882730e+00 -1.3924167503995447e-01 + 1.1293231898518956e+00 -1.3871855378377487e-01 + 1.1287654212875082e+00 -1.3812839532457094e-01 + 1.1281366693048471e+00 -1.3746308945815097e-01 + 1.1274282161496982e+00 -1.3671378281792038e-01 + 1.1266255174419244e+00 -1.3587541939551692e-01 + 1.1257127065138011e+00 -1.3494242749534549e-01 + 1.1246797683027627e+00 -1.3390154156921499e-01 + 1.1235177173902973e+00 -1.3273658652792508e-01 + 1.1222131394224275e+00 -1.3143354507496821e-01 + 1.1207545692584449e+00 -1.2997513013014689e-01 + 1.1191274123697175e+00 -1.2834478752104245e-01 + 1.1173151463498885e+00 -1.2652626256972413e-01 + 1.1153003402509403e+00 -1.2450254957142934e-01 + 1.1130637387433218e+00 -1.2225757125199005e-01 + 1.1105862611536372e+00 -1.1977482458909749e-01 + 1.1078483321917627e+00 -1.1703859956849903e-01 + 1.1048286672412360e+00 -1.1403613643033905e-01 + 1.1015024707595049e+00 -1.1076064396323977e-01 + 1.0978460988321448e+00 -1.0720796116920997e-01 + 1.0938390313145232e+00 -1.0337613539724759e-01 + 1.0894609001109794e+00 -9.9270142602969347e-02 + 1.0846935212630395e+00 -9.4901674398237656e-02 + 1.0795386690543145e+00 -9.0271460822243965e-02 + 1.0740128986878019e+00 -8.5375192375656869e-02 + 1.0681177149058492e+00 -8.0238589435302307e-02 + 1.0618647468431590e+00 -7.4890503891230475e-02 + 1.0552770833049387e+00 -6.9361551727045737e-02 + 1.0483922836962463e+00 -6.3679886571424468e-02 + 1.0412595422932405e+00 -5.7873367275692075e-02 + 1.0339267990971095e+00 -5.1983340523678111e-02 + 1.0264388402944524e+00 -4.6065198121880584e-02 + 1.0188333608014213e+00 -4.0191122389287702e-02 + 1.0111516420163877e+00 -3.4433858759412447e-02 + 1.0034372287089237e+00 -2.8864873474459010e-02 + 9.9574619635248496e-01 -2.3535348796226888e-02 + 9.8814331964739421e-01 -1.8476189442036467e-02 + 9.8069303134320129e-01 -1.3706074342744913e-02 + 9.7343682430154055e-01 -9.2644756422061436e-03 + 9.6642078848801982e-01 -5.1675693902175895e-03 + 9.5969715261024491e-01 -1.3996866581677616e-03 + 9.5329175498616481e-01 2.0293770184672496e-03 + 9.4722427455598968e-01 5.1184071555084414e-03 + 9.4151036633666552e-01 7.8771549701264296e-03 + 9.3613946404752846e-01 1.0275886570591993e-02 + 9.3113446378307296e-01 1.2372563956656075e-02 + 9.2649567024262414e-01 1.4194570957752025e-02 + 9.2221672174338709e-01 1.5767785096362022e-02 + 9.1828588044618087e-01 1.7114143164296682e-02 + 9.1467946046254278e-01 1.8224807742894256e-02 + 9.1139232855248375e-01 1.9154960559921490e-02 + 9.0840613573299245e-01 1.9927472763056356e-02 + 9.0569646304430440e-01 2.0539880524792390e-02 + 9.0324597672503681e-01 2.1012036719915493e-02 + 9.0104045391487020e-01 2.1389389698469055e-02 + 8.9905672909099321e-01 2.1666345943415096e-02 + 8.9727817856419123e-01 2.1863683730962639e-02 + 8.9568842743983890e-01 2.2016326016285122e-02 + 8.9426697422840828e-01 2.2088431036295177e-02 + 8.9300144727552511e-01 2.2144092840756916e-02 + 8.9187498526052622e-01 2.2152915956017104e-02 + 1.1306155428124784e+00 -1.4011984047642767e-01 + 1.1302270198711120e+00 -1.3970986553822556e-01 + 1.1297883863061595e+00 -1.3924679382136101e-01 + 1.1292932636793678e+00 -1.3872418012666227e-01 + 1.1287348170243228e+00 -1.3813459674549153e-01 + 1.1281053073191156e+00 -1.3746993658995540e-01 + 1.1273960305118869e+00 -1.3672134547298148e-01 + 1.1265924636642703e+00 -1.3588376996401386e-01 + 1.1256788033521099e+00 -1.3495161829942837e-01 + 1.1246451456682349e+00 -1.3391155855109424e-01 + 1.1234826124460748e+00 -1.3274731158984157e-01 + 1.1221781528027692e+00 -1.3144453509351020e-01 + 1.1207197383535734e+00 -1.2998639422972050e-01 + 1.1190926476800749e+00 -1.2835646009860346e-01 + 1.1172801993520756e+00 -1.2653861958544815e-01 + 1.1152652692819223e+00 -1.2451559948817875e-01 + 1.1130288092971719e+00 -1.2227113689880431e-01 + 1.1105517162011473e+00 -1.1978873901772227e-01 + 1.1078143712664279e+00 -1.1705273475610103e-01 + 1.1047954565245359e+00 -1.1405039880440856e-01 + 1.1014701412718393e+00 -1.1077497845040515e-01 + 1.0978147221231491e+00 -1.0722237995716916e-01 + 1.0938086215505580e+00 -1.0339071739636153e-01 + 1.0894314409579891e+00 -9.9285002934320465e-02 + 1.0846649602605807e+00 -9.4916970763901334e-02 + 1.0795109597711974e+00 -9.0287347687403971e-02 + 1.0739860262920795e+00 -8.5391789409124938e-02 + 1.0680916348598144e+00 -8.0256048082810810e-02 + 1.0618393943092759e+00 -7.4908995691367192e-02 + 1.0552523867915022e+00 -6.9381250964390309e-02 + 1.0483681896436392e+00 -6.3700938766749232e-02 + 1.0412360367341109e+00 -5.7895860511967275e-02 + 1.0339039029824497e+00 -5.2007308268162945e-02 + 1.0264166282541076e+00 -4.6090594420834699e-02 + 1.0188119672979374e+00 -4.0217809425870416e-02 + 1.0111311928375435e+00 -3.4461684159680990e-02 + 1.0034178753279921e+00 -2.8893620155571027e-02 + 9.9572809362310311e-01 -2.3564753821203526e-02 + 9.8812652025926917e-01 -1.8506104681134592e-02 + 9.8067738018647399e-01 -1.3736657086408307e-02 + 9.7342214561412865e-01 -9.2959128717736705e-03 + 9.6640704322734794e-01 -5.1998245112178003e-03 + 9.5968436911314103e-01 -1.4325917689258774e-03 + 9.5327996557144523e-01 1.9960184375162884e-03 + 9.4721351138201559e-01 5.0848182843742122e-03 + 9.4150066534518961e-01 7.8435967775275610e-03 + 9.3613082557717409e-01 1.0242583878417583e-02 + 9.3112689021752626e-01 1.2339763156797896e-02 + 9.2648911737734463e-01 1.4162413551335554e-02 + 9.2221111877487305e-01 1.5736338005748238e-02 + 9.1828114108606584e-01 1.7083414705414860e-02 + 9.1467546614133821e-01 1.8194676285351517e-02 + 9.1138899823443897e-01 1.9125388687141330e-02 + 9.0840341561308313e-01 1.9898547708619128e-02 + 9.0569431479863372e-01 2.0511884230897452e-02 + 9.0324433316690034e-01 2.0985185681104249e-02 + 9.0103924125694868e-01 2.1363854127698121e-02 + 8.9905586087895151e-01 2.1642076737335522e-02 + 8.9727759057267542e-01 2.1840519437361049e-02 + 8.9568807967487807e-01 2.1994091142943421e-02 + 8.9426683020474851e-01 2.2066776819109544e-02 + 8.9300148906600274e-01 2.2122848269150945e-02 + 8.9187519275522575e-01 2.2131823914644948e-02 + 1.1305919441069432e+00 -1.4012340648332372e-01 + 1.1302030532771239e+00 -1.3971375422970497e-01 + 1.1297639907212984e+00 -1.3925105246208841e-01 + 1.1292683726975601e+00 -1.3872886102199070e-01 + 1.1287093620171591e+00 -1.3813975606868434e-01 + 1.1280792220413394e+00 -1.3747563310950492e-01 + 1.1273692601120644e+00 -1.3672763727861270e-01 + 1.1265649711222867e+00 -1.3589071729401941e-01 + 1.1256506042494070e+00 -1.3495926470442193e-01 + 1.1246163480426581e+00 -1.3391989237202170e-01 + 1.1234534135485010e+00 -1.3275623463005209e-01 + 1.1221490522315702e+00 -1.3145367879268199e-01 + 1.1206907671980846e+00 -1.2999576621251710e-01 + 1.1190637314755099e+00 -1.2836617220118296e-01 + 1.1172511313408722e+00 -1.2654890141466496e-01 + 1.1152360979620402e+00 -1.2452645814276690e-01 + 1.1129997554984505e+00 -1.2228242505459139e-01 + 1.1105229820264904e+00 -1.1980031784939436e-01 + 1.1077861226928132e+00 -1.1706449781526131e-01 + 1.1047678317920955e+00 -1.1406226829737086e-01 + 1.1014432493772464e+00 -1.1078690860826967e-01 + 1.0977886225910340e+00 -1.0723438096853606e-01 + 1.0937833261645831e+00 -1.0340285496632554e-01 + 1.0894069361226579e+00 -9.9297372903671063e-02 + 1.0846412023147973e+00 -9.4929704415498639e-02 + 1.0794879100630002e+00 -9.0300573624694069e-02 + 1.0739636724582877e+00 -8.5405607292803540e-02 + 1.0680699398098201e+00 -8.0270584031044423e-02 + 1.0618183040485600e+00 -7.4924392560989733e-02 + 1.0552318417758588e+00 -6.9397653916468946e-02 + 1.0483481452441490e+00 -6.3718469038789305e-02 + 1.0412164812723008e+00 -5.7914591542468502e-02 + 1.0338848538494427e+00 -5.2027268033764999e-02 + 1.0263981475387483e+00 -4.6111744772384423e-02 + 1.0187941669239864e+00 -4.0240035711840365e-02 + 1.0111141775351062e+00 -3.4484859575378217e-02 + 1.0034017712447298e+00 -2.8917563979310817e-02 + 9.9571302975496589e-01 -2.3589247104030920e-02 + 9.8811254055308362e-01 -1.8531024038909358e-02 + 9.8066435554196107e-01 -1.3762133475538844e-02 + 9.7340992971798379e-01 -9.3221019949249768e-03 + 9.6639560363032795e-01 -5.2266958683713808e-03 + 9.5967372949425300e-01 -1.4600054776649888e-03 + 9.5327015293692630e-01 1.9682261192071290e-03 + 9.4720455261242953e-01 5.0568333281597192e-03 + 9.4149259047897915e-01 7.8156366551656500e-03 + 9.3612363499600004e-01 1.0214835966600175e-02 + 9.3112058600581549e-01 1.2312432815016160e-02 + 9.2648366280236127e-01 1.4135618759434032e-02 + 9.2220645493559439e-01 1.5710134606715810e-02 + 9.1827719617104253e-01 1.7057809706211857e-02 + 9.1467214143283582e-01 1.8169568410907812e-02 + 9.1138622627849675e-01 1.9100746817383281e-02 + 9.0840115163770696e-01 1.9874444578864930e-02 + 9.0569252692518187e-01 2.0488554816869529e-02 + 9.0324296546088723e-01 2.0962810427233542e-02 + 9.0103823227748092e-01 2.1342574913502530e-02 + 8.9905513862374953e-01 2.1621852685966465e-02 + 8.9727710155750340e-01 2.1821216044144449e-02 + 8.9568779060301418e-01 2.1975562194583582e-02 + 8.9426671069980179e-01 2.2048731704096488e-02 + 8.9300152421343926e-01 2.2105144492686447e-02 + 8.9187536581878002e-01 2.2114247223481029e-02 + 1.1305723103467729e+00 -1.4012637402360670e-01 + 1.1301831134354359e+00 -1.3971699028619250e-01 + 1.1297436939582912e+00 -1.3925459636647439e-01 + 1.1292476637595334e+00 -1.3873275630139822e-01 + 1.1286881837998965e+00 -1.3814404947021738e-01 + 1.1280575194212765e+00 -1.3748037354180953e-01 + 1.1273469874431756e+00 -1.3673287308815349e-01 + 1.1265420975919505e+00 -1.3589649861792816e-01 + 1.1256271428080318e+00 -1.3496562779889490e-01 + 1.1245923885652311e+00 -1.3392682756053265e-01 + 1.1234291201388609e+00 -1.3276366023599775e-01 + 1.1221248405647131e+00 -1.3146128818356168e-01 + 1.1206666631327784e+00 -1.3000356575702479e-01 + 1.1190396730412937e+00 -1.2837425498215083e-01 + 1.1172269464836666e+00 -1.2655745851702932e-01 + 1.1152118270147446e+00 -1.2453549551472259e-01 + 1.1129755821926661e+00 -1.2229182015083652e-01 + 1.1104990745179177e+00 -1.1980995519294989e-01 + 1.1077626190831495e+00 -1.1707428886673270e-01 + 1.1047448471087313e+00 -1.1407214835821829e-01 + 1.1014208743186664e+00 -1.1079683962635750e-01 + 1.0977669066904661e+00 -1.0724437145727472e-01 + 1.0937622792265005e+00 -1.0341295964209582e-01 + 1.0893865468287898e+00 -9.9307671567882921e-02 + 1.0846214343205276e+00 -9.4940306374621738e-02 + 1.0794687311871096e+00 -9.0311585965363109e-02 + 1.0739450723957820e+00 -8.5417113020990407e-02 + 1.0680518876689657e+00 -8.0282688183993797e-02 + 1.0618007548598460e+00 -7.4937214121114898e-02 + 1.0552147459420096e+00 -6.9411313797580435e-02 + 1.0483314655770843e+00 -6.3733068251017169e-02 + 1.0412002080125600e+00 -5.7930191310168119e-02 + 1.0338690014414855e+00 -5.2043891732342890e-02 + 1.0263827676508124e+00 -4.6129360713794636e-02 + 1.0187793527351046e+00 -4.0258548491424462e-02 + 1.0111000162547712e+00 -3.4504163645252897e-02 + 1.0033883679393967e+00 -2.8937508865595610e-02 + 9.9570049188668464e-01 -2.3609650466026838e-02 + 9.8810090477184742e-01 -1.8551783096979146e-02 + 9.8065351437553805e-01 -1.3783357276022449e-02 + 9.7339976134828410e-01 -9.3439202085321086e-03 + 9.6638608107709867e-01 -5.2490830752793313e-03 + 9.5966487253604116e-01 -1.4828451343842162e-03 + 9.5326198413096264e-01 1.9450704473197823e-03 + 9.4719709441721478e-01 5.0335166092314925e-03 + 9.4148586798795530e-01 7.7923401140450235e-03 + 9.3611764859732238e-01 1.0191715768437313e-02 + 9.3111533750594655e-01 1.2289660115856863e-02 + 9.2647912166432733e-01 1.4113291919787389e-02 + 9.2220257214722323e-01 1.5688300215057141e-02 + 9.1827391195688912e-01 1.7036473656073949e-02 + 9.1466937359173883e-01 1.8148646365415421e-02 + 9.1138391865251189e-01 1.9080212885801532e-02 + 9.0839926696301043e-01 1.9854359402719415e-02 + 9.0569103867731260e-01 2.0469114226157818e-02 + 9.0324182706610667e-01 2.0944164815132664e-02 + 9.0103739256924442e-01 2.1324842537835585e-02 + 8.9905453763070109e-01 2.1604999513043822e-02 + 8.9727669473543481e-01 2.1805130014079414e-02 + 8.9568755022695989e-01 2.1960121484277000e-02 + 8.9426661147596798e-01 2.2033694155141257e-02 + 8.9300155373041368e-01 2.2090391369277363e-02 + 8.9187551014525690e-01 2.2099599988035203e-02 + 1.1305559712973163e+00 -1.4012884405752260e-01 + 1.1301665196647008e+00 -1.3971968381055380e-01 + 1.1297268031554257e+00 -1.3925754611858579e-01 + 1.1292304299393627e+00 -1.3873599851122279e-01 + 1.1286705594361923e+00 -1.3814762304862432e-01 + 1.1280394586347702e+00 -1.3748431920011225e-01 + 1.1273284522402593e+00 -1.3673723107162047e-01 + 1.1265230623217752e+00 -1.3590131066429448e-01 + 1.1256076182385391e+00 -1.3497092409626493e-01 + 1.1245724494820173e+00 -1.3393260007286703e-01 + 1.1234089031035712e+00 -1.3276984100799827e-01 + 1.1221046915103725e+00 -1.3146762204097143e-01 + 1.1206466035739739e+00 -1.3001005801755988e-01 + 1.1190196513948043e+00 -1.2838098313457508e-01 + 1.1172068195427942e+00 -1.2656458161974474e-01 + 1.1151916283324896e+00 -1.2454301854766743e-01 + 1.1129554646720980e+00 -1.2229964115118504e-01 + 1.1104791781033561e+00 -1.1981797807838490e-01 + 1.1077430587095927e+00 -1.1708243997241817e-01 + 1.1047257185107495e+00 -1.1408037386000199e-01 + 1.1014022529852794e+00 -1.1080510787668019e-01 + 1.0977488338496297e+00 -1.0725268956665124e-01 + 1.0937447630378037e+00 -1.0342137318084350e-01 + 1.0893695778683610e+00 -9.9316246990747467e-02 + 1.0846049823290871e+00 -9.4949134702852350e-02 + 1.0794527693672276e+00 -9.0320756379476994e-02 + 1.0739295921583607e+00 -8.5426694661087446e-02 + 1.0680368632828796e+00 -8.0292768538092585e-02 + 1.0617861488688560e+00 -7.4947892295417803e-02 + 1.0552005170310541e+00 -6.9422690515755101e-02 + 1.0483175827580804e+00 -6.3745227673397409e-02 + 1.0411866631333084e+00 -5.7943184474910744e-02 + 1.0338558065051067e+00 -5.2057738162419591e-02 + 1.0263699656630974e+00 -4.6144034074985303e-02 + 1.0187670212814364e+00 -4.0273969377267196e-02 + 1.0110882279633755e+00 -3.4520244185528168e-02 + 1.0033772103258254e+00 -2.8954123755367218e-02 + 9.9569005447843417e-01 -2.3626647836789454e-02 + 9.8809121812980871e-01 -1.8569077327636775e-02 + 9.8064448901813683e-01 -1.3801039179265789e-02 + 9.7339129583754413e-01 -9.3620977860043395e-03 + 9.6637815297241081e-01 -5.2677351414524495e-03 + 9.5965749835186076e-01 -1.5018745874258630e-03 + 9.5325518270173848e-01 1.9257772908580458e-03 + 9.4719088449912203e-01 5.0140888836920031e-03 + 9.4148027053545369e-01 7.7729288390974462e-03 + 9.3611266398336856e-01 1.0172451094159035e-02 + 9.3111096728469644e-01 1.2270684688668791e-02 + 9.2647534044021607e-01 1.4094687737934167e-02 + 9.2219933912750229e-01 1.5670106139108644e-02 + 9.1827117737618968e-01 1.7018694635677987e-02 + 9.1466706899396499e-01 1.8131212161482793e-02 + 9.1138199727708080e-01 1.9063101952779340e-02 + 9.0839769778935975e-01 1.9837622295481732e-02 + 9.0568979963049279e-01 2.0452914148178489e-02 + 9.0324087936185993e-01 2.0928627110221698e-02 + 9.0103669359286975e-01 2.1310065771827588e-02 + 8.9905403742739898e-01 2.1590955345650458e-02 + 8.9727635620343482e-01 2.1791725081427609e-02 + 8.9568735027787216e-01 2.1947254282175036e-02 + 8.9426652904555415e-01 2.2021162897531057e-02 + 8.9300157848810702e-01 2.2078097116521974e-02 + 8.9187563049256957e-01 2.2087393963676847e-02 + 1.1305423711750264e+00 -1.4013090036667855e-01 + 1.1301527075182909e+00 -1.3972192616991069e-01 + 1.1297127437648422e+00 -1.3926000178180611e-01 + 1.1292160850256505e+00 -1.3873869763977989e-01 + 1.1286558894366798e+00 -1.3815059803672999e-01 + 1.1280244253568408e+00 -1.3748760394153603e-01 + 1.1273130240539606e+00 -1.3674085907363931e-01 + 1.1265072178699620e+00 -1.3590531667797617e-01 + 1.1255913664775457e+00 -1.3497533326046937e-01 + 1.1245558526557924e+00 -1.3393740571041099e-01 + 1.1233920748788229e+00 -1.3277498656567691e-01 + 1.1220879198394753e+00 -1.3147289512163071e-01 + 1.1206299063615037e+00 -1.3001546305991762e-01 + 1.1190029856960770e+00 -1.2838658465625274e-01 + 1.1171900661396239e+00 -1.2657051204354039e-01 + 1.1151748151450778e+00 -1.2454928203974894e-01 + 1.1129387189744937e+00 -1.2230615285380669e-01 + 1.1104626163855447e+00 -1.1982465802725197e-01 + 1.1077267766455285e+00 -1.1708922686319655e-01 + 1.1047097957937690e+00 -1.1408722290328929e-01 + 1.1013867524574730e+00 -1.1081199274341481e-01 + 1.0977337898327484e+00 -1.0725961619355986e-01 + 1.0937301823238823e+00 -1.0342837952455065e-01 + 1.0893554526098819e+00 -9.9323388397501600e-02 + 1.0845912873295156e+00 -9.4956486976336810e-02 + 1.0794394823096312e+00 -9.0328393795708214e-02 + 1.0739167058839432e+00 -8.5434674814726941e-02 + 1.0680243563575580e+00 -8.0301164305472850e-02 + 1.0617739900919174e+00 -7.4956786232992956e-02 + 1.0551886719845969e+00 -6.9432166533321599e-02 + 1.0483060256201431e+00 -6.3755355894162050e-02 + 1.0411753870966713e+00 -5.7954007443259320e-02 + 1.0338448215486533e+00 -5.2069272178031936e-02 + 1.0263593075890440e+00 -4.6156257243538633e-02 + 1.0187567546994272e+00 -4.0286815595208622e-02 + 1.0110784133643931e+00 -3.4533640288414304e-02 + 1.0033679206115471e+00 -2.8967965385488039e-02 + 9.9568136423795617e-01 -2.3640808494871685e-02 + 9.8808315284420245e-01 -1.8583485682792552e-02 + 9.8063697417450502e-01 -1.3815770867106662e-02 + 9.7338424695857995e-01 -9.3772427677065937e-03 + 9.6637155138769426e-01 -5.2832757606828011e-03 + 9.5965135784621225e-01 -1.5177299384630757e-03 + 9.5324951899622878e-01 1.9097019357525152e-03 + 9.4718571325267065e-01 4.9979011323856614e-03 + 9.4147560924049289e-01 7.7567545405322286e-03 + 9.3610851298539988e-01 1.0156398715603889e-02 + 9.3110732791315243e-01 1.2254873113679159e-02 + 9.2647219156865745e-01 1.4079185319982267e-02 + 9.2219664679757829e-01 1.5654945288258448e-02 + 9.1826890015014229e-01 1.7003879503417533e-02 + 9.1466514985653058e-01 1.8116684244558284e-02 + 9.1138039728770348e-01 1.9048843317646356e-02 + 9.0839639112040105e-01 1.9823675085446003e-02 + 9.0568876790647190e-01 2.0439414374605745e-02 + 9.0324009028148999e-01 2.0915679237438901e-02 + 9.0103611166093855e-01 2.1297751950462379e-02 + 8.9905362102997655e-01 2.1579251973675835e-02 + 8.9727607443522317e-01 2.1780554369285665e-02 + 8.9568718390962387e-01 2.1936531653551826e-02 + 8.9426646053347170e-01 2.2010720206211407e-02 + 8.9300159923208666e-01 2.2067851917798791e-02 + 8.9187573083488625e-01 2.2077222280440709e-02 + 1.1305310487868363e+00 -1.4013261251657178e-01 + 1.1301412086141973e+00 -1.3972379322710127e-01 + 1.1297010390221809e+00 -1.3926204643838611e-01 + 1.1292041425746546e+00 -1.3874094500934228e-01 + 1.1286436763384211e+00 -1.3815307509213073e-01 + 1.1280119098121089e+00 -1.3749033890502099e-01 + 1.1273001797265956e+00 -1.3674387984660169e-01 + 1.1264940269752570e+00 -1.3590865219829212e-01 + 1.1255778364673317e+00 -1.3497900446466424e-01 + 1.1245420353456668e+00 -1.3394140704786700e-01 + 1.1233780648966569e+00 -1.3277927096217049e-01 + 1.1220739569175142e+00 -1.3147728575345774e-01 + 1.1206160054032390e+00 -1.3001996363113735e-01 + 1.1189891109432892e+00 -1.2839124889201042e-01 + 1.1171761183284414e+00 -1.2657545020794675e-01 + 1.1151608175138574e+00 -1.2455449761596975e-01 + 1.1129247774832196e+00 -1.2231157520511170e-01 + 1.1104488280176867e+00 -1.1983022058991243e-01 + 1.1077132210556135e+00 -1.1709487860837796e-01 + 1.1046965393330308e+00 -1.1409292655150016e-01 + 1.1013738474485162e+00 -1.1081772638457255e-01 + 1.0977212648524084e+00 -1.0726538478293256e-01 + 1.0937180430269708e+00 -1.0343421467940016e-01 + 1.0893436924606423e+00 -9.9329336216902611e-02 + 1.0845798853446897e+00 -9.4962610596715208e-02 + 1.0794284199017126e+00 -9.0334755085029000e-02 + 1.0739059770864976e+00 -8.5441321753042032e-02 + 1.0680139433147529e+00 -8.0308157601852004e-02 + 1.0617638668122060e+00 -7.4964194661848144e-02 + 1.0551788097942476e+00 -6.9440060000888273e-02 + 1.0482964030018329e+00 -6.3763792829136787e-02 + 1.0411659983682395e+00 -5.7963023308147926e-02 + 1.0338356750090616e+00 -5.2078880577297752e-02 + 1.0263504330484305e+00 -4.6166439967648236e-02 + 1.0187482059675772e+00 -4.0297517605891148e-02 + 1.0110702408276753e+00 -3.4544800657823893e-02 + 1.0033601850016693e+00 -2.8979497193187619e-02 + 9.9567412770062025e-01 -2.3652606365270334e-02 + 9.8807643662311562e-01 -1.8595490187559571e-02 + 9.8063071621433928e-01 -1.3828045006755297e-02 + 9.7337837689953188e-01 -9.3898614815591461e-03 + 9.6636605369225503e-01 -5.2962243340529064e-03 + 9.5964624401765641e-01 -1.5309409587081519e-03 + 9.5324480215362661e-01 1.8963074025549816e-03 + 9.4718140646512716e-01 4.9844127566081352e-03 + 9.4147172710639981e-01 7.7432771957956130e-03 + 9.3610505581704784e-01 1.0143022797460564e-02 + 9.3110429684248563e-01 1.2241697699796090e-02 + 9.2646956901581146e-01 1.4066267386926923e-02 + 9.2219440448894185e-01 1.5642311862589599e-02 + 9.1826700357766045e-01 1.6991534063710834e-02 + 9.1466355152964429e-01 1.8104578058524425e-02 + 9.1137906477446373e-01 1.9036961455524797e-02 + 9.0839530291389448e-01 1.9812052676611715e-02 + 9.0568790870797455e-01 2.0428164767699427e-02 + 9.0323943318664923e-01 2.0904889494089571e-02 + 9.0103562710225915e-01 2.1287490538113310e-02 + 8.9905327433973758e-01 2.1569499234558281e-02 + 8.9727583986806669e-01 2.1771245488195760e-02 + 8.9568704544889322e-01 2.1927596157674433e-02 + 8.9426640356633702e-01 2.2002017979872848e-02 + 8.9300161659769106e-01 2.2059314260547323e-02 + 8.9187581449058984e-01 2.2068745880343358e-02 + 1.1305216211980325e+00 -1.4013403829825077e-01 + 1.1301316340483984e+00 -1.3972534800400521e-01 + 1.1296912930630361e+00 -1.3926374910710079e-01 + 1.1291941986846081e+00 -1.3874281648308739e-01 + 1.1286335070892866e+00 -1.3815513783276795e-01 + 1.1280014887242256e+00 -1.3749261641531454e-01 + 1.1272894848685857e+00 -1.3674639536267749e-01 + 1.1264830435356441e+00 -1.3591142982009710e-01 + 1.1255665706476472e+00 -1.3498206163063661e-01 + 1.1245305302875517e+00 -1.3394473914200855e-01 + 1.1233663993906009e+00 -1.3278283879338820e-01 + 1.1220623305806321e+00 -1.3148094209037606e-01 + 1.1206044306433034e+00 -1.3002371156420509e-01 + 1.1189775579820456e+00 -1.2839513316440207e-01 + 1.1171645045052827e+00 -1.2657956264473433e-01 + 1.1151491621741123e+00 -1.2455884112764998e-01 + 1.1129131688555707e+00 -1.2231609098240716e-01 + 1.1104373468577453e+00 -1.1983485321432669e-01 + 1.1077019336905336e+00 -1.1709958559654662e-01 + 1.1046855010134931e+00 -1.1409767686877823e-01 + 1.1013631017445233e+00 -1.1082250179402818e-01 + 1.0977108355609200e+00 -1.0727018941949726e-01 + 1.0937079348565943e+00 -1.0343907488167252e-01 + 1.0893338999677011e+00 -9.9334290384757024e-02 + 1.0845703910527067e+00 -9.4967711320574508e-02 + 1.0794192083281116e+00 -9.0340053901311015e-02 + 1.0738970432586805e+00 -8.5446858634252110e-02 + 1.0680052723570530e+00 -8.0313983124109450e-02 + 1.0617554370712594e+00 -7.4970366121372298e-02 + 1.0551705973808616e+00 -6.9446635639758753e-02 + 1.0482883899855540e+00 -6.3770821332860772e-02 + 1.0411581800072465e+00 -5.7970534235019036e-02 + 1.0338280582075490e+00 -5.2086885279302012e-02 + 1.0263430426304239e+00 -4.6174923295261350e-02 + 1.0187410867525846e+00 -4.0306433727472397e-02 + 1.0110634347884015e+00 -3.4554098829963811e-02 + 1.0033537427341201e+00 -2.8989105013187254e-02 + 9.9566810098447034e-01 -2.3662436048487910e-02 + 9.8807084316817917e-01 -1.8605492220265068e-02 + 9.8062550433487827e-01 -1.3838271868967260e-02 + 9.7337348798908596e-01 -9.4003756028839328e-03 + 9.6636147481759704e-01 -5.3070134514892238e-03 + 9.5964198477604312e-01 -1.5419489010673932e-03 + 9.5324087349031683e-01 1.8851464093185984e-03 + 9.4717781928508227e-01 4.9731734358119395e-03 + 9.4146849358987805e-01 7.7320469417518538e-03 + 9.3610217624133241e-01 1.0131876944112788e-02 + 9.3110177216772394e-01 1.2230718817532174e-02 + 9.2646738461005507e-01 1.4055502966952517e-02 + 9.2219253680833446e-01 1.5631784439803113e-02 + 9.1826542388192112e-01 1.6981246550101158e-02 + 9.1466222025869626e-01 1.8094489858283967e-02 + 9.1137795491476248e-01 1.9027060137523668e-02 + 9.0839439655419396e-01 1.9802367522344488e-02 + 9.0568719310937484e-01 2.0418790238507976e-02 + 9.0323888593817625e-01 2.0895898146825104e-02 + 9.0103522357262800e-01 2.1278939435084486e-02 + 8.9905298564659619e-01 2.1561372001599091e-02 + 8.9727564456326259e-01 2.1763488119347384e-02 + 8.9568693019062884e-01 2.1920149930722208e-02 + 8.9426635618202821e-01 2.1994766136189788e-02 + 8.9300163112428510e-01 2.2052199552051264e-02 + 8.9187588422959407e-01 2.2061682215440914e-02 + 9.2936425990562865e-01 -3.3158224227577235e-02 + 9.2479340500563301e-01 -3.1431025326258230e-02 + 9.2021683799116616e-01 -2.9719013939801153e-02 + 9.1563382586907693e-01 -2.8024313889992700e-02 + 9.1104388825886495e-01 -2.6348459921772004e-02 + 9.0645064479391968e-01 -2.4681781309151940e-02 + 9.0186737024268770e-01 -2.2988200769659052e-02 + 8.9731113903987225e-01 -2.1223620817637356e-02 + 8.9281968014553803e-01 -1.9301791620651210e-02 + 8.8846586864004784e-01 -1.7089405955289877e-02 + 9.2935965855862213e-01 -3.3169474019211449e-02 + 9.2478850609034824e-01 -3.1442374387066506e-02 + 9.2021164972154190e-01 -2.9730439688137808e-02 + 9.1562839532538332e-01 -2.8035683394978930e-02 + 9.1103831380832589e-01 -2.6359521135652694e-02 + 9.0644510014863033e-01 -2.4692159915839632e-02 + 9.0186208561985148e-01 -2.2997503852492763e-02 + 8.9730629687508234e-01 -2.1231614007534705e-02 + 8.9281534470812851e-01 -1.9308465800680883e-02 + 8.8846192742019758e-01 -1.7095022601980443e-02 + 9.2935413693344926e-01 -3.3182973762776909e-02 + 9.2478262738426265e-01 -3.1455993253929830e-02 + 9.2020542379134762e-01 -2.9744150580402404e-02 + 9.1562187866731393e-01 -2.8049326795615930e-02 + 9.1103162446307662e-01 -2.6372794587452602e-02 + 9.0643844657067463e-01 -2.4704614239534448e-02 + 9.0185574406973257e-01 -2.3008667548180262e-02 + 8.9730048627551495e-01 -2.1241205832381396e-02 + 8.9281014218224508e-01 -1.9316474814389153e-02 + 8.8845719795635203e-01 -1.7101762576313597e-02 + 9.2934751097058532e-01 -3.3199173445753766e-02 + 9.2477557292586432e-01 -3.1472335885443826e-02 + 9.2019795266552251e-01 -2.9760603642891396e-02 + 9.1561405866955192e-01 -2.8065698868753198e-02 + 9.1102359724219695e-01 -2.6388722722583902e-02 + 9.0643046227191837e-01 -2.4719559421725764e-02 + 9.0184813420570931e-01 -2.3022063977679658e-02 + 8.9729351355337850e-01 -2.1252716017888185e-02 + 8.9280389914983849e-01 -1.9326085627489498e-02 + 8.8845152259960658e-01 -1.7109850543039821e-02 + 9.2933955979692617e-01 -3.3218613051902955e-02 + 9.2476710755975644e-01 -3.1491947030593125e-02 + 9.2018898730070320e-01 -2.9780347305966383e-02 + 9.1560467466055673e-01 -2.8085345345455620e-02 + 9.1101396456753880e-01 -2.6407836474630981e-02 + 9.0642088110589003e-01 -2.4737493631364366e-02 + 9.0183900236324710e-01 -2.3038139685386524e-02 + 8.9728514628308842e-01 -2.1266528234227530e-02 + 8.9279640750896749e-01 -1.9337618598378851e-02 + 8.8844471217144183e-01 -1.7119556099620382e-02 + 9.2933001836226037e-01 -3.3241940560005928e-02 + 9.2475694909731099e-01 -3.1515480386479409e-02 + 9.2017822884293365e-01 -2.9804039684514404e-02 + 9.1559341383295845e-01 -2.8108921101459149e-02 + 9.1100240534418675e-01 -2.6430772962426380e-02 + 9.0640938369578450e-01 -2.4759014669869569e-02 + 9.0182804414425510e-01 -2.3057430523497624e-02 + 8.9727510555329981e-01 -2.1283102884743801e-02 + 8.9278741753709556e-01 -1.9351458156443974e-02 + 8.8843653965748670e-01 -1.7131202762404995e-02 + 9.2931856860280171e-01 -3.3269933541819327e-02 + 9.2474475890905017e-01 -3.1543720387224368e-02 + 9.2016531866484541e-01 -2.9832470513959760e-02 + 9.1557990081554885e-01 -2.8137211985562079e-02 + 9.1098853425630455e-01 -2.6458296726657681e-02 + 9.0639558678807386e-01 -2.4784839897322979e-02 + 9.0181489426980543e-01 -2.3080579513180984e-02 + 8.9726305666970085e-01 -2.1302992452311834e-02 + 8.9277662956679071e-01 -1.9368065616071933e-02 + 8.8842673264048533e-01 -1.7145178750387898e-02 + 9.2930482883674248e-01 -3.3303525079619513e-02 + 9.2473013063504061e-01 -3.1577608350038901e-02 + 9.2014982640963450e-01 -2.9866587473471456e-02 + 9.1556368515967590e-01 -2.8171161013144073e-02 + 9.1097188892217051e-01 -2.6491325213156312e-02 + 9.0637903047623858e-01 -2.4815830143056102e-02 + 9.0179911440369920e-01 -2.3108358277586144e-02 + 8.9724859799812429e-01 -2.1326859914458905e-02 + 8.9276368399647943e-01 -1.9387994553022387e-02 + 8.8841496421970567e-01 -1.7161949925314897e-02 + 9.2928834103859481e-01 -3.3343834866772080e-02 + 9.2471257663684425e-01 -3.1618273850318006e-02 + 9.2013123564349064e-01 -2.9907527773069872e-02 + 9.1554422632210786e-01 -2.8211899797934085e-02 + 9.1095191447994872e-01 -2.6530959352795851e-02 + 9.0635916286956031e-01 -2.4853018398702527e-02 + 9.0178017854018755e-01 -2.3141692761275031e-02 + 8.9723124757601613e-01 -2.1355500841727808e-02 + 8.9274814930369861e-01 -1.9411909256228543e-02 + 8.8840084211442083e-01 -1.7182075319757358e-02 + 9.2926855556688048e-01 -3.3392206526971106e-02 + 9.2469151173883679e-01 -3.1667072370955625e-02 + 9.2010892663764043e-01 -2.9956656057557502e-02 + 9.1552087564410101e-01 -2.8260786269835751e-02 + 9.1092794508963526e-01 -2.6578520256334875e-02 + 9.0633532169465825e-01 -2.4897644248469967e-02 + 9.0175745546913122e-01 -2.3181694093114782e-02 + 8.9721042704601051e-01 -2.1389869914805050e-02 + 8.9272950766016823e-01 -1.9440606869488487e-02 + 8.8838389558746256e-01 -1.7206225770740321e-02 + 9.2924481283622729e-01 -3.3450252397047742e-02 + 9.2466623371648293e-01 -3.1725630480257574e-02 + 9.2008215570576901e-01 -3.0015609890334777e-02 + 9.1549285472530773e-01 -2.8319449934879618e-02 + 9.1089918173520490e-01 -2.6635593247901351e-02 + 9.0630671221713299e-01 -2.4951195185750886e-02 + 9.0173018773357072e-01 -2.3229695620774114e-02 + 8.9718544237634046e-01 -2.1431112745026199e-02 + 8.9270713767044207e-01 -1.9475043961017076e-02 + 8.8836355975435388e-01 -1.7235206279470811e-02 + 9.2921632132151677e-01 -3.3519907264095192e-02 + 9.2463589988055472e-01 -3.1795900044007508e-02 + 9.2005003040702693e-01 -3.0086354332106068e-02 + 9.1545922947067337e-01 -2.8389846186026118e-02 + 9.1086466558560431e-01 -2.6704080703295264e-02 + 9.0627238074643623e-01 -2.5015456190829732e-02 + 9.0169746637832882e-01 -2.3287297351703984e-02 + 8.9715546072403474e-01 -2.1480604057947737e-02 + 8.9268029365761115e-01 -1.9516368406550084e-02 + 8.8833915675367336e-01 -1.7269982842809974e-02 + 9.2918213115965054e-01 -3.3603492847392481e-02 + 9.2459949897482963e-01 -3.1880223277430710e-02 + 9.2001147978759334e-01 -3.0171247433308887e-02 + 9.1541887894528007e-01 -2.8474321474059944e-02 + 9.1082324602643183e-01 -2.6786265454303220e-02 + 9.0623118284048010e-01 -2.5092569222949241e-02 + 9.0165820064730440e-01 -2.3356419280137177e-02 + 8.9711948267111508e-01 -2.1539993512283123e-02 + 8.9264808080603997e-01 -1.9565957647480269e-02 + 8.8830987315168375e-01 -1.7311714650238025e-02 + 9.2914110246699244e-01 -3.3703795173524009e-02 + 9.2455581744997894e-01 -3.1981410804011970e-02 + 9.1996521866655190e-01 -3.0273118821930747e-02 + 9.1537045799677963e-01 -2.8575691509354743e-02 + 9.1077354229567498e-01 -2.6884886871169834e-02 + 9.0618174514946548e-01 -2.5185104608353763e-02 + 9.0161108161883630e-01 -2.3439365377756389e-02 + 8.9707630890651813e-01 -2.1611260680959941e-02 + 8.9260942533222365e-01 -1.9625464600202158e-02 + 8.8827473282806013e-01 -1.7361792719145643e-02 + 9.2909186731330562e-01 -3.3824157420341450e-02 + 9.2450339898542411e-01 -3.2102835320844882e-02 + 9.1990970477411038e-01 -3.0395364003117355e-02 + 9.1531235239795328e-01 -2.8697335099188023e-02 + 9.1071389744274012e-01 -2.7003232156667091e-02 + 9.0612241962527773e-01 -2.5296146701559521e-02 + 9.0155453856612366e-01 -2.3538900379148874e-02 + 8.9702450024304781e-01 -2.1696781025766339e-02 + 8.9256303868893228e-01 -1.9696872744263138e-02 + 8.8823256443853771e-01 -1.7421886255742685e-02 + 9.2903278408030054e-01 -3.3968591321795784e-02 + 9.2444049590687294e-01 -3.2248543989102263e-02 + 9.1984308730953357e-01 -3.0542057512071428e-02 + 9.1524262501161247e-01 -2.8843306745906881e-02 + 9.1064232307448933e-01 -2.7145245893290825e-02 + 9.0605122856935250e-01 -2.5429396673643089e-02 + 9.0148668658679021e-01 -2.3658341919046949e-02 + 8.9696232963622080e-01 -2.1799405062811503e-02 + 8.9250737460985152e-01 -1.9782562225748541e-02 + 8.8818196237071168e-01 -1.7493998285575626e-02 + 9.2896188267640156e-01 -3.4141910840617941e-02 + 9.2436501087426570e-01 -3.2423393290362361e-02 + 9.1976314519918334e-01 -3.0718088685439477e-02 + 9.1515895117864798e-01 -2.9018471753796189e-02 + 9.1055643304236111e-01 -2.7315661489209025e-02 + 9.0596579868349214e-01 -2.5589295848916938e-02 + 9.0140526375422181e-01 -2.3801671089773917e-02 + 8.9688772460390054e-01 -2.1922553354632824e-02 + 8.9244057756114548e-01 -1.9885389175720025e-02 + 8.8812123989068714e-01 -1.7580532406871418e-02 + 9.2887679877205487e-01 -3.4349892557060474e-02 + 9.2427442688696226e-01 -3.2633210836440968e-02 + 9.1966721298949905e-01 -3.0929324570216181e-02 + 9.1505854116967622e-01 -2.9228668340872538e-02 + 9.1045336385585640e-01 -2.7520158899304349e-02 + 9.0586328192264765e-01 -2.5781173696031900e-02 + 9.0130755569241583e-01 -2.3973665098924405e-02 + 8.9679819812558315e-01 -2.2070330491776868e-02 + 8.9236042088204992e-01 -2.0008780885867470e-02 + 8.8804837292003269e-01 -1.7684372888755635e-02 + 9.2877469484784225e-01 -3.4599468105483339e-02 + 9.2416572326056790e-01 -3.2884989512940464e-02 + 9.1955209189282405e-01 -3.1182805387934793e-02 + 9.1493804710587812e-01 -2.9480902148941782e-02 + 9.1032967916153629e-01 -2.7765553867024406e-02 + 9.0574026050487277e-01 -2.6011425396489572e-02 + 9.0119030505688635e-01 -2.4180056440189730e-02 + 8.9669076571590278e-01 -2.2247661855677177e-02 + 8.9226423255074927e-01 -2.0156850007332593e-02 + 8.8796093256893682e-01 -1.7808980780745814e-02 + 9.2865216540058282e-01 -3.4898955053733423e-02 + 9.2403527475402281e-01 -3.3187120409056720e-02 + 9.1941394300415880e-01 -3.1486979050860078e-02 + 9.1479345123210887e-01 -2.9783579616869733e-02 + 9.1018125509232795e-01 -2.8060024979605868e-02 + 9.0559263290375058e-01 -2.6287724895481111e-02 + 9.0104960289733182e-01 -2.4427723872025027e-02 + 8.9656184590388344e-01 -2.2460457712473174e-02 + 8.9214880609981018e-01 -2.0334531572153335e-02 + 8.8785600417713106e-01 -1.7958509231322875e-02 + 9.2850512311259459e-01 -3.5258333889031102e-02 + 9.2387873045426938e-01 -3.3549672266903037e-02 + 9.1924815910340607e-01 -3.1851982518948885e-02 + 9.1461993179663958e-01 -3.0146787969833104e-02 + 9.1000314264848781e-01 -2.8413386079529139e-02 + 9.0541547701013358e-01 -2.6619280513681513e-02 + 9.0088075827234393e-01 -2.4724921549291987e-02 + 8.9640714079495620e-01 -2.2715810090020095e-02 + 8.9201029370918039e-01 -2.0547747391649447e-02 + 8.8773009016631188e-01 -1.8137941849131842e-02 + 9.2832866213478826e-01 -3.5689580292466258e-02 + 9.2369086833303815e-01 -3.3984726717832529e-02 + 9.1904921072905132e-01 -3.2289979329832977e-02 + 9.1441170203326627e-01 -3.0582631113704132e-02 + 9.0978940249568641e-01 -2.8837413073249933e-02 + 9.0520288588163933e-01 -2.7017141604932408e-02 + 9.0067814175503857e-01 -2.5081553915290322e-02 + 8.9622149272606511e-01 -2.3022228976662125e-02 + 8.9184407791007703e-01 -2.0803603291746166e-02 + 8.8757899346693814e-01 -1.8353258704791289e-02 + 9.2811689384159402e-01 -3.6207063699546516e-02 + 9.2346542055478809e-01 -3.4506780404045520e-02 + 9.1881046132990640e-01 -3.2815564481457053e-02 + 9.1416181682702291e-01 -3.1105632564069216e-02 + 9.0953290663326480e-01 -2.9346235967246188e-02 + 9.0494777057366982e-01 -2.7494566425014726e-02 + 9.0043499759177847e-01 -2.5509505468461476e-02 + 8.9599871222193161e-01 -2.3389925673881481e-02 + 8.9164461761852054e-01 -2.1110625728784013e-02 + 8.8739767763858779e-01 -1.8611635482398216e-02 + 9.2786274944839020e-01 -3.6828025305350183e-02 + 9.2319486359539304e-01 -3.5133227270039272e-02 + 9.1852394523520020e-01 -3.3446250048134153e-02 + 9.1386194053795722e-01 -3.1733218731708715e-02 + 9.0922510025683467e-01 -2.9956809099780785e-02 + 9.0464162343173093e-01 -2.8067463383731565e-02 + 9.0014321821901422e-01 -2.6023036318023243e-02 + 8.9573137149782567e-01 -2.3831152684140010e-02 + 8.9140526335837533e-01 -2.1479045621325538e-02 + 8.8718009902678474e-01 -1.8921682380565037e-02 + 9.2755774270066438e-01 -3.7573151248390030e-02 + 9.2287016599251881e-01 -3.5884936908076988e-02 + 9.1818010088475732e-01 -3.4203047535886891e-02 + 9.1350206811468593e-01 -3.2486298503193206e-02 + 9.0885571577534952e-01 -3.0689475083314474e-02 + 9.0427423387745520e-01 -2.8754920245727338e-02 + 8.9979307356723937e-01 -2.6639256590428623e-02 + 8.9541055659294533e-01 -2.4360611361715672e-02 + 8.9111803550363344e-01 -2.1921138780320485e-02 + 8.8691900537227608e-01 -1.9293730666105863e-02 + 9.2719168438383726e-01 -3.8467259758384734e-02 + 9.2248048502367608e-01 -3.6786947930778899e-02 + 9.1776745017837991e-01 -3.5111166097156268e-02 + 9.1307018999639766e-01 -3.3389958161043488e-02 + 9.0841242928726751e-01 -3.1568641001221628e-02 + 9.0383334709200391e-01 -2.9579838690958777e-02 + 8.9937288604413168e-01 -2.7378695302274624e-02 + 8.9502556981993675e-01 -2.4995940751992286e-02 + 8.9077335812958569e-01 -2.2451634156559205e-02 + 8.8660569417605173e-01 -1.9740176335245569e-02 + 9.2675233859131634e-01 -3.9540124661746626e-02 + 9.2201280172696631e-01 -3.7869298993839472e-02 + 9.1727221285207217e-01 -3.6200849413521058e-02 + 9.1255188930100639e-01 -3.4474294367986179e-02 + 9.0788044780077781e-01 -3.2623588992072329e-02 + 9.0330425402029890e-01 -3.0569695021747466e-02 + 8.9886864022219648e-01 -2.8265982347064018e-02 + 8.9456357252869345e-01 -2.5758303653431357e-02 + 8.9035973956936487e-01 -2.3088203308736666e-02 + 8.8622972279110879e-01 -2.0275892182535959e-02 + 9.2622500840290933e-01 -4.0827461874943446e-02 + 9.2145148132503474e-01 -3.9168024388358154e-02 + 9.1667784237072569e-01 -3.7508378399040976e-02 + 9.1192985732947374e-01 -3.5775412282123636e-02 + 9.0724201300800666e-01 -3.3889447593158033e-02 + 9.0266929870310819e-01 -3.1757451790333097e-02 + 8.9826351399036219e-01 -2.9330665826035513e-02 + 8.9400915613378729e-01 -2.6673089024708715e-02 + 8.8986338897499417e-01 -2.3852047084607659e-02 + 8.8577856061404237e-01 -2.0918721768547435e-02 + 9.2559203571140714e-01 -4.2372110462778147e-02 + 9.2077774313676064e-01 -4.0726346142617040e-02 + 9.1596446679113586e-01 -3.9077271963649532e-02 + 9.1118331034733424e-01 -3.7336620958713457e-02 + 9.0647580436087982e-01 -3.5408355191352742e-02 + 9.0190728597229197e-01 -3.3182649810673627e-02 + 8.9753731515542945e-01 -3.0608191170867233e-02 + 8.9334382686845049e-01 -2.7770753494317655e-02 + 8.8926775600384356e-01 -2.4768598555985150e-02 + 8.8523717183688944e-01 -2.1690071364623545e-02 + 1.1275627788571210e+00 -1.4524478825749790e-01 + 1.1271250633262544e+00 -1.4494431052837831e-01 + 1.1266764884148039e+00 -1.4460563231066945e-01 + 1.1262121387892778e+00 -1.4423366747811847e-01 + 1.1257276655791453e+00 -1.4383118973510978e-01 + 1.1252195853861300e+00 -1.4339965031538771e-01 + 1.1246858001265536e+00 -1.4293845596976937e-01 + 1.1241223989034741e+00 -1.4244895675184907e-01 + 1.1235264899062556e+00 -1.4193110596370631e-01 + 1.1228958146100103e+00 -1.4138401328889696e-01 + 1.1222277539716845e+00 -1.4080706185125305e-01 + 1.1215206520759335e+00 -1.4019839266063397e-01 + 1.1207711896807491e+00 -1.3955793772916492e-01 + 1.1199776621114204e+00 -1.3888363174521581e-01 + 1.1191384125618564e+00 -1.3817319172072454e-01 + 1.1182497663255593e+00 -1.3742660392760778e-01 + 1.1173111242751630e+00 -1.3664007018563473e-01 + 1.1163158404835587e+00 -1.3581689874266067e-01 + 1.1152641388633888e+00 -1.3495207932899664e-01 + 1.1141496358538725e+00 -1.3404845572139809e-01 + 1.1129726420024746e+00 -1.3310067056794106e-01 + 1.1117292288213541e+00 -1.3210842183110488e-01 + 1.1104167566504470e+00 -1.3106982290325211e-01 + 1.1090327073032171e+00 -1.2998270176225438e-01 + 1.1075727914569413e+00 -1.2884720799041349e-01 + 1.1060356636549600e+00 -1.2765963210529119e-01 + 1.1044153285758780e+00 -1.2642241926464248e-01 + 1.1027115468745405e+00 -1.2513046761391813e-01 + 1.1009190349632010e+00 -1.2378551631535506e-01 + 1.0990377514104603e+00 -1.2238236968223179e-01 + 1.0970628888655336e+00 -1.2092247054494018e-01 + 1.0949941717378300e+00 -1.1940128292802354e-01 + 1.0928271880102420e+00 -1.1782023345091322e-01 + 1.0905613521520685e+00 -1.1617576368811855e-01 + 1.0881911092012906e+00 -1.1447165082924413e-01 + 1.0857156789284061e+00 -1.1270538951481451e-01 + 1.0831287667158647e+00 -1.1088295684409323e-01 + 1.0804283682401001e+00 -1.0900461807437907e-01 + 1.0776119245602029e+00 -1.0707256075215710e-01 + 1.0746745783519398e+00 -1.0509258121367956e-01 + 1.0716198835593582e+00 -1.0305952579395661e-01 + 1.0684396077852376e+00 -1.0098610192087888e-01 + 1.0651422205283230e+00 -9.8861323884182520e-02 + 1.0617153898185170e+00 -9.6706640863121682e-02 + 1.0581738344277281e+00 -9.4502889777689864e-02 + 1.0545011948185750e+00 -9.2280990435909441e-02 + 1.0507183041509203e+00 -9.0013294380212452e-02 + 1.0468054648855449e+00 -8.7739908525121618e-02 + 1.0427887173303714e+00 -8.5425607874468595e-02 + 1.0386460294347020e+00 -8.3118730358420365e-02 + 1.0344089415128852e+00 -8.0775163205770370e-02 + 1.0300596551071437e+00 -7.8439911916318425e-02 + 1.0256266609654203e+00 -7.6074973326497375e-02 + 1.0210963081128153e+00 -7.3721467030536322e-02 + 1.0164940064657964e+00 -7.1348145845560373e-02 + 1.0118101906118802e+00 -6.8991645543176980e-02 + 1.0070672178777658e+00 -6.6627711497771580e-02 + 1.0022607958595315e+00 -6.4285300296999803e-02 + 9.9740585680337945e-01 -6.1956366646198309e-02 + 9.9250342733828156e-01 -5.9661058872860606e-02 + 9.8756751774400087e-01 -5.7394183712018432e-02 + 9.8260937859059927e-01 -5.5155102225254937e-02 + 9.7763608177772476e-01 -5.2953580827162727e-02 + 9.7266685919668561e-01 -5.0771042421329515e-02 + 9.6769976220674159e-01 -4.8637273084720212e-02 + 9.6275606199315023e-01 -4.6528050965546526e-02 + 9.5783591176740723e-01 -4.4467512219566914e-02 + 9.5295005973500158e-01 -4.2454743123128205e-02 + 9.4811017948094456e-01 -4.0484777638736286e-02 + 9.4331912541882612e-01 -3.8573745059819121e-02 + 9.3859045401309760e-01 -3.6709892045434650e-02 + 1.1275621788585672e+00 -1.4525367818526710e-01 + 1.1271225946617103e+00 -1.4495341043244050e-01 + 1.1266727063468509e+00 -1.4461455502188561e-01 + 1.1262073393900613e+00 -1.4424251098486601e-01 + 1.1257221902668195e+00 -1.4383978719389665e-01 + 1.1252135657299867e+00 -1.4340814409696553e-01 + 1.1246794363685959e+00 -1.4294681048916319e-01 + 1.1241157686530381e+00 -1.4245725282961444e-01 + 1.1235197010011557e+00 -1.4193933568578979e-01 + 1.1228889052304349e+00 -1.4139222729692974e-01 + 1.1222207805044659e+00 -1.4081526114215592e-01 + 1.1215136361263454e+00 -1.4020660006782415e-01 + 1.1207641578334064e+00 -1.3956615487202709e-01 + 1.1199706234522611e+00 -1.3889187076783466e-01 + 1.1191313806345777e+00 -1.3818145252929417e-01 + 1.1182427435316540e+00 -1.3743489584557156e-01 + 1.1173041201018183e+00 -1.3664839189080052e-01 + 1.1163088550122395e+00 -1.3582525815563309e-01 + 1.1152571797926958e+00 -1.3496047237680261e-01 + 1.1141427012885281e+00 -1.3405688711381328e-01 + 1.1129657353369671e+00 -1.3310913645257330e-01 + 1.1117223475677034e+00 -1.3211692488859023e-01 + 1.1104099013153634e+00 -1.3107836222021607e-01 + 1.1090258774279456e+00 -1.2999127802320720e-01 + 1.1075659862247271e+00 -1.2885582262318782e-01 + 1.1060288843689241e+00 -1.2766828368208166e-01 + 1.1044085733714075e+00 -1.2643110972086785e-01 + 1.1027048169784013e+00 -1.2513919369652918e-01 + 1.1009123270953789e+00 -1.2379427978346902e-01 + 1.0990310657991167e+00 -1.2239116743782848e-01 + 1.0970562220282583e+00 -1.2093130515469708e-01 + 1.0949875242254257e+00 -1.1941015315943349e-01 + 1.0928205580943791e+00 -1.1782914374276517e-01 + 1.0905547424576054e+00 -1.1618471575215258e-01 + 1.0881845215294876e+00 -1.1448065078437006e-01 + 1.0857091186261993e+00 -1.1271444103897209e-01 + 1.0831222389794148e+00 -1.1089206488679523e-01 + 1.0804218787175199e+00 -1.0901378646593402e-01 + 1.0776054794620122e+00 -1.0708179088902300e-01 + 1.0746681805176945e+00 -1.0510187756178792e-01 + 1.0716135390826518e+00 -1.0306888649434380e-01 + 1.0684333165625155e+00 -1.0099553369277664e-01 + 1.0651359896536723e+00 -9.8870821968234671e-02 + 1.0617092173488023e+00 -9.6716214226176642e-02 + 1.0581677287154716e+00 -9.4512530504489253e-02 + 1.0544951521985337e+00 -9.2290709453788658e-02 + 1.0507123336398900e+00 -9.0023080893554930e-02 + 1.0467995613242242e+00 -8.7749774004517223e-02 + 1.0427828890218995e+00 -8.5435537996171582e-02 + 1.0386402686825802e+00 -8.3128735215491342e-02 + 1.0344032534121665e+00 -8.0785227433788506e-02 + 1.0300540302113186e+00 -7.8450045878535296e-02 + 1.0256211030138480e+00 -7.6085164424578147e-02 + 1.0210908099541816e+00 -7.3731725451958538e-02 + 1.0164885725965149e+00 -7.1358462184670873e-02 + 1.0118048174643659e+00 -6.9002029133125128e-02 + 1.0070619110121508e+00 -6.6638156943193236e-02 + 1.0022555558762383e+00 -6.4295814115888222e-02 + 9.9740068909468138e-01 -6.1966943866729622e-02 + 9.9249833265404275e-01 -5.9671698501397662e-02 + 9.8756249533500384e-01 -5.7404881060258130e-02 + 9.8260442562233974e-01 -5.5165852673745817e-02 + 9.7763119307375013e-01 -5.2964384798322432e-02 + 9.7266203297251563e-01 -5.0781895942058848e-02 + 9.6769499538464909e-01 -4.8648179717595212e-02 + 9.6275135601968487e-01 -4.6539007799217796e-02 + 9.5783126687370168e-01 -4.4478521138393796e-02 + 9.5294547777292182e-01 -4.2465801605621904e-02 + 9.4810566085582026e-01 -4.0495884549335830e-02 + 9.4331466987538737e-01 -3.8584898581794549e-02 + 9.3858606053791938e-01 -3.6721089587890679e-02 + 1.1275614596568206e+00 -1.4526435440938504e-01 + 1.1271196312575640e+00 -1.4496433883050566e-01 + 1.1266681655984476e+00 -1.4462527060879177e-01 + 1.1262015768770737e+00 -1.4425313143530105e-01 + 1.1257156160274158e+00 -1.4385011213036111e-01 + 1.1252063377806292e+00 -1.4341834449764213e-01 + 1.1246717951979448e+00 -1.4295684361467895e-01 + 1.1241078074719437e+00 -1.4246721573912657e-01 + 1.1235115493224102e+00 -1.4194921887239281e-01 + 1.1228806089106396e+00 -1.4140209157594796e-01 + 1.1222124072648172e+00 -1.4082510770853757e-01 + 1.1215052119169222e+00 -1.4021645634044691e-01 + 1.1207557145836193e+00 -1.3957602279304590e-01 + 1.1199621720767570e+00 -1.3890176491875178e-01 + 1.1191229374010976e+00 -1.3819137279471749e-01 + 1.1182343113270616e+00 -1.3744485341932022e-01 + 1.1172957103221608e+00 -1.3665838518177045e-01 + 1.1163004677581581e+00 -1.3583529667252028e-01 + 1.1152488243123160e+00 -1.3497055122499085e-01 + 1.1141343753084474e+00 -1.3406701194571263e-01 + 1.1129574429364111e+00 -1.3311930263818786e-01 + 1.1117140857616041e+00 -1.3212713564331058e-01 + 1.1104016707150932e+00 -1.3108861644326941e-01 + 1.1090176774852991e+00 -1.3000157653239997e-01 + 1.1075578159618342e+00 -1.2886616712895241e-01 + 1.1060207453533204e+00 -1.2767867246530271e-01 + 1.1044004633667874e+00 -1.2644154510118322e-01 + 1.1026967374606051e+00 -1.2514967176289848e-01 + 1.1009042741282977e+00 -1.2380480264356078e-01 + 1.0990230396592160e+00 -1.2240173136660848e-01 + 1.0970482185364452e+00 -1.2094191322928420e-01 + 1.0949795440454682e+00 -1.1942080389466550e-01 + 1.0928125991533182e+00 -1.1783984246337832e-01 + 1.0905468079092493e+00 -1.1619546450817635e-01 + 1.0881766135386819e+00 -1.1449145691745885e-01 + 1.0857012436146876e+00 -1.1272530895950728e-01 + 1.0831144031874460e+00 -1.1090300053178773e-01 + 1.0804140889274803e+00 -1.0902479442820416e-01 + 1.0775977431308914e+00 -1.0709287283901414e-01 + 1.0746605010544421e+00 -1.0511303885528699e-01 + 1.0716059238026534e+00 -1.0308012489304176e-01 + 1.0684257653397280e+00 -1.0100685725773810e-01 + 1.0651285110033535e+00 -9.8882224978723843e-02 + 1.0617018089351922e+00 -9.6727707441615143e-02 + 1.0581604005631344e+00 -9.4524104415655522e-02 + 1.0544878999030993e+00 -9.2302377173549777e-02 + 1.0507051680217729e+00 -9.0034829455145474e-02 + 1.0467924761842877e+00 -8.7761617173068462e-02 + 1.0427758943221797e+00 -8.5447458570310761e-02 + 1.0386333551770617e+00 -8.3140745306732031e-02 + 1.0343964272104582e+00 -8.0797308592760658e-02 + 1.0300472799660245e+00 -7.8462210541527383e-02 + 1.0256144332061052e+00 -7.6097397464376909e-02 + 1.0210842119915746e+00 -7.3744039094062797e-02 + 1.0164820518681907e+00 -7.1370845135501237e-02 + 1.0117983696792288e+00 -6.9014492593080429e-02 + 1.0070555428353190e+00 -6.6650694433274829e-02 + 1.0022492680190507e+00 -6.4308433457665265e-02 + 9.9739448801970132e-01 -6.1979639090875761e-02 + 9.9249221925145270e-01 -5.9684468413931074e-02 + 9.8755646869548663e-01 -5.7417720033353506e-02 + 9.8259848233393310e-01 -5.5178755163095040e-02 + 9.7762532691376958e-01 -5.2977351311352484e-02 + 9.7265624178984245e-01 -5.0794921711269557e-02 + 9.6768927547628314e-01 -4.8661269019928052e-02 + 9.6274570911284163e-01 -4.6552157142284160e-02 + 9.5782569323705158e-01 -4.4491732785528093e-02 + 9.5293997962046628e-01 -4.2479072533152154e-02 + 9.4810023866584703e-01 -4.0509213397112713e-02 + 9.4330932333390738e-01 -3.8598283172558839e-02 + 9.3858078842149073e-01 -3.6734526815832343e-02 + 1.1275605977207659e+00 -1.4527717780277583e-01 + 1.1271160736930070e+00 -1.4497746512286608e-01 + 1.1266627134138067e+00 -1.4463814126991703e-01 + 1.1261946571883341e+00 -1.4426588780169092e-01 + 1.1257077213626507e+00 -1.4386251351235713e-01 + 1.1251976579508789e+00 -1.4343059625988694e-01 + 1.1246626190738964e+00 -1.4296889441658031e-01 + 1.1240982470207723e+00 -1.4247918215839375e-01 + 1.1235017601134829e+00 -1.4196108948618452e-01 + 1.1228706460299049e+00 -1.4141393942808583e-01 + 1.1222023520593782e+00 -1.4083693423050941e-01 + 1.1214950955608112e+00 -1.4022829446211424e-01 + 1.1207455754323523e+00 -1.3958787484356783e-01 + 1.1199520232441391e+00 -1.3891364840820344e-01 + 1.1191127984306140e+00 -1.3820328758043612e-01 + 1.1182241856900832e+00 -1.3745681294190384e-01 + 1.1172856117104906e+00 -1.3667038752576632e-01 + 1.1162903962966526e+00 -1.3584735325404804e-01 + 1.1152387911125419e+00 -1.3498265616024505e-01 + 1.1141243776439957e+00 -1.3407917201867112e-01 + 1.1129474857106023e+00 -1.3313151228264355e-01 + 1.1117041653931747e+00 -1.3213939871560632e-01 + 1.1103917879422971e+00 -1.3110093161564240e-01 + 1.1090078316538543e+00 -1.3001394478129227e-01 + 1.1075480059012284e+00 -1.2887859050237555e-01 + 1.1060109729502716e+00 -1.2769114889237987e-01 + 1.1043907259394019e+00 -1.2645407736124495e-01 + 1.1026870367852255e+00 -1.2516225515212348e-01 + 1.1008946054814919e+00 -1.2381743968640790e-01 + 1.0990134033767862e+00 -1.2241441758240947e-01 + 1.0970386096029903e+00 -1.2095465230635273e-01 + 1.0949699632616556e+00 -1.1943359404217807e-01 + 1.0928030440329382e+00 -1.1785269006843203e-01 + 1.0905372822428552e+00 -1.1620837202477263e-01 + 1.0881671199286294e+00 -1.1450443315412495e-01 + 1.0856917897749843e+00 -1.1273835920421595e-01 + 1.0831049966133650e+00 -1.1091613190534247e-01 + 1.0804047377645631e+00 -1.0903801243716907e-01 + 1.0775884563338451e+00 -1.0710617948025590e-01 + 1.0746512827161352e+00 -1.0512644055091823e-01 + 1.0715967827058488e+00 -1.0309361894628281e-01 + 1.0684167013308203e+00 -1.0102045333877716e-01 + 1.0651195343039834e+00 -9.8895916209436177e-02 + 1.0616929167367830e+00 -9.6741506731908553e-02 + 1.0581516048973421e+00 -9.4538000338723907e-02 + 1.0544791954759327e+00 -9.2316385465015693e-02 + 1.0506965678182512e+00 -9.0048934537823172e-02 + 1.0467839727538304e+00 -8.7775835565456511e-02 + 1.0427674996169751e+00 -8.5461769612455427e-02 + 1.0386250580872558e+00 -8.3155163532046009e-02 + 1.0343882350610716e+00 -8.0811811845015125e-02 + 1.0300391791235821e+00 -7.8476813744706150e-02 + 1.0256064290393900e+00 -7.6112082452389110e-02 + 1.0210762941740628e+00 -7.3758820538436451e-02 + 1.0164742268574298e+00 -7.1385709474078740e-02 + 1.0117906323116763e+00 -6.9029453267156052e-02 + 1.0070479010989390e+00 -6.6665743661823013e-02 + 1.0022417227543725e+00 -6.4323580626415536e-02 + 9.9738704697021285e-01 -6.1994877031929831e-02 + 9.9248488347134334e-01 -5.9699795692418949e-02 + 9.8754923707891040e-01 -5.7433129893278520e-02 + 9.8259135077130977e-01 -5.5194240949727122e-02 + 9.7761828792240901e-01 -5.2992913634394130e-02 + 9.7264929277439505e-01 -5.0810554849970664e-02 + 9.6768241197923011e-01 -4.8676978109395197e-02 + 9.6273893319425941e-01 -4.6567937993271052e-02 + 9.5781900520698560e-01 -4.4507588117224932e-02 + 9.5293338212383349e-01 -4.2494998720043059e-02 + 9.4809373226503513e-01 -4.0525208810662162e-02 + 9.4330290764105962e-01 -3.8614345204222286e-02 + 9.3857446195803240e-01 -3.6750651743232561e-02 + 1.1275595649218670e+00 -1.4529258296841671e-01 + 1.1271118024361582e+00 -1.4499323418256524e-01 + 1.1266561660246230e+00 -1.4465360320250650e-01 + 1.1261863468082380e+00 -1.4428121239294914e-01 + 1.1256982397161996e+00 -1.4387741159537859e-01 + 1.1251872330852573e+00 -1.4344531454599499e-01 + 1.1246515980411984e+00 -1.4298337122037683e-01 + 1.1240867643451620e+00 -1.4249355752611828e-01 + 1.1234900026988499e+00 -1.4197534968976766e-01 + 1.1228586800623315e+00 -1.4142817221351586e-01 + 1.1221902752725328e+00 -1.4085114131241122e-01 + 1.1214829454121409e+00 -1.4024251539525079e-01 + 1.1207333980059677e+00 -1.3960211242058526e-01 + 1.1199398343000981e+00 -1.3892792365885037e-01 + 1.1191006214526882e+00 -1.3821760032758845e-01 + 1.1182120248543455e+00 -1.3747117932590927e-01 + 1.1172734834706450e+00 -1.3668480523922261e-01 + 1.1162783008084574e+00 -1.3586183600424825e-01 + 1.1152267417299015e+00 -1.3499719687215883e-01 + 1.1141123710973480e+00 -1.3409377883443610e-01 + 1.1129355278957962e+00 -1.3314617850823662e-01 + 1.1116922520139776e+00 -1.3215412897570855e-01 + 1.1103799198913067e+00 -1.3111572430715571e-01 + 1.1089960081508952e+00 -1.3002880106862566e-01 + 1.1075362255460974e+00 -1.2889351283702929e-01 + 1.1059992380150219e+00 -1.2770613477766313e-01 + 1.1043790332082664e+00 -1.2646913012627789e-01 + 1.1026753883974276e+00 -1.2517736913730523e-01 + 1.1008829957688691e+00 -1.2383261791417409e-01 + 1.0990018327479716e+00 -1.2242965466080656e-01 + 1.0970270720390261e+00 -1.2096995265531184e-01 + 1.0949584597291997e+00 -1.1944895550024237e-01 + 1.0927915715504961e+00 -1.1786812029636067e-01 + 1.0905258453676139e+00 -1.1622387395894028e-01 + 1.0881557217900821e+00 -1.1452001736257583e-01 + 1.0856804396412938e+00 -1.1275403202607127e-01 + 1.0830937034888843e+00 -1.1093190188054432e-01 + 1.0803935114335153e+00 -1.0905388616631839e-01 + 1.0775773075509414e+00 -1.0712215934882940e-01 + 1.0746402163959294e+00 -1.0514253425865541e-01 + 1.0715858093938040e+00 -1.0310982324127117e-01 + 1.0684058208394387e+00 -1.0103677982108156e-01 + 1.0651087589037838e+00 -9.8912356606037005e-02 + 1.0616822430495041e+00 -9.6758076532864820e-02 + 1.0581410473641824e+00 -9.4554685809500355e-02 + 1.0544687477315802e+00 -9.2333205488413408e-02 + 1.0506862454454553e+00 -9.0065870396654327e-02 + 1.0467737667954182e+00 -8.7792907082598681e-02 + 1.0427574244122964e+00 -8.5478951969503475e-02 + 1.0386151002834358e+00 -8.3172474168845073e-02 + 1.0343784034388908e+00 -8.0829224149423354e-02 + 1.0300294572991828e+00 -7.8494345626280049e-02 + 1.0255968234430135e+00 -7.6129712092592380e-02 + 1.0210667923915113e+00 -7.3776565544375949e-02 + 1.0164648366243465e+00 -7.1403553557102276e-02 + 1.0117813474113595e+00 -6.9047412558018995e-02 + 1.0070387311025344e+00 -6.6683808814216788e-02 + 1.0022326686515808e+00 -6.4341762903153021e-02 + 9.9737811803669318e-01 -6.2013167824686299e-02 + 9.9247608095210182e-01 -5.9718193276337699e-02 + 9.8754055962591236e-01 -5.7451626157457372e-02 + 9.8258279343124810e-01 -5.5212827906173600e-02 + 9.7760984169386544e-01 -5.3011592016075693e-02 + 9.7264095452278188e-01 -5.0829317792333933e-02 + 9.6767417633565100e-01 -4.8695831778359525e-02 + 9.6273080261296451e-01 -4.6586877364261897e-02 + 9.5781098004210219e-01 -4.4526616457701486e-02 + 9.5292546553240254e-01 -4.2514111683473306e-02 + 9.4808592490526078e-01 -4.0544404448155304e-02 + 9.4329520903162722e-01 -3.8633620391493435e-02 + 9.3856687030963148e-01 -3.6770002019991789e-02 + 1.1275583276452923e+00 -1.4531109364100991e-01 + 1.1271066737116584e+00 -1.4501218212155251e-01 + 1.1266483022390139e+00 -1.4467218205973306e-01 + 1.1261763645927600e+00 -1.4429962617171457e-01 + 1.1256868501286823e+00 -1.4389531281027176e-01 + 1.1251747101742746e+00 -1.4346299964202489e-01 + 1.1246383588518440e+00 -1.4300076606556822e-01 + 1.1240729705403110e+00 -1.4251083039482565e-01 + 1.1234758788790005e+00 -1.4199248407862700e-01 + 1.1228443057694175e+00 -1.4144527355152245e-01 + 1.1221757679544440e+00 -1.4086821165257885e-01 + 1.1214683500874720e+00 -1.4025960225880552e-01 + 1.1207187700579229e+00 -1.3961921915551917e-01 + 1.1199251926743261e+00 -1.3894507552626512e-01 + 1.1190859943749945e+00 -1.3823479710640577e-01 + 1.1181974173508178e+00 -1.3748844040098557e-01 + 1.1172589153195320e+00 -1.3670212782895358e-01 + 1.1162637722051654e+00 -1.3587923656901008e-01 + 1.1152122687277155e+00 -1.3501466690107061e-01 + 1.1140979497759904e+00 -1.3411132809997578e-01 + 1.1129211653473503e+00 -1.3316379895675756e-01 + 1.1116779430846284e+00 -1.3217182615258469e-01 + 1.1103656656618750e+00 -1.3113349627476542e-01 + 1.1089818076923037e+00 -1.3004664921391998e-01 + 1.1075220771844141e+00 -1.2891144009267383e-01 + 1.1059851444883018e+00 -1.2772413813116981e-01 + 1.1043649906611115e+00 -1.2648721356399048e-01 + 1.1026613994079146e+00 -1.2519552584594312e-01 + 1.1008690535351571e+00 -1.2385085151098241e-01 + 1.0989879377685987e+00 -1.2244795865371268e-01 + 1.0970132170905009e+00 -1.2098833233959289e-01 + 1.0949446459800101e+00 -1.1946740826428427e-01 + 1.0927777954257736e+00 -1.1788665532772259e-01 + 1.0905121123481796e+00 -1.1624249476909602e-01 + 1.0881420356409384e+00 -1.1453873663006624e-01 + 1.0856668115004540e+00 -1.1277285734863035e-01 + 1.0830801441760030e+00 -1.1095084349888346e-01 + 1.0803800327033992e+00 -1.0907295199100935e-01 + 1.0775639223222946e+00 -1.0714135222671849e-01 + 1.0746269305706553e+00 -1.0516186341957906e-01 + 1.0715726356354651e+00 -1.0312928476077397e-01 + 1.0683927589182527e+00 -1.0105638761302554e-01 + 1.0650958235513051e+00 -9.8932100715306337e-02 + 1.0616694302003058e+00 -9.6777975544870026e-02 + 1.0581283743523096e+00 -9.4574723210674075e-02 + 1.0544562069008783e+00 -9.2353403938375586e-02 + 1.0506738554961728e+00 -9.0086207399579302e-02 + 1.0467615169555495e+00 -8.7813406426831969e-02 + 1.0427453318842799e+00 -8.5499583835229140e-02 + 1.0386031490139014e+00 -8.3193259483337223e-02 + 1.0343666039516444e+00 -8.0850130942891632e-02 + 1.0300177898997420e+00 -7.8515395391277956e-02 + 1.0255852958299736e+00 -7.6150878619386866e-02 + 1.0210553896359147e+00 -7.3797869963328461e-02 + 1.0164535679897808e+00 -7.1424976301699097e-02 + 1.0117702054086968e+00 -6.9068972986797983e-02 + 1.0070277271963106e+00 -6.6705495698826389e-02 + 1.0022218040026594e+00 -6.4363589758499762e-02 + 9.9736740375209376e-01 -6.2035124311307546e-02 + 9.9246551849719056e-01 -5.9740277319960247e-02 + 9.8753014735303313e-01 -5.7473828019709329e-02 + 9.8257252536521256e-01 -5.5235137998351821e-02 + 9.7759970700128429e-01 -5.3034011219310007e-02 + 9.7263094941330042e-01 -5.0851837869813982e-02 + 9.6766429433816470e-01 -4.8718460134594334e-02 + 9.6272104664680203e-01 -4.6609607973323267e-02 + 9.5780135050679482e-01 -4.4549453246986490e-02 + 9.5291596619212138e-01 -4.2537049443112075e-02 + 9.4807655652608447e-01 -4.0567440846928191e-02 + 9.4328597101317568e-01 -3.8656751688648690e-02 + 9.3855776048325745e-01 -3.6793222872802275e-02 + 1.1275568457263598e+00 -1.4533334143439222e-01 + 1.1271005144883868e+00 -1.4503495548158288e-01 + 1.1266388556552147e+00 -1.4469451176497938e-01 + 1.1261643718365286e+00 -1.4432175739837266e-01 + 1.1256731658810950e+00 -1.4391682788286164e-01 + 1.1251596638532468e+00 -1.4348425485380278e-01 + 1.1246224517436341e+00 -1.4302167230194104e-01 + 1.1240563969745203e+00 -1.4253158989748713e-01 + 1.1234589088269811e+00 -1.4201307700139371e-01 + 1.1228270348512217e+00 -1.4146582660022244e-01 + 1.1221583373466852e+00 -1.4088872728418367e-01 + 1.1214508139118853e+00 -1.4028013757835578e-01 + 1.1207011948919285e+00 -1.3963977817601819e-01 + 1.1199076013006388e+00 -1.3896568859713901e-01 + 1.1190684207293271e+00 -1.3825546395008809e-01 + 1.1181798674856942e+00 -1.3750918430301334e-01 + 1.1172414130171728e+00 -1.3672294543330560e-01 + 1.1162463177121644e+00 -1.3590014764449160e-01 + 1.1151948813490429e+00 -1.3503566120488125e-01 + 1.1140806248118040e+00 -1.3413241736199660e-01 + 1.1129039113325045e+00 -1.3318497348282662e-01 + 1.1116607538372310e+00 -1.3219309259107986e-01 + 1.1103485424926356e+00 -1.3115485228038412e-01 + 1.1089647494966621e+00 -1.3006809643628664e-01 + 1.1075050819627685e+00 -1.2893298203828835e-01 + 1.1059682155427857e+00 -1.2774577116127181e-01 + 1.1043481233704899e+00 -1.2650894244990288e-01 + 1.1026445968815937e+00 -1.2521734238088311e-01 + 1.1008523076108763e+00 -1.2387276002147307e-01 + 1.0989712490564729e+00 -1.2246995131831280e-01 + 1.0969965769213690e+00 -1.2101041550037958e-01 + 1.0949280557682710e+00 -1.1948957876161606e-01 + 1.0927612508857676e+00 -1.1790892417909042e-01 + 1.0904956200744893e+00 -1.1626486617088000e-01 + 1.0881256001653128e+00 -1.1456122579214417e-01 + 1.0856504462117142e+00 -1.1279547337498735e-01 + 1.0830638620784381e+00 -1.1097359866812434e-01 + 1.0803638479225630e+00 -1.0909585578112049e-01 + 1.0775478503793186e+00 -1.0716440803169254e-01 + 1.0746109785542901e+00 -1.0518508230121640e-01 + 1.0715568187548921e+00 -1.0315266197772241e-01 + 1.0683770768910954e+00 -1.0107993985319121e-01 + 1.0650802940652031e+00 -9.8955815993296989e-02 + 1.0616540483604793e+00 -9.6801876159335692e-02 + 1.0581131609663421e+00 -9.4598789299430025e-02 + 1.0544411527559507e+00 -9.2377662693238605e-02 + 1.0506589830342445e+00 -9.0110631775360189e-02 + 1.0467468132167614e+00 -8.7838024970835676e-02 + 1.0427308175048609e+00 -8.5524360709698002e-02 + 1.0385888046870626e+00 -8.3218219800301058e-02 + 1.0343524422872881e+00 -8.0875236288250080e-02 + 1.0300037872161536e+00 -7.8540671557590216e-02 + 1.0255714613403348e+00 -7.6176294115768373e-02 + 1.0210417053800285e+00 -7.3823450148679956e-02 + 1.0164400450565971e+00 -7.1450697667600496e-02 + 1.0117568347696051e+00 -6.9094858765808245e-02 + 1.0070145225792950e+00 -6.6731532398406943e-02 + 1.0022087667622348e+00 -6.4389793596276917e-02 + 9.9735454718288385e-01 -6.2061482866184264e-02 + 9.9245284431682612e-01 -5.9766788096510440e-02 + 9.8751765354141252e-01 -5.7500479324147480e-02 + 9.8256020470763428e-01 -5.5261918319828809e-02 + 9.7758754645219781e-01 -5.3060921617642934e-02 + 9.7261894438326746e-01 -5.0878868461523903e-02 + 9.6765243702107051e-01 -4.8745619813132600e-02 + 9.6270934050929946e-01 -4.6636889512399179e-02 + 9.5778979599179348e-01 -4.4576861368568643e-02 + 9.5290456778193788e-01 -4.2564577904030947e-02 + 9.4806531510601977e-01 -4.0595086860463613e-02 + 9.4327488583023900e-01 -3.8684510778054508e-02 + 9.3854682890429797e-01 -3.6821088640181195e-02 + 1.1275550711738787e+00 -1.4536008870210324e-01 + 1.1270931163867488e+00 -1.4506233463472143e-01 + 1.1266275051864603e+00 -1.4472135745297740e-01 + 1.1261499601804104e+00 -1.4434836436302556e-01 + 1.1256567206668155e+00 -1.4394269392643361e-01 + 1.1251415811801588e+00 -1.4350980832540464e-01 + 1.1246033343409607e+00 -1.4304680604128328e-01 + 1.1240364785139958e+00 -1.4255654704035681e-01 + 1.1234385139168284e+00 -1.4203783367199174e-01 + 1.1228062784770938e+00 -1.4149053511806406e-01 + 1.1221373892615902e+00 -1.4091339058830096e-01 + 1.1214297392037047e+00 -1.4030482430793020e-01 + 1.1206800736209732e+00 -1.3966449314025875e-01 + 1.1198864608747019e+00 -1.3899046826671221e-01 + 1.1190473019635110e+00 -1.3828030797472479e-01 + 1.1181587776733792e+00 -1.3753412065888426e-01 + 1.1172203807659176e+00 -1.3674797006731865e-01 + 1.1162253433353468e+00 -1.3592528430268658e-01 + 1.1151739880709088e+00 -1.3506089755347261e-01 + 1.1140598069991987e+00 -1.3415776748092867e-01 + 1.1128831792621501e+00 -1.3321042569657485e-01 + 1.1116401000945708e+00 -1.3221865486897788e-01 + 1.1103279686703091e+00 -1.3118052177967834e-01 + 1.1089442542840093e+00 -1.3009387511531814e-01 + 1.1074846629732393e+00 -1.2895887408653070e-01 + 1.1059478767626671e+00 -1.2777177217857547e-01 + 1.1043278592617409e+00 -1.2653505814421404e-01 + 1.1026244111982035e+00 -1.2524356285985519e-01 + 1.1008321905581908e+00 -1.2389909045707559e-01 + 1.0989512013834684e+00 -1.2249638228060628e-01 + 1.0969765882238944e+00 -1.2103695458212427e-01 + 1.0949081277609873e+00 -1.1951622213497609e-01 + 1.0927413784322180e+00 -1.1793568505396476e-01 + 1.0904758111131982e+00 -1.1629174955818654e-01 + 1.0881058601541937e+00 -1.1458824993734140e-01 + 1.0856307912506065e+00 -1.1282264918406781e-01 + 1.0830443078021883e+00 -1.1100094086066291e-01 + 1.0803444113099876e+00 -1.0912337570989901e-01 + 1.0775285500826048e+00 -1.0719210973763860e-01 + 1.0745918230893570e+00 -1.0521297903843893e-01 + 1.0715378263911430e+00 -1.0318074801120361e-01 + 1.0683582472805138e+00 -1.0110823519577933e-01 + 1.0650616484470483e+00 -9.8984306206593112e-02 + 1.0616355808379501e+00 -9.6830587996211706e-02 + 1.0580948965182269e+00 -9.4627698859857390e-02 + 1.0544230802908481e+00 -9.2406802607769761e-02 + 1.0506411294848934e+00 -9.0139969518233498e-02 + 1.0467291629837219e+00 -8.7867594800428606e-02 + 1.0427133953423544e+00 -8.5554119543928664e-02 + 1.0385715873661683e+00 -8.3248197772434196e-02 + 1.0343354449133344e+00 -8.0905387229790904e-02 + 1.0299869813022677e+00 -7.8571026421656129e-02 + 1.0255548579067639e+00 -7.6206815057275848e-02 + 1.0210252828096542e+00 -7.3854167601964935e-02 + 1.0164238166172774e+00 -7.1481583381569083e-02 + 1.0117407895678527e+00 -6.9125940622924750e-02 + 1.0069986770465105e+00 -6.6762794181329285e-02 + 1.0021931224693423e+00 -6.4421254765576905e-02 + 9.9733912003530500e-01 -6.2093128497039622e-02 + 9.9243763631734605e-01 -5.9798615185485425e-02 + 9.8750266220488692e-01 -5.7532473827833872e-02 + 9.8254542131293243e-01 -5.5294066418696233e-02 + 9.7757295528004684e-01 -5.3093224586859791e-02 + 9.7260453986777295e-01 -5.0911314442117703e-02 + 9.6763820973683334e-01 -4.8778219488355000e-02 + 9.6269529456398850e-01 -4.6669634217977311e-02 + 9.5777593186498244e-01 -4.4609756784012695e-02 + 9.5289089080289624e-01 -4.2597616549500186e-02 + 9.4805182628852858e-01 -4.0628265407278506e-02 + 9.4326158422421025e-01 -3.8717823871380189e-02 + 9.3853371130610097e-01 -3.6854528621944389e-02 + 1.1275529466293561e+00 -1.4539225645881762e-01 + 1.1270842282554865e+00 -1.4509526236533651e-01 + 1.1266138635064895e+00 -1.4475364348883821e-01 + 1.1261326368607709e+00 -1.4438036314920988e-01 + 1.1256369517225595e+00 -1.4397380142234789e-01 + 1.1251198430642397e+00 -1.4354053968359884e-01 + 1.1245803520141704e+00 -1.4307703235301944e-01 + 1.1240125330591251e+00 -1.4258656070214204e-01 + 1.1234139957771248e+00 -1.4206760594738876e-01 + 1.1227813259789281e+00 -1.4152024917779946e-01 + 1.1221122065933371e+00 -1.4094304994575280e-01 + 1.1214044046721476e+00 -1.4033451149134399e-01 + 1.1206546835369255e+00 -1.3969421391129766e-01 + 1.1198610482247973e+00 -1.3902026646347562e-01 + 1.1190219158571668e+00 -1.3831018315217136e-01 + 1.1181334269058281e+00 -1.3756410643620143e-01 + 1.1171950997643054e+00 -1.3677806154390737e-01 + 1.1162001325005475e+00 -1.3595551000724981e-01 + 1.1151488753551901e+00 -1.3509124262508010e-01 + 1.1140347856522843e+00 -1.3418824882117519e-01 + 1.1128582616657656e+00 -1.3324102923446896e-01 + 1.1116152773568140e+00 -1.3224939015540763e-01 + 1.1103032427305424e+00 -1.3121138536268501e-01 + 1.1089196235906345e+00 -1.3012486931495168e-01 + 1.1074601246811087e+00 -1.2899000390411663e-01 + 1.1059234356891821e+00 -1.2780303228586745e-01 + 1.1043035087719884e+00 -1.2656645536583305e-01 + 1.1026001558292404e+00 -1.2527508526220757e-01 + 1.1008080185568303e+00 -1.2393074421800346e-01 + 1.0989271136727268e+00 -1.2252815602126520e-01 + 1.0969525723172482e+00 -1.2106885738883530e-01 + 1.0948841857411860e+00 -1.1954824936242395e-01 + 1.0927175041443131e+00 -1.1796785253849859e-01 + 1.0904520141194751e+00 -1.1632406327761657e-01 + 1.0880821470323454e+00 -1.1462073177713705e-01 + 1.0856071813680386e+00 -1.1285531220460143e-01 + 1.0830208199630302e+00 -1.1103380270446905e-01 + 1.0803210659292766e+00 -1.0915644997056970e-01 + 1.0775053695811898e+00 -1.0722540121912484e-01 + 1.0745688176998915e+00 -1.0524650361716446e-01 + 1.0715150180634510e+00 -1.0321449874037687e-01 + 1.0683356355840841e+00 -1.0114223607302904e-01 + 1.0650392588891786e+00 -9.9018539826109142e-02 + 1.0616134063100582e+00 -9.6865086453721008e-02 + 1.0580729670087479e+00 -9.4662433382244601e-02 + 1.0544013824391625e+00 -9.2441812352192371e-02 + 1.0506196956138532e+00 -9.0175215351905605e-02 + 1.0467079743067120e+00 -8.7903117836077627e-02 + 1.0426924815512790e+00 -8.5589867973482114e-02 + 1.0385509205001617e+00 -8.3284207754402928e-02 + 1.0343150430612658e+00 -8.0941603259802264e-02 + 1.0299668101823898e+00 -7.8607485646600139e-02 + 1.0255349306927877e+00 -7.6243471983389058e-02 + 1.0210055734690915e+00 -7.3891058755620367e-02 + 1.0164043410164907e+00 -7.1518674803215151e-02 + 1.0117215345505253e+00 -6.9163265776196831e-02 + 1.0069796622706808e+00 -6.6800333568124787e-02 + 1.0021743497425744e+00 -6.4459031737726477e-02 + 9.9732060837560188e-01 -6.2131125116906098e-02 + 9.9241938804543994e-01 -5.9836827836306797e-02 + 9.8748467425184405e-01 -5.7570885641936645e-02 + 9.8252768312316463e-01 -5.5332660803486484e-02 + 9.7755544789859017e-01 -5.3132003077536134e-02 + 9.7258725653220746e-01 -5.0950262809493399e-02 + 9.6762113905420322e-01 -4.8817350568299347e-02 + 9.6267844138910530e-01 -4.6708937623520790e-02 + 9.5775929669928328e-01 -4.4649239349013228e-02 + 9.5287447997124886e-01 -4.2637269315520226e-02 + 9.4803564093831028e-01 -4.0668084401801557e-02 + 9.4324562314914695e-01 -3.8757802693126647e-02 + 9.3851797059922348e-01 -3.6894658108735726e-02 + 1.1275504034969386e+00 -1.4543095853411869e-01 + 1.1270735471058186e+00 -1.4513487882971401e-01 + 1.1265974629306446e+00 -1.4479248773967635e-01 + 1.1261118066823852e+00 -1.4441886159046613e-01 + 1.1256131792113750e+00 -1.4401122721810106e-01 + 1.1250937015701574e+00 -1.4357751262315321e-01 + 1.1245527138778324e+00 -1.4311339729800884e-01 + 1.1239837365386784e+00 -1.4262266942606047e-01 + 1.1233845106983764e+00 -1.4210342384562547e-01 + 1.1227513188202856e+00 -1.4155599660388182e-01 + 1.1220819230673995e+00 -1.4097873109714101e-01 + 1.1213739390327921e+00 -1.4037022563000554e-01 + 1.1206241516947544e+00 -1.3972996793817993e-01 + 1.1198304899017146e+00 -1.3905611308787511e-01 + 1.1189913901706905e+00 -1.3834612180501438e-01 + 1.1181029444714736e+00 -1.3760017752824183e-01 + 1.1171647020338000e+00 -1.3681425914241174e-01 + 1.1161698199903494e+00 -1.3599186839371669e-01 + 1.1151186817259968e+00 -1.3512774388092907e-01 + 1.1140047028174300e+00 -1.3422491323639463e-01 + 1.1128283045539380e+00 -1.3327783983820035e-01 + 1.1115854353057508e+00 -1.3228635839118333e-01 + 1.1102735181077437e+00 -1.3124850703057220e-01 + 1.1088900145644347e+00 -1.3016214715653690e-01 + 1.1074306278640380e+00 -1.2902744388392284e-01 + 1.1058940569103128e+00 -1.2784062794206272e-01 + 1.1042742400850654e+00 -1.2660421485235010e-01 + 1.1025710027248832e+00 -1.2531299416980812e-01 + 1.1007789669317816e+00 -1.2396880991979048e-01 + 1.0988981646693330e+00 -1.2256636477342375e-01 + 1.0969237109498011e+00 -1.2110722005925872e-01 + 1.0948554145448379e+00 -1.1958676030333480e-01 + 1.0926888157461956e+00 -1.1800653073136398e-01 + 1.0904234200455221e+00 -1.1636291584567005e-01 + 1.0880536552162710e+00 -1.1465978497018625e-01 + 1.0855788151183303e+00 -1.1289458165695976e-01 + 1.0829926019049747e+00 -1.1107330955746875e-01 + 1.0802930206184491e+00 -1.0919621049431780e-01 + 1.0774775239773224e+00 -1.0726542111426308e-01 + 1.0745411841017050e+00 -1.0528680189488902e-01 + 1.0714876228486432e+00 -1.0325506697294039e-01 + 1.0683084782180003e+00 -1.0118310303212581e-01 + 1.0650123700097534e+00 -9.9059684511989696e-02 + 1.0615867773411545e+00 -9.6906547369957186e-02 + 1.0580466339567849e+00 -9.4704175869300827e-02 + 1.0543753291993907e+00 -9.2483883399282901e-02 + 1.0505939609793338e+00 -9.0217567855447170e-02 + 1.0466825356381750e+00 -8.7945801134679868e-02 + 1.0426673744610624e+00 -8.5632819742642141e-02 + 1.0385261113132365e+00 -8.3327471381920759e-02 + 1.0342905534314788e+00 -8.0985111996042747e-02 + 1.0299425988336879e+00 -7.8651284071753466e-02 + 1.0255110133623073e+00 -7.6287505392301058e-02 + 1.0209819187878699e+00 -7.3935370987001453e-02 + 1.0163809679461990e+00 -7.1563225023140678e-02 + 1.0116984271848262e+00 -6.9208094147739610e-02 + 1.0069568441147614e+00 -6.6845416640575098e-02 + 1.0021518228557440e+00 -6.4504397532132871e-02 + 9.9729839548278620e-01 -6.2176752068737066e-02 + 9.9239749181440728e-01 -5.9882711587334776e-02 + 9.8746309087697026e-01 -5.7617005929031774e-02 + 9.8250639981005461e-01 -5.5378997702547339e-02 + 9.7753444177114301e-01 -5.3178558437707517e-02 + 9.7256651935744265e-01 -5.0997019558010760e-02 + 9.6760065704363396e-01 -4.8864324130846570e-02 + 9.6265822026309800e-01 -4.6756115550081738e-02 + 9.5773933695466362e-01 -4.4696629866635376e-02 + 9.5285478909794019e-01 -4.2684861698674685e-02 + 9.4801622021520437e-01 -4.0715873914337335e-02 + 9.4322647103469281e-01 -3.8805781688324818e-02 + 9.3849908231627177e-01 -3.6942815631036310e-02 + 1.1275473596567505e+00 -1.4547754338918917e-01 + 1.1270607070150784e+00 -1.4518256436011842e-01 + 1.1265777381342919e+00 -1.4483924353326694e-01 + 1.1260867499532634e+00 -1.4446520084280190e-01 + 1.1255845809893159e+00 -1.4405627492322987e-01 + 1.1250622521409488e+00 -1.4362201479511316e-01 + 1.1245194634188489e+00 -1.4315716713937787e-01 + 1.1239490923120266e+00 -1.4266613033203143e-01 + 1.1233490383203886e+00 -1.4214653412011524e-01 + 1.1227152187515945e+00 -1.4159902144549841e-01 + 1.1220454911320856e+00 -1.4102167551647546e-01 + 1.1213372887384798e+00 -1.4041320906326626e-01 + 1.1205874226105608e+00 -1.3977299864811210e-01 + 1.1197937298888818e+00 -1.3909925447188695e-01 + 1.1189546704329971e+00 -1.3838937313090582e-01 + 1.1180662778344579e+00 -1.3764358738436044e-01 + 1.1171281384359475e+00 -1.3685782033576288e-01 + 1.1161333601016021e+00 -1.3603562212868781e-01 + 1.1150823661059530e+00 -1.3517166853458207e-01 + 1.1139685217816981e+00 -1.3426903316793926e-01 + 1.1127922761168367e+00 -1.3332213456173742e-01 + 1.1115495466843179e+00 -1.3233084161417644e-01 + 1.1102377722000767e+00 -1.3129317363191251e-01 + 1.1088544092156996e+00 -1.3020700036582591e-01 + 1.1073951590473399e+00 -1.2907249080648830e-01 + 1.1058587316889230e+00 -1.2788586072755848e-01 + 1.1042390489459319e+00 -1.2664964323539651e-01 + 1.1025359523221108e+00 -1.2535860073361002e-01 + 1.1007440403430422e+00 -1.2401460345511145e-01 + 1.0988633633147740e+00 -1.2261232866173510e-01 + 1.0968890168444489e+00 -1.2115336729186811e-01 + 1.0948208307819196e+00 -1.1963308399890576e-01 + 1.0926543334971821e+00 -1.1805305363631641e-01 + 1.0903890532143066e+00 -1.1640964643733297e-01 + 1.0880194133808132e+00 -1.1470675472992298e-01 + 1.0855447263448268e+00 -1.1294180929220943e-01 + 1.0829586934293740e+00 -1.1112082039578297e-01 + 1.0802593219892533e+00 -1.0924402400033270e-01 + 1.0774440676237309e+00 -1.0731354403814887e-01 + 1.0745079848103463e+00 -1.0533525699294211e-01 + 1.0714547123267550e+00 -1.0330384400227513e-01 + 1.0682758557992642e+00 -1.0123223648295551e-01 + 1.0649800725012777e+00 -9.9109149025171997e-02 + 1.0615547943876529e+00 -9.6956389134066817e-02 + 1.0580150087948539e+00 -9.4754353106755618e-02 + 1.0543440424025361e+00 -9.2534452497915892e-02 + 1.0505630591073818e+00 -9.0268472087288457e-02 + 1.0466519913904395e+00 -8.7997099710904081e-02 + 1.0426372305470024e+00 -8.5684437655032752e-02 + 1.0384963271516106e+00 -8.3379460692498242e-02 + 1.0342611549328247e+00 -8.1037392401285047e-02 + 1.0299135362725267e+00 -7.8703909073695386e-02 + 1.0254823055230513e+00 -7.6340409185391353e-02 + 1.0209535278446131e+00 -7.3988606187924438e-02 + 1.0163529165434555e+00 -7.1616742514606618e-02 + 1.0116706960675554e+00 -6.9261942134815041e-02 + 1.0069294613704476e+00 -6.6899566907650740e-02 + 1.0021247908009627e+00 -6.4558883702744638e-02 + 9.9727174125107565e-01 -6.2231548209922480e-02 + 9.9237121844214382e-01 -5.9937812443763443e-02 + 9.8743719362413751e-01 -5.7672387153914192e-02 + 9.8248086314327887e-01 -5.5434635368641162e-02 + 9.7750923805545620e-01 -5.3234454773715280e-02 + 9.7254163854674380e-01 -5.1053154079852212e-02 + 9.6757608242666160e-01 -4.8920715381257134e-02 + 9.6263395855545431e-01 -4.6812748609369230e-02 + 9.5771538860443117e-01 -4.4753514644526163e-02 + 9.5283116295190873e-01 -4.2741985359129007e-02 + 9.4799291766939864e-01 -4.0773230817706480e-02 + 9.4320349010659921e-01 -3.8863362707871961e-02 + 9.3847641714768548e-01 -3.7000607675082640e-02 + 1.1275437166488782e+00 -1.4553364533268895e-01 + 1.1270452655225351e+00 -1.4523999188745645e-01 + 1.1265540049755007e+00 -1.4489555104465293e-01 + 1.1260565954518109e+00 -1.4452100629533474e-01 + 1.1255501616955894e+00 -1.4411052437738187e-01 + 1.1250243995778169e+00 -1.4367560665030496e-01 + 1.1244794425263926e+00 -1.4320987635349472e-01 + 1.1239073937026325e+00 -1.4271846675792671e-01 + 1.1233063432952448e+00 -1.4219844748369292e-01 + 1.1226717688270971e+00 -1.4165083107211041e-01 + 1.1220016426569057e+00 -1.4107338738195674e-01 + 1.1212931784874334e+00 -1.4046496694306876e-01 + 1.1205432187355255e+00 -1.3982481243155545e-01 + 1.1197494900971976e+00 -1.3915120044119075e-01 + 1.1189104805384162e+00 -1.3844145033812083e-01 + 1.1180221533496559e+00 -1.3769585426932451e-01 + 1.1170841395633770e+00 -1.3691026816361784e-01 + 1.1160894877160694e+00 -1.3608830043793319e-01 + 1.1150386691133687e+00 -1.3522455120825327e-01 + 1.1139249885888822e+00 -1.3432214945287058e-01 + 1.1127489284817091e+00 -1.3337545970514947e-01 + 1.1115063692843088e+00 -1.3238439203007538e-01 + 1.1101947685936551e+00 -1.3134694306077213e-01 + 1.1088115768780229e+00 -1.3026099259859070e-01 + 1.1073524932002643e+00 -1.2912671429620082e-01 + 1.1058162409050822e+00 -1.2794030591893946e-01 + 1.1041967218416926e+00 -1.2670432173926868e-01 + 1.1024937969749016e+00 -1.2541349147345676e-01 + 1.1007020364488838e+00 -1.2406971689962880e-01 + 1.0988215126478280e+00 -1.2266764469191981e-01 + 1.0968472978205017e+00 -1.2120890142628624e-01 + 1.0947792471852649e+00 -1.1968882783436618e-01 + 1.0926128747608770e+00 -1.1810903442430735e-01 + 1.0903477361258893e+00 -1.1646587425116194e-01 + 1.0879782495153876e+00 -1.1476326732163500e-01 + 1.0855037495172499e+00 -1.1299862903503310e-01 + 1.0829179364438402e+00 -1.1117797762364034e-01 + 1.0802188204194187e+00 -1.0930154198698003e-01 + 1.0774038604943859e+00 -1.0737143075669987e-01 + 1.0744680899057932e+00 -1.0539353967044231e-01 + 1.0714151677722514e+00 -1.0336251016554474e-01 + 1.0682366607613931e+00 -1.0129132746948076e-01 + 1.0649412712076725e+00 -9.9168634180476598e-02 + 1.0615163743231404e+00 -9.7016323861882123e-02 + 1.0579770218847673e+00 -9.4814687012648252e-02 + 1.0543064651943541e+00 -9.2595253248291626e-02 + 1.0505259474853046e+00 -9.0329671322635433e-02 + 1.0466153124066857e+00 -8.8058768491151795e-02 + 1.0426010354185440e+00 -8.5746485663193539e-02 + 1.0384605669411100e+00 -8.3441950398281506e-02 + 1.0342258606296153e+00 -8.1100227153882543e-02 + 1.0298786479342148e+00 -7.8767153083546745e-02 + 1.0254478455508678e+00 -7.6403983262224445e-02 + 1.0209194505911823e+00 -7.4052573485729717e-02 + 1.0163192490289341e+00 -7.1681043929146190e-02 + 1.0116374149515028e+00 -6.9326635525157471e-02 + 1.0068966001913764e+00 -6.6964618310194471e-02 + 1.0020923521222620e+00 -6.4624333463314060e-02 + 9.9723975744187532e-01 -6.2297365130930857e-02 + 9.9233969291476842e-01 -6.0003990182977342e-02 + 9.8740612044758735e-01 -5.7738896451638481e-02 + 9.8245022342478405e-01 -5.5501447486406529e-02 + 9.7747899837544905e-01 -5.3301572399646967e-02 + 9.7251178661610338e-01 -5.1120552637527503e-02 + 9.6754659796009646e-01 -4.8988417166853461e-02 + 9.6260484940267099e-01 -4.6880735747919282e-02 + 9.5768665509490136e-01 -4.4821799079841206e-02 + 9.5280281550354595e-01 -4.2810551736735807e-02 + 9.4796495776265421e-01 -4.0842072431588022e-02 + 9.4317591517549726e-01 -3.8932468674943425e-02 + 9.3844921998568842e-01 -3.7069962362835461e-02 + 1.1275393561835312e+00 -1.4560124720806134e-01 + 1.1270266869386159e+00 -1.4530919110389709e-01 + 1.1265254345385902e+00 -1.4496340018767512e-01 + 1.1260202873078848e+00 -1.4458824987659083e-01 + 1.1255087148930978e+00 -1.4417589218771804e-01 + 1.1249788163783583e+00 -1.4374018120928136e-01 + 1.1244312474497555e+00 -1.4327338637735854e-01 + 1.1238571781297273e+00 -1.4278152655153042e-01 + 1.1232549283596327e+00 -1.4226099638564416e-01 + 1.1226194456919460e+00 -1.4171325378913249e-01 + 1.1219488408369795e+00 -1.4113569103404319e-01 + 1.1212400629016335e+00 -1.4052732469104737e-01 + 1.1204899920992430e+00 -1.3988723610673018e-01 + 1.1196962220415174e+00 -1.3921378186839203e-01 + 1.1188572745550389e+00 -1.3850418828303646e-01 + 1.1179690282248056e+00 -1.3775881904649623e-01 + 1.1170311679255418e+00 -1.3697344914706377e-01 + 1.1160366707145382e+00 -1.3615175720379113e-01 + 1.1149860657628718e+00 -1.3528825217983353e-01 + 1.1138725850173594e+00 -1.3438612974819364e-01 + 1.1126967509957686e+00 -1.3343968938393397e-01 + 1.1114543995212667e+00 -1.3244889074020641e-01 + 1.1101430109371269e+00 -1.3141170313155720e-01 + 1.1087600283842936e+00 -1.3032601846108807e-01 + 1.1073011482117441e+00 -1.2919201599144492e-01 + 1.1057651098445520e+00 -1.2800587179221046e-01 + 1.1041457910946635e+00 -1.2677016562504700e-01 + 1.1024430763642572e+00 -1.2547958783358582e-01 + 1.1006515016147322e+00 -1.2413607818452255e-01 + 1.0987711658179056e+00 -1.2273424651180104e-01 + 1.0967971130916818e+00 -1.2127576230460627e-01 + 1.0947292292007591e+00 -1.1975593748363138e-01 + 1.0925630108794908e+00 -1.1817642548447785e-01 + 1.0902980466373555e+00 -1.1653355867157698e-01 + 1.0879287484246596e+00 -1.1483129036840012e-01 + 1.0854544775922146e+00 -1.1306701745053260e-01 + 1.0828689332193371e+00 -1.1124676772578823e-01 + 1.0801701287461769e+00 -1.0937076158752743e-01 + 1.0773555273563402e+00 -1.0744108924556851e-01 + 1.0744201367015422e+00 -1.0546366960789780e-01 + 1.0713676403603156e+00 -1.0343309632984325e-01 + 1.0681895580955625e+00 -1.0136241939498636e-01 + 1.0648946464448426e+00 -9.9240194769397785e-02 + 1.0614702123223276e+00 -9.7088419567358725e-02 + 1.0579313850155729e+00 -9.4887256996704028e-02 + 1.0542613251185144e+00 -9.2668378711622437e-02 + 1.0504813712824028e+00 -9.0403269834936920e-02 + 1.0465712602799548e+00 -8.8132925333297862e-02 + 1.0425575687812374e+00 -8.5821092026208134e-02 + 1.0384176267351606e+00 -8.3517081238881019e-02 + 1.0341834838992612e+00 -8.1175766091462265e-02 + 1.0298367623704843e+00 -7.8843177181425958e-02 + 1.0254064778408583e+00 -7.6480397180034645e-02 + 1.0208785456013247e+00 -7.4129453027694206e-02 + 1.0162788389705821e+00 -7.1758317941870750e-02 + 1.0115974714897968e+00 -6.9404373457785343e-02 + 1.0068571633411769e+00 -6.7042779259779001e-02 + 1.0020534246581108e+00 -6.4702965841561849e-02 + 9.9720137794067198e-01 -6.2376431391797368e-02 + 9.9230186514898344e-01 -6.0083482665945001e-02 + 9.8736883696140343e-01 -5.7818779984159720e-02 + 9.8241346119473361e-01 -5.5581687546322089e-02 + 9.7744271693879481e-01 -5.3382172231792313e-02 + 9.7247597089981097e-01 -5.1201482756524898e-02 + 9.6751122329839268e-01 -4.9069704390603777e-02 + 9.6256992492345061e-01 -4.6962358666405621e-02 + 9.5765218090287696e-01 -4.4903772098720679e-02 + 9.5276880382328566e-01 -4.2892856498696313e-02 + 9.4793141009846227e-01 -4.0924700975268284e-02 + 9.4314282818711936e-01 -3.9015408037201577e-02 + 9.3841658477811041e-01 -3.7153193892649511e-02 + 1.1275341357999178e+00 -1.4568275698522221e-01 + 1.1270043218811119e+00 -1.4539262685328583e-01 + 1.1264910213559221e+00 -1.4504520744936886e-01 + 1.1259765444797305e+00 -1.4466932617042941e-01 + 1.1254587767597322e+00 -1.4425470568053805e-01 + 1.1249238917887030e+00 -1.4381803707225038e-01 + 1.1243731749483166e+00 -1.4334995736552889e-01 + 1.1237966710343859e+00 -1.4285755326608271e-01 + 1.1231929769729629e+00 -1.4233640557398497e-01 + 1.1225564012688307e+00 -1.4178850919834701e-01 + 1.1218852214192063e+00 -1.4121080113793619e-01 + 1.1211760674839997e+00 -1.4060249815515874e-01 + 1.1204258652318639e+00 -1.3996248707891792e-01 + 1.1196320478111927e+00 -1.3928922093452908e-01 + 1.1187931778656248e+00 -1.3857981382822970e-01 + 1.1179050318568848e+00 -1.3783471570641836e-01 + 1.1169673595679253e+00 -1.3704960397080868e-01 + 1.1159730518848454e+00 -1.3622824186249716e-01 + 1.1149227077331012e+00 -1.3536502845411746e-01 + 1.1138094711971409e+00 -1.3446323980973318e-01 + 1.1126339132267180e+00 -1.3351709697639075e-01 + 1.1113918158032399e+00 -1.3252661937322266e-01 + 1.1100806866886088e+00 -1.3148974337934302e-01 + 1.1086979601930311e+00 -1.3040437547729528e-01 + 1.1072393293954945e+00 -1.2927070168320631e-01 + 1.1057035530997978e+00 -1.2808487191293103e-01 + 1.1040844801486327e+00 -1.2684949663925271e-01 + 1.1023820231857582e+00 -1.2555921875445103e-01 + 1.1005906769801941e+00 -1.2421602379704880e-01 + 1.0987105725387181e+00 -1.2281447720646474e-01 + 1.0967367200828155e+00 -1.2135630017209594e-01 + 1.0946690421769529e+00 -1.1983676989696297e-01 + 1.0925030147271100e+00 -1.1825759152576143e-01 + 1.0902382659059215e+00 -1.1661507248753365e-01 + 1.0878692000804764e+00 -1.1491320622825185e-01 + 1.0853952108215443e+00 -1.1314936729849023e-01 + 1.0828099957007198e+00 -1.1132959502883466e-01 + 1.0801115721266479e+00 -1.0945409955759541e-01 + 1.0772974082318005e+00 -1.0752494890451172e-01 + 1.0743624808316321e+00 -1.0554808987219871e-01 + 1.0713105029265722e+00 -1.0351805858193219e-01 + 1.0681329377806257e+00 -1.0144798297777248e-01 + 1.0648386071547196e+00 -9.9326314733237081e-02 + 1.0614147357197012e+00 -9.7175175612124506e-02 + 1.0578765460274659e+00 -9.4974575611847759e-02 + 1.0542070894708606e+00 -9.2756357339226894e-02 + 1.0504278194977916e+00 -9.0491809006280802e-02 + 1.0465183442449584e+00 -8.8222127397386885e-02 + 1.0425053621283191e+00 -8.5910825819013326e-02 + 1.0383660581350387e+00 -8.3607436698557080e-02 + 1.0341325976085873e+00 -8.1266603007833282e-02 + 1.0297864710967175e+00 -7.8934588045143514e-02 + 1.0253568133408957e+00 -7.6572267150609594e-02 + 1.0208294412226342e+00 -7.4221873096731880e-02 + 1.0162303330731561e+00 -7.1851202409390788e-02 + 1.0115495296213577e+00 -6.9497805687475128e-02 + 1.0068098332001318e+00 -6.7136709965367677e-02 + 1.0020067091573936e+00 -6.4797453112319631e-02 + 9.9715532300507570e-01 -6.2471430021858489e-02 + 9.9225647485999324e-01 -6.0178983393441736e-02 + 9.8732410190383790e-01 -5.7914740517872612e-02 + 9.8236935325321950e-01 -5.5678066409683293e-02 + 9.7739918706097184e-01 -5.3478973344979731e-02 + 9.7243300054677351e-01 -5.1298670745722599e-02 + 9.6746878242361911e-01 -4.9167311523944927e-02 + 9.6252802407615579e-01 -4.7060359307238273e-02 + 9.5761081980609131e-01 -4.5002183635006111e-02 + 9.5272799676262709e-01 -4.2991656996065573e-02 + 9.4789115850165284e-01 -4.1023880999035520e-02 + 9.4310312768363902e-01 -3.9114952165462812e-02 + 9.3837742435095806e-01 -3.7253079893972120e-02 + 1.1275278834696021e+00 -1.4578110105396871e-01 + 1.1269773822487346e+00 -1.4549329460941524e-01 + 1.1264495446083460e+00 -1.4514390946859868e-01 + 1.1259238113112993e+00 -1.4476714511525271e-01 + 1.1253985696063784e+00 -1.4434979296066780e-01 + 1.1248576696792925e+00 -1.4391196732724126e-01 + 1.1243031566397252e+00 -1.4344233556830846e-01 + 1.1237237175257506e+00 -1.4294927285079920e-01 + 1.1231182834028641e+00 -1.4242737801001193e-01 + 1.1224803916913468e+00 -1.4187929386143366e-01 + 1.1218085210819320e+00 -1.4130140810110592e-01 + 1.1210989166783480e+00 -1.4069317901396292e-01 + 1.1203485591894857e+00 -1.4005325874292365e-01 + 1.1195546881629623e+00 -1.3938021664995401e-01 + 1.1187159154756030e+00 -1.3867103147362059e-01 + 1.1178278943880138e+00 -1.3792625719852936e-01 + 1.1168904529807855e+00 -1.3714145349473483e-01 + 1.1158963781917015e+00 -1.3632048566987010e-01 + 1.1148463530845241e+00 -1.3545762023267116e-01 + 1.1137334157630696e+00 -1.3455623020634278e-01 + 1.1125581955939572e+00 -1.3361044203340094e-01 + 1.1113164096213122e+00 -1.3262034720868537e-01 + 1.1100055986781969e+00 -1.3158384237925250e-01 + 1.1086231864259706e+00 -1.3049885160132879e-01 + 1.1071648620014234e+00 -1.2936556902448137e-01 + 1.1056294075756528e+00 -1.2818011301736323e-01 + 1.1040106370576313e+00 -1.2694513107638300e-01 + 1.1023084971411634e+00 -1.2565520887182391e-01 + 1.1005174329271956e+00 -1.2431238712327021e-01 + 1.0986376140425282e+00 -1.2291117774062239e-01 + 1.0966640098418379e+00 -1.2145336423439822e-01 + 1.0945965872470045e+00 -1.1993418194766955e-01 + 1.0924307970505782e+00 -1.1835539834520134e-01 + 1.0901663152211021e+00 -1.1671329078774305e-01 + 1.0877975369695398e+00 -1.1501190106281456e-01 + 1.0853238946729320e+00 -1.1324857679926481e-01 + 1.0827390840556386e+00 -1.1142937119862495e-01 + 1.0800411272741870e+00 -1.0955448202807358e-01 + 1.0772274983844110e+00 -1.0762595056415561e-01 + 1.0742931370146440e+00 -1.0564975720663258e-01 + 1.0712417915679009e+00 -1.0362036876772759e-01 + 1.0680648572170754e+00 -1.0155100709127232e-01 + 1.0647712342373281e+00 -9.9429998241551173e-02 + 1.0613480482157425e+00 -9.7279614094448880e-02 + 1.0578106339662927e+00 -9.5079680162801841e-02 + 1.0541419113581345e+00 -9.2862244890554904e-02 + 1.0503634720004784e+00 -9.0598359437649434e-02 + 1.0464547691393034e+00 -8.8329463543644238e-02 + 1.0424426476885211e+00 -8.6018789469449075e-02 + 1.0383041181380368e+00 -8.3716135764802857e-02 + 1.0340714848952066e+00 -8.1375868478460234e-02 + 1.0297260802024852e+00 -7.9044530928527465e-02 + 1.0252971820090604e+00 -7.6682749045403259e-02 + 1.0207704887967972e+00 -7.4333003228900352e-02 + 1.0161721051844146e+00 -7.1962877505356029e-02 + 1.0114919843107062e+00 -6.9610125817489543e-02 + 1.0067530272689891e+00 -6.7249615707822549e-02 + 1.0019506455312348e+00 -6.4911014167620310e-02 + 9.9710005629053799e-01 -6.2585591936283408e-02 + 9.9220200934481850e-01 -6.0293734957880783e-02 + 9.8727042564842826e-01 -5.8030030867115029e-02 + 9.8231643185146156e-01 -5.5793845703433764e-02 + 9.7734696096868079e-01 -5.3595246323311418e-02 + 9.7238144689839268e-01 -5.1415394972024769e-02 + 9.6741786454918222e-01 -4.9284525838800018e-02 + 9.6247775408019165e-01 -4.7178033022873919e-02 + 9.5756119680340590e-01 -4.5120337755818737e-02 + 9.5267903736883564e-01 -4.3110265330469424e-02 + 9.4784286391151196e-01 -4.1142932388823890e-02 + 9.4305549215471984e-01 -3.9234428287955161e-02 + 9.3833043419120898e-01 -3.7372954277202594e-02 + 1.1275203909296729e+00 -1.4589983737314929e-01 + 1.1269449107593081e+00 -1.4561483626659499e-01 + 1.1263995209705768e+00 -1.4526307651636963e-01 + 1.1258601974800548e+00 -1.4488524441134101e-01 + 1.1253259332967247e+00 -1.4446459211281129e-01 + 1.1247777731300117e+00 -1.4402536735146010e-01 + 1.1242186793149203e+00 -1.4355385927330980e-01 + 1.1236356994272199e+00 -1.4305999875409689e-01 + 1.1230281678846166e+00 -1.4253719902664805e-01 + 1.1223886910729768e+00 -1.4198888514955629e-01 + 1.1217159905396277e+00 -1.4141078162034304e-01 + 1.1210058465928783e+00 -1.4080263830301254e-01 + 1.1202553062419418e+00 -1.4016282400177685e-01 + 1.1194613752969058e+00 -1.3949004851093602e-01 + 1.1186227250575114e+00 -1.3878112714215263e-01 + 1.1177348600572605e+00 -1.3803673945464823e-01 + 1.1167977028870359e+00 -1.3725230298899760e-01 + 1.1158039150105186e+00 -1.3643180623792261e-01 + 1.1147542810450024e+00 -1.3556935569060613e-01 + 1.1136417111773347e+00 -1.3466844138534384e-01 + 1.1124669052795133e+00 -1.3372307557335711e-01 + 1.1112255020269992e+00 -1.3273343672403765e-01 + 1.1099150821674015e+00 -1.3169737352154251e-01 + 1.1085330565133562e+00 -1.3061283121672115e-01 + 1.1070751094460265e+00 -1.2948001375931517e-01 + 1.1055400513305400e+00 -1.2829500144037634e-01 + 1.1039216539242573e+00 -1.2706048641541678e-01 + 1.1022199049980628e+00 -1.2577098530838252e-01 + 1.1004291897297351e+00 -1.2442860540126496e-01 + 1.0985497243316944e+00 -1.2302779402166987e-01 + 1.0965764288594069e+00 -1.2157040984600098e-01 + 1.0945093237316785e+00 -1.2005163771627222e-01 + 1.0923438294431693e+00 -1.1847332024618124e-01 + 1.0900796795889938e+00 -1.1683169851656314e-01 + 1.0877112583157502e+00 -1.1513087258923349e-01 + 1.0852380447620644e+00 -1.1336815760817842e-01 + 1.0826537323835332e+00 -1.1154962347902142e-01 + 1.0799563490148725e+00 -1.0967545303556389e-01 + 1.0771433757993243e+00 -1.0774765530615552e-01 + 1.0742097074920964e+00 -1.0577225117512290e-01 + 1.0711591351094976e+00 -1.0374362391954770e-01 + 1.0679829717186222e+00 -1.0167510853410826e-01 + 1.0646902121456574e+00 -9.9554879730508958e-02 + 1.0612678625456990e+00 -9.7405390241848050e-02 + 1.0577313929149970e+00 -9.5206243341924526e-02 + 1.0540635646403205e+00 -9.2989735420446251e-02 + 1.0502861356733972e+00 -9.0726632145518293e-02 + 1.0463783726763449e+00 -8.8458665852471086e-02 + 1.0423672969068853e+00 -8.6148730421740538e-02 + 1.0382297087213319e+00 -8.3846944834718329e-02 + 1.0339980798930444e+00 -8.1507341821819068e-02 + 1.0296535520927093e+00 -7.9176801781287026e-02 + 1.0252255755908575e+00 -7.6815650521211684e-02 + 1.0206997063717060e+00 -7.4466666447434493e-02 + 1.0161022009680327e+00 -7.2097177949657462e-02 + 1.0114229071182281e+00 -6.9745183617540507e-02 + 1.0066848446714372e+00 -6.7385359180107338e-02 + 1.0018833602675452e+00 -6.5047526943473544e-02 + 9.9703373320749100e-01 -6.2722808390915902e-02 + 9.9213665276119245e-01 -6.0431641511442362e-02 + 9.8720602036746907e-01 -5.8168566324297261e-02 + 9.8225293568078631e-01 -5.5932950162670435e-02 + 9.7728430153136903e-01 -5.3734925521410813e-02 + 9.7231959591630712e-01 -5.1555598001228803e-02 + 9.6735677718506563e-01 -4.9425299468935972e-02 + 9.6241744410661456e-01 -4.7319340532084177e-02 + 9.5750166240755352e-01 -4.5262204538119070e-02 + 9.5262029777333324e-01 -4.3252660132197106e-02 + 9.4778491984534796e-01 -4.1285842042044732e-02 + 9.4299833605019501e-01 -3.9377831055205446e-02 + 9.3827404897624778e-01 -3.7516818671235845e-02 + 1.1275114055611632e+00 -1.4604329198016250e-01 + 1.1269057441351737e+00 -1.4576167982149665e-01 + 1.1263391476710793e+00 -1.4540704938066326e-01 + 1.1257834055098532e+00 -1.4502792510417320e-01 + 1.1252382424822849e+00 -1.4460328291214344e-01 + 1.1246813134293541e+00 -1.4416236482728056e-01 + 1.1241166887926664e+00 -1.4368858657449690e-01 + 1.1235294351932703e+00 -1.4319375867795217e-01 + 1.1229193742675854e+00 -1.4266986193979356e-01 + 1.1222779874814948e+00 -1.4212126647951842e-01 + 1.1216042897189880e+00 -1.4154289554945534e-01 + 1.1208934997204221e+00 -1.4093485125500885e-01 + 1.1201427445543546e+00 -1.4029516009472301e-01 + 1.1193487476487411e+00 -1.3962270149134778e-01 + 1.1185102520709600e+00 -1.3891409332312321e-01 + 1.1176225826955446e+00 -1.3817016681529992e-01 + 1.1166857762670841e+00 -1.3738616781191126e-01 + 1.1156923426944172e+00 -1.3656623357282172e-01 + 1.1146431892464148e+00 -1.3570427730013535e-01 + 1.1135310716181948e+00 -1.3480393034024019e-01 + 1.1123567748310650e+00 -1.3385906702237088e-01 + 1.1111158429238248e+00 -1.3286997083335389e-01 + 1.1098059048485747e+00 -1.3183443252097066e-01 + 1.1084243559053528e+00 -1.3075042291175798e-01 + 1.1069668747355161e+00 -1.2961815776921048e-01 + 1.1054323057422515e+00 -1.2843367139526918e-01 + 1.1038143697915179e+00 -1.2719970984565535e-01 + 1.1021131042378547e+00 -1.2591070637927687e-01 + 1.1003228219205392e+00 -1.2456884861566794e-01 + 1.0984437952783530e+00 -1.2316850591880103e-01 + 1.0964708848608342e+00 -1.2171162767391763e-01 + 1.0944041756423737e+00 -1.2019333776132085e-01 + 1.0922390515431764e+00 -1.1861556946217867e-01 + 1.0899753156739218e+00 -1.1697452005665807e-01 + 1.0876073388012835e+00 -1.1527435988955403e-01 + 1.0851346564370192e+00 -1.1351236488374639e-01 + 1.0825509592448892e+00 -1.1169462506916261e-01 + 1.0798542818476375e+00 -1.0982130524115516e-01 + 1.0770421138658781e+00 -1.0789437552098460e-01 + 1.0741092958739245e+00 -1.0591990559910650e-01 + 1.0710596701989834e+00 -1.0389217802279581e-01 + 1.0678844508498102e+00 -1.0182466419854404e-01 + 1.0645927465612028e+00 -9.9705356382788851e-02 + 1.0611714194581261e+00 -9.7556925304830830e-02 + 1.0576361023821121e+00 -9.5358706403278967e-02 + 1.0539693656645379e+00 -9.3143294863552370e-02 + 1.0501931676042127e+00 -9.0881112384508411e-02 + 1.0462865500042033e+00 -8.8614243822362937e-02 + 1.0422767464666634e+00 -8.6305175493066599e-02 + 1.0381403042005726e+00 -8.4004412348804181e-02 + 1.0339098964735922e+00 -8.1665585784406858e-02 + 1.0295664354591343e+00 -7.9335982109213860e-02 + 1.0251395788456421e+00 -7.6975565872089438e-02 + 1.0206147110596813e+00 -7.4627474228846927e-02 + 1.0160182714250845e+00 -7.2258727952373022e-02 + 1.0113399808078345e+00 -6.9907620058073272e-02 + 1.0066030018898089e+00 -6.7548595532371830e-02 + 1.0018026032694403e+00 -6.5211663552631138e-02 + 9.9695413889816864e-01 -6.2887766131439052e-02 + 9.9205822521745546e-01 -6.0597403914698374e-02 + 9.8712874018984531e-01 -5.8335059745274205e-02 + 9.8217675102675595e-01 -5.6100102594356584e-02 + 9.7720912431128981e-01 -5.3902743912857189e-02 + 9.7224539107187258e-01 -5.1724021284513033e-02 + 9.6728348979483270e-01 -4.9594383984043373e-02 + 9.6234508968852384e-01 -4.7489042351727996e-02 + 9.5743023777954595e-01 -4.5432554388256163e-02 + 9.5254982504186381e-01 -4.3423620744861044e-02 + 9.4771539893964696e-01 -4.1457397913718948e-02 + 9.4292975698032278e-01 -3.9549956435678699e-02 + 9.3820639039405418e-01 -3.7689476150475854e-02 + 1.1275006207226546e+00 -1.4621672274438380e-01 + 1.1268584690322090e+00 -1.4593920690978002e-01 + 1.1262662342947789e+00 -1.4558110353250489e-01 + 1.1256906439373071e+00 -1.4520041417713939e-01 + 1.1251323074509487e+00 -1.4477094476318078e-01 + 1.1245647810521195e+00 -1.4432797564353403e-01 + 1.1239934747325697e+00 -1.4385144857486235e-01 + 1.1234010600033959e+00 -1.4335544656080351e-01 + 1.1227879473879090e+00 -1.4283021865888620e-01 + 1.1221442583062549e+00 -1.4228127747325697e-01 + 1.1214693621702450e+00 -1.4170257761718758e-01 + 1.1207577988022854e+00 -1.4109464698402757e-01 + 1.1200067920031285e+00 -1.4045509826743766e-01 + 1.1192127238369638e+00 -1.3978301590901762e-01 + 1.1183744241008331e+00 -1.3907477912175636e-01 + 1.1174870005118631e+00 -1.3833140241916908e-01 + 1.1165506277786796e+00 -1.3754792410236405e-01 + 1.1155576326421799e+00 -1.3672866119959792e-01 + 1.1145090705935052e+00 -1.3586729329927039e-01 + 1.1133975106287122e+00 -1.3496762249265259e-01 + 1.1122238406655938e+00 -1.3402335642385305e-01 + 1.1109834903939713e+00 -1.3303490545628391e-01 + 1.1096741470171769e+00 -1.3199999031089785e-01 + 1.1082931870959847e+00 -1.3091661269289853e-01 + 1.1068362823402642e+00 -1.2978500261302861e-01 + 1.1053023182703856e+00 -1.2860113879527316e-01 + 1.1036849542737914e+00 -1.2736783238372598e-01 + 1.1019842875901233e+00 -1.2607941592671484e-01 + 1.1001945436838942e+00 -1.2473817405957367e-01 + 1.0983160628933919e+00 -1.2333838197580144e-01 + 1.0963436339025265e+00 -1.2188209858473428e-01 + 1.0942774196270182e+00 -1.2036437413641375e-01 + 1.0921127598111739e+00 -1.1878725135898069e-01 + 1.0898495414647333e+00 -1.1714687462183801e-01 + 1.0874821191622945e+00 -1.1544749907739060e-01 + 1.0850100964062208e+00 -1.1368635326695653e-01 + 1.0824271604183955e+00 -1.1186955147445587e-01 + 1.0797313539331617e+00 -1.0999723669306147e-01 + 1.0769201767079777e+00 -1.0807133207853752e-01 + 1.0739884038602123e+00 -1.0609796618575515e-01 + 1.0709399395210026e+00 -1.0407130004163116e-01 + 1.0677658781275732e+00 -1.0200496958030514e-01 + 1.0644754656961402e+00 -9.9886747012267296e-02 + 1.0610553905749700e+00 -9.7739565940800244e-02 + 1.0575214818476717e+00 -9.5542438885108563e-02 + 1.0538560794215872e+00 -9.3328321250851914e-02 + 1.0500813829837401e+00 -9.1067220152496076e-02 + 1.0461761632408211e+00 -8.8801645328061340e-02 + 1.0421679095745808e+00 -8.6493592024240229e-02 + 1.0380328641134160e+00 -8.4194030277330967e-02 + 1.0338039427834109e+00 -8.1856108091002966e-02 + 1.0294617812895437e+00 -7.9527600737179641e-02 + 1.0250362870565746e+00 -7.7168037784488511e-02 + 1.0205126379011507e+00 -7.4820988398171986e-02 + 1.0159174931487995e+00 -7.2453103084710993e-02 + 1.0112404209007133e+00 -7.0103029292551869e-02 + 1.0065047556675712e+00 -6.7744934369101825e-02 + 1.0017056720771080e+00 -6.5409052389213615e-02 + 9.9685861382083341e-01 -6.3086109520867198e-02 + 9.9196410968827486e-01 -6.0796681865965950e-02 + 9.8703600939418001e-01 -5.8535183605584025e-02 + 9.8208534115410262e-01 -5.6300985789490873e-02 + 9.7711892802007794e-01 -5.4104394866839975e-02 + 9.7215636480673462e-01 -5.1926366744182439e-02 + 9.6719556617475289e-01 -4.9797491842752804e-02 + 9.6225828600089292e-01 -4.7692860080601890e-02 + 9.5734454887503961e-01 -4.5637119193386935e-02 + 9.5246527617762577e-01 -4.3628888217810934e-02 + 9.4763198877958710e-01 -4.1663349844315196e-02 + 9.4284747233396116e-01 -3.9756562366534874e-02 + 9.3812520450254333e-01 -3.7896691685077213e-02 + 1.1274876646417173e+00 -1.4642651473296547e-01 + 1.1268013698953125e+00 -1.4615395265064285e-01 + 1.1261781218689360e+00 -1.4579164492240945e-01 + 1.1255785241779066e+00 -1.4540905845302604e-01 + 1.1250042563082738e+00 -1.4497374503794436e-01 + 1.1244239160718308e+00 -1.4452828979470608e-01 + 1.1238445336957641e+00 -1.4404843206172088e-01 + 1.1232458831932775e+00 -1.4355100379644564e-01 + 1.1226290872508176e+00 -1.4302415926937292e-01 + 1.1219826220443183e+00 -1.4247479300398214e-01 + 1.1213062857054148e+00 -1.4189568794925070e-01 + 1.1205937968065713e+00 -1.4128788697192152e-01 + 1.1198424960889177e+00 -1.4064850224583808e-01 + 1.1190483527232444e+00 -1.3997686613963364e-01 + 1.1182103013748277e+00 -1.3926906919647308e-01 + 1.1173231871346565e+00 -1.3852634755271254e-01 + 1.1163873515429401e+00 -1.3774348849690909e-01 + 1.1153948998456400e+00 -1.3692502640238047e-01 + 1.1143470667548085e+00 -1.3606435834952890e-01 + 1.1132361955250227e+00 -1.3516549285158419e-01 + 1.1120632984835566e+00 -1.3422193599700444e-01 + 1.1108236670808094e+00 -1.3323425151416698e-01 + 1.1095150589494298e+00 -1.3220007543692280e-01 + 1.1081348280015777e+00 -1.3111744676963499e-01 + 1.1066786375728941e+00 -1.2998661271140100e-01 + 1.1051454228774447e+00 -1.2880348478399828e-01 + 1.1035287689970472e+00 -1.2757095276873534e-01 + 1.1018288455342313e+00 -1.2628322748556234e-01 + 1.1000397723643078e+00 -1.2494271078365712e-01 + 1.0981619718616387e+00 -1.2354356405271205e-01 + 1.0961901458752679e+00 -1.2208797850728072e-01 + 1.0941245514676712e+00 -1.2057091542169364e-01 + 1.0919604749992060e+00 -1.1899454970102821e-01 + 1.0896979047830684e+00 -1.1735496176687828e-01 + 1.0873311757862878e+00 -1.1565650914984360e-01 + 1.0848599735454045e+00 -1.1389636312236462e-01 + 1.0822779810330918e+00 -1.1208066720944032e-01 + 1.0795832506734786e+00 -1.1020953803844688e-01 + 1.0767732943416113e+00 -1.0828484204654358e-01 + 1.0738428080346403e+00 -1.0631277881166813e-01 + 1.0707957703491340e+00 -1.0428736269796657e-01 + 1.0676231313240045e+00 -1.0222242815662089e-01 + 1.0643343024817387e+00 -1.0010548191286651e-01 + 1.0609157624156382e+00 -9.7959774681585080e-02 + 1.0573835767763020e+00 -9.5763929505200379e-02 + 1.0537198074564971e+00 -9.3551336220045869e-02 + 1.0499469450732009e+00 -9.1291502069822228e-02 + 1.0460434333708957e+00 -8.9027449066293229e-02 + 1.0420370699242985e+00 -8.6720580581712170e-02 + 1.0379037290687494e+00 -8.4422427249393195e-02 + 1.0336766190460938e+00 -8.2085554677163941e-02 + 1.0293360424047888e+00 -7.9758327323588632e-02 + 1.0249122073386183e+00 -7.7399750869829767e-02 + 1.0203900427685060e+00 -7.5053914856680365e-02 + 1.0157964728700732e+00 -7.2687024005914730e-02 + 1.0111208817525830e+00 -7.0338152545983801e-02 + 1.0063868106797149e+00 -6.7981133684696091e-02 + 1.0015893210962759e+00 -6.5646472222439828e-02 + 9.9674396458907888e-01 -6.3324634689635617e-02 + 9.9185116442988808e-01 -6.1036288083286337e-02 + 9.8692473633627620e-01 -5.8775764124702624e-02 + 9.8197566164488737e-01 -5.6542436504556905e-02 + 9.7701071112544668e-01 -5.4346725996736824e-02 + 9.7204955632838452e-01 -5.2169490421219961e-02 + 9.6709008333603308e-01 -5.0041489910355751e-02 + 9.6215414781081809e-01 -4.7937669743703247e-02 + 9.5724174742212853e-01 -4.5882785535610621e-02 + 9.5236384011615527e-01 -4.3875358356999704e-02 + 9.4753191487685817e-01 -4.1910602441648750e-02 + 9.4274874319461555e-01 -4.0004561449948205e-02 + 9.3802778652910068e-01 -3.8145384623973738e-02 + 1.1274720800326437e+00 -1.4668041389198594e-01 + 1.1267323598643708e+00 -1.4641384458513371e-01 + 1.1260715796364131e+00 -1.4604644406126771e-01 + 1.1254429309462590e+00 -1.4566155638910033e-01 + 1.1248493879920216e+00 -1.4521916423559833e-01 + 1.1242535472286512e+00 -1.4477069362625555e-01 + 1.1236643995090214e+00 -1.4428679791153085e-01 + 1.1230582119561767e+00 -1.4378763590212809e-01 + 1.1224369688951683e+00 -1.4325882675264229e-01 + 1.1217871553386620e+00 -1.4270893727811335e-01 + 1.1211090880926649e+00 -1.4212933252841933e-01 + 1.1203954918563110e+00 -1.4152167848756189e-01 + 1.1196438488060307e+00 -1.4088248164370015e-01 + 1.1188496284758180e+00 -1.4021137431205941e-01 + 1.1180118923892377e+00 -1.3950409772478167e-01 + 1.1171251678805065e+00 -1.3876215611009002e-01 + 1.1161899983195402e+00 -1.3798003303178064e-01 + 1.1151982209925742e+00 -1.3716252575360954e-01 + 1.1141512874101429e+00 -1.3630268956700320e-01 + 1.1130412677598436e+00 -1.3540478264656031e-01 + 1.1118693248557474e+00 -1.3446206725089377e-01 + 1.1106305829551610e+00 -1.3347529257055102e-01 + 1.1093228848817445e+00 -1.3244199217696054e-01 + 1.1079435571629432e+00 -1.3136025014627184e-01 + 1.1064882530130218e+00 -1.3023033442106657e-01 + 1.1049559677307625e+00 -1.2904807522963013e-01 + 1.1033401965516940e+00 -1.2781645739710235e-01 + 1.1016411965550528e+00 -1.2652954454901919e-01 + 1.0998529599633100e+00 -1.2518988020750027e-01 + 1.0979760083066479e+00 -1.2379148817547189e-01 + 1.0960049384696322e+00 -1.2233671955453876e-01 + 1.0939401212804243e+00 -1.2082042805621861e-01 + 1.0917767785612695e+00 -1.1924494827350393e-01 + 1.0895150209881692e+00 -1.1760628330947037e-01 + 1.0871491597721441e+00 -1.1590891432807382e-01 + 1.0846789794607818e+00 -1.1414994335363815e-01 + 1.0820981577752040e+00 -1.1233554917522781e-01 + 1.0794047587113538e+00 -1.1046581652102813e-01 + 1.0765963086261552e+00 -1.0854254330467911e-01 + 1.0736674078413264e+00 -1.0657201482525888e-01 + 1.0706221246970080e+00 -1.0454806837872589e-01 + 1.0674512347867655e+00 -1.0248477802340825e-01 + 1.0641643492244546e+00 -1.0036933007204520e-01 + 1.0607476933323443e+00 -9.8225357901214283e-02 + 1.0572176180191157e+00 -9.6031014656166536e-02 + 1.0535558496333071e+00 -9.3820214261626789e-02 + 1.0497852295252403e+00 -9.1561861084855478e-02 + 1.0458838069782586e+00 -8.9299594956429473e-02 + 1.0418797510070525e+00 -8.6994105683260159e-02 + 1.0377484924253912e+00 -8.4697599808521318e-02 + 1.0335235916935268e+00 -8.2361941088166191e-02 + 1.0291849497878434e+00 -8.0036204115501108e-02 + 1.0247631372130312e+00 -7.7678763462401060e-02 + 1.0202427829810596e+00 -7.5334335633526428e-02 + 1.0156511301720264e+00 -7.2968588535188728e-02 + 1.0109773412414726e+00 -7.0621110400861747e-02 + 1.0062452062702800e+00 -6.8265332227269188e-02 + 1.0014496503484274e+00 -6.5932084771034627e-02 + 9.9660635480127302e-01 -6.3611522199337800e-02 + 9.9171561584973489e-01 -6.1324421027833489e-02 + 9.8679120828677436e-01 -5.9065013941618415e-02 + 9.8184405708632005e-01 -5.6832677987869853e-02 + 9.7688087022018799e-01 -5.4637971548288103e-02 + 9.7192141156747047e-01 -5.2461634645281710e-02 + 9.6696353293140380e-01 -5.0334631493839391e-02 + 9.6202921235101035e-01 -4.8231733639653343e-02 + 9.5711841519498220e-01 -4.6177826403763431e-02 + 9.5224214338739444e-01 -4.4171313261927789e-02 + 9.4741184767908226e-01 -4.2207446434761584e-02 + 9.4263028264487392e-01 -4.0302252104013600e-02 + 9.3791089040300024e-01 -3.8443859608747848e-02 + 1.1274532646540611e+00 -1.4698781127901944e-01 + 1.1266488637662699e+00 -1.4672849301626284e-01 + 1.1259426477616921e+00 -1.4635492050427770e-01 + 1.1252788338899162e+00 -1.4596723977668064e-01 + 1.1246619634287689e+00 -1.4551626975948281e-01 + 1.1240473666985287e+00 -1.4506414011245197e-01 + 1.1234464078513064e+00 -1.4457534677985648e-01 + 1.1228311081613760e+00 -1.4407407612112788e-01 + 1.1222044947896508e+00 -1.4354287825578599e-01 + 1.1215506421491115e+00 -1.4299234432793442e-01 + 1.1208704947615444e+00 -1.4241212293082836e-01 + 1.1201555741578515e+00 -1.4180463425731007e-01 + 1.1194035336361678e+00 -1.4116565160129796e-01 + 1.1186092379350847e+00 -1.4049517027189037e-01 + 1.1177719020902499e+00 -1.3978850866884329e-01 + 1.1168856688541058e+00 -1.3904749542614070e-01 + 1.1159513258461733e+00 -1.3826624648108066e-01 + 1.1149603860793795e+00 -1.3744987717579704e-01 + 1.1139145634043748e+00 -1.3659102915902110e-01 + 1.1128055975928486e+00 -1.3569426265590323e-01 + 1.1116348335479462e+00 -1.3475254486023397e-01 + 1.1103971932546841e+00 -1.3376684930713570e-01 + 1.1090906226166073e+00 -1.3273458555952861e-01 + 1.1077124150407747e+00 -1.3165389217292031e-01 + 1.1062582115058481e+00 -1.3052506212982939e-01 + 1.1047270799819220e+00 -1.2934382728723995e-01 + 1.1031124070356615e+00 -1.2811328737660649e-01 + 1.1014145555262704e+00 -1.2682732798083773e-01 + 1.0996273633046578e+00 -1.2548866390697722e-01 + 1.0977514717850261e+00 -1.2409115256791450e-01 + 1.0957813509359640e+00 -1.2263733833964274e-01 + 1.0937175090978128e+00 -1.2112194486229390e-01 + 1.0915550900465343e+00 -1.1954749970774925e-01 + 1.0892943522975524e+00 -1.1790991246664356e-01 + 1.0869295782688559e+00 -1.1621381364427918e-01 + 1.0844606720381040e+00 -1.1445622150691293e-01 + 1.0818813048331510e+00 -1.1264335738029274e-01 + 1.0791895544667707e+00 -1.1077526738627338e-01 + 1.0763829646005019e+00 -1.0885366662984071e-01 + 1.0734560198272609e+00 -1.0688494389515117e-01 + 1.0704128966643416e+00 -1.0486272264673609e-01 + 1.0672441599034028e+00 -1.0280136621493199e-01 + 1.0639596614050002e+00 -1.0068767411633325e-01 + 1.0605453205984496e+00 -9.8545741596794245e-02 + 1.0570178324339139e+00 -9.6353154749639805e-02 + 1.0533585181841072e+00 -9.4144459891083984e-02 + 1.0495906421123846e+00 -9.1887834124520451e-02 + 1.0456917774994063e+00 -8.9627662548537046e-02 + 1.0416905411098316e+00 -8.7323774522090503e-02 + 1.0375618288022455e+00 -8.5029191694545148e-02 + 1.0333396255081317e+00 -8.2694931856380549e-02 + 1.0290033480718297e+00 -8.0370925674628710e-02 + 1.0245840035142677e+00 -7.8014787316689191e-02 + 1.0200658594026391e+00 -7.5671988805366325e-02 + 1.0154765428631800e+00 -7.3307551513805511e-02 + 1.0108049492786968e+00 -7.0961682832401132e-02 + 1.0060751682052460e+00 -6.8607329542344594e-02 + 1.0012819604308763e+00 -6.6275714914155390e-02 + 9.9644116329753551e-01 -6.3956617275536518e-02 + 9.9155292002276496e-01 -6.1670945123025948e-02 + 9.8663095612650642e-01 -5.9412812191238853e-02 + 9.8168612880874917e-01 -5.7181599790453161e-02 + 9.7672507060702995e-01 -5.4988031958216700e-02 + 9.7176765649984409e-01 -5.2812707243530828e-02 + 9.6681169717129967e-01 -5.0686835302158333e-02 + 9.6187931780322444e-01 -4.8584978989822454e-02 + 9.5697044500554040e-01 -4.6532179593498431e-02 + 9.5209613359757461e-01 -4.4526699430194078e-02 + 9.4726778848727478e-01 -4.2563836474233119e-02 + 9.4248814404815584e-01 -4.0659596035525630e-02 + 9.3777061931379657e-01 -3.8802083679357349e-02 + 1.1274305653129129e+00 -1.4736004793482671e-01 + 1.1265478432966805e+00 -1.4710950308849524e-01 + 1.1257866142390740e+00 -1.4672844798144352e-01 + 1.1250802271624185e+00 -1.4633737559827839e-01 + 1.1244351203296650e+00 -1.4587600843174170e-01 + 1.1237978249432012e+00 -1.4541943729449153e-01 + 1.1231825784916136e+00 -1.4492470219009210e-01 + 1.1225562608134050e+00 -1.4442086614081864e-01 + 1.1219231614494145e+00 -1.4388676316039511e-01 + 1.1212644359127750e+00 -1.4333543528648629e-01 + 1.1205817885561946e+00 -1.4275445284302921e-01 + 1.1198652841255157e+00 -1.4214714905213369e-01 + 1.1191127830048346e+00 -1.4150840949424978e-01 + 1.1183184177227319e+00 -1.4083866884251958e-01 + 1.1174815891181629e+00 -1.4013273357376477e-01 + 1.1165959744038283e+00 -1.3939282493669225e-01 + 1.1156626568379697e+00 -1.3861261381526901e-01 + 1.1146727569440609e+00 -1.3779760046945455e-01 + 1.1136283060788792e+00 -1.3693992585551484e-01 + 1.1125206441367785e+00 -1.3604451569344178e-01 + 1.1113513363884424e+00 -1.3510398004731877e-01 + 1.1101150600654073e+00 -1.3411956387733376e-01 + 1.1088098858175695e+00 -1.3308852663412177e-01 + 1.1074330669873389e+00 -1.3200907273453361e-01 + 1.1059802297589256e+00 -1.3088152539162456e-01 + 1.1044505300117093e+00 -1.2970149740497589e-01 + 1.1028372228555892e+00 -1.2847222744784342e-01 + 1.1011407990839697e+00 -1.2718738570982058e-01 + 1.0993549098345370e+00 -1.2584989411813124e-01 + 1.0974803414900891e+00 -1.2445340882838690e-01 + 1.0955114105351413e+00 -1.2300070788803801e-01 + 1.0934487915503390e+00 -1.2148635762205882e-01 + 1.0912875339126249e+00 -1.1991311885054702e-01 + 1.0890280747833776e+00 -1.1827678804841917e-01 + 1.0866646616740083e+00 -1.1658217614450449e-01 + 1.0841973429823744e+00 -1.1482620008108313e-01 + 1.0816197819079476e+00 -1.1301513249998152e-01 + 1.0789300727581494e+00 -1.1114897279043132e-01 + 1.0761257798705870e+00 -1.0922933596933124e-01 + 1.0732012478301729e+00 -1.0726273576751835e-01 + 1.0701607835667857e+00 -1.0524253738373841e-01 + 1.0669946970975241e+00 -1.0318345342810041e-01 + 1.0637131307078924e+00 -1.0107181641865629e-01 + 1.0603016343252314e+00 -9.8932279149081356e-02 + 1.0567773178897935e+00 -9.6741743327658891e-02 + 1.0531210135907465e+00 -9.4535518445639413e-02 + 1.0493564956997157e+00 -9.2280904179730838e-02 + 1.0454607630222306e+00 -9.0023184749881580e-02 + 1.0414629721223805e+00 -8.7721151824595722e-02 + 1.0373373735419267e+00 -8.5428810138949984e-02 + 1.0331184638141644e+00 -8.3096157698960824e-02 + 1.0287850760512871e+00 -8.0774157292935841e-02 + 1.0243687432475796e+00 -7.8419506806837957e-02 + 1.0198532973166166e+00 -7.6078588791728685e-02 + 1.0152668279212249e+00 -7.3715645873020971e-02 + 1.0105979086129591e+00 -7.1371631335206839e-02 + 1.0058709894235429e+00 -6.9018908971996820e-02 + 1.0010806331447959e+00 -6.6689174759076611e-02 + 9.9624286474762203e-01 -6.4371754776601536e-02 + 9.9135764317738073e-01 -6.2087716586162307e-02 + 9.8643863462615400e-01 -5.9831031046923895e-02 + 9.8149661479513406e-01 -5.7601084874405559e-02 + 9.7653812560601561e-01 -5.5408801543449557e-02 + 9.7158317573424413e-01 -5.3234609692635493e-02 + 9.6662952654092293e-01 -5.1110014176799175e-02 + 9.6169948013919415e-01 -4.9009327166970644e-02 + 9.5679291663213928e-01 -4.6957777502370991e-02 + 9.5192095446466962e-01 -4.4953458054537203e-02 + 9.4709494357968438e-01 -4.2991721911211048e-02 + 9.4231759423020212e-01 -4.1088549461649075e-02 + 9.3760229790310445e-01 -3.9232017878120626e-02 + 1.1274032202504667e+00 -1.4781081034728327e-01 + 1.1264256584137140e+00 -1.4757087845254999e-01 + 1.1255978196722591e+00 -1.4718074953847646e-01 + 1.1248398905570054e+00 -1.4678555705626170e-01 + 1.1241606055578488e+00 -1.4631158625088839e-01 + 1.1234958400327026e+00 -1.4584962303882648e-01 + 1.1228633102561074e+00 -1.4534767880355554e-01 + 1.1222236700279307e+00 -1.4484072141837470e-01 + 1.1215827370982794e+00 -1.4430308514073389e-01 + 1.1209181325523312e+00 -1.4375077938161773e-01 + 1.1202324805433452e+00 -1.4316885803430851e-01 + 1.1195140819414748e+00 -1.4256175961841502e-01 + 1.1187610477632630e+00 -1.4192329487870811e-01 + 1.1179666240629089e+00 -1.4125443029277560e-01 + 1.1171304365801054e+00 -1.4054935253230383e-01 + 1.1162455989789712e+00 -1.3981075801864051e-01 + 1.1153135523682292e+00 -1.3903177883489093e-01 + 1.1143249422068366e+00 -1.3821838105265272e-01 + 1.1132821841357270e+00 -1.3736209955045808e-01 + 1.1121761340995706e+00 -1.3646830232174523e-01 + 1.1110086240702075e+00 -1.3552916716899682e-01 + 1.1097740351152556e+00 -1.3454626744559969e-01 + 1.1084705888544937e+00 -1.3351668088769134e-01 + 1.1070954901629257e+00 -1.3243869153603910e-01 + 1.1056443473349509e+00 -1.3131265910193213e-01 + 1.1041164225946918e+00 -1.3013405228792357e-01 + 1.1025048120244834e+00 -1.2890627777646471e-01 + 1.1008101611512644e+00 -1.2762274516959199e-01 + 1.0990258952755940e+00 -1.2628662685314118e-01 + 1.0971529760870440e+00 -1.2489133554532707e-01 + 1.0951855344493315e+00 -1.2343993181445823e-01 + 1.0931244459173137e+00 -1.2192679171633114e-01 + 1.0909646456837023e+00 -1.2035495800212394e-01 + 1.0887067867848741e+00 -1.1872009031770850e-01 + 1.0863450744108083e+00 -1.1702721757625055e-01 + 1.0838797312146469e+00 -1.1527313414485718e-01 + 1.0813044104740048e+00 -1.1346417457539815e-01 + 1.0786172261872269e+00 -1.1160028168634992e-01 + 1.0758157673962336e+00 -1.0968294951585709e-01 + 1.0728942093027896e+00 -1.0771884265751733e-01 + 1.0698570160616103e+00 -1.0570101436506088e-01 + 1.0666941897623181e+00 -1.0364459899717687e-01 + 1.0634162230567783e+00 -1.0153536522226474e-01 + 1.0600082195212235e+00 -9.9398638902100225e-02 + 1.0564877896830907e+00 -9.7210495721046841e-02 + 1.0528351752004317e+00 -9.5007166205136204e-02 + 1.0490747654061756e+00 -9.2754891401781989e-02 + 1.0451828657661724e+00 -9.0500040300639739e-02 + 1.0411892836400531e+00 -8.8200153085551847e-02 + 1.0370674911011470e+00 -8.5910420209557969e-02 + 1.0328526013210089e+00 -8.3579610321024220e-02 + 1.0285227435681936e+00 -8.1259930618429524e-02 + 1.0241100846193560e+00 -7.8906974844058952e-02 + 1.0195979312741523e+00 -7.6568222925371576e-02 + 1.0150149302804681e+00 -7.4206979463211017e-02 + 1.0103492673622112e+00 -7.1865096342885113e-02 + 1.0056258264646254e+00 -6.9514235434850594e-02 + 1.0008389317739006e+00 -6.7186662011067516e-02 + 9.9600483391460537e-01 -6.4871157948615976e-02 + 9.9112326989805477e-01 -6.2588982518178016e-02 + 9.8620783448261329e-01 -6.0333934961275745e-02 + 9.8126920536645224e-01 -5.8105408828125565e-02 + 9.7631381561906760e-01 -5.5914567707616630e-02 + 9.7136183481135119e-01 -5.3741636175044939e-02 + 9.6641096514249503e-01 -5.1618474139942146e-02 + 9.6148372148163208e-01 -4.9519092642398663e-02 + 9.5657992812975445e-01 -4.7468946062437740e-02 + 9.5171078006803245e-01 -4.5465923870140923e-02 + 9.4688756133922813e-01 -4.3505445541929644e-02 + 9.4211295340039258e-01 -4.1603461714019740e-02 + 9.3740031487158426e-01 -3.9748015649678517e-02 + 1.1273703579802483e+00 -1.4835658877466448e-01 + 1.1262779695726091e+00 -1.4812948903739726e-01 + 1.1253694920059085e+00 -1.4772835492891404e-01 + 1.1245491721861907e+00 -1.4732815591634085e-01 + 1.1238285234560041e+00 -1.4683890722187676e-01 + 1.1231305184054154e+00 -1.4637039786529574e-01 + 1.1224770845323255e+00 -1.4585970750831631e-01 + 1.1218213372545596e+00 -1.4534895277402726e-01 + 1.1211709441481179e+00 -1.4480701989590683e-01 + 1.1204992471632476e+00 -1.4425351044458359e-01 + 1.1198099838026963e+00 -1.4367043170430213e-01 + 1.1190893195594058e+00 -1.4306356004050094e-01 + 1.1183356687776147e+00 -1.4242540494481637e-01 + 1.1175412044331863e+00 -1.4175757649063311e-01 + 1.1167058244698955e+00 -1.4105351101552799e-01 + 1.1158219604559312e+00 -1.4031647995443564e-01 + 1.1148914866021249e+00 -1.3953896317646297e-01 + 1.1139044734308425e+00 -1.3872749038752374e-01 + 1.1128638016369032e+00 -1.3787286291082523e-01 + 1.1117597415437068e+00 -1.3698098385209789e-01 + 1.1105944478627574e+00 -1.3604350787666414e-01 + 1.1093619433314965e+00 -1.3506240560884875e-01 + 1.1080606322518332e+00 -1.3403453484324884e-01 + 1.1066876608712504e+00 -1.3295827587384901e-01 + 1.1052386158517091e+00 -1.3183403247495082e-01 + 1.1037128880479710e+00 -1.3065709896754041e-01 + 1.1021033811837790e+00 -1.2943108516928586e-01 + 1.1004109279126391e+00 -1.2814908545223883e-01 + 1.0986286804067102e+00 -1.2681457503466784e-01 + 1.0967578123257251e+00 -1.2542067220902917e-01 + 1.0947922300692137e+00 -1.2397077909238687e-01 + 1.0927330521292355e+00 -1.2245904164177247e-01 + 1.0905750755928281e+00 -1.2088884335459148e-01 + 1.0883192143300546e+00 -1.1925567838594009e-01 + 1.0859596222229517e+00 -1.1756483899536362e-01 + 1.0834967323051041e+00 -1.1581297128658719e-01 + 1.0809241856040339e+00 -1.1400648449964024e-01 + 1.0782401196258606e+00 -1.1214525298051112e-01 + 1.0754421529331968e+00 -1.1023062454958654e-01 + 1.0725242558329899e+00 -1.0826944593760696e-01 + 1.0694910820233821e+00 -1.0625439364593477e-01 + 1.0663322614607964e+00 -1.0420111124642399e-01 + 1.0630587094529131e+00 -1.0209468667088419e-01 + 1.0596549904397559e+00 -9.9961258245128068e-02 + 1.0561393187550179e+00 -9.7775904744682798e-02 + 1.0524912230916332e+00 -9.5575968167594727e-02 + 1.0487358344977646e+00 -9.3326412385962995e-02 + 1.0448486217008388e+00 -9.1074915056935879e-02 + 1.0408601766402621e+00 -8.8777507117555388e-02 + 1.0367430323555753e+00 -8.6490809052236273e-02 + 1.0325330452272472e+00 -8.4162107577995457e-02 + 1.0282074958998566e+00 -8.1845110179628366e-02 + 1.0237993148081654e+00 -7.9494080134678929e-02 + 1.0192911758379775e+00 -7.7157819881034345e-02 + 1.0147123966749938e+00 -7.4798504185833295e-02 + 1.0100506957077175e+00 -7.2459067466277657e-02 + 1.0053314791814061e+00 -7.0110326499216849e-02 + 1.0005487837540328e+00 -6.7785232158641184e-02 + 9.9571913143476631e-01 -6.5471911480102438e-02 + 9.9084199195612177e-01 -6.3191854770621267e-02 + 9.8593087407442426e-01 -6.0938655124115775e-02 + 9.8099633764406247e-01 -5.8711714704428694e-02 + 9.7604468497954855e-01 -5.6522486178038442e-02 + 9.7109627927605502e-01 -5.4350949044047012e-02 + 9.6614875177208770e-01 -5.2229390254154053e-02 + 9.6122487316952276e-01 -5.0131459126674736e-02 + 9.5632440081808734e-01 -4.8082881262061714e-02 + 9.5145862176676554e-01 -4.6081301968742321e-02 + 9.4663874105058721e-01 -4.4122220689081483e-02 + 9.4186740575129801e-01 -4.2221552534444311e-02 + 9.3715793527677527e-01 -4.0367300270119914e-02 + 1.1273310057766617e+00 -1.4901722364505124e-01 + 1.1260996308703821e+00 -1.4880562820247795e-01 + 1.1250935591856079e+00 -1.4839114497084316e-01 + 1.1241977391314593e+00 -1.4798486054952756e-01 + 1.1234270456046693e+00 -1.4747709506343626e-01 + 1.1226888318070012e+00 -1.4700063934986743e-01 + 1.1220101216631850e+00 -1.4647934049582326e-01 + 1.1213349058396604e+00 -1.4596396723980642e-01 + 1.1206730905153743e+00 -1.4541681136149931e-01 + 1.1199928383905888e+00 -1.4486182164915667e-01 + 1.1192992343027228e+00 -1.4427731783860945e-01 + 1.1185758593920445e+00 -1.4367069512533556e-01 + 1.1178214950550220e+00 -1.4303288802724959e-01 + 1.1170270156890882e+00 -1.4236628527291370e-01 + 1.1161926486284697e+00 -1.4166341507829827e-01 + 1.1153100000918381e+00 -1.4092824452092145e-01 + 1.1143814683358204e+00 -1.4015246417831406e-01 + 1.1133964282655526e+00 -1.3934328557751030e-01 + 1.1123583232365897e+00 -1.3849062242445598e-01 + 1.1112567151091575e+00 -1.3760102509360195e-01 + 1.1100941490510152e+00 -1.3666551529294677e-01 + 1.1088642143631571e+00 -1.3568654412183848e-01 + 1.1075655363442887e+00 -1.3466070323573537e-01 + 1.1061951903378782e+00 -1.3358648925997210e-01 + 1.1047487368513342e+00 -1.3246435915605534e-01 + 1.1032257222872131e+00 -1.3128939626817979e-01 + 1.1016188177491839e+00 -1.3006545596237931e-01 + 1.0999290821403773e+00 -1.2878525137043326e-01 + 1.0981493373875042e+00 -1.2745262378374791e-01 + 1.0962810133921297e+00 -1.2606033548477624e-01 + 1.0943177451759778e+00 -1.2461220141096632e-01 + 1.0922609448238041e+00 -1.2310208932192872e-01 + 1.0901052424160009e+00 -1.2153379446534888e-01 + 1.0878518669063206e+00 -1.1990261089553643e-01 + 1.0854949099870510e+00 -1.1821414896508030e-01 + 1.0830350586372932e+00 -1.1646487549158735e-01 + 1.0804659387795936e+00 -1.1466128980737267e-01 + 1.0777857159895661e+00 -1.1280318340084249e-01 + 1.0749920441135286e+00 -1.1089172740338407e-01 + 1.0720786456722544e+00 -1.0893398839803436e-01 + 1.0690504028446761e+00 -1.0692218794323526e-01 + 1.0658964959581922e+00 -1.0487258431739016e-01 + 1.0626283501094491e+00 -1.0276944373839840e-01 + 1.0592298786552019e+00 -1.0063988509660846e-01 + 1.0557200241386160e+00 -9.8457784213212621e-02 + 1.0520774546221312e+00 -9.6261824157807444e-02 + 1.0483281954880828e+00 -9.4015428190999770e-02 + 1.0444467058343467e+00 -9.1767852511168257e-02 + 1.0404645233547805e+00 -8.9473308197412393e-02 + 1.0363530485413579e+00 -8.7190140173561304e-02 + 1.0321490334344641e+00 -8.4863848972688047e-02 + 1.0278287356284248e+00 -8.2549950624595997e-02 + 1.0234260056084419e+00 -8.0201105409840517e-02 + 1.0189227545087003e+00 -7.7867709419091671e-02 + 1.0143491079999616e+00 -7.5510576693230275e-02 + 1.0096922213941035e+00 -7.3173945630436846e-02 + 1.0049781295818285e+00 -7.0827615634056901e-02 + 1.0002005227845168e+00 -6.8505363171766198e-02 + 9.9537624938436353e-01 -6.6194527358277203e-02 + 9.9050445726493241e-01 -6.3916876889662896e-02 + 9.8559855165799293e-01 -6.1665757230141408e-02 + 9.8066895072936666e-01 -5.9440581355814336e-02 + 9.7572179973733819e-01 -5.7253149929293888e-02 + 9.7077769487528343e-01 -5.5083148128769528e-02 + 9.6583418227364781e-01 -5.2963376508002577e-02 + 9.6091434025541944e-01 -5.0867049897888601e-02 + 9.5601784584815253e-01 -4.8820220035352940e-02 + 9.5115609685120062e-01 -4.6820239141483963e-02 + 9.4634020358068183e-01 -4.4862702965453027e-02 + 9.4157277208353862e-01 -4.2963484196322607e-02 + 9.3686707498450572e-01 -4.1110537224242003e-02 + 1.1272841114453840e+00 -1.4981655908999109e-01 + 1.1258845736477971e+00 -1.4962367835695761e-01 + 1.1247604365205091e+00 -1.4919300124552040e-01 + 1.1237732907401148e+00 -1.4877931764061697e-01 + 1.1229420753296973e+00 -1.4824911505591809e-01 + 1.1221552426419179e+00 -1.4776301501700348e-01 + 1.1214459817895788e+00 -1.4722885285178824e-01 + 1.1207472429655752e+00 -1.4670786449998502e-01 + 1.1200716405018456e+00 -1.4615436254634015e-01 + 1.1193810709867738e+00 -1.4559755455766646e-01 + 1.1186822492274726e+00 -1.4501129859015799e-01 + 1.1179556299614464e+00 -1.4440494782246432e-01 + 1.1172004386512742e+00 -1.4376753118935409e-01 + 1.1164059788892078e+00 -1.4310237907737641e-01 + 1.1155728764800341e+00 -1.4240092101609036e-01 + 1.1146917393532014e+00 -1.4166796533081083e-01 + 1.1137655996187394e+00 -1.4089424778239845e-01 + 1.1127829908787379e+00 -1.4008780437647772e-01 + 1.1117480369971002e+00 -1.3923747518252583e-01 + 1.1106494430903076e+00 -1.3835059321075960e-01 + 1.1094902265375712e+00 -1.3741741461807064e-01 + 1.1082634525454957e+00 -1.3644097139940889e-01 + 1.1069680136568854e+00 -1.3541753329350315e-01 + 1.1056008994895057e+00 -1.3434573748033546e-01 + 1.1041576389342216e+00 -1.3322610510661068e-01 + 1.1026379664231276e+00 -1.3205346436031676e-01 + 1.1010342718496875e+00 -1.3083196732391203e-01 + 1.0993478875769003e+00 -1.2955386621442433e-01 + 1.0975712363615988e+00 -1.2822344469417832e-01 + 1.0957060577595317e+00 -1.2683303471748655e-01 + 1.0937456588004828e+00 -1.2538695002775718e-01 + 1.0916918062577572e+00 -1.2387872215483769e-01 + 1.0895389283145058e+00 -1.2231264375183909e-01 + 1.0872886344161221e+00 -1.2068376701920143e-01 + 1.0849349408989517e+00 -1.1899808643174480e-01 + 1.0824788411873418e+00 -1.1725185209122913e-01 + 1.0799139426086404e+00 -1.1545167198241302e-01 + 1.0772384442639236e+00 -1.1359723736526915e-01 + 1.0744500421847789e+00 -1.1168950592016796e-01 + 1.0715421593493055e+00 -1.0973580953184001e-01 + 1.0685199533081076e+00 -1.0772782054260235e-01 + 1.0653720612958479e+00 -1.0568253908917222e-01 + 1.0621105231642372e+00 -1.0358323975514118e-01 + 1.0587184662197877e+00 -1.0145822457846009e-01 + 1.0552157110666309e+00 -9.9279918140612392e-02 + 1.0515798871616890e+00 -9.7088621226476227e-02 + 1.0478380980315198e+00 -9.4845899122574934e-02 + 1.0439635848278928e+00 -9.2602911667484022e-02 + 1.0399890250769788e+00 -9.0311675986441742e-02 + 1.0358844536358871e+00 -8.8032616017272858e-02 + 1.0316877017437835e+00 -8.5709079782048989e-02 + 1.0273737939123024e+00 -8.3398763029791045e-02 + 1.0229776889175481e+00 -8.1052395014423226e-02 + 1.0184803788380474e+00 -7.8722291881812873e-02 + 1.0139129622330620e+00 -7.6367629121986025e-02 + 1.0092619161041558e+00 -7.4034215623575539e-02 + 1.0045540319007147e+00 -7.1690626185924158e-02 + 9.9978258251152563e-01 -6.9371631307219794e-02 + 9.9496480880068494e-01 -6.7063622155188601e-02 + 9.9009947116019614e-01 -6.4788702799559686e-02 + 9.8519985023274959e-01 -6.2539921239302104e-02 + 9.8027619384854947e-01 -6.0316703963720041e-02 + 9.7533445863343893e-01 -5.8131270503052800e-02 + 9.7039552113483729e-01 -5.5962952594707419e-02 + 9.6545682541485145e-01 -5.3845168452936590e-02 + 9.6054181966891239e-01 -5.1750611048461667e-02 + 9.5565008457120704e-01 -4.9705724260718696e-02 + 9.5079315114147034e-01 -4.7707508497881621e-02 + 9.4598201614606969e-01 -4.5751675473846259e-02 + 9.4121923664680307e-01 -4.3854047205643995e-02 + 9.3651802944800455e-01 -4.2002520285408053e-02 + 1.1272285820228662e+00 -1.5078322671747341e-01 + 1.1256256792472659e+00 -1.5061290806069288e-01 + 1.1243587841154847e+00 -1.5016258320973397e-01 + 1.1232612274312037e+00 -1.4973989907620919e-01 + 1.1223568582079773e+00 -1.4918251665662258e-01 + 1.1215112676993895e+00 -1.4868471389536081e-01 + 1.1207650993085707e+00 -1.4813496034965543e-01 + 1.1200379515157648e+00 -1.4760714836769476e-01 + 1.1193457134288247e+00 -1.4704594020457709e-01 + 1.1186427044595764e+00 -1.4648690159501038e-01 + 1.1179376105159329e+00 -1.4589849473348318e-01 + 1.1172071061724738e+00 -1.4529243971811820e-01 + 1.1164509539799903e+00 -1.4465546092193890e-01 + 1.1156565584197737e+00 -1.4399202691399179e-01 + 1.1148250271526290e+00 -1.4329223858752016e-01 + 1.1139457612418671e+00 -1.4256192110151744e-01 + 1.1130225591174241e+00 -1.4179065570647253e-01 + 1.1120429373698715e+00 -1.4098747492259633e-01 + 1.1110118425337256e+00 -1.4013992077809689e-01 + 1.1099169441598880e+00 -1.3925627214942438e-01 + 1.1087618304572795e+00 -1.3832585969393560e-01 + 1.1075389332039696e+00 -1.3735241739402654e-01 + 1.1062474679578727e+00 -1.3633182579070327e-01 + 1.1048843207286310e+00 -1.3526289182015389e-01 + 1.1034449821976307e+00 -1.3414621406371430e-01 + 1.1019294139874640e+00 -1.3297631226456422e-01 + 1.1003296661894175e+00 -1.3175769690070385e-01 + 1.0986474015491943e+00 -1.3048206318775743e-01 + 1.0968745605496160e+00 -1.2915422913311156e-01 + 1.0950132567876456e+00 -1.2776600675230201e-01 + 1.0930564010332180e+00 -1.2632231225131435e-01 + 1.0910061883750382e+00 -1.2481627097352010e-01 + 1.0888568030072880e+00 -1.2325277623324242e-01 + 1.0866103136636551e+00 -1.2162658805571860e-01 + 1.0842606454075117e+00 -1.1994416462280809e-01 + 1.0818091613299863e+00 -1.1820149420391601e-01 + 1.0792494459080642e+00 -1.1640531578805735e-01 + 1.0765797382996631e+00 -1.1455519944782110e-01 + 1.0737977849940361e+00 -1.1265184509248613e-01 + 1.0708966470299062e+00 -1.1070290463734876e-01 + 1.0678818137734865e+00 -1.0869938762099794e-01 + 1.0647412667331828e+00 -1.0665918919113364e-01 + 1.0614877868953516e+00 -1.0456438762405375e-01 + 1.0581035529117695e+00 -1.0244471208853440e-01 + 1.0546094438562956e+00 -1.0027083692361520e-01 + 1.0509818362175627e+00 -9.8085013753206163e-02 + 1.0472491329281313e+00 -9.5846567780384390e-02 + 1.0433831063496595e+00 -9.3608953881528123e-02 + 1.0394178074265685e+00 -9.1321544906691088e-02 + 1.0353216247893471e+00 -8.9047270607778728e-02 + 1.0311336897408825e+00 -8.6726885640018722e-02 + 1.0268275409357612e+00 -8.4420712176281915e-02 + 1.0224394719162624e+00 -8.2077153793845531e-02 + 1.0179493676322737e+00 -7.9750839439265350e-02 + 1.0133894978785245e+00 -7.7398971894719296e-02 + 1.0087455227173228e+00 -7.5069251145866350e-02 + 1.0040451439654943e+00 -7.2728778210770936e-02 + 9.9928113190039136e-01 -7.0413520202918842e-02 + 9.9447119933273753e-01 -6.8108727969487637e-02 + 9.8961364023743059e-01 -6.5836909488750484e-02 + 9.8472158535923215e-01 -6.3590755421069567e-02 + 9.7980507778697057e-01 -6.1369709066623403e-02 + 9.7486984761303708e-01 -5.9186494042420025e-02 + 9.6993710868159744e-01 -5.7020017680083065e-02 + 9.6500418265881605e-01 -5.4904440923634501e-02 + 9.6009496242914905e-01 -5.2811829987973472e-02 + 9.5520891309801081e-01 -5.0769100214197144e-02 + 9.5035772592811074e-01 -4.8772829711839390e-02 + 9.4555226156800676e-01 -4.6818869795767340e-02 + 9.4079501860070525e-01 -4.4922981936397773e-02 + 9.3609914721884235e-01 -4.3072993647158261e-02 + 1.1271633429677226e+00 -1.5195158718482227e-01 + 1.1253146385717632e+00 -1.5180842785542889e-01 + 1.1238752280696802e+00 -1.5133425871144338e-01 + 1.1226442657629854e+00 -1.5090061924112763e-01 + 1.1216515274356862e+00 -1.5031032099416519e-01 + 1.1207349676233505e+00 -1.4979832026781664e-01 + 1.1199442373921702e+00 -1.4922967637660844e-01 + 1.1191827975945159e+00 -1.4869357592041538e-01 + 1.1184704953321187e+00 -1.4812301567567887e-01 + 1.1177524927938143e+00 -1.4756124416871252e-01 + 1.1170398584230667e+00 -1.4697020132164781e-01 + 1.1163046988984358e+00 -1.4636446672474715e-01 + 1.1155474261631393e+00 -1.4572797908081714e-01 + 1.1147531500303283e+00 -1.4506658184293997e-01 + 1.1139235606025415e+00 -1.4436877001800497e-01 + 1.1130466007491973e+00 -1.4364159714435232e-01 + 1.1121269948886761e+00 -1.4287324925220446e-01 + 1.1111510308695089e+00 -1.4207396265960881e-01 + 1.1101246492496335e+00 -1.4122971086842995e-01 + 1.1090342685505299e+00 -1.4034991527685747e-01 + 1.1078841666726906e+00 -1.3942278825510354e-01 + 1.1066660102182517e+00 -1.3845291166977328e-01 + 1.1053794049565908e+00 -1.3743569577772366e-01 + 1.1040211117282837e+00 -1.3637015244948131e-01 + 1.1025865750496675e+00 -1.3525697365330794e-01 + 1.1010760309088392e+00 -1.3409030646626455e-01 + 1.0994811189983658e+00 -1.3287509405244832e-01 + 1.0978039010266192e+00 -1.3160235883626173e-01 + 1.0960357350807575e+00 -1.3027756395408321e-01 + 1.0941791863536383e+00 -1.2889189351790598e-01 + 1.0922266870955246e+00 -1.2745099106357810e-01 + 1.0901809493666419e+00 -1.2594749148764411e-01 + 1.0880358626272033e+00 -1.2438701315578103e-01 + 1.0857940497520768e+00 -1.2276396332747175e-01 + 1.0834493253014545e+00 -1.2108535975906418e-01 + 1.0810034981157748e+00 -1.1934687455598691e-01 + 1.0784501246473668e+00 -1.1755540461723513e-01 + 1.0757874919363473e+00 -1.1571037356016232e-01 + 1.0730134068550419e+00 -1.1381217012349500e-01 + 1.0701204933440680e+00 -1.1186883211037395e-01 + 1.0671146405012439e+00 -1.0987056948013409e-01 + 1.0639830384738431e+00 -1.0783635674498217e-01 + 1.0607393614657632e+00 -1.0574682948996066e-01 + 1.0573646437063702e+00 -1.0363343768013598e-01 + 1.0538810398260650e+00 -1.0146474553923360e-01 + 1.0502634153183115e+00 -9.9285356433043342e-02 + 1.0465417387372304e+00 -9.7051895663639712e-02 + 1.0426860117796410e+00 -9.4820584101640293e-02 + 1.0387319398180757e+00 -9.2537608510156133e-02 + 1.0346459276618949e+00 -9.0268917920326430e-02 + 1.0304686723460064e+00 -8.7952143311952086e-02 + 1.0261719226022186e+00 -8.5650770627608841e-02 + 1.0217935791050949e+00 -8.3310403171379915e-02 + 1.0173121934814955e+00 -8.0988455061139178e-02 + 1.0127614452493894e+00 -7.8639754618786417e-02 + 1.0081260108351702e+00 -7.6314278464098009e-02 + 1.0034346873175859e+00 -7.3977354326796765e-02 + 9.9867963983405073e-01 -7.1666389505196076e-02 + 9.9387914864658311e-01 -6.9365263327852936e-02 + 9.8903094645742384e-01 -6.7096970060417274e-02 + 9.8414798371933654e-01 -6.4853771086142847e-02 + 9.7924005746976384e-01 -6.2635130518101337e-02 + 9.7431262578403521e-01 -6.0454378496698782e-02 + 9.6938730825958541e-01 -5.8289912779195679e-02 + 9.6446127980953700e-01 -5.6176787333283809e-02 + 9.5955896791434003e-01 -5.4086315707337282e-02 + 9.5467969908605332e-01 -5.2045980003001521e-02 + 9.4983535732512792e-01 -5.0051851433895435e-02 + 9.4503664011724464e-01 -4.8099949320741506e-02 + 9.4028597622743604e-01 -4.6205962758566456e-02 + 9.3559643634550560e-01 -4.4357636667428313e-02 + 1.1270874214680671e+00 -1.5336286202274663e-01 + 1.1249417950231255e+00 -1.5325233659243256e-01 + 1.1232940373773244e+00 -1.5274921798551594e-01 + 1.1219019882684060e+00 -1.5230223175063878e-01 + 1.1208025703841893e+00 -1.5167208086928907e-01 + 1.1198003467255064e+00 -1.5114285649267958e-01 + 1.1189558461032920e+00 -1.5055133412346178e-01 + 1.1181530364150276e+00 -1.5000517003711525e-01 + 1.1174165459463226e+00 -1.4942326728251437e-01 + 1.1166804770975953e+00 -1.4885815168574323e-01 + 1.1159587767481987e+00 -1.4826388368744714e-01 + 1.1152180353792480e+00 -1.4765849509352297e-01 + 1.1144594498561551e+00 -1.4702255919898727e-01 + 1.1136653591716390e+00 -1.4636357915262010e-01 + 1.1128381571315975e+00 -1.4566811003815872e-01 + 1.1119640258311470e+00 -1.4494468842302410e-01 + 1.1110488079854677e+00 -1.4417981519375189e-01 + 1.1100773077749948e+00 -1.4338518001285649e-01 + 1.1090566661623018e+00 -1.4254486207840955e-01 + 1.1079717912400335e+00 -1.4166966203723064e-01 + 1.1068277937525470e+00 -1.4074644177939888e-01 + 1.1056154164936967e+00 -1.3978080670065640e-01 + 1.1043347363394163e+00 -1.3876759912861220e-01 + 1.1029823629811077e+00 -1.3770607821835434e-01 + 1.1015536851740377e+00 -1.3659704852143328e-01 + 1.1000492700553419e+00 -1.3543420711286402e-01 + 1.0984602619225379e+00 -1.3422301925502830e-01 + 1.0967892040111360e+00 -1.3295369514908362e-01 + 1.0950267514766927e+00 -1.3163247640056780e-01 + 1.0931760144542839e+00 -1.3024978923453912e-01 + 1.0912288476221998e+00 -1.2881215483276712e-01 + 1.0891885866850013e+00 -1.2731161623768256e-01 + 1.0870487652286411e+00 -1.2575466662546650e-01 + 1.0848126743666566e+00 -1.2413528760274038e-01 + 1.0824739949384155e+00 -1.2246117192120207e-01 + 1.0800350730359098e+00 -1.2072761015228650e-01 + 1.0774894308098919e+00 -1.1894168947941353e-01 + 1.0748354125677106e+00 -1.1710265662337349e-01 + 1.0720708974850488e+00 -1.1521052484978606e-01 + 1.0691879819486161e+00 -1.1327379704248092e-01 + 1.0661930364764332e+00 -1.1128171897905617e-01 + 1.0630722966351585e+00 -1.0925456631170476e-01 + 1.0598405127729880e+00 -1.0717123550814807e-01 + 1.0564773391519975e+00 -1.0506525059239209e-01 + 1.0530064670578492e+00 -1.0290263277046642e-01 + 1.0494009405882503e+00 -1.0073081936073447e-01 + 1.0456926140764866e+00 -9.8503182713031393e-02 + 1.0418493554692458e+00 -9.6279276085311949e-02 + 1.0379088624855439e+00 -9.4001448560518952e-02 + 1.0338351501429404e+00 -9.1739285868555953e-02 + 1.0296708006385826e+00 -8.9426657666606929e-02 + 1.0253854071856787e+00 -8.7130859757053022e-02 + 1.0210188050211262e+00 -8.4794124661284401e-02 + 1.0165479405244369e+00 -8.2477219582762246e-02 + 1.0120081895954096e+00 -8.0132115542690854e-02 + 1.0073830446640775e+00 -7.7811529247169331e-02 + 1.0027026202766252e+00 -7.5478655260862823e-02 + 9.9795835322361881e-01 -7.3172633815814930e-02 + 9.9316920598349367e-01 -7.0875694933832001e-02 + 9.8833223602967901e-01 -6.8611418129405521e-02 + 9.8346017703525612e-01 -6.6371549063069968e-02 + 9.7856253039835028e-01 -6.4155577488902216e-02 + 9.7364442760513126e-01 -6.1977563164956839e-02 + 9.6872797628897001e-01 -5.9815292078247428e-02 + 9.6381017543534797e-01 -5.7704891797142110e-02 + 9.5891609515014009e-01 -5.5616772095461717e-02 + 9.5404489577300311e-01 -5.3579096313967949e-02 + 9.4920869311455214e-01 -5.1587327240358860e-02 + 9.4441798908891594e-01 -4.9637686320211677e-02 + 9.3967512909633377e-01 -4.7745776092202874e-02 + 9.3499308891712141e-01 -4.5899242679241066e-02 + 1.1282667756472435e+00 -1.4502523511109322e-01 + 1.1282708600375597e+00 -1.4503310851351817e-01 + 1.1282757665312997e+00 -1.4504256394613330e-01 + 1.1282816617781035e+00 -1.4505392101182255e-01 + 1.1282887466884470e+00 -1.4506756461059866e-01 + 1.1282972636604811e+00 -1.4508395858000661e-01 + 1.1283075053932741e+00 -1.4510366229858429e-01 + 1.1283198256502363e+00 -1.4512735093277060e-01 + 1.1283346524186781e+00 -1.4515584016757821e-01 + 1.1283525040128866e+00 -1.4519011645859611e-01 + 1.1283740087808798e+00 -1.4523137407515480e-01 + 1.1283999292092288e+00 -1.4528106047515890e-01 + 1.1284311913620870e+00 -1.4534093185170865e-01 + 1.1284689207492546e+00 -1.4541312101516937e-01 + 1.1285144858795833e+00 -1.4550022010136923e-01 + 1.1285695507610345e+00 -1.4560537969450343e-01 + 1.1286361384200123e+00 -1.4573243037888756e-01 + 1.1287167073154896e+00 -1.4588602977142048e-01 + 1.1288142424777228e+00 -1.4607183515193076e-01 + 1.1289323575771701e+00 -1.4629671153700513e-01 + 1.1290753844781340e+00 -1.4656898532882826e-01 + 1.1292486266840918e+00 -1.4689871718729988e-01 + 1.1294585081817625e+00 -1.4729805748658159e-01 + 1.1297128108441896e+00 -1.4778166058982950e-01 + 1.1300209660945351e+00 -1.4836718236058818e-01 + 1.1303944133114285e+00 -1.4907588089764109e-01 + 1.1308470388407357e+00 -1.4993334585652413e-01 + 1.1313957105188586e+00 -1.5097038847424793e-01 + 1.1320609233289476e+00 -1.5222413313324348e-01 + 1.1285566443705048e+00 -1.4452223001774470e-01 + 1.1285625857400399e+00 -1.4452945872428299e-01 + 1.1285697222985314e+00 -1.4453813993965706e-01 + 1.1285782960421620e+00 -1.4454856710948746e-01 + 1.1285885986080586e+00 -1.4456109363614469e-01 + 1.1286009817058302e+00 -1.4457614540537525e-01 + 1.1286158698281450e+00 -1.4459423603475524e-01 + 1.1286337757598131e+00 -1.4461598546913593e-01 + 1.1286553195258082e+00 -1.4464214269600562e-01 + 1.1286812515617404e+00 -1.4467361353441371e-01 + 1.1287124810585889e+00 -1.4471149466607447e-01 + 1.1287501106263020e+00 -1.4475711532596419e-01 + 1.1287954786335281e+00 -1.4481208834771117e-01 + 1.1288502108118930e+00 -1.4487837255822883e-01 + 1.1289162829539197e+00 -1.4495834882264252e-01 + 1.1289960964381467e+00 -1.4505490991459574e-01 + 1.1290925697929484e+00 -1.4517157284259002e-01 + 1.1292092488950547e+00 -1.4531261597945389e-01 + 1.1293504379608128e+00 -1.4548323709695757e-01 + 1.1295213499186869e+00 -1.4568974540080204e-01 + 1.1297282569715492e+00 -1.4593979577994107e-01 + 1.1299787992609547e+00 -1.4624264258596373e-01 + 1.1302822166097743e+00 -1.4660946979393266e-01 + 1.1306496775162282e+00 -1.4705377767617958e-01 + 1.1310946788818637e+00 -1.4759184921087040e-01 + 1.1316335321388513e+00 -1.4824331616681299e-01 + 1.1322859533584644e+00 -1.4903185048521453e-01 + 1.1330757763841606e+00 -1.4998601390265978e-01 + 1.1340318089506904e+00 -1.5114030847932397e-01 + 1.1288460297306506e+00 -1.4401919258950055e-01 + 1.1288530828416838e+00 -1.4402564319602362e-01 + 1.1288615544468303e+00 -1.4403338998900997e-01 + 1.1288717316148118e+00 -1.4404269484409940e-01 + 1.1288839602438572e+00 -1.4405387314838633e-01 + 1.1288986574029196e+00 -1.4406730498256945e-01 + 1.1289163263615756e+00 -1.4408344873364864e-01 + 1.1289375749203032e+00 -1.4410285769735651e-01 + 1.1289631377950560e+00 -1.4412620036042631e-01 + 1.1289939039777457e+00 -1.4415428521660911e-01 + 1.1290309501942801e+00 -1.4418809116136191e-01 + 1.1290755818094249e+00 -1.4422880473454663e-01 + 1.1291293827819167e+00 -1.4427786573112009e-01 + 1.1291942765475373e+00 -1.4433702296997022e-01 + 1.1292725999966053e+00 -1.4440840229130697e-01 + 1.1293671924901234e+00 -1.4449458552144881e-01 + 1.1294815039664046e+00 -1.4459871157186646e-01 + 1.1296197251239961e+00 -1.4472460123193506e-01 + 1.1297869418118742e+00 -1.4487689775287096e-01 + 1.1299893141308275e+00 -1.4506123942621310e-01 + 1.1302342645973285e+00 -1.4528447038211276e-01 + 1.1305308150049456e+00 -1.4555487022027108e-01 + 1.1308898686007343e+00 -1.4588245274307066e-01 + 1.1313245925172200e+00 -1.4627931718895906e-01 + 1.1318508806459611e+00 -1.4676007323011422e-01 + 1.1324879148502023e+00 -1.4734235836276405e-01 + 1.1332588449974212e+00 -1.4804747154607728e-01 + 1.1341916105336534e+00 -1.4890115367472490e-01 + 1.1353199281339457e+00 -1.4993455440342526e-01 + 1.1291352058565503e+00 -1.4351627324758998e-01 + 1.1291431521155040e+00 -1.4352210632624005e-01 + 1.1291526962375811e+00 -1.4352911154268472e-01 + 1.1291641614823715e+00 -1.4353752572596185e-01 + 1.1291779373111821e+00 -1.4354763410501506e-01 + 1.1291944932570330e+00 -1.4355978042461356e-01 + 1.1292143958112353e+00 -1.4357437926204730e-01 + 1.1292383290100065e+00 -1.4359193104918400e-01 + 1.1292671195650759e+00 -1.4361304042624248e-01 + 1.1293017675697190e+00 -1.4363843870073037e-01 + 1.1293434840358416e+00 -1.4366901135890600e-01 + 1.1293937367731561e+00 -1.4370583178176941e-01 + 1.1294543064088873e+00 -1.4375020254650964e-01 + 1.1295273546554965e+00 -1.4380370594299435e-01 + 1.1296155072605851e+00 -1.4386826559460841e-01 + 1.1297219537193792e+00 -1.4394621655458983e-01 + 1.1298505685515288e+00 -1.4404039762930620e-01 + 1.1300060574223529e+00 -1.4415426676203849e-01 + 1.1301941301113310e+00 -1.4429202768257410e-01 + 1.1304217026034113e+00 -1.4445878720477004e-01 + 1.1306971159531500e+00 -1.4466074753180713e-01 + 1.1310304935290050e+00 -1.4490541751023658e-01 + 1.1314340641490497e+00 -1.4520188674422305e-01 + 1.1319225869227800e+00 -1.4556114927960495e-01 + 1.1325138644165713e+00 -1.4599649623414970e-01 + 1.1332293641249989e+00 -1.4652399463081203e-01 + 1.1340949716088149e+00 -1.4716307423506481e-01 + 1.1351419019231854e+00 -1.4793724991572302e-01 + 1.1364077990915873e+00 -1.4887501450243079e-01 + 1.1294240822311270e+00 -1.4301323741177130e-01 + 1.1294325191742964e+00 -1.4301828866741800e-01 + 1.1294426524632117e+00 -1.4302435499425017e-01 + 1.1294548252014429e+00 -1.4303164150209649e-01 + 1.1294694507244494e+00 -1.4304039522478668e-01 + 1.1294870273010622e+00 -1.4305091388534022e-01 + 1.1295081560260749e+00 -1.4306355656838038e-01 + 1.1295335626280971e+00 -1.4307875673892981e-01 + 1.1295641240820427e+00 -1.4309703815001659e-01 + 1.1296009011159269e+00 -1.4311903431162323e-01 + 1.1296451779373837e+00 -1.4314551234409009e-01 + 1.1296985107763398e+00 -1.4317740221834052e-01 + 1.1297627871445339e+00 -1.4321583258715789e-01 + 1.1298402980415743e+00 -1.4326217463139845e-01 + 1.1299338256849905e+00 -1.4331809557848255e-01 + 1.1300467488403467e+00 -1.4338561784389942e-01 + 1.1301831711440082e+00 -1.4346720006083677e-01 + 1.1303480758150746e+00 -1.4356584002880940e-01 + 1.1305475084392818e+00 -1.4368518383243906e-01 + 1.1307887916277413e+00 -1.4382966358401492e-01 + 1.1310807621735559e+00 -1.4400466617775573e-01 + 1.1314341341339555e+00 -1.4421672012927125e-01 + 1.1318618455587255e+00 -1.4447373790871676e-01 + 1.1323795051552736e+00 -1.4478530347310312e-01 + 1.1330059312562182e+00 -1.4516302211600987e-01 + 1.1337638043867271e+00 -1.4562094799432951e-01 + 1.1346804588102022e+00 -1.4617610833763670e-01 + 1.1357888426744192e+00 -1.4684914773416430e-01 + 1.1371286808663423e+00 -1.4766512136546733e-01 + 1.1297128843783040e+00 -1.4251018928798126e-01 + 1.1297218502752013e+00 -1.4251451710809526e-01 + 1.1297326186914385e+00 -1.4251971466643273e-01 + 1.1297455541291048e+00 -1.4252595772439566e-01 + 1.1297610956705118e+00 -1.4253345797550421e-01 + 1.1297797725773480e+00 -1.4254247056063776e-01 + 1.1298022232712854e+00 -1.4255330321897755e-01 + 1.1298292184620093e+00 -1.4256632745211584e-01 + 1.1298616893632036e+00 -1.4258199216740733e-01 + 1.1299007621493198e+00 -1.4260084037755352e-01 + 1.1299478000546468e+00 -1.4262352966558389e-01 + 1.1300044548045405e+00 -1.4265085727811200e-01 + 1.1300727293907533e+00 -1.4268379088663427e-01 + 1.1301550545542414e+00 -1.4272350625017324e-01 + 1.1302543817079982e+00 -1.4277143322263589e-01 + 1.1303742943867394e+00 -1.4282930465561480e-01 + 1.1305191442195821e+00 -1.4289922699782256e-01 + 1.1306942149583303e+00 -1.4298377184347050e-01 + 1.1309059159403301e+00 -1.4308606875987670e-01 + 1.1311620103370355e+00 -1.4320992495244103e-01 + 1.1314718717998289e+00 -1.4335997223017508e-01 + 1.1318468548291667e+00 -1.4354183152021346e-01 + 1.1323006667753956e+00 -1.4376232592209864e-01 + 1.1328498383254602e+00 -1.4402973508418770e-01 + 1.1335142906470692e+00 -1.4435410587941089e-01 + 1.1343180218874762e+00 -1.4474763297228893e-01 + 1.1352899405438277e+00 -1.4522512562751988e-01 + 1.1364648785032214e+00 -1.4580458013714789e-01 + 1.1378848225067775e+00 -1.4650788065690290e-01 + 1.1300014670069938e+00 -1.4200700006195208e-01 + 1.1300106223356652e+00 -1.4201039141786403e-01 + 1.1300216181230414e+00 -1.4201446436447410e-01 + 1.1300348264812732e+00 -1.4201935666148466e-01 + 1.1300506956336989e+00 -1.4202523424010710e-01 + 1.1300697658238503e+00 -1.4203229709823412e-01 + 1.1300926886691880e+00 -1.4204078648023699e-01 + 1.1301202507383237e+00 -1.4205099363801968e-01 + 1.1301534023093671e+00 -1.4206327054017359e-01 + 1.1301932924805052e+00 -1.4207804298453272e-01 + 1.1302413120593056e+00 -1.4209582667376308e-01 + 1.1302991459490492e+00 -1.4211724693717118e-01 + 1.1303688370810181e+00 -1.4214306292520937e-01 + 1.1304528642992318e+00 -1.4217419726276759e-01 + 1.1305542369831199e+00 -1.4221177232334672e-01 + 1.1306766083889852e+00 -1.4225714619928984e-01 + 1.1308244141753327e+00 -1.4231196962388332e-01 + 1.1310030396327122e+00 -1.4237826222797154e-01 + 1.1312190165317191e+00 -1.4245848443158929e-01 + 1.1314802562886725e+00 -1.4255563351601880e-01 + 1.1317963158292714e+00 -1.4267336226537125e-01 + 1.1321787629971505e+00 -1.4281611343926948e-01 + 1.1326415593074155e+00 -1.4298929441733474e-01 + 1.1332015368835202e+00 -1.4319948761466564e-01 + 1.1338789728847041e+00 -1.4345470917969011e-01 + 1.1346982846393892e+00 -1.4376472742763149e-01 + 1.1356888740183857e+00 -1.4414145428535158e-01 + 1.1368861556256420e+00 -1.4459942465562531e-01 + 1.1383328104814991e+00 -1.4515637993763217e-01 + 1.1302901514906760e+00 -1.4150369036936999e-01 + 1.1302995719197744e+00 -1.4150597381893970e-01 + 1.1303108859573454e+00 -1.4150871625381400e-01 + 1.1303244764011786e+00 -1.4151201046782308e-01 + 1.1303408043211134e+00 -1.4151596824182713e-01 + 1.1303604254097490e+00 -1.4152072432179819e-01 + 1.1303840098706612e+00 -1.4152644126549221e-01 + 1.1304123666421051e+00 -1.4153331535972843e-01 + 1.1304464729384569e+00 -1.4154158385772078e-01 + 1.1304875103108980e+00 -1.4155153384740962e-01 + 1.1305369086898269e+00 -1.4156351313501572e-01 + 1.1305964001731135e+00 -1.4157794361360174e-01 + 1.1306680846627382e+00 -1.4159533769195640e-01 + 1.1307545098225316e+00 -1.4161631847595357e-01 + 1.1308587682198625e+00 -1.4164164453052622e-01 + 1.1309846135523038e+00 -1.4167223075510410e-01 + 1.1311366029247514e+00 -1.4170918902243676e-01 + 1.1313202687216264e+00 -1.4175388602875258e-01 + 1.1315423205539226e+00 -1.4180799051579723e-01 + 1.1318108853859727e+00 -1.4187354131583085e-01 + 1.1321357851073479e+00 -1.4195303240689677e-01 + 1.1325288996799230e+00 -1.4204951117960266e-01 + 1.1330045639825062e+00 -1.4216670738732626e-01 + 1.1335800549913273e+00 -1.4230919107980944e-01 + 1.1342761777769061e+00 -1.4248256941666021e-01 + 1.1351179739607511e+00 -1.4269373159413554e-01 + 1.1361355819419670e+00 -1.4295115215194715e-01 + 1.1373652847575146e+00 -1.4326526345820961e-01 + 1.1388507892732338e+00 -1.4364890792761667e-01 + 1.1305783632562694e+00 -1.4099989587649678e-01 + 1.1305876552538574e+00 -1.4100058917240910e-01 + 1.1305988149229291e+00 -1.4100142192460335e-01 + 1.1306122197670578e+00 -1.4100242237302377e-01 + 1.1306283244585524e+00 -1.4100362455713703e-01 + 1.1306476769506508e+00 -1.4100506954138570e-01 + 1.1306709380729187e+00 -1.4100680691262227e-01 + 1.1306989053949921e+00 -1.4100889661644567e-01 + 1.1307325423248389e+00 -1.4101141121371505e-01 + 1.1307730136235712e+00 -1.4101443866379215e-01 + 1.1308217287762894e+00 -1.4101808576598199e-01 + 1.1308803949553767e+00 -1.4102248242885548e-01 + 1.1309510816470874e+00 -1.4102778698031951e-01 + 1.1310362993783081e+00 -1.4103419279093912e-01 + 1.1311390953661318e+00 -1.4104193655852273e-01 + 1.1312631677773215e+00 -1.4105129805885322e-01 + 1.1314130059103051e+00 -1.4106261723738200e-01 + 1.1315940597018410e+00 -1.4107632496026698e-01 + 1.1318129384133417e+00 -1.4109295515748571e-01 + 1.1320776478036951e+00 -1.4111317247022370e-01 + 1.1323978678164097e+00 -1.4113780902985087e-01 + 1.1327852992035363e+00 -1.4116790925117617e-01 + 1.1332540578808346e+00 -1.4120479262580843e-01 + 1.1338211522814341e+00 -1.4125013508547768e-01 + 1.1345070564966317e+00 -1.4130607563895523e-01 + 1.1353364018950556e+00 -1.4137535479486105e-01 + 1.1363388153426752e+00 -1.4146149176862086e-01 + 1.1375499383639722e+00 -1.4156900746126438e-01 + 1.1390126689032012e+00 -1.4170369947362929e-01 + 7.0928888086488340e-01 -2.3664228141440775e-02 + 7.0764939312131503e-01 -2.2361505591120993e-02 + 7.0629346783045666e-01 -2.1283957991540387e-02 + 7.0517284084230059e-01 -2.0393285012072312e-02 + 7.0424733279559926e-01 -1.9657594043573312e-02 + 7.0348348428121532e-01 -1.9050321704575587e-02 + 7.0285343149968682e-01 -1.8549344270118642e-02 + 7.0233398039206296e-01 -1.8136244358577351e-02 + 7.0190584264900946e-01 -1.7795705256905145e-02 + 7.0155300185235003e-01 -1.7515007988382354e-02 + 7.0126218430526177e-01 -1.7283611174820804e-02 + 7.0102241370599117e-01 -1.7092797343240526e-02 + 7.0082463401723094e-01 -1.6935373372548964e-02 + 7.0066138905657671e-01 -1.6805416039404959e-02 + 7.0052655038385603e-01 -1.6698055990844982e-02 + 7.0041508703968958e-01 -1.6609295010000320e-02 + 7.0032287184185560e-01 -1.6535852342642467e-02 + 7.0024651956794004e-01 -1.6475036345893448e-02 + 7.0018325272220860e-01 -1.6424638023627678e-02 + 7.0013079088485553e-01 -1.6382843259433930e-02 + 7.0008725996791554e-01 -1.6348160826523829e-02 + 7.0005111807429921e-01 -1.6319363555449485e-02 + 7.0002109506768428e-01 -1.6295440367468040e-02 + 6.9999614338366245e-01 -1.6275557199431308e-02 + 6.9997539797822261e-01 -1.6259025200667587e-02 + 6.9996575347343559e-01 -1.6251350165020960e-02 + 6.9995796138390165e-01 -1.6245149180334765e-02 + 6.9995163636106383e-01 -1.6240115624948804e-02 + 6.9994648110137780e-01 -1.6236012932605053e-02 + 6.9994226439371143e-01 -1.6232657124955689e-02 + 6.9993881174792982e-01 -1.6229909384808255e-02 + 6.9993597721535306e-01 -1.6227653561246669e-02 + 6.9993364478647602e-01 -1.6225797329819026e-02 + 6.9993172172539575e-01 -1.6224266888029488e-02 + 7.0951635204259134e-01 -2.2313517192545193e-02 + 7.0783648337852823e-01 -2.1000604878114015e-02 + 7.0644725210412740e-01 -1.9914513872010306e-02 + 7.0529917452077484e-01 -1.9016683521653824e-02 + 7.0435106061063213e-01 -1.8274998562400044e-02 + 7.0356861206277743e-01 -1.7662706683333085e-02 + 7.0292326797144877e-01 -1.7157524882271714e-02 + 7.0239125474610709e-01 -1.6740902211600569e-02 + 7.0195280247948311e-01 -1.6397410405450730e-02 + 7.0159149505424578e-01 -1.6114237546748688e-02 + 7.0129372775632948e-01 -1.5880764878719138e-02 + 7.0104825090296674e-01 -1.5688210453108965e-02 + 7.0084578336826264e-01 -1.5529327317724245e-02 + 7.0067868420247570e-01 -1.5398147189744119e-02 + 7.0054067369710959e-01 -1.5289762904374945e-02 + 7.0042659730145729e-01 -1.5200144452351724e-02 + 7.0033222698517239e-01 -1.5125984315219542e-02 + 7.0025409527917515e-01 -1.5064568308501534e-02 + 7.0018935759991807e-01 -1.5013668453625569e-02 + 7.0013567876420890e-01 -1.4971454658818084e-02 + 7.0009113992761196e-01 -1.4936422264340769e-02 + 7.0005416256027519e-01 -1.4907332818150126e-02 + 7.0002344649046788e-01 -1.4883165777374825e-02 + 6.9999791949538304e-01 -1.4863079136513730e-02 + 6.9997669624648617e-01 -1.4846377393552764e-02 + 6.9996682210384353e-01 -1.4838632483758796e-02 + 6.9995884454512614e-01 -1.4832374969003028e-02 + 6.9995236902127245e-01 -1.4827295466939273e-02 + 6.9994709113177234e-01 -1.4823155279754592e-02 + 6.9994277414775363e-01 -1.4819768769196540e-02 + 6.9993923939588176e-01 -1.4816995889109614e-02 + 6.9993633745658079e-01 -1.4814719426041794e-02 + 6.9993394956137356e-01 -1.4812846211039725e-02 + 6.9993198076900176e-01 -1.4811301766370185e-02 + 7.0982076053070553e-01 -2.0494726090861077e-02 + 7.0808683468562061e-01 -1.9158948298797680e-02 + 7.0665301449695306e-01 -1.8053794281485333e-02 + 7.0546818629786490e-01 -1.7140080248464643e-02 + 7.0448980841595510e-01 -1.6385165309766483e-02 + 7.0368246003693158e-01 -1.5761855416792103e-02 + 7.0301664712630119e-01 -1.5247497537579259e-02 + 7.0246782011455622e-01 -1.4823231677417170e-02 + 7.0201556409353272e-01 -1.4473372109496898e-02 + 7.0164292753592494e-01 -1.4184892828286317e-02 + 7.0133586226477174e-01 -1.3946997239730944e-02 + 7.0108275232562245e-01 -1.3750755707507865e-02 + 7.0087401502141111e-01 -1.3588798574490711e-02 + 7.0070176186626787e-01 -1.3455055519956941e-02 + 7.0055951051699439e-01 -1.3344534440507429e-02 + 7.0044194088919198e-01 -1.3253134556934382e-02 + 7.0034468990598819e-01 -1.3177489345111428e-02 + 7.0026417998461365e-01 -1.3114835402687507e-02 + 7.0019747674381849e-01 -1.3062903689934369e-02 + 7.0014217171541748e-01 -1.3019829858306272e-02 + 7.0009628617569808e-01 -1.2984080670889275e-02 + 7.0005819259417534e-01 -1.2954393841876459e-02 + 7.0002655063140584e-01 -1.2929728957742408e-02 + 7.0000025509422004e-01 -1.2909227433720092e-02 + 6.9997839353629066e-01 -1.2892179947257474e-02 + 6.9996821228020201e-01 -1.2884286833724390e-02 + 6.9995998668173010e-01 -1.2877909474169657e-02 + 6.9995330988584648e-01 -1.2872732607884470e-02 + 6.9994786799957265e-01 -1.2868512999644024e-02 + 6.9994341691426964e-01 -1.2865061479739860e-02 + 6.9993977236059479e-01 -1.2862235369201501e-02 + 6.9993678027714556e-01 -1.2859915204969525e-02 + 6.9993431820595198e-01 -1.2858006029670556e-02 + 6.9993228825650533e-01 -1.2856431936027790e-02 + 7.1021683645913147e-01 -1.8113590517714766e-02 + 7.0841255946131787e-01 -1.6735985414926931e-02 + 7.0692070664983275e-01 -1.5596044210908341e-02 + 7.0568804650320538e-01 -1.4653412799799247e-02 + 7.0467027996456555e-01 -1.3874468492398361e-02 + 7.0383052604594298e-01 -1.3231195298481062e-02 + 7.0313807641541104e-01 -1.2700253452726983e-02 + 7.0256737140263048e-01 -1.2262210346909686e-02 + 7.0209715629534308e-01 -1.1900903714352659e-02 + 7.0170978232621684e-01 -1.1602911604388007e-02 + 7.0139062374569050e-01 -1.1357108829517164e-02 + 7.0112758753069759e-01 -1.1154293243651314e-02 + 7.0091069818612850e-01 -1.0986869237855712e-02 + 7.0073174482699541e-01 -1.0848579113173993e-02 + 7.0058398122081689e-01 -1.0734275319621655e-02 + 7.0046187174386365e-01 -1.0639728065741132e-02 + 7.0036087751052745e-01 -1.0561463710658588e-02 + 7.0027727761930181e-01 -1.0496629884256514e-02 + 7.0020802083888278e-01 -1.0442883631873895e-02 + 7.0015060336112311e-01 -1.0398299181770878e-02 + 7.0010296857990539e-01 -1.0361292243430008e-02 + 7.0006342524595078e-01 -1.0330558090540017e-02 + 7.0003058079731939e-01 -1.0305021027220949e-02 + 7.0000328718410154e-01 -1.0283793110413971e-02 + 6.9998059671675061e-01 -1.0266140598474135e-02 + 6.9997001616872001e-01 -1.0257983083860384e-02 + 6.9996146808690263e-01 -1.0251391962540050e-02 + 6.9995452961494120e-01 -1.0246041468287968e-02 + 6.9994887451712440e-01 -1.0241680257393273e-02 + 6.9994424908897068e-01 -1.0238112850398245e-02 + 6.9994046178404901e-01 -1.0235191850401391e-02 + 6.9993735250597577e-01 -1.0232793783783821e-02 + 6.9993479400012104e-01 -1.0230820505224518e-02 + 6.9993268454155466e-01 -1.0229193558911869e-02 + 7.1071374366833695e-01 -1.5108740908884814e-02 + 7.0882119357887408e-01 -1.3664171346121247e-02 + 7.0725651995523786e-01 -1.2468608733510762e-02 + 7.0596383799780815e-01 -1.1479799356388846e-02 + 7.0489664559315912e-01 -1.0662531378237323e-02 + 7.0401623040998729e-01 -9.9874610554789786e-03 + 7.0329036059007310e-01 -9.4301407770174886e-03 + 7.0269220876795868e-01 -8.9702149818616239e-03 + 7.0219946602308148e-01 -8.5907537193912059e-03 + 7.0179360819023584e-01 -8.2776974557544503e-03 + 7.0145928428147974e-01 -8.0193921349552659e-03 + 7.0118380219788135e-01 -7.8061973264596050e-03 + 7.0095669318870291e-01 -7.6301544063706213e-03 + 7.0076934153792214e-01 -7.4847050712910559e-03 + 7.0061466968664576e-01 -7.3644528450234319e-03 + 7.0048687143090749e-01 -7.2649617711832738e-03 + 7.0038118722201737e-01 -7.1825874186241629e-03 + 7.0029371631142590e-01 -7.1143358909286306e-03 + 7.0022126086849446e-01 -7.0577469197747400e-03 + 7.0016119749871697e-01 -7.0107974559861733e-03 + 7.0011137192835982e-01 -6.9718225166724226e-03 + 7.0007001301902461e-01 -6.9394504176697501e-03 + 7.0003566274590057e-01 -6.9125498870747613e-03 + 7.0000711934679416e-01 -6.8901868075619639e-03 + 6.9998339096872897e-01 -6.8715890791796203e-03 + 6.9997230988051629e-01 -6.8630139871122568e-03 + 6.9996335754849692e-01 -6.8560853050570287e-03 + 6.9995609105546963e-01 -6.8504606586056224e-03 + 6.9995016869171311e-01 -6.8458758864249755e-03 + 6.9994532472291859e-01 -6.8421255357492793e-03 + 6.9994135847765748e-01 -6.8390547398286539e-03 + 6.9993810229495879e-01 -6.8365336938094315e-03 + 6.9993542290728927e-01 -6.8344592196697505e-03 + 6.9993321378330908e-01 -6.8327488384021789e-03 + 7.1130940540546783e-01 -1.1488234413416577e-02 + 7.0931102307789806e-01 -9.9481383338503124e-03 + 7.0765903860983226e-01 -8.6732897488775561e-03 + 7.0629439045421161e-01 -7.6187036840355635e-03 + 7.0516793734111594e-01 -6.7468870619671962e-03 + 7.0423877216053243e-01 -6.0265922923012413e-03 + 7.0347283659028448e-01 -5.4317844614635248e-03 + 7.0284178311676815e-01 -4.9407862669271366e-03 + 7.0232203842120688e-01 -4.5355687139727917e-03 + 7.0189402824386915e-01 -4.2011596999555374e-03 + 7.0154153153821963e-01 -3.9251484156129042e-03 + 7.0125113746346335e-01 -3.6972675537410905e-03 + 7.0101178548267817e-01 -3.5090395908319591e-03 + 7.0081437420390824e-01 -3.3534768950505569e-03 + 7.0065142861250318e-01 -3.2248278409596097e-03 + 7.0051681796154441e-01 -3.1183626864286895e-03 + 7.0040551807426510e-01 -3.0301939416324231e-03 + 7.0031341256192303e-01 -2.9571265694457614e-03 + 7.0023712785188996e-01 -2.8965337933600736e-03 + 7.0017389721894585e-01 -2.8462546702212135e-03 + 7.0012144935213216e-01 -2.8045099674097436e-03 + 7.0007791739756520e-01 -2.7698332991715176e-03 + 7.0004176491245107e-01 -2.7410148636672210e-03 + 7.0001172580311577e-01 -2.7170553580511962e-03 + 6.9998675532948573e-01 -2.6971285701533464e-03 + 6.9997507462988984e-01 -2.6879625135107946e-03 + 6.9996563804044254e-01 -2.6805561420013813e-03 + 6.9995797861018461e-01 -2.6745435633324130e-03 + 6.9995173609111916e-01 -2.6696424664654863e-03 + 6.9994663033671012e-01 -2.6656332774334887e-03 + 6.9994244974263353e-01 -2.6623505424876377e-03 + 6.9993901758598986e-01 -2.6596554989612941e-03 + 6.9993619339664559e-01 -2.6574378481455069e-03 + 6.9993386488579024e-01 -2.6556094188416569e-03 + 7.1198569061060002e-01 -7.3618403265485613e-03 + 7.0986713745360985e-01 -5.7002076363337918e-03 + 7.0811600893526783e-01 -4.3245277803919948e-03 + 7.0666964006341682e-01 -3.1863254186884002e-03 + 7.0547589467311334e-01 -2.2451948023467605e-03 + 7.0449137424888364e-01 -1.4674590700887939e-03 + 7.0367994665065603e-01 -8.2505881754319421e-04 + 7.0301153801629723e-01 -2.9463142131543654e-04 + 7.0246113890413120e-01 1.4325323351574868e-04 + 7.0200798220539851e-01 5.0473048464944222e-04 + 7.0163485845846729e-01 8.0317560846772135e-04 + 7.0132754027472777e-01 1.0496546664531721e-03 + 7.0107429479949590e-01 1.2533061244263705e-03 + 7.0086546889220180e-01 1.4216642074782557e-03 + 7.0069313604261529e-01 1.5609324266434826e-03 + 7.0055079687107713e-01 1.6762140759156931e-03 + 7.0043312665917190e-01 1.7717054675705246e-03 + 7.0033576414597987e-01 1.8508570061081975e-03 + 7.0025513622297419e-01 1.9165067054931922e-03 + 7.0018831345253396e-01 1.9709903190414735e-03 + 7.0013289167952875e-01 2.0162318169197869e-03 + 7.0008689542256408e-01 2.0538174846273373e-03 + 7.0004869925347957e-01 2.0850564949251205e-03 + 7.0001696408735292e-01 2.1110305931663154e-03 + 6.9999058518392643e-01 2.1326343998304860e-03 + 6.9997822405983812e-01 2.1425489281862325e-03 + 6.9996823795141738e-01 2.1505602810832553e-03 + 6.9996013263283463e-01 2.1570641467557887e-03 + 6.9995352681791478e-01 2.1623658304492093e-03 + 6.9994812400474515e-01 2.1667027958378656e-03 + 6.9994370018033725e-01 2.1702539167237343e-03 + 6.9994006833905831e-01 2.1731692995321872e-03 + 6.9993707983753772e-01 2.1755682600333535e-03 + 6.9993461585363836e-01 2.1775461776517291e-03 + 7.1270774601308595e-01 -2.9470220094738146e-03 + 7.1046088315091160e-01 -1.1480602121118342e-03 + 7.0860389350630970e-01 3.4153085975597138e-04 + 7.0707026672930928e-01 1.5741784191127567e-03 + 7.0580466997825531e-01 2.5935846726046737e-03 + 7.0476104501762038e-01 3.4361750479759670e-03 + 7.0390104549388854e-01 4.1322990821330199e-03 + 7.0319275413330196e-01 4.7072256172477137e-03 + 7.0260962786353343e-01 5.1819694098583207e-03 + 7.0212962565826831e-01 5.5739813147591974e-03 + 7.0173448242130343e-01 5.8977272574679907e-03 + 7.0140909866594792e-01 6.1651764588066746e-03 + 7.0114102348035734e-01 6.3862146004246001e-03 + 7.0092001444971763e-01 6.5689937142814807e-03 + 7.0073766287911721e-01 6.7202279335840673e-03 + 7.0058707572070233e-01 6.8454425268097982e-03 + 7.0046260732404875e-01 6.9491825422716789e-03 + 7.0035963496254172e-01 7.0351866551323014e-03 + 7.0027437248692492e-01 7.1065312515295725e-03 + 7.0020371674874904e-01 7.1657492844697888e-03 + 7.0014512178051891e-01 7.2149279489444286e-03 + 7.0009649614857872e-01 7.2557887065183950e-03 + 7.0005611944576762e-01 7.2897527339902176e-03 + 7.0002257468472862e-01 7.3179946775927748e-03 + 6.9999469309176587e-01 7.3414862293574848e-03 + 6.9998160570585299e-01 7.3522447299654726e-03 + 6.9997103306238662e-01 7.3609382435441727e-03 + 6.9996245182214512e-01 7.3679960612365314e-03 + 6.9995545824265926e-01 7.3737494201272253e-03 + 6.9994973836431851e-01 7.3784559587816798e-03 + 6.9994505492861347e-01 7.3823096892182373e-03 + 6.9994120995440601e-01 7.3854735081013345e-03 + 6.9993804607470222e-01 7.3880768981831550e-03 + 6.9993543749401377e-01 7.3902233662874973e-03 + 7.1342979950348084e-01 1.4677963077859700e-03 + 7.1105462535370745e-01 3.4040872124943703e-03 + 7.0909177327394068e-01 5.0075895004873501e-03 + 7.0747088751002507e-01 6.3346822576182951e-03 + 7.0613343850476284e-01 7.4323641483601119e-03 + 7.0503070827029302e-01 8.3398091669088011e-03 + 7.0412213621278241e-01 9.0896569827910931e-03 + 7.0337396162436039e-01 9.7090826568425430e-03 + 7.0275810778358860e-01 1.0220685587253956e-02 + 7.0225125973102176e-01 1.0643232146021548e-02 + 7.0183409672316699e-01 1.0992278907620900e-02 + 7.0149064716464393e-01 1.1280698252348382e-02 + 7.0120774207766512e-01 1.1519123077632384e-02 + 7.0097454976596063e-01 1.1716323222351128e-02 + 7.0078217934416787e-01 1.1879523441734251e-02 + 7.0062334409115790e-01 1.2014670978998786e-02 + 7.0049207742069641e-01 1.2126659618225099e-02 + 7.0038349513704201e-01 1.2219516305437104e-02 + 7.0029359804768598e-01 1.2296555798875083e-02 + 7.0021910929111986e-01 1.2360508251221454e-02 + 7.0015734108562211e-01 1.2413624082264006e-02 + 7.0010608604374069e-01 1.2457759929704394e-02 + 7.0006352877821265e-01 1.2494448974364471e-02 + 7.0002817439815956e-01 1.2524958763363920e-02 + 6.9999879009563049e-01 1.2550338060193646e-02 + 6.9998497643859925e-01 1.2561940533060983e-02 + 6.9997381725252705e-01 1.2571316207314255e-02 + 6.9996476008446640e-01 1.2578927977040652e-02 + 6.9995737873546204e-01 1.2585133011128619e-02 + 6.9995134178792839e-01 1.2590209123020453e-02 + 6.9994639873752273e-01 1.2594365462986383e-02 + 6.9994234062766547e-01 1.2597777717993862e-02 + 6.9993900136754750e-01 1.2600585537627905e-02 + 6.9993624818823652e-01 1.2602900556246504e-02 + 7.1410608164082112e-01 5.5941903950813563e-03 + 7.1161073412266151e-01 7.6520179107944439e-03 + 7.0954873589270995e-01 9.3563514700130152e-03 + 7.0784612767691502e-01 1.0767060524226456e-02 + 7.0644138496092568e-01 1.1934056409433909e-02 + 7.0528329829963576e-01 1.2898942390731355e-02 + 7.0432923323815877e-01 1.3696382628513731e-02 + 7.0354370268420507e-01 1.4355237504320786e-02 + 7.0289719376354431e-01 1.4899507536701651e-02 + 7.0236519864289826e-01 1.5349122332692460e-02 + 7.0192740814318555e-01 1.5720602933824466e-02 + 7.0156703410410115e-01 1.6027620474679930e-02 + 7.0127023521619725e-01 1.6281468795084950e-02 + 7.0102562802298007e-01 1.6491464327102690e-02 + 7.0082387013399261e-01 1.6665283711624120e-02 + 7.0065730618764221e-01 1.6809247743587375e-02 + 7.0051966904960772e-01 1.6928559029729146e-02 + 7.0040582964677667e-01 1.7027499883320626e-02 + 7.0031158924636494e-01 1.7109596300036632e-02 + 7.0023350827095976e-01 1.7177753242827980e-02 + 7.0016876609181156e-01 1.7234365868937399e-02 + 7.0011504669144209e-01 1.7281410715825816e-02 + 7.0007044569544596e-01 1.7320520335322030e-02 + 7.0003339521989127e-01 1.7353044716946663e-02 + 7.0000260245537094e-01 1.7380101032542720e-02 + 6.9998810835892589e-01 1.7392451977130362e-02 + 6.9997639964182934e-01 1.7402432632749935e-02 + 6.9996689657563849e-01 1.7410535689479898e-02 + 6.9995915192281444e-01 1.7417141310380153e-02 + 6.9995281790993358e-01 1.7422545198671278e-02 + 6.9994763162391016e-01 1.7426969924598544e-02 + 6.9994337382497673e-01 1.7430602518881035e-02 + 6.9993987024905857e-01 1.7433591648143679e-02 + 6.9993698159375506e-01 1.7436056155134397e-02 + 7.1470174116040863e-01 9.2146968908824976e-03 + 7.1210055956882234e-01 1.1368050923603426e-02 + 7.0995124897650752e-01 1.3151670455396671e-02 + 7.0817667330791556e-01 1.4628156197507196e-02 + 7.0671266884729433e-01 1.5849700726758870e-02 + 7.0550583133331890e-01 1.6859811155091397e-02 + 7.0451169981600981e-01 1.7694738945292277e-02 + 7.0369326702898927e-01 1.8384666220628780e-02 + 7.0301975567816277e-01 1.8954692543514645e-02 + 7.0246560781786316e-01 1.9425660089864440e-02 + 7.0200964419554390e-01 1.9814846654632099e-02 + 7.0163435789674478e-01 2.0136550248970164e-02 + 7.0132531581564417e-01 2.0402583612173907e-02 + 7.0107064881157943e-01 2.0622692504907603e-02 + 7.0086061703135927e-01 2.0804908717266486e-02 + 7.0068724056491738e-01 2.0955846829984390e-02 + 7.0054398764518788e-01 2.1080952508320636e-02 + 7.0042551355501426e-01 2.1184709206445836e-02 + 7.0032744381661705e-01 2.1270809428079390e-02 + 7.0024619551924772e-01 2.1342296030270741e-02 + 7.0017883099487843e-01 2.1401678419877855e-02 + 7.0012293850879059e-01 2.1451027836023120e-02 + 7.0007653526713154e-01 2.1492055360371781e-02 + 7.0003798905340231e-01 2.1526176168135156e-02 + 7.0000595417008959e-01 2.1554561543268024e-02 + 6.9999086045146108e-01 2.1567503452409535e-02 + 6.9997866746820403e-01 2.1577961797490389e-02 + 6.9996877145768421e-01 2.1586452786423703e-02 + 6.9996070664373189e-01 2.1593374732059970e-02 + 6.9995411084057524e-01 2.1599037458657658e-02 + 6.9994871020183558e-01 2.1603674123603041e-02 + 6.9994427642579515e-01 2.1607480715428173e-02 + 6.9994062804561596e-01 2.1610613021366860e-02 + 6.9993762000119875e-01 2.1613195576364687e-02 + 7.1519865212622302e-01 1.2219546499193412e-02 + 7.1250920055208811e-01 1.4439864991456341e-02 + 7.1028707171905492e-01 1.6279105931557014e-02 + 7.0845247636499320e-01 1.7801769639417254e-02 + 7.0693904779374428e-01 1.9061637839163599e-02 + 7.0569155046405874e-01 2.0103545396187816e-02 + 7.0466399995248596e-01 2.0964851618897037e-02 + 7.0381812134153332e-01 2.1676661583451218e-02 + 7.0312208316535263e-01 2.2264842536158028e-02 + 7.0254945211078546e-01 2.2750874236123014e-02 + 7.0207832371198720e-01 2.3152563346719487e-02 + 7.0169059199957129e-01 2.3484646163566526e-02 + 7.0137133062918433e-01 2.3759298441049403e-02 + 7.0110826564328266e-01 2.3986566544166702e-02 + 7.0089132587388792e-01 2.4174731189191112e-02 + 7.0071226084022509e-01 2.4330613121825998e-02 + 7.0056431811994135e-01 2.4459828797653002e-02 + 7.0044197315533829e-01 2.4567003197014804e-02 + 7.0034070487453870e-01 2.4655946137426724e-02 + 7.0025681078474844e-01 2.4729797753282299e-02 + 7.0018725555389005e-01 2.4791148143840969e-02 + 7.0012954756101720e-01 2.4842135506106013e-02 + 7.0008163855188688e-01 2.4884526497759012e-02 + 7.0004184259961955e-01 2.4919782468185568e-02 + 7.0000876984497795e-01 2.4949113059718309e-02 + 6.9999317560444241e-01 2.4962472546348955e-02 + 6.9998057838578409e-01 2.4973268452178916e-02 + 6.9997035436623489e-01 2.4982033593290234e-02 + 6.9996202229614846e-01 2.4989179100233769e-02 + 6.9995520796025945e-01 2.4995024770505022e-02 + 6.9994962838775987e-01 2.4999811231352857e-02 + 6.9994504771246557e-01 2.5003740802558325e-02 + 6.9994127845494092e-01 2.5006974304098720e-02 + 6.9993817074876241e-01 2.5009640294058749e-02 + 7.1559472999886586e-01 1.4600682072588406e-02 + 7.1283492888104583e-01 1.6862827875788897e-02 + 7.1055476875601220e-01 1.8736856002766301e-02 + 7.0867234255440859e-01 2.0288437088821491e-02 + 7.0711952623485064e-01 2.1572334657405535e-02 + 7.0583962411545809e-01 2.2634205515457910e-02 + 7.0478543750248224e-01 2.3512095704829140e-02 + 7.0391768140049993e-01 2.4237682915052721e-02 + 7.0320368455839066e-01 2.4837310932453116e-02 + 7.0261631643877964e-01 2.5332855461236113e-02 + 7.0213309501615384e-01 2.5742451758183574e-02 + 7.0173543726334675e-01 2.6081108628708900e-02 + 7.0140802404689262e-01 2.6361227778998641e-02 + 7.0113825901729243e-01 2.6593042952235461e-02 + 7.0091580712344470e-01 2.6784990311398221e-02 + 7.0073220235009714e-01 2.6944019614376105e-02 + 7.0058051647031061e-01 2.7075854433476907e-02 + 7.0045508161086834e-01 2.7185208716838175e-02 + 7.0035125985258184e-01 2.7275966196886686e-02 + 7.0026525336496859e-01 2.7351328431210065e-02 + 7.0019394893539355e-01 2.7413936572713925e-02 + 7.0013479122558053e-01 2.7465971258856144e-02 + 7.0008567976008995e-01 2.7509234429658639e-02 + 7.0004488575631130e-01 2.7545216792884054e-02 + 7.0001098411265505e-01 2.7575152409943758e-02 + 6.9999499058964199e-01 2.7588776297647964e-02 + 6.9998207089526221e-01 2.7599785965215104e-02 + 6.9997158520580993e-01 2.7608724734321737e-02 + 6.9996303992924658e-01 2.7616011843926636e-02 + 6.9995605125474170e-01 2.7621973401274529e-02 + 6.9995032893436315e-01 2.7626854751595077e-02 + 6.9994563106720908e-01 2.7630862225164813e-02 + 6.9994176537724728e-01 2.7634159829986876e-02 + 6.9993857816390226e-01 2.7636878672609715e-02 + 7.1589913452662723e-01 1.6419473118680094e-02 + 7.1308527295008906e-01 1.8704484353597565e-02 + 7.1076052119988420e-01 2.0597575453748181e-02 + 7.0884134214199135e-01 2.2165040191068620e-02 + 7.0725826000011527e-01 2.3462167713176385e-02 + 7.0595345652211483e-01 2.4535056563699059e-02 + 7.0487879982994583e-01 2.5422122813550527e-02 + 7.0399422890261931e-01 2.6155353198684648e-02 + 7.0326642744984991e-01 2.6761348965868622e-02 + 7.0266772949210787e-01 2.7262199907191215e-02 + 7.0217520951450285e-01 2.7676219116471917e-02 + 7.0176991819630707e-01 2.8018563086859981e-02 + 7.0143623481458772e-01 2.8301756229197277e-02 + 7.0116131546900196e-01 2.8536134324383414e-02 + 7.0093462246143967e-01 2.8730218473810888e-02 + 7.0074752423290987e-01 2.8891029205162462e-02 + 7.0059295750161965e-01 2.9024349096360542e-02 + 7.0046514427401918e-01 2.9134941313232118e-02 + 7.0035935682750494e-01 2.9226730649331803e-02 + 7.0027172404228111e-01 2.9302952919019080e-02 + 7.0019907282237170e-01 2.9366277852240500e-02 + 7.0013879882605368e-01 2.9418909920181688e-02 + 7.0008876140750309e-01 2.9462670933483308e-02 + 7.0004719881166544e-01 2.9499068179180559e-02 + 7.0001265881744523e-01 2.9529349539159325e-02 + 6.9999635816173056e-01 2.9543121630247377e-02 + 6.9998319041201396e-01 2.9554251142471361e-02 + 6.9997250343786999e-01 2.9563287275614660e-02 + 6.9996379415423005e-01 2.9570653806069394e-02 + 6.9995667136997131e-01 2.9576680372670909e-02 + 6.9995083924085488e-01 2.9581614953336357e-02 + 6.9994605122390363e-01 2.9585666128020383e-02 + 6.9994211135331574e-01 2.9588999693047163e-02 + 6.9993886297903851e-01 2.9591748184600510e-02 + 7.1612660530670558e-01 1.7770184124735092e-02 + 7.1327236248059134e-01 2.0065385170944236e-02 + 7.1091430447469028e-01 2.1967019716725711e-02 + 7.0896767459657228e-01 2.3541641857206877e-02 + 7.0736198640544679e-01 2.4844763396742749e-02 + 7.0603858274059073e-01 2.5922671809332706e-02 + 7.0494863461210888e-01 2.6813942443949853e-02 + 7.0405150146284234e-01 2.7550695603219866e-02 + 7.0331338540051913e-01 2.8159644087195342e-02 + 7.0270622074332179e-01 2.8662970628928742e-02 + 7.0220675095655438e-01 2.9079065701132743e-02 + 7.0179575333606237e-01 2.9423150272506794e-02 + 7.0145738206875774e-01 2.9707802585235702e-02 + 7.0117860848526892e-01 2.9943403480018518e-02 + 7.0094874361801085e-01 3.0138511870156003e-02 + 7.0075903231562064e-01 3.0300180075947467e-02 + 7.0060231044741195e-01 3.0434217439584309e-02 + 7.0047271777236020e-01 3.0545409668662794e-02 + 7.0036545947970208e-01 3.0637700539270892e-02 + 7.0027660968552763e-01 3.0714341841091328e-02 + 7.0020295053724990e-01 3.0778016737130678e-02 + 7.0014184105998511e-01 3.0830940981218170e-02 + 7.0009111057219497e-01 3.0874945848167856e-02 + 7.0004897266029364e-01 3.0911546567433678e-02 + 7.0001395481844408e-01 3.0941997672200142e-02 + 6.9999742452287772e-01 3.0955839637755254e-02 + 6.9998407130243490e-01 3.0967025680254778e-02 + 6.9997323382604004e-01 3.0976107760253162e-02 + 6.9996440191154730e-01 3.0983511785756368e-02 + 6.9995717885007758e-01 3.0989569055357529e-02 + 6.9995126461422363e-01 3.0994528776105226e-02 + 6.9994640918995876e-01 3.0998600590336541e-02 + 6.9994241385257872e-01 3.1001951139018134e-02 + 6.9993911974661260e-01 3.1004713633514352e-02 + 7.1715351899959767e-01 1.8786478096387782e-02 + 7.1429432604749377e-01 2.1078511605821859e-02 + 7.1193221986704081e-01 2.2977583755640296e-02 + 7.0998228057854995e-01 2.4550133453423939e-02 + 7.0837388907472287e-01 2.5851580613462474e-02 + 7.0704827963844408e-01 2.6928138600048473e-02 + 7.0595653399514324e-01 2.7818322449163088e-02 + 7.0505793788580562e-01 2.8554203041539623e-02 + 7.0431863246451420e-01 2.9162452512358425e-02 + 7.0371050164241999e-01 2.9665220104248963e-02 + 7.0321024728301096e-01 3.0080868771236155e-02 + 7.0279861246888986e-01 3.0424596981028174e-02 + 7.0245972337843943e-01 3.0708964701588570e-02 + 7.0218052852635560e-01 3.0944338044761821e-02 + 7.0195032044558325e-01 3.1139264140676914e-02 + 7.0176032904336705e-01 3.1300785944118573e-02 + 7.0160337815496387e-01 3.1434705390680190e-02 + 7.0147359786215457e-01 3.1545802349797827e-02 + 7.0136618557491914e-01 3.1638016002550597e-02 + 7.0127720915168368e-01 3.1714594521816866e-02 + 7.0120344569843951e-01 3.1778218219265977e-02 + 7.0114225016944021e-01 3.1831100594530301e-02 + 7.0109144858693262e-01 3.1875071132907704e-02 + 7.0104925186478761e-01 3.1911643642241604e-02 + 7.0101418532152870e-01 3.1942071518570356e-02 + 7.0099762926701170e-01 3.1955898992606396e-02 + 7.0098425526062158e-01 3.1967073357719741e-02 + 7.0097340093179450e-01 3.1976145983094284e-02 + 7.0096455529691326e-01 3.1983542320901392e-02 + 7.0095732102437958e-01 3.1989593316275489e-02 + 7.0095139760898162e-01 3.1994547899714121e-02 + 7.0094653464855827e-01 3.1998615496434013e-02 + 7.0094253310997356e-01 3.2001962574653930e-02 + 7.0093923389119084e-01 3.2004722207815917e-02 + 7.1853477669408694e-01 1.8841004914769144e-02 + 7.1571506447175115e-01 2.1123811356225985e-02 + 7.1338557509430367e-01 2.3015205470017008e-02 + 7.1146256127944552e-01 2.4581368486700228e-02 + 7.0987637904852485e-01 2.5877504339014461e-02 + 7.0856907413870951e-01 2.6949645703353852e-02 + 7.0749240375352074e-01 2.7836156746572534e-02 + 7.0660621582840910e-01 2.8568982626960348e-02 + 7.0587711905049888e-01 2.9174690907864238e-02 + 7.0527738556618469e-01 2.9675343980514256e-02 + 7.0478403894665620e-01 3.0089232731384623e-02 + 7.0437808817975900e-01 3.0431495847885515e-02 + 7.0404387863450801e-01 3.0714643699077726e-02 + 7.0376853904469538e-01 3.0949001220449190e-02 + 7.0354150979551389e-01 3.1143081332338340e-02 + 7.0335414189475642e-01 3.1303898546852352e-02 + 7.0319935826883295e-01 3.1437231137765469e-02 + 7.0307137005362819e-01 3.1547839281708172e-02 + 7.0296544097530489e-01 3.1639645765825716e-02 + 7.0287769318895232e-01 3.1715885113407886e-02 + 7.0280494830379314e-01 3.1779226270423205e-02 + 7.0274459779819454e-01 3.1831873273027472e-02 + 7.0269449771370440e-01 3.1875647727999286e-02 + 7.0265288366881740e-01 3.1912056878485376e-02 + 7.0261830134516434e-01 3.1942348654253556e-02 + 7.0260197390447521e-01 3.1956117175724170e-02 + 7.0258878457265517e-01 3.1967243874255744e-02 + 7.0257808012555500e-01 3.1976277778618112e-02 + 7.0256935663536602e-01 3.1983642534591183e-02 + 7.0256222225715337e-01 3.1989667681273204e-02 + 7.0255638063508685e-01 3.1994601099498254e-02 + 7.0255158482474644e-01 3.1998651319973703e-02 + 7.0254763854129731e-01 3.2001984099835568e-02 + 7.0254438487970816e-01 3.2004731944120124e-02 + 7.2072231886987059e-01 1.8927360788410397e-02 + 7.1796513354736136e-01 2.1195554025993601e-02 + 7.1568730044852968e-01 2.3074788187429363e-02 + 7.1380692937094214e-01 2.4630836412143253e-02 + 7.1225592067892651e-01 2.5918560575775001e-02 + 7.1097760523568276e-01 2.6983707193678996e-02 + 7.0992481002090024e-01 2.7864401496187265e-02 + 7.0905827333574145e-01 2.8592389531094518e-02 + 7.0834534431420959e-01 2.9194073247963383e-02 + 7.0775890996352309e-01 2.9691377488546621e-02 + 7.0727650335345471e-01 3.0102479003701870e-02 + 7.0687955459468510e-01 3.0442421804934838e-02 + 7.0655275619546343e-01 3.0723637709812124e-02 + 7.0628352230835345e-01 3.0956386441566508e-02 + 7.0606152747686179e-01 3.1149126741397026e-02 + 7.0587831449965632e-01 3.1308828075779629e-02 + 7.0572696323688389e-01 3.1441231244528620e-02 + 7.0560181319255799e-01 3.1551065236187698e-02 + 7.0549823311975468e-01 3.1642226874286784e-02 + 7.0541243116515728e-01 3.1717929064670330e-02 + 7.0534129941903201e-01 3.1780822753369048e-02 + 7.0528228720411357e-01 3.1833096988819282e-02 + 7.0523329810452073e-01 3.1876560900171852e-02 + 7.0519260686427143e-01 3.1912711334011711e-02 + 7.0515879141487681e-01 3.1942787562924763e-02 + 7.0514282603717171e-01 3.1956462719378312e-02 + 7.0512992918048745e-01 3.1967513926829824e-02 + 7.0511946210584842e-01 3.1976486507460322e-02 + 7.0511093206021613e-01 3.1983801246141752e-02 + 7.0510395588776809e-01 3.1989785455508013e-02 + 7.0509824380442099e-01 3.1994685353751606e-02 + 7.0509355434180054e-01 3.1998708054878477e-02 + 7.0508969556772916e-01 3.2002018189984938e-02 + 7.0508651405648937e-01 3.2004747363764352e-02 + 7.2411402554216608e-01 1.9061252512244664e-02 + 7.2145378596346843e-01 2.1306788494683815e-02 + 7.1925604409515853e-01 2.3167169080707595e-02 + 7.1744178907154221e-01 2.4707534678626075e-02 + 7.1594531570590336e-01 2.5982216816892376e-02 + 7.1471194740395672e-01 2.7036518328131216e-02 + 7.1369616979539863e-01 2.7908193980244144e-02 + 7.1286010166174696e-01 2.8628681107011562e-02 + 7.1217224017394876e-01 2.9224124879830848e-02 + 7.1160642565893606e-01 2.9716236874889852e-02 + 7.1114098114608759e-01 3.0123016879841188e-02 + 7.1075798968217185e-01 3.0459362114385158e-02 + 7.1044268200242278e-01 3.0737582604885461e-02 + 7.1018291479104767e-01 3.0967836965373863e-02 + 7.0996872564597135e-01 3.1158499934008432e-02 + 7.0979195473052636e-01 3.1316471135767202e-02 + 7.0964592522531644e-01 3.1447433268425737e-02 + 7.0952517566439566e-01 3.1556066964371285e-02 + 7.0942523764153220e-01 3.1646228791533997e-02 + 7.0934245263009588e-01 3.1721098138796963e-02 + 7.0927382199893352e-01 3.1783298043663560e-02 + 7.0921688475626621e-01 3.1834994316781579e-02 + 7.0916961819947189e-01 3.1877976741326433e-02 + 7.0913035773516808e-01 3.1913726044126907e-02 + 7.0909773129708753e-01 3.1943468075261064e-02 + 7.0908232728529796e-01 3.1956998472537482e-02 + 7.0906988390085335e-01 3.1967932633705218e-02 + 7.0905978486386079e-01 3.1976810134125344e-02 + 7.0905155474711401e-01 3.1984047322836773e-02 + 7.0904482386710632e-01 3.1989968060280205e-02 + 7.0903931262895914e-01 3.1994815986948311e-02 + 7.0903478805473674e-01 3.1998796020353382e-02 + 7.0903106496081902e-01 3.2002071045525327e-02 + 7.0902799531618388e-01 3.2004771271417098e-02 + 7.2920343453399838e-01 1.9262163088811231e-02 + 7.2668866642083008e-01 2.1473700837034922e-02 + 7.2461110505993620e-01 2.3305790781897425e-02 + 7.2289606016034624e-01 2.4822623890287328e-02 + 7.2148141951418743e-01 2.6077735880662076e-02 + 7.2031549642695825e-01 2.7115763819750640e-02 + 7.1935526540787187e-01 2.7973906579673653e-02 + 7.1856491671138045e-01 2.8683138255157347e-02 + 7.1791467018968547e-01 2.9269218710196682e-02 + 7.1737979666900886e-01 2.9753539506472606e-02 + 7.1693980454893647e-01 3.0153834890192840e-02 + 7.1657775663600642e-01 3.0484781813569839e-02 + 7.1627969129963975e-01 3.0758507549613512e-02 + 7.1603412926269505e-01 3.0985018993277436e-02 + 7.1583165290238027e-01 3.1172564832729677e-02 + 7.1566454859151152e-01 3.1327939892392478e-02 + 7.1552650462375256e-01 3.1456739685310847e-02 + 7.1541235818683835e-01 3.1563572283311782e-02 + 7.1531788522431505e-01 3.1652233849062336e-02 + 7.1523962727237400e-01 3.1725853477582756e-02 + 7.1517474967712380e-01 3.1787012328493472e-02 + 7.1512092602407762e-01 3.1837841343076309e-02 + 7.1507624422043836e-01 3.1880101274864035e-02 + 7.1503913070003311e-01 3.1915248662403931e-02 + 7.1500828842713082e-01 3.1944489214750536e-02 + 7.1499372677017781e-01 3.1957802394351947e-02 + 7.1498196384137558e-01 3.1968560922322795e-02 + 7.1497241706143888e-01 3.1977295750593271e-02 + 7.1496463700153057e-01 3.1984416572029772e-02 + 7.1495827419394298e-01 3.1990242066981978e-02 + 7.1495306433313666e-01 3.1995012007932644e-02 + 7.1494878718136301e-01 3.1998928016477635e-02 + 7.1494526768161482e-01 3.2002150357662629e-02 + 7.1494236589789018e-01 3.2004807145924019e-02 + 7.3647721926730747e-01 1.9549304540205960e-02 + 7.3417035901278871e-01 2.1712252002693312e-02 + 7.3226455966621262e-01 2.3503908955419189e-02 + 7.3069130590323450e-01 2.4987109423342684e-02 + 7.2939362060223079e-01 2.6214251752946869e-02 + 7.2832409023450650e-01 2.7229021498157948e-02 + 7.2744324641631786e-01 2.8067823044934423e-02 + 7.2671823995205886e-01 2.8760968426365094e-02 + 7.2612175275026736e-01 2.9333666825023849e-02 + 7.2563110010726739e-01 2.9806852437843510e-02 + 7.2522748455388486e-01 3.0197879999093385e-02 + 7.2489536916987929e-01 3.0521111654621787e-02 + 7.2462194659537726e-01 3.0788413486320106e-02 + 7.2439668659758627e-01 3.1009575552317866e-02 + 7.2421095015260972e-01 3.1192666389856072e-02 + 7.2405766135560812e-01 3.1344331042539877e-02 + 7.2393103032019390e-01 3.1470040418888477e-02 + 7.2382632106996336e-01 3.1574298887236792e-02 + 7.2373965877319690e-01 3.1660816278904387e-02 + 7.2366787089586504e-01 3.1732649809087361e-02 + 7.2360835714057525e-01 3.1792320785427937e-02 + 7.2355898343062086e-01 3.1841910313865067e-02 + 7.2351799575696207e-01 3.1883137658808396e-02 + 7.2348395064935822e-01 3.1917424788918784e-02 + 7.2345565830580416e-01 3.1945948627607849e-02 + 7.2344230054265379e-01 3.1958951359626876e-02 + 7.2343151012121021e-01 3.1969458872545417e-02 + 7.2342275262726452e-01 3.1977989793738004e-02 + 7.2341561578869062e-01 3.1984944303061980e-02 + 7.2340977903027992e-01 3.1990633677438041e-02 + 7.2340499989805007e-01 3.1995292161205668e-02 + 7.2340107636249884e-01 3.1999116665431870e-02 + 7.2339784783965078e-01 3.2002263710580792e-02 + 7.2339518596271501e-01 3.2004858417764126e-02 + 7.4618062608623359e-01 1.9932358262536583e-02 + 7.4415112000247297e-01 2.2030485094852059e-02 + 7.4247445538584811e-01 2.3768203446713966e-02 + 7.4109035446869065e-01 2.5206537149258978e-02 + 7.3994869045993594e-01 2.6396367267011417e-02 + 7.3900775033870192e-01 2.7380110012501072e-02 + 7.3823281098908966e-01 2.8193109907639312e-02 + 7.3759497266148999e-01 2.8864795779139477e-02 + 7.3707020170792736e-01 2.9419642187227694e-02 + 7.3663854079777857e-01 2.9877973192782129e-02 + 7.3628345247450933e-01 3.0256637252151056e-02 + 7.3599126781645086e-01 3.0569576551535214e-02 + 7.3575071928931246e-01 3.0828308737703453e-02 + 7.3555254270855952e-01 3.1042334602958001e-02 + 7.3538913772016756e-01 3.1219482358928002e-02 + 7.3525427915677544e-01 3.1366197237865379e-02 + 7.3514287325238392e-01 3.1487783922934047e-02 + 7.3505075344007575e-01 3.1588608439322145e-02 + 7.3497451076256026e-01 3.1672265450299802e-02 + 7.3491135412312525e-01 3.1741716281616428e-02 + 7.3485899586156878e-01 3.1799402396814100e-02 + 7.3481555848457625e-01 3.1847338420405331e-02 + 7.3477949887069205e-01 3.1887188269251125e-02 + 7.3474954710088758e-01 3.1920327794960970e-02 + 7.3472465642545737e-01 3.1947895520033014e-02 + 7.3471290468612238e-01 3.1960484107422242e-02 + 7.3470341161327601e-01 3.1970656760144309e-02 + 7.3469570704614962e-01 3.1978915664303997e-02 + 7.3468942828057759e-01 3.1985648309195369e-02 + 7.3468429328461859e-01 3.1991156095358519e-02 + 7.3468008875482738e-01 3.1995665892523562e-02 + 7.3467663695201602e-01 3.1999368327703337e-02 + 7.3467379659947529e-01 3.2002414926182610e-02 + 7.3467145476409657e-01 3.2004926815680790e-02 + 7.5800026459474146e-01 2.0398952790811734e-02 + 7.5630860130150324e-01 2.2418122156891023e-02 + 7.5491104377881124e-01 2.4090138351154231e-02 + 7.5375734835750952e-01 2.5473820222883903e-02 + 7.5280573257705263e-01 2.6618200648143419e-02 + 7.5202142715715936e-01 2.7564149665365391e-02 + 7.5137548915301788e-01 2.8345720784854318e-02 + 7.5084382960198037e-01 2.8991267007239477e-02 + 7.5040641560922217e-01 2.9524368055176654e-02 + 7.5004661203439615e-01 2.9964604788232929e-02 + 7.4975063432331823e-01 3.0328208969549724e-02 + 7.4950708894787721e-01 3.0628611236238376e-02 + 7.4930658402224737e-01 3.0876904808977011e-02 + 7.4914139752474274e-01 3.1082238127950589e-02 + 7.4900519429645573e-01 3.1252146666076772e-02 + 7.4889278544612814e-01 3.1392832267137197e-02 + 7.4879992514621996e-01 3.1509397136474618e-02 + 7.4872314042270882e-01 3.1606038784773381e-02 + 7.4865958979604552e-01 3.1686211590037414e-02 + 7.4860694679509643e-01 3.1752760075818939e-02 + 7.4856330458052422e-01 3.1808028448338688e-02 + 7.4852709820096519e-01 3.1853950351511062e-02 + 7.4849704141538242e-01 3.1892122283884557e-02 + 7.4847207570598773e-01 3.1923863922242224e-02 + 7.4845132857403540e-01 3.1950267013413483e-02 + 7.4844153311880235e-01 3.1962351134666174e-02 + 7.4843362033546312e-01 3.1972115896977002e-02 + 7.4842719832961480e-01 3.1980043459455480e-02 + 7.4842196477563383e-01 3.1986505853154761e-02 + 7.4841768459063018e-01 3.1991792448266665e-02 + 7.4841417997925552e-01 3.1996121131513178e-02 + 7.4841130279014478e-01 3.1999674875443418e-02 + 7.4840893526454533e-01 3.2002599120602326e-02 + 7.4840698326913391e-01 3.2005010130603750e-02 + 7.7090193925061279e-01 2.0908262004915211e-02 + 7.6957904677598765e-01 2.2841245694487724e-02 + 7.6848614737942378e-01 2.4441544986340387e-02 + 7.6758395006821800e-01 2.5765571891472151e-02 + 7.6683978059911140e-01 2.6860341903873521e-02 + 7.6622644910160498e-01 2.7765037342523172e-02 + 7.6572132195114306e-01 2.8512302519634172e-02 + 7.6530556137875461e-01 2.9129316122488948e-02 + 7.6496350149402959e-01 2.9638681117779037e-02 + 7.6468213347887037e-01 3.0059167126863517e-02 + 7.6445067769772079e-01 3.0406332764242830e-02 + 7.6426022431822427e-01 3.0693050287808041e-02 + 7.6410342881046800e-01 3.0929949637765491e-02 + 7.6397425249389128e-01 3.1125794645908800e-02 + 7.6386774122771639e-01 3.1287801247514825e-02 + 7.6377983726338849e-01 3.1421905616681643e-02 + 7.6370722033680105e-01 3.1532988945059286e-02 + 7.6364717456231157e-01 3.1625064802028952e-02 + 7.6359747788821464e-01 3.1701434437808401e-02 + 7.6355631100334431e-01 3.1764814881001198e-02 + 7.6352218275165862e-01 3.1817444177093479e-02 + 7.6349386933570218e-01 3.1861167575953982e-02 + 7.6347036491106435e-01 3.1897507985973392e-02 + 7.6345084171407196e-01 3.1927723766526916e-02 + 7.6343461744884389e-01 3.1952855606604068e-02 + 7.6342695736696842e-01 3.1964389080101692e-02 + 7.6342076954169802e-01 3.1973708611367585e-02 + 7.6341574751003027e-01 3.1981274499287317e-02 + 7.6341165485213180e-01 3.1987441901499367e-02 + 7.6340830773232904e-01 3.1992487056498924e-02 + 7.6340556711384833e-01 3.1996618045631912e-02 + 7.6340331714177856e-01 3.2000009486239371e-02 + 7.6340146572836776e-01 3.2002800177210133e-02 + 7.6339993926107641e-01 3.2005101072627440e-02 + 7.8340277500580657e-01 2.1401747618552860e-02 + 7.8243719610153162e-01 2.3251223312803198e-02 + 7.8163948948402262e-01 2.4782033856757899e-02 + 7.8098097655107612e-01 2.6048259200478031e-02 + 7.8043780829582754e-01 2.7094960133537922e-02 + 7.7999013877466583e-01 2.7959683690737942e-02 + 7.7962144766074415e-01 2.8673708768187502e-02 + 7.7931798523060991e-01 2.9263076224294478e-02 + 7.7906831692102807e-01 2.9749442616448244e-02 + 7.7886294757080254e-01 3.0150791531880425e-02 + 7.7869400910385744e-01 3.0482029350337989e-02 + 7.7855499821833685e-01 3.0755487298591556e-02 + 7.7844055413151048e-01 3.0981346430024623e-02 + 7.7834626920452965e-01 3.1167997917321898e-02 + 7.7826852740836805e-01 3.1322348085680449e-02 + 7.7820436699382212e-01 3.1450075693598381e-02 + 7.7815136450431355e-01 3.1555847785661201e-02 + 7.7810753762062324e-01 3.1643499704700047e-02 + 7.7807126447410280e-01 3.1716184330713305e-02 + 7.7804121715670704e-01 3.1776495158439749e-02 + 7.7801630728096438e-01 3.1826567370941930e-02 + 7.7799564160410495e-01 3.1868160570219496e-02 + 7.7797848596673491e-01 3.1902726360996357e-02 + 7.7796423619012611e-01 3.1931463690247526e-02 + 7.7795239427182039e-01 3.1955363775466178e-02 + 7.7794680321992715e-01 3.1966363709081173e-02 + 7.7794228676040189e-01 3.1975251842140992e-02 + 7.7793862120742496e-01 3.1982467292294807e-02 + 7.7793563399944576e-01 3.1988348867983511e-02 + 7.7793319095566660e-01 3.1993160084127226e-02 + 7.7793119059373883e-01 3.1997099521262840e-02 + 7.7792954835187644e-01 3.2000333701148520e-02 + 7.7792819701572979e-01 3.2002994987252009e-02 + 7.7792708285585954e-01 3.2005189189163730e-02 + 7.9419227737979492e-01 2.1827676276742865e-02 + 7.9353509670511424e-01 2.3605076012927162e-02 + 7.9299217170806280e-01 2.5075910646080314e-02 + 7.9254398336694987e-01 2.6292247318678921e-02 + 7.9217429975832487e-01 2.7297459710034257e-02 + 7.9186961350025220e-01 2.8127683437091235e-02 + 7.9161868066817642e-01 2.8813018901984920e-02 + 7.9141214304342578e-01 2.9378524900208779e-02 + 7.9124221813169138e-01 2.9845041140923116e-02 + 7.9110244341782110e-01 3.0229872783316038e-02 + 7.9098746379999785e-01 3.0547363261732088e-02 + 7.9089285305875312e-01 3.0809376837630933e-02 + 7.9081496258845152e-01 3.1025707129046481e-02 + 7.9075079250645308e-01 3.1204423665641891e-02 + 7.9069788171126953e-01 3.1352165547460217e-02 + 7.9065421441351658e-01 3.1474389356958447e-02 + 7.9061814119330109e-01 3.1575577307734221e-02 + 7.9058831287454923e-01 3.1659410914997736e-02 + 7.9056362560796067e-01 3.1728914999903726e-02 + 7.9054317561689758e-01 3.1786576434925273e-02 + 7.9052622214434254e-01 3.1834441622166337e-02 + 7.9051215725005319e-01 3.1874196240977384e-02 + 7.9050048126674810e-01 3.1907230353467923e-02 + 7.9049078299235342e-01 3.1934691627703106e-02 + 7.9048272348853577e-01 3.1957528582210841e-02 + 7.9047891822157412e-01 3.1968068016283227e-02 + 7.9047584432195583e-01 3.1976583808472007e-02 + 7.9047334954918025e-01 3.1983496794893540e-02 + 7.9047131645773161e-01 3.1989131673022086e-02 + 7.9046965372418931e-01 3.1993740975892138e-02 + 7.9046829227956106e-01 3.1997515084057682e-02 + 7.9046717457113225e-01 3.2000613531799615e-02 + 7.9046625485292077e-01 3.2003163128287326e-02 + 7.9046549655664777e-01 3.2005265242823100e-02 + 8.0261351451504381e-01 2.2160114799802934e-02 + 8.0219703953124155e-01 2.3881259046731863e-02 + 8.0185297230993446e-01 2.5305282311748539e-02 + 8.0156894290793557e-01 2.6482680735377056e-02 + 8.0133466455697655e-01 2.7455511202518310e-02 + 8.0114157714033918e-01 2.8258807714522015e-02 + 8.0098255498048854e-01 2.8921750855701398e-02 + 8.0085166744057623e-01 2.9468632918514759e-02 + 8.0074398247652256e-01 2.9919656059803214e-02 + 8.0065540456195827e-01 3.0291595923856076e-02 + 8.0058253997851037e-01 3.0598356564425437e-02 + 8.0052258367559603e-01 3.0851437775325504e-02 + 8.0047322340637261e-01 3.1060330780150022e-02 + 8.0043255804617686e-01 3.1232854065308398e-02 + 8.0039902791745876e-01 3.1375438160765157e-02 + 8.0037135555539296e-01 3.1493366239971010e-02 + 8.0034849567776112e-01 3.1590976255543544e-02 + 8.0032959327857034e-01 3.1671829659657827e-02 + 8.0031394882404183e-01 3.1738851323226618e-02 + 8.0030098957333728e-01 3.1794444899738220e-02 + 8.0029024609596688e-01 3.1840587497548277e-02 + 8.0028133313117800e-01 3.1878907099084565e-02 + 8.0027393403335767e-01 3.1910745732318266e-02 + 8.0026778821932554e-01 3.1937211042026854e-02 + 8.0026268090073460e-01 3.1959218220016614e-02 + 8.0026026944393192e-01 3.1969398232860130e-02 + 8.0025832146644660e-01 3.1977623411961531e-02 + 8.0025674049089346e-01 3.1984300324594983e-02 + 8.0025545209010485e-01 3.1989742654559450e-02 + 8.0025439839090662e-01 3.1994194363619499e-02 + 8.0025353562303336e-01 3.1997839432001740e-02 + 8.0025282731445013e-01 3.2000831940436569e-02 + 8.0025224447522281e-01 3.2003294362837664e-02 + 8.0025176393153263e-01 3.2005324602913277e-02 + 8.0868482573164868e-01 2.2399787154483871e-02 + 8.0844188809607231e-01 2.4080373870866364e-02 + 8.0824118786762511e-01 2.5470648367168280e-02 + 8.0807550924856730e-01 2.6619974166287363e-02 + 8.0793885164457879e-01 2.7569458807086274e-02 + 8.0782622168171114e-01 2.8353342078489146e-02 + 8.0773346274259861e-01 2.9000141419835649e-02 + 8.0765711531380879e-01 2.9533596511526702e-02 + 8.0759430239008911e-01 2.9973449865494110e-02 + 8.0754263493142286e-01 3.0336095370806490e-02 + 8.0750013328362136e-01 3.0635120308950544e-02 + 8.0746516118142775e-01 3.0881761709792954e-02 + 8.0743636982957545e-01 3.1085292784908347e-02 + 8.0741265025517484e-01 3.1253351030457566e-02 + 8.0739309266470494e-01 3.1392216607443402e-02 + 8.0737695189002900e-01 3.1507047669563804e-02 + 8.0736361820363223e-01 3.1602078164084460e-02 + 8.0735259287244199e-01 3.1680782983556921e-02 + 8.0734346785511346e-01 3.1746014939486533e-02 + 8.0733590907173192e-01 3.1800117688419616e-02 + 8.0732964270537388e-01 3.1845018381233117e-02 + 8.0732444403656378e-01 3.1882303403584430e-02 + 8.0732012836964850e-01 3.1913280153162193e-02 + 8.0731654371047379e-01 3.1939027419837951e-02 + 8.0731356477694549e-01 3.1960436368436151e-02 + 8.0731215819096769e-01 3.1970357255708834e-02 + 8.0731102194971838e-01 3.1978372916597664e-02 + 8.0731009977848289e-01 3.1984879631259844e-02 + 8.0730934826423340e-01 3.1990183143179252e-02 + 8.0730873364982803e-01 3.1994521234572915e-02 + 8.0730823040415900e-01 3.1998073271431338e-02 + 8.0730781725335121e-01 3.2000989402668267e-02 + 8.0730747728787033e-01 3.2003388976697522e-02 + 8.0730719699054854e-01 3.2005367398681983e-02 + 8.1281594246024602e-01 2.2562867984738944e-02 + 8.1269108525518008e-01 2.4215858044129845e-02 + 8.1258793657064277e-01 2.5583168785459520e-02 + 8.1250278765625294e-01 2.6713393061953639e-02 + 8.1243255436924811e-01 2.7646992446634044e-02 + 8.1237467026299615e-01 2.8417666320549977e-02 + 8.1232699896475424e-01 2.9053480897815061e-02 + 8.1228776239342704e-01 2.9577799843636191e-02 + 8.1225548185885388e-01 3.0010052912572801e-02 + 8.1222892946945868e-01 3.0366374235335052e-02 + 8.1220708774610195e-01 3.0660135551073608e-02 + 8.1218911570313168e-01 3.0902395096603641e-02 + 8.1217432010855084e-01 3.1102277741176465e-02 + 8.1216213099547185e-01 3.1267297829217000e-02 + 8.1215208077243939e-01 3.1403633205798087e-02 + 8.1214378646321417e-01 3.1516356957233427e-02 + 8.1213693470575932e-01 3.1609632262117777e-02 + 8.1213126918672585e-01 3.1686875115006841e-02 + 8.1212658020555439e-01 3.1750889295928383e-02 + 8.1212269607494691e-01 3.1803977637494596e-02 + 8.1211947607986490e-01 3.1848033297947616e-02 + 8.1211680473832337e-01 3.1884614359114487e-02 + 8.1211458713764850e-01 3.1915004655189649e-02 + 8.1211274517116927e-01 3.1940263342107547e-02 + 8.1211121445972001e-01 3.1961265236105818e-02 + 8.1211049162039806e-01 3.1971009805900501e-02 + 8.1210990771079072e-01 3.1978882903800354e-02 + 8.1210943381132505e-01 3.1985273810285264e-02 + 8.1210904761205771e-01 3.1990482865914771e-02 + 8.1210873176515519e-01 3.1994743648148471e-02 + 8.1210847315005608e-01 3.1998232383351422e-02 + 8.1210826083416676e-01 3.2001096545059227e-02 + 8.1210808612783136e-01 3.2003453355038403e-02 + 8.1210794208459591e-01 3.2005396518329121e-02 + 8.1551742392149273e-01 2.2669512233385092e-02 + 8.1546978363258182e-01 2.4304455875267195e-02 + 8.1543042730845317e-01 2.5656749815482272e-02 + 8.1539793957955675e-01 2.6774482939430300e-02 + 8.1537114347254946e-01 2.7697694400508510e-02 + 8.1534905959332948e-01 2.8459730188238549e-02 + 8.1533087267761128e-01 2.9088361444742337e-02 + 8.1531590419166755e-01 2.9606705945752678e-02 + 8.1530358985231888e-01 3.0033988923015873e-02 + 8.1529346108359735e-01 3.0386174642003990e-02 + 8.1528512960618216e-01 3.0676493891277801e-02 + 8.1527827449543322e-01 3.0915887988655300e-02 + 8.1527263121520066e-01 3.1113384797066601e-02 + 8.1526798227336128e-01 3.1276418127831107e-02 + 8.1526414924984858e-01 3.1411098918056268e-02 + 8.1526098601832298e-01 3.1522444625451840e-02 + 8.1525837302050497e-01 3.1614572150552078e-02 + 8.1525621246973379e-01 3.1690858972481827e-02 + 8.1525442436748086e-01 3.1754076807786275e-02 + 8.1525294322064812e-01 3.1806501792978302e-02 + 8.1525171535412544e-01 3.1850004857240322e-02 + 8.1525069672010164e-01 3.1886125573628021e-02 + 8.1524985111819848e-01 3.1916132367257412e-02 + 8.1524914875930243e-01 3.1941071554868389e-02 + 8.1524856509087940e-01 3.1961807261588128e-02 + 8.1524828937729343e-01 3.1971436531279096e-02 + 8.1524806665666694e-01 3.1979216402248767e-02 + 8.1524788589778885e-01 3.1985531577674919e-02 + 8.1524773859071309e-01 3.1990678865064126e-02 + 8.1524761811830004e-01 3.1994889092167966e-02 + 8.1524751947564555e-01 3.1998336432202734e-02 + 8.1524743849275150e-01 3.2001166609212817e-02 + 8.1524737185512897e-01 3.2003495454304698e-02 + 8.1524731691322749e-01 3.2005415560689698e-02 + 8.1943142633423149e-01 2.2800945594681193e-02 + 8.1939917390132044e-01 2.4413267831695982e-02 + 8.1937249842399795e-01 2.5746794060862964e-02 + 8.1935045091621050e-01 2.6848964778115467e-02 + 8.1933224128080284e-01 2.7759277503907581e-02 + 8.1931721151767856e-01 2.8510626133656070e-02 + 8.1930481364216834e-01 2.9130404815770658e-02 + 8.1929459149384731e-01 2.9641417337348375e-02 + 8.1928616572046165e-01 3.0062627787610961e-02 + 8.1927922131561581e-01 3.0409783563331669e-02 + 8.1927349721192355e-01 3.0695935609709703e-02 + 8.1926877752196015e-01 3.0931876294569366e-02 + 8.1926488412010634e-01 3.1126510241608611e-02 + 8.1926167034088293e-01 3.1287169368705604e-02 + 8.1925901562727788e-01 3.1419880405048915e-02 + 8.1925682100328989e-01 3.1529591230127760e-02 + 8.1925500526572781e-01 3.1620361253376465e-02 + 8.1925350180284462e-01 3.1695520440957713e-02 + 8.1925225595574247e-01 3.1757801229867856e-02 + 8.1925122284315177e-01 3.1809447268666337e-02 + 8.1925036557730291e-01 3.1852302601758441e-02 + 8.1924965380637249e-01 3.1887884541770085e-02 + 8.1924906252598939e-01 3.1917443072738354e-02 + 8.1924857111183391e-01 3.1942009218002033e-02 + 8.1924816253201249e-01 3.1962434417219306e-02 + 8.1924797269006688e-01 3.1971924752123015e-02 + 8.1924781931006307e-01 3.1979592327014465e-02 + 8.1924769480723370e-01 3.1985816312828312e-02 + 8.1924759332970976e-01 3.1990889247711145e-02 + 8.1924751032648180e-01 3.1995038638089106e-02 + 8.1924744236333580e-01 3.1998436164566151e-02 + 8.1924738656734841e-01 3.2001225445734895e-02 + 8.1924734065497817e-01 3.2003520639039794e-02 + 8.1924730280070490e-01 3.2005412999846820e-02 + 8.2230168387079383e-01 2.2890881694270913e-02 + 8.2222522841570522e-01 2.4487446896723181e-02 + 8.2216199331765105e-01 2.5807940731716751e-02 + 8.2210972897380430e-01 2.6899340064884425e-02 + 8.2206656243293341e-01 2.7800756412050879e-02 + 8.2203093388417781e-01 2.8544762200470322e-02 + 8.2200154431170802e-01 2.9158483858809391e-02 + 8.2197731237220029e-01 2.9664502315448940e-02 + 8.2195733879872379e-01 3.0081596325800319e-02 + 8.2194087685817407e-01 3.0425359389148244e-02 + 8.2192730768171740e-01 3.0708714905421566e-02 + 8.2191611950107912e-01 3.0942349769871674e-02 + 8.2190689006377537e-01 3.1135081582361265e-02 + 8.2189927169419530e-01 3.1294170606825267e-02 + 8.2189297860806398e-01 3.1425584673888000e-02 + 8.2188777617962461e-01 3.1534223308047511e-02 + 8.2188347191384548e-01 3.1624106246586271e-02 + 8.2187990790550003e-01 3.1698530912334003e-02 + 8.2187695458394427e-01 3.1760203038413766e-02 + 8.2187450555647967e-01 3.1811344346604681e-02 + 8.2187247337959701e-01 3.1853780859589398e-02 + 8.2187078610307418e-01 3.1889015061535540e-02 + 8.2186938445345326e-01 3.1918284720444612e-02 + 8.2186821954001121e-01 3.1942610783712945e-02 + 8.2186725098799795e-01 3.1962836369860990e-02 + 8.2186680096143117e-01 3.1972233956832685e-02 + 8.2186643736914344e-01 3.1979826597453784e-02 + 8.2186614223108867e-01 3.1985989756958294e-02 + 8.2186590167521245e-01 3.1991013114673859e-02 + 8.2186570491335376e-01 3.1995121953518127e-02 + 8.2186554380448507e-01 3.1998486276382875e-02 + 8.2186541153827597e-01 3.2001248298240401e-02 + 8.2186530270145453e-01 3.2003521060911970e-02 + 8.2186521296670612e-01 3.2005394927895774e-02 + 8.2595253251205147e-01 2.3017243323834969e-02 + 8.2581992776970081e-01 2.4591544284546407e-02 + 8.2571025248398600e-01 2.5893623717257525e-02 + 8.2561960493189002e-01 2.6969803391051608e-02 + 8.2554473665700201e-01 2.7858649408253833e-02 + 8.2548294231517316e-01 2.8592279970705820e-02 + 8.2543196888655035e-01 2.9197443226731862e-02 + 8.2538994088360385e-01 2.9696405211577570e-02 + 8.2535529861300150e-01 3.0107682809411569e-02 + 8.2532674693695884e-01 3.0446652066710871e-02 + 8.2530321248615823e-01 3.0726056165487299e-02 + 8.2528380764692721e-01 3.0956432971254385e-02 + 8.2526780006248457e-01 3.1146477121733022e-02 + 8.2525458672233043e-01 3.1303347635787154e-02 + 8.2524367196075432e-01 3.1432929122170820e-02 + 8.2523464884157927e-01 3.1540052781049162e-02 + 8.2522718350043800e-01 3.1628682294156836e-02 + 8.2522100206568894e-01 3.1702069101401699e-02 + 8.2521587980925593e-01 3.1762881204296475e-02 + 8.2521163220321025e-01 3.1813309342434697e-02 + 8.2520810758494312e-01 3.1855154074544673e-02 + 8.2520518116374042e-01 3.1889896932423757e-02 + 8.2520275013521138e-01 3.1918758423383091e-02 + 8.2520072970326175e-01 3.1942745257569106e-02 + 8.2519904984159620e-01 3.1962688796165609e-02 + 8.2519826931310991e-01 3.1971955332944391e-02 + 8.2519763869675966e-01 3.1979442093496346e-02 + 8.2519712680777124e-01 3.1985519307208159e-02 + 8.2519670958642877e-01 3.1990472613751757e-02 + 8.2519636832162202e-01 3.1994524154536401e-02 + 8.2519608889351770e-01 3.1997841561585930e-02 + 8.2519585949030427e-01 3.2000565066826074e-02 + 8.2519567072314426e-01 3.2002806135597119e-02 + 8.2519551508674449e-01 3.2004653871335734e-02 + 8.3043106374149633e-01 2.3192126058462152e-02 + 8.3022972365570580e-01 2.4734991851944069e-02 + 8.3006319845422583e-01 2.6011071754866048e-02 + 8.2992556396549899e-01 2.7065762597167309e-02 + 8.2981188790366789e-01 2.7936860404881962e-02 + 8.2971806261607195e-01 2.8655842053317285e-02 + 8.2964066723557683e-01 2.9248921591800807e-02 + 8.2957685412021454e-01 2.9737920454109966e-02 + 8.2952425511348282e-01 3.0140985784754278e-02 + 8.2948090374608952e-01 3.0473186606066009e-02 + 8.2944517027035247e-01 3.0747011647960280e-02 + 8.2941570698030254e-01 3.0972788359086234e-02 + 8.2939140190361638e-01 3.1159037765213300e-02 + 8.2937133946097152e-01 3.1312775936100413e-02 + 8.2935476705945610e-01 3.1439769978447309e-02 + 8.2934106682857045e-01 3.1544754624362417e-02 + 8.2932973184611092e-01 3.1631614410036854e-02 + 8.2932034627980267e-01 3.1703535851639798e-02 + 8.2931256891426974e-01 3.1763133676789658e-02 + 8.2930611957205036e-01 3.1812554881028118e-02 + 8.2930076797653662e-01 3.1853564070161301e-02 + 8.2929632465208780e-01 3.1887613193136891e-02 + 8.2929263350585891e-01 3.1915898386522340e-02 + 8.2928956578793223e-01 3.1939406258842416e-02 + 8.2928701517411441e-01 3.1958951570842303e-02 + 8.2928583006061873e-01 3.1968033076217560e-02 + 8.2928487256579131e-01 3.1975370343388279e-02 + 8.2928409534037806e-01 3.1981326209147967e-02 + 8.2928346185338842e-01 3.1986180609570938e-02 + 8.2928294369481115e-01 3.1990151250354218e-02 + 8.2928251942585274e-01 3.1993402416467469e-02 + 8.2928217111204017e-01 3.1996071539566233e-02 + 8.2928188449786533e-01 3.1998267859350740e-02 + 8.2928164818770156e-01 3.2000078700064855e-02 + 8.3568689298196108e-01 2.3428272763994906e-02 + 8.3540514956572653e-01 2.4926678148497611e-02 + 8.3517212404091867e-01 2.6165985550130253e-02 + 8.3497952647202511e-01 2.7190283608859524e-02 + 8.3482045490968682e-01 2.8036279191250752e-02 + 8.3468916134760696e-01 2.8734542110775058e-02 + 8.3458085882644328e-01 2.9310531012484684e-02 + 8.3449156252434198e-01 2.9785438506984393e-02 + 8.3441795858310119e-01 3.0176888796617937e-02 + 8.3435729524173685e-01 3.0499516663212739e-02 + 8.3430729192772590e-01 3.0765450951818901e-02 + 8.3426606274098880e-01 3.0984721507351910e-02 + 8.3423205165319669e-01 3.1165603807167593e-02 + 8.3420397745669561e-01 3.1314911740523213e-02 + 8.3418078701751319e-01 3.1438246224702482e-02 + 8.3416161572412051e-01 3.1540205552218155e-02 + 8.3414575421962756e-01 3.1624562319413616e-02 + 8.3413262061282800e-01 3.1694411217372570e-02 + 8.3412173742717466e-01 3.1752291625693325e-02 + 8.3411271259884023e-01 3.1800288670460593e-02 + 8.3410522389240116e-01 3.1840116107177227e-02 + 8.3409900616674015e-01 3.1873184044418273e-02 + 8.3409384099486583e-01 3.1900654149894653e-02 + 8.3408954821173431e-01 3.1923484601250704e-02 + 8.3408597903350579e-01 3.1942466680490569e-02 + 8.3408432065572324e-01 3.1951286486226083e-02 + 8.3408298079405485e-01 3.1958412317081235e-02 + 8.3408189319074211e-01 3.1964196553978690e-02 + 8.3408100672650809e-01 3.1968911066257925e-02 + 8.3408028164601322e-01 3.1972767286035209e-02 + 8.3407968794910547e-01 3.1975924764019212e-02 + 8.3407920053934004e-01 3.1978516971605878e-02 + 8.3407879946838970e-01 3.1980650000549629e-02 + 8.3407846878995118e-01 3.1982408658692250e-02 + 8.4154321921869768e-01 2.3737415012378731e-02 + 8.4117234078058545e-01 2.5174016699631742e-02 + 8.4086559308854292e-01 2.6362207240496961e-02 + 8.4061206352433027e-01 2.7344256781034335e-02 + 8.4040266657239904e-01 2.8155358164981631e-02 + 8.4022983573259724e-01 2.8824820313693489e-02 + 8.4008726959768620e-01 2.9377051796970942e-02 + 8.3996972266971914e-01 2.9832371108363131e-02 + 8.3987283268682666e-01 3.0207675516905879e-02 + 8.3979297731496882e-01 3.0516996173588894e-02 + 8.3972715447780988e-01 3.0771961653343609e-02 + 8.3967288163415932e-01 3.0982188106932807e-02 + 8.3962811047573027e-01 3.1155609678812583e-02 + 8.3959115445989596e-01 3.1298759210450722e-02 + 8.3956062727326153e-01 3.1417006601941543e-02 + 8.3953539076749495e-01 3.1514760483119277e-02 + 8.3951451116681319e-01 3.1595637844715252e-02 + 8.3949722248751801e-01 3.1662605733159981e-02 + 8.3948289619392880e-01 3.1718098788047669e-02 + 8.3947101618523812e-01 3.1764116131711491e-02 + 8.3946115828047918e-01 3.1802300833513208e-02 + 8.3945297345611447e-01 3.1834004840282565e-02 + 8.3944617418144485e-01 3.1860341905166935e-02 + 8.3944052329267116e-01 3.1882230684573389e-02 + 8.3943582493535374e-01 3.1900429823068094e-02 + 8.3943364189744041e-01 3.1908885844302411e-02 + 8.3943187814441567e-01 3.1915717760902851e-02 + 8.3943044645660514e-01 3.1921263419398826e-02 + 8.3942927954209134e-01 3.1925783475415415e-02 + 8.3942832506826037e-01 3.1929480640314985e-02 + 8.3942754354377125e-01 3.1932507883993884e-02 + 8.3942690193240466e-01 3.1934993172584324e-02 + 8.3942637397486342e-01 3.1937038221949189e-02 + 8.3942593867985260e-01 3.1938724341927585e-02 + 8.4770249162848965e-01 2.4129321122503451e-02 + 8.4723863871168970e-01 2.5484525773765074e-02 + 8.4685499329840064e-01 2.6605394113149081e-02 + 8.4653790711657428e-01 2.7531801284261082e-02 + 8.4627601702826072e-01 2.8296946124278511e-02 + 8.4605985970843289e-01 2.8928476927701931e-02 + 8.4588155406774457e-01 2.9449419288667986e-02 + 8.4573453962907674e-01 2.9878940466368676e-02 + 8.4561336056729719e-01 3.0232980340216542e-02 + 8.4551348647550040e-01 3.0524775064080748e-02 + 8.4543116269535079e-01 3.0765294344491125e-02 + 8.4536328434428731e-01 3.0963609486591166e-02 + 8.4530728962934520e-01 3.1127205090662635e-02 + 8.4526106921323396e-01 3.1262243851074560e-02 + 8.4522288925148070e-01 3.1373791412505729e-02 + 8.4519132627664528e-01 3.1466006614301552e-02 + 8.4516521242725984e-01 3.1542301510482089e-02 + 8.4514358969725689e-01 3.1605475036414046e-02 + 8.4512567198520494e-01 3.1657823886313018e-02 + 8.4511081381034781e-01 3.1701233913395591e-02 + 8.4509848465505688e-01 3.1737255091671940e-02 + 8.4508824799991622e-01 3.1767162767408076e-02 + 8.4507974423409826e-01 3.1792007589169564e-02 + 8.4507267673982489e-01 3.1812656162756789e-02 + 8.4506680056445915e-01 3.1829824148367478e-02 + 8.4506407026684283e-01 3.1837801056283879e-02 + 8.4506186436353137e-01 3.1844245880343187e-02 + 8.4506007376987724e-01 3.1849477324982452e-02 + 8.4505861432486928e-01 3.1853741277188881e-02 + 8.4505742057664635e-01 3.1857228962842057e-02 + 8.4505644313395256e-01 3.1860084684602524e-02 + 8.4505564067885253e-01 3.1862429158146334e-02 + 8.4505498036909044e-01 3.1864358336174091e-02 + 8.4505443595117069e-01 3.1865948921521302e-02 + 8.5379763512805540e-01 2.4608050786968920e-02 + 8.5324305223860919e-01 2.5862477540360241e-02 + 8.5278436549948755e-01 2.6899994073817459e-02 + 8.5240525702663317e-01 2.7757510271768229e-02 + 8.5209214104388575e-01 2.8465756186241659e-02 + 8.5183370319291674e-01 2.9050324085018463e-02 + 8.5162052083737072e-01 2.9532527296141343e-02 + 8.5144475026604471e-01 2.9930107732412524e-02 + 8.5129986849043249e-01 3.0257819926355744e-02 + 8.5118045895259742e-01 3.0527915743804250e-02 + 8.5108203258033477e-01 3.0750549144436475e-02 + 8.5100087717371964e-01 3.0934116858440015e-02 + 8.5093392985124494e-01 3.1085546904300876e-02 + 8.5087866868764017e-01 3.1210543696240031e-02 + 8.5083302069725109e-01 3.1313796179311862e-02 + 8.5079528398123228e-01 3.1399153926641978e-02 + 8.5076406224366163e-01 3.1469775259592311e-02 + 8.5073821009171158e-01 3.1528250974658917e-02 + 8.5071678766197689e-01 3.1576706975570829e-02 + 8.5069902321714896e-01 3.1616888876726888e-02 + 8.5068428246995775e-01 3.1650231390481343e-02 + 8.5067204351756698e-01 3.1677915023749975e-02 + 8.5066187640884094e-01 3.1700912295109879e-02 + 8.5065342650749698e-01 3.1720025366383055e-02 + 8.5064640094788557e-01 3.1735916678783886e-02 + 8.5064313660206403e-01 3.1743300395092447e-02 + 8.5064049922243778e-01 3.1749265958850983e-02 + 8.5063835838734070e-01 3.1754108374407515e-02 + 8.5063661347379516e-01 3.1758055243784618e-02 + 8.5063518622753032e-01 3.1761283572578250e-02 + 8.5063401759635238e-01 3.1763926932583883e-02 + 8.5063305818042190e-01 3.1766097062629929e-02 + 8.5063226871358610e-01 3.1767882780033278e-02 + 8.5063161780716678e-01 3.1769355083739709e-02 + 8.5947379251683242e-01 2.5167901503013564e-02 + 8.5883670167004400e-01 2.6303333887045994e-02 + 8.5830977390397178e-01 2.7242432059085213e-02 + 8.5787426364464558e-01 2.8018604648123783e-02 + 8.5751456389481173e-01 2.8659666667071839e-02 + 8.5721767700473439e-01 2.9188782712422482e-02 + 8.5697277848734676e-01 2.9625244339286736e-02 + 8.5677085768477901e-01 2.9985110470478124e-02 + 8.5660442115226954e-01 3.0281736030034655e-02 + 8.5646724648457229e-01 3.0526210677195551e-02 + 8.5635417674865477e-01 3.0727725171474280e-02 + 8.5626094746280645e-01 3.0893879733000531e-02 + 8.5618404006595239e-01 3.1030945191375663e-02 + 8.5612055743391346e-01 3.1144084842694344e-02 + 8.5606811817293071e-01 3.1237542840678291e-02 + 8.5602476718463749e-01 3.1314803589686697e-02 + 8.5598890043936071e-01 3.1378725814119053e-02 + 8.5595920213875254e-01 3.1431654548597303e-02 + 8.5593459259134030e-01 3.1475514034610831e-02 + 8.5591418524482021e-01 3.1511884298297287e-02 + 8.5589725144596540e-01 3.1542063955899036e-02 + 8.5588319164589632e-01 3.1567121531915980e-02 + 8.5587151192763311e-01 3.1587937292232110e-02 + 8.5586180489393548e-01 3.1605237305989325e-02 + 8.5585373410808341e-01 3.1619621175501378e-02 + 8.5584998410984714e-01 3.1626304475736354e-02 + 8.5584695435460389e-01 3.1631704148722420e-02 + 8.5584449501721205e-01 3.1636087214877769e-02 + 8.5584249050451189e-01 3.1639659685936301e-02 + 8.5584085091998308e-01 3.1642581776907278e-02 + 8.5583950842591094e-01 3.1644974388939436e-02 + 8.5583840627308572e-01 3.1646938661425240e-02 + 8.5583749935350661e-01 3.1648554986442534e-02 + 8.5583675160859851e-01 3.1649887628085425e-02 + 8.6446396285617721e-01 2.5795530949369996e-02 + 8.6375732603281474e-01 2.6796444554395948e-02 + 8.6317287788919594e-01 2.7624284371244964e-02 + 8.6268982655084203e-01 2.8308500987910486e-02 + 8.6229086133284671e-01 2.8873614072086010e-02 + 8.6196156573875404e-01 2.9340043826875682e-02 + 8.6168993366106938e-01 2.9724796267069049e-02 + 8.6146597082249377e-01 3.0042027756765004e-02 + 8.6128136578032255e-01 3.0303511014026674e-02 + 8.6112921688048705e-01 3.0519021866006635e-02 + 8.6100380424992751e-01 3.0696662209707098e-02 + 8.6090039788845596e-01 3.0843131839681872e-02 + 8.6081509514256704e-01 3.0963958657743689e-02 + 8.6074468263284276e-01 3.1063694245581870e-02 + 8.6068651900832671e-01 3.1146079936704204e-02 + 8.6063843574859888e-01 3.1214187325502289e-02 + 8.6059865372523670e-01 3.1270536452919113e-02 + 8.6056571350502808e-01 3.1317194528866527e-02 + 8.6053841753538074e-01 3.1355857823044210e-02 + 8.6051578248642113e-01 3.1387919170136516e-02 + 8.6049700016380049e-01 3.1414523334606724e-02 + 8.6048140557080977e-01 3.1436612249005673e-02 + 8.6046845087358959e-01 3.1454961890939534e-02 + 8.6045768420272095e-01 3.1470212309543347e-02 + 8.6044873239544140e-01 3.1482892070030806e-02 + 8.6044457304073074e-01 3.1488783575525779e-02 + 8.6044121255196793e-01 3.1493543529741444e-02 + 8.6043848474891393e-01 3.1497407318212836e-02 + 8.6043626142003093e-01 3.1500556545729815e-02 + 8.6043444285547854e-01 3.1503132445976710e-02 + 8.6043295381237195e-01 3.1505241596640719e-02 + 8.6043173134657791e-01 3.1506973154663796e-02 + 8.6043072542601973e-01 3.1508397987781669e-02 + 8.6042989605590792e-01 3.1509572746572630e-02 + 8.6862682473602182e-01 2.6476815405860808e-02 + 8.6786663657951546e-01 2.7333451088712029e-02 + 8.6723789697493903e-01 2.8041960917401736e-02 + 8.6671823836920403e-01 2.8627550288624300e-02 + 8.6628903821493441e-01 2.9111204452514267e-02 + 8.6593478748480213e-01 2.9510400116824834e-02 + 8.6564257020773883e-01 2.9839691943473232e-02 + 8.6540163470625886e-01 3.0111195710106876e-02 + 8.6520303966841672e-01 3.0334987141729247e-02 + 8.6503936040934271e-01 3.0519432917011494e-02 + 8.6490444358465179e-01 3.0671467074946421e-02 + 8.6479320073868093e-01 3.0796823660040790e-02 + 8.6470143346164552e-01 3.0900233747850801e-02 + 8.6462568485329694e-01 3.0985592826766974e-02 + 8.6456311339223846e-01 3.1056102931145978e-02 + 8.6451138622012547e-01 3.1114392896646567e-02 + 8.6446858938023552e-01 3.1162619509810870e-02 + 8.6443315283847055e-01 3.1202552000059461e-02 + 8.6440378828775488e-01 3.1235642126148416e-02 + 8.6437943787809834e-01 3.1263081950954119e-02 + 8.6435923216738608e-01 3.1285851225422538e-02 + 8.6434245576326685e-01 3.1304756106085012e-02 + 8.6432851931521615e-01 3.1320460716347212e-02 + 8.6431693670953624e-01 3.1333512844611722e-02 + 8.6430730650398468e-01 3.1344364865404435e-02 + 8.6430283193927870e-01 3.1349407132609051e-02 + 8.6429921678129962e-01 3.1353480957385230e-02 + 8.6429628225605426e-01 3.1356787795296284e-02 + 8.6429389043578864e-01 3.1359483073515555e-02 + 8.6429193405426796e-01 3.1361687667491388e-02 + 8.6429033216643736e-01 3.1363492792039122e-02 + 8.6428901705799932e-01 3.1364974752471679e-02 + 8.6428793490536393e-01 3.1366194201329058e-02 + 8.6428704268281831e-01 3.1367199623020793e-02 + 8.7193873081646411e-01 2.7199166283910881e-02 + 8.7114260316336634e-01 2.7907051865615332e-02 + 8.7048413856945761e-01 2.8492532837563655e-02 + 8.6993991200837995e-01 2.8976437817247940e-02 + 8.6949042051263903e-01 2.9376108080798144e-02 + 8.6911942183294855e-01 2.9705985601322635e-02 + 8.6881338936852692e-01 2.9978097703279246e-02 + 8.6856106313364889e-01 3.0202456325775843e-02 + 8.6835307909702353e-01 3.0387387599277491e-02 + 8.6818166155615384e-01 3.0539805374439250e-02 + 8.6804036625433911e-01 3.0665439632387180e-02 + 8.6792386416846246e-01 3.0769028732095804e-02 + 8.6782775840009718e-01 3.0854482223731380e-02 + 8.6774842861671908e-01 3.0925019165451709e-02 + 8.6768289895802653e-01 3.0983285575843143e-02 + 8.6762872627484933e-01 3.1031453807627611e-02 + 8.6758390612421044e-01 3.1071306133210134e-02 + 8.6754679424527870e-01 3.1104304564911991e-02 + 8.6751604142359617e-01 3.1131648771591400e-02 + 8.6749053979695423e-01 3.1154323820886096e-02 + 8.6746937881874686e-01 3.1173139335389927e-02 + 8.6745180927478793e-01 3.1188761486920839e-02 + 8.6743721395179085e-01 3.1201739077491568e-02 + 8.6742508375402383e-01 3.1212524775057676e-02 + 8.6741499826024260e-01 3.1221492401819331e-02 + 8.6741031215105480e-01 3.1225659106908690e-02 + 8.6740652607882118e-01 3.1229025534258898e-02 + 8.6740345281774056e-01 3.1231758157872505e-02 + 8.6740094791913891e-01 3.1233985415788378e-02 + 8.6739889904555290e-01 3.1235807194065067e-02 + 8.6739722142507880e-01 3.1237298868589541e-02 + 8.6739584414216164e-01 3.1238523494708296e-02 + 8.6739471082848763e-01 3.1239531192927487e-02 + 8.6739377642420967e-01 3.1240362028655586e-02 + 8.7445566811084829e-01 2.7954707955818225e-02 + 8.7364242814110926e-01 2.8511757804278649e-02 + 8.7296981022063258e-01 2.8972484926153431e-02 + 8.7241388581534696e-01 2.9353279792664524e-02 + 8.7195473275242930e-01 2.9667788613722441e-02 + 8.7157575966451206e-01 2.9927376077499939e-02 + 8.7126314920417891e-01 3.0141506735163793e-02 + 8.7100539935864185e-01 3.0318059189242696e-02 + 8.7079294482197200e-01 3.0463585444551893e-02 + 8.7061784275738974e-01 3.0583526153557253e-02 + 8.7047351039242327e-01 3.0682390357250067e-02 + 8.7035450415968330e-01 3.0763906768606047e-02 + 8.7025633265178826e-01 3.0831151893821650e-02 + 8.7017529771925750e-01 3.0886658876447783e-02 + 8.7010835953736076e-01 3.0932509923460059e-02 + 8.7005302244283256e-01 3.0970414504238052e-02 + 8.7000723890819009e-01 3.1001775125918608e-02 + 8.6996932933029902e-01 3.1027742276342501e-02 + 8.6993791549397070e-01 3.1049259999790066e-02 + 8.6991186572420798e-01 3.1067103466462798e-02 + 8.6989024990265551e-01 3.1081909785104351e-02 + 8.6987230271123683e-01 3.1094203180214951e-02 + 8.6985739366993653e-01 3.1104415515432565e-02 + 8.6984500274040255e-01 3.1112903004590957e-02 + 8.6983470046457345e-01 3.1119959816109672e-02 + 8.6982991363009776e-01 3.1123238682738499e-02 + 8.6982604617838910e-01 3.1125887794303270e-02 + 8.6982290685929442e-01 3.1128038152516538e-02 + 8.6982034811927433e-01 3.1129790827961312e-02 + 8.6981825520632072e-01 3.1131224423070612e-02 + 8.6981654152634269e-01 3.1132398252694472e-02 + 8.6981513463950777e-01 3.1133361936406031e-02 + 8.6981397696587037e-01 3.1134154915026819e-02 + 8.6981302247713643e-01 3.1134808716914743e-02 + 8.7626563940296864e-01 2.8744964400762053e-02 + 8.7545676704072861e-01 2.9149233664516341e-02 + 8.7478776149931803e-01 2.9483598380476202e-02 + 8.7423482275593212e-01 2.9759953648733944e-02 + 8.7377813563225981e-01 2.9988202969477160e-02 + 8.7340119786695092e-01 3.0176594067936369e-02 + 8.7309026632043596e-01 3.0331995677984159e-02 + 8.7283390075281375e-01 3.0460125558663197e-02 + 8.7262258722994090e-01 3.0565738713847868e-02 + 8.7244842557299573e-01 3.0652783602634303e-02 + 8.7230486836311594e-01 3.0724532583378379e-02 + 8.7218650126830577e-01 3.0783691704770109e-02 + 8.7208885700286642e-01 3.0832493687804243e-02 + 8.7200825727864217e-01 3.0872776917505423e-02 + 8.7194167859667326e-01 3.0906052519441316e-02 + 8.7188663869695460e-01 3.0933561111367285e-02 + 8.7184110104854617e-01 3.0956320538503550e-02 + 8.7180339506880311e-01 3.0975165747448352e-02 + 8.7177214994442398e-01 3.0990781861952185e-02 + 8.7174624007823742e-01 3.1003731448315929e-02 + 8.7172474034715375e-01 3.1014476877221087e-02 + 8.7170688954337994e-01 3.1023398595463721e-02 + 8.7169206057298365e-01 3.1030810020570860e-02 + 8.7167973619048789e-01 3.1036969668591544e-02 + 8.7166948924433763e-01 3.1042091027131919e-02 + 8.7166472811814344e-01 3.1044470607710675e-02 + 8.7166088143707743e-01 3.1046393154461800e-02 + 8.7165775897807463e-01 3.1047953739630443e-02 + 8.7165521398009316e-01 3.1049225713424288e-02 + 8.7165313230740005e-01 3.1050266120210803e-02 + 8.7165142783094685e-01 3.1051118006701177e-02 + 8.7165002849997353e-01 3.1051817383422248e-02 + 8.7164887704376948e-01 3.1052392873914331e-02 + 8.7164792768123178e-01 3.1052867359279600e-02 + 8.7743881100222298e-01 2.9571525598260453e-02 + 8.7666336217881491e-01 2.9820047213522785e-02 + 8.7602200071790881e-01 3.0025595511989082e-02 + 8.7549191004109583e-01 3.0195482920758535e-02 + 8.7505409375601106e-01 3.0335797545047654e-02 + 8.7469273149386617e-01 3.0451609614641804e-02 + 8.7439464799739242e-01 3.0547141634003488e-02 + 8.7414887575070743e-01 3.0625908554399613e-02 + 8.7394629394628065e-01 3.0690833480080452e-02 + 8.7377932884983089e-01 3.0744343697933444e-02 + 8.7364170358946847e-01 3.0788450866538784e-02 + 8.7352822755949122e-01 3.0824818509899460e-02 + 8.7343461806769085e-01 3.0854819177151147e-02 + 8.7335734881700655e-01 3.0879583002154105e-02 + 8.7329352124295034e-01 3.0900038938561785e-02 + 8.7324075565537795e-01 3.0916949647106295e-02 + 8.7319709967513115e-01 3.0930940840842330e-02 + 8.7316095174994468e-01 3.0942525797185802e-02 + 8.7313099771012415e-01 3.0952125690973300e-02 + 8.7310615846949446e-01 3.0960086355833524e-02 + 8.7308554713211095e-01 3.0966692030790860e-02 + 8.7306843394413758e-01 3.0972176592768567e-02 + 8.7305421772388303e-01 3.0976732712918342e-02 + 8.7304240259906851e-01 3.0980519312095556e-02 + 8.7303257906854670e-01 3.0983667630359042e-02 + 8.7302801467760160e-01 3.0985130460379672e-02 + 8.7302432694583521e-01 3.0986312332103708e-02 + 8.7302133351044353e-01 3.0987271690605677e-02 + 8.7301889367472663e-01 3.0988053627325495e-02 + 8.7301689801915072e-01 3.0988693209906180e-02 + 8.7301526397359774e-01 3.0989216900977255e-02 + 8.7301392246460230e-01 3.0989646837768343e-02 + 8.7301281858791002e-01 3.0990000616403109e-02 + 8.7301190845411025e-01 3.0990292302847045e-02 + 8.7754576342257851e-01 3.1214501985146668e-02 + 8.7692669939521728e-01 3.2167439563597147e-02 + 8.7611814064274185e-01 3.3251070236848090e-02 + 8.7507114107403072e-01 3.4470478933284449e-02 + 8.7373040342174102e-01 3.5826841075170895e-02 + 8.7203543923832894e-01 3.7317915288026145e-02 + 8.6991890553759310e-01 3.8940069804245137e-02 + 8.6731074554604015e-01 4.0686569442887295e-02 + 8.6413171996605087e-01 4.2552780804218947e-02 + 8.6029857678789412e-01 4.4532184020337581e-02 + 8.5572067082178205e-01 4.6619100254421952e-02 + 8.5030000945340078e-01 4.8807790673674641e-02 + 8.4393242711273753e-01 5.1092370074304672e-02 + 8.3650956367383611e-01 5.3467774930137706e-02 + 8.2792125973350716e-01 5.5926104839660290e-02 + 8.1806870554737587e-01 5.8488161614232093e-02 + 8.0685458311823322e-01 6.1155526386738171e-02 + 7.9418650623168674e-01 6.3887419524508729e-02 + 7.7999637202581074e-01 6.6635672756287692e-02 + 7.6424939383749979e-01 6.9342439212373583e-02 + 7.4695396143214965e-01 7.1945399436575352e-02 + 7.2817001875143639e-01 7.4380865854865932e-02 + 7.0801449168613051e-01 7.6586656730301267e-02 + 6.8666487903550177e-01 7.8520151274104166e-02 + 6.6436092295250526e-01 8.0229941438569000e-02 + 6.4138606671930731e-01 8.1759737670171306e-02 + 6.1805520354137222e-01 8.3123474570963085e-02 + 5.9470111754828470e-01 8.4326188814389066e-02 + 5.7165670743482522e-01 8.5369010598641923e-02 + 5.4923667778854990e-01 8.6248034994797343e-02 + 5.2772132330194454e-01 8.6956789596116746e-02 + 5.0734409824726667e-01 8.7489485189324215e-02 + 4.8828407754707903e-01 8.7843833410446437e-02 + 4.7066357468210646e-01 8.8043413846766477e-02 + 4.5454916689955677e-01 8.8100678595799925e-02 + 4.3995751048433324e-01 8.8034803035559037e-02 + 4.2686303788744895e-01 8.7867467010013939e-02 + 4.1520682832475403e-01 8.7619981871725719e-02 + 4.0490556894590635e-01 8.7312200708858548e-02 + 3.9585981637719153e-01 8.6961209457044442e-02 + 3.8796106435164279e-01 8.6587791288110491e-02 + 3.8109789711844910e-01 8.6201827614225221e-02 + 3.7515990609442412e-01 8.5818818325641685e-02 + 8.7675433039409101e-01 3.1199349665748582e-02 + 8.7604056668199826e-01 3.2023532711353060e-02 + 8.7513415757600677e-01 3.2962075831879906e-02 + 8.7398845751717069e-01 3.4020160553628671e-02 + 8.7255059857439887e-01 3.5199889365805419e-02 + 8.7076236871081591e-01 3.6500909970219909e-02 + 8.6855854546890987e-01 3.7921100223077840e-02 + 8.6587041187386626e-01 3.9456288257011578e-02 + 8.6262017899677301e-01 4.1103659750082684e-02 + 8.5872527914668362e-01 4.2858871021420136e-02 + 8.5409560413411445e-01 4.4718412748335469e-02 + 8.4863357256413818e-01 4.6678465773884223e-02 + 8.4223538459220904e-01 4.8735379299014871e-02 + 8.3479320273083257e-01 5.0887909560590493e-02 + 8.2619717482731148e-01 5.3130942044373186e-02 + 8.1634710937040789e-01 5.5481952775285247e-02 + 8.0514514942591953e-01 5.7940081815662486e-02 + 7.9250013040085143e-01 6.0469257500333634e-02 + 7.7834506651314805e-01 6.3027993936234719e-02 + 7.6264569622488876e-01 6.5563765359488699e-02 + 7.4541050140065035e-01 6.8020125252527028e-02 + 7.2669895664634798e-01 7.0339059958480984e-02 + 7.0662688171522059e-01 7.2462179761361600e-02 + 6.8536989052660746e-01 7.4346433793017613e-02 + 6.6316470590657139e-01 7.6027824978363218e-02 + 6.4029222704886590e-01 7.7538008865449481e-02 + 6.1706530400793569e-01 7.8882807140902608e-02 + 5.9381506418010255e-01 8.0064351047598542e-02 + 5.7087293092983260e-01 8.1083840337500546e-02 + 5.4855222626382272e-01 8.1936892563023125e-02 + 5.2713206713886673e-01 8.2617754804724094e-02 + 5.0684507480926044e-01 8.3127693343429371e-02 + 4.8786954671105864e-01 8.3467293141581592e-02 + 4.7032717258923334e-01 8.3659854580628690e-02 + 4.5428417101303570e-01 8.3717103642246021e-02 + 4.3975706056988628e-01 8.3659462460514256e-02 + 4.2672030219639739e-01 8.3509486153005311e-02 + 4.1511515575161789e-01 8.3287901731253930e-02 + 4.0485862045234200e-01 8.3012769070009859e-02 + 3.9585170686759386e-01 8.2698027412334577e-02 + 3.8798634744217120e-01 8.2366041188230266e-02 + 3.8115171567500045e-01 8.2021283234404149e-02 + 3.7523789535620194e-01 8.1680857515863223e-02 + 8.7609974898157961e-01 3.1186765319503894e-02 + 8.7530765853189885e-01 3.1904392945288587e-02 + 8.7432031352788342e-01 3.2722856283082941e-02 + 8.7309297022987153e-01 3.3647412928576786e-02 + 8.7157476901148967e-01 3.4680927646885691e-02 + 8.6970937964028061e-01 3.5824605442794324e-02 + 8.6743333251498145e-01 3.7077566451639142e-02 + 8.6467901777585299e-01 3.8437752269888811e-02 + 8.6136984506173453e-01 3.9903844870106689e-02 + 8.5742381165705295e-01 4.1473291826679679e-02 + 8.5275125254998618e-01 4.3144368680689001e-02 + 8.4725492559819249e-01 4.4914833750492572e-02 + 8.4083133280519728e-01 4.6782873823790080e-02 + 8.3337306877039619e-01 4.8750395081558144e-02 + 8.2477053573906134e-01 5.0814578697380028e-02 + 8.1492239900918018e-01 5.2990138769895702e-02 + 8.0373035637002055e-01 5.5274186002068869e-02 + 7.9110425651225647e-01 5.7634540846765885e-02 + 7.7697804215902355e-01 6.0035251187858144e-02 + 7.6131789198253841e-01 6.2428206546480867e-02 + 7.4413237124717169e-01 6.4761843191152094e-02 + 7.2548057443387204e-01 6.6982877243889877e-02 + 7.0547741450230483e-01 6.9036100743092396e-02 + 6.8429695318800399e-01 7.0878152854163198e-02 + 6.6217341917935368e-01 7.2534642262782598e-02 + 6.3938560950796308e-01 7.4027261759265869e-02 + 6.1624468544233801e-01 7.5355128298620150e-02 + 5.9308040410009000e-01 7.6517980376594741e-02 + 5.7022296696196040e-01 7.7517087950846456e-02 + 5.4798454892253867e-01 7.8347678003269777e-02 + 5.2664328786277137e-01 7.9004595692070342e-02 + 5.0643111065497803e-01 7.9494970163893605e-02 + 4.8752566505975592e-01 7.9821772708300334e-02 + 4.7004811785631956e-01 8.0008065870982414e-02 + 4.5406438441361252e-01 8.0064963140619186e-02 + 4.3959086369363642e-01 8.0013914724472626e-02 + 4.2660203534947971e-01 7.9878195059592372e-02 + 4.1503930489450314e-01 7.9678035738496342e-02 + 4.0481992706523051e-01 7.9429994687302732e-02 + 3.9584528664112323e-01 7.9145381862943689e-02 + 3.8800767815246823e-01 7.8847871357759072e-02 + 3.8119676313870210e-01 7.8537423582744806e-02 + 3.7530303322660502e-01 7.8232473167510405e-02 + 8.7555873216614444e-01 3.1176316868151449e-02 + 8.7470190202658604e-01 3.1805816812278266e-02 + 8.7364765783793419e-01 3.2524960303623951e-02 + 8.7235282689858495e-01 3.3339064345723438e-02 + 8.7076820858809556e-01 3.4251619645642654e-02 + 8.6883902710643346e-01 3.5265113637079439e-02 + 8.6650326069572414e-01 3.6379687522908433e-02 + 8.6369421360366661e-01 3.7595023590070296e-02 + 8.6033628518517113e-01 3.8911033114614225e-02 + 8.5634793875193127e-01 4.0326636267663245e-02 + 8.5163987469740254e-01 4.1841575136898297e-02 + 8.4611513048881470e-01 4.3454902513998715e-02 + 8.3967045702659882e-01 4.5166314464764032e-02 + 8.3219880586698747e-01 4.6980312149584438e-02 + 8.2359078976397793e-01 4.8895966438215185e-02 + 8.1374412883354652e-01 5.0925698468559391e-02 + 8.0256015326345576e-01 5.3064932211241193e-02 + 7.8994955186603499e-01 5.5284703378645141e-02 + 7.7584703895062523e-01 5.7553639833293167e-02 + 7.6021916238101728e-01 5.9827293359460368e-02 + 7.4307456292492291e-01 6.2058158965966836e-02 + 7.2447202821442247e-01 6.4196895598157153e-02 + 7.0452572908647315e-01 6.6190966369133200e-02 + 6.8340845054924004e-01 6.7996795866986301e-02 + 6.6135236269257791e-01 6.9631418170387566e-02 + 6.3863452693408762e-01 7.1108298729684841e-02 + 6.1556470973292032e-01 7.2421017833434520e-02 + 5.9247153565365507e-01 7.3567345710898208e-02 + 5.6968419478097210e-01 7.4548621876302873e-02 + 5.4751391064784771e-01 7.5359754484437727e-02 + 5.2623800739330540e-01 7.5996085738587307e-02 + 5.0608783306907112e-01 7.6469615394919851e-02 + 4.8724049245124018e-01 7.6785296016083124e-02 + 4.6981671364505384e-01 7.6965987290539578e-02 + 4.5388215547297173e-01 7.7022285622197637e-02 + 4.3945311280750105e-01 7.6976488110955532e-02 + 4.2650407636483717e-01 7.6852459528417211e-02 + 4.1497656862726789e-01 7.6670010975391126e-02 + 4.0478805316508487e-01 7.6444441896484153e-02 + 3.9584022291609855e-01 7.6184864831354490e-02 + 3.8802567097647722e-01 7.5916037982260279e-02 + 3.8123446287044044e-01 7.5634156659560831e-02 + 3.7535742784941795e-01 7.5358758899582753e-02 + 8.7511189189768512e-01 3.1167644384961137e-02 + 8.7420158967075345e-01 3.1724304212906833e-02 + 8.7309208709151453e-01 3.2361350876882522e-02 + 8.7174150826909202e-01 3.3084147325211581e-02 + 8.7010202200990394e-01 3.3896697551823451e-02 + 8.6812013554974110e-01 3.4802543916043330e-02 + 8.6573502212540265e-01 3.5802665839547269e-02 + 8.6288074011924087e-01 3.6898177716686582e-02 + 8.5948250550171990e-01 3.8089999513495461e-02 + 8.5545916564360414e-01 3.9378260502083394e-02 + 8.5072172193328277e-01 4.0763906197789301e-02 + 8.4517344206290490e-01 4.2247050110099438e-02 + 8.3871128197429179e-01 4.3828626272827659e-02 + 8.3122848789082004e-01 4.5515271450484368e-02 + 8.2261584665131293e-01 4.7307610295733389e-02 + 8.1277029742367490e-01 4.9216160904316651e-02 + 8.0159286716348632e-01 5.1234945586658830e-02 + 7.8899494094069700e-01 5.3337654170308557e-02 + 7.7491187410521756e-01 5.5496702909596039e-02 + 7.5931052428511114e-01 5.7670680096808515e-02 + 7.4219960054939871e-01 5.9815453822164265e-02 + 7.2363764371935380e-01 6.1884969900806441e-02 + 7.0373821833951644e-01 6.3828934916369887e-02 + 6.8267306051237742e-01 6.5603633847491377e-02 + 6.6067264263650460e-01 6.7219033520720978e-02 + 6.3801259430939516e-01 6.8681810496167991e-02 + 6.1500153087919085e-01 6.9980976564182520e-02 + 5.9196714150754504e-01 7.1112684770128887e-02 + 5.6923777959319399e-01 7.2078342498494430e-02 + 5.4712387997241163e-01 7.2872598176809980e-02 + 5.2590209060769966e-01 7.3491206997391423e-02 + 5.0580327705694128e-01 7.3950213992378999e-02 + 4.8700409019217367e-01 7.4256216204329165e-02 + 4.6962488998972851e-01 7.4431900096558437e-02 + 4.5373111800829879e-01 7.4487425188256975e-02 + 4.3933897843402109e-01 7.4445785503282388e-02 + 4.2642296713726774e-01 7.4331329600296217e-02 + 4.1492470011929694e-01 7.4163511320540582e-02 + 4.0476181130059802e-01 7.3956575230609625e-02 + 3.9583624711180332e-01 7.3717797009599170e-02 + 3.8804084660632809e-01 7.3472831758194898e-02 + 3.8126600952362000e-01 7.3214732962412335e-02 + 3.7540284445731253e-01 7.2963953247245986e-02 + 8.7474308164324421e-01 3.1160448007827687e-02 + 8.7378864328540107e-01 3.1656939980149353e-02 + 8.7263352776984482e-01 3.2226167083426766e-02 + 8.7123692888676474e-01 3.2873527399016098e-02 + 8.6955214502311073e-01 3.3603445264172818e-02 + 8.6752674167037291e-01 3.4420329912333528e-02 + 8.6510087765102928e-01 3.5325848055596819e-02 + 8.6220923302324159e-01 3.6322291084812643e-02 + 8.5877769704134521e-01 3.7411405619406368e-02 + 8.5472543330872675e-01 3.8594312470626307e-02 + 8.4996369092551471e-01 3.9872943415230566e-02 + 8.4439592696657484e-01 4.1248279914396363e-02 + 8.3791926613425205e-01 4.2722270104829881e-02 + 8.3042719772356066e-01 4.4303306567298355e-02 + 8.2181065245343310e-01 4.5993290168593749e-02 + 8.1196592464988226e-01 4.7801160025370083e-02 + 8.0079379132666340e-01 4.9719773906728194e-02 + 7.8820621435440474e-01 5.1725010975415202e-02 + 7.7413908155202449e-01 5.3792419396293104e-02 + 7.5855951055042503e-01 5.5883104232348525e-02 + 7.4147627211153411e-01 5.7955736300092604e-02 + 7.2294770927575436e-01 5.9967001510676354e-02 + 7.0308689212223618e-01 6.1868491594408104e-02 + 6.8206469601093078e-01 6.3616409976039304e-02 + 6.6011019440632679e-01 6.5214903556458106e-02 + 6.3749783661896897e-01 6.6665051154098071e-02 + 6.1453528871071628e-01 6.7952097764731059e-02 + 5.9154946779493023e-01 6.9070869226570616e-02 + 5.6886803549182796e-01 7.0022838271639409e-02 + 5.4680077304043639e-01 7.0802442179100075e-02 + 5.2562376665247423e-01 7.1405779219225668e-02 + 5.0556747968634408e-01 7.1852253438947189e-02 + 4.8680818350823413e-01 7.2149826436798681e-02 + 4.6946592904561740e-01 7.2321036615802178e-02 + 4.5360597372285172e-01 7.2375674119649083e-02 + 4.3924444265455448e-01 7.2337305914705954e-02 + 4.2635583239897390e-01 7.2230676475228475e-02 + 4.1488183337925910e-01 7.2074935849790953e-02 + 4.0474021820905215e-01 7.1883444092541826e-02 + 3.9583314162752770e-01 7.1661941132084780e-02 + 3.8805364512338320e-01 7.1436823690881029e-02 + 3.8129240478142562e-01 7.1198523315672391e-02 + 3.7544076019315881e-01 7.0968250422922069e-02 + 8.7443885452388670e-01 3.1154477917553224e-02 + 8.7344800731572259e-01 3.1601296143436153e-02 + 8.7225526259424724e-01 3.2114527574820424e-02 + 8.7082069592149469e-01 3.2699596812563569e-02 + 8.6909853683537841e-01 3.3361272003005198e-02 + 8.6703722312436959e-01 3.4104674055264787e-02 + 8.6457772596221283e-01 3.4932032606435494e-02 + 8.6165523753841367e-01 3.5846605470952135e-02 + 8.5819620184844203e-01 3.6850815979002242e-02 + 8.5412004267804575e-01 3.7946597165182262e-02 + 8.4933821282256861e-01 3.9136688156532956e-02 + 8.4375432501073355e-01 4.0422779716352567e-02 + 8.3726564273208703e-01 4.1807649712319206e-02 + 8.2976585566446404e-01 4.3301133017309854e-02 + 8.2114601338289051e-01 4.4906177717721728e-02 + 8.1130187805319931e-01 4.6630413150269223e-02 + 8.0013402081266538e-01 4.8465729707602240e-02 + 7.8755488120762795e-01 5.0389811357178904e-02 + 7.7350078926316868e-01 5.2380794221762533e-02 + 7.5793908091209972e-01 5.4401868714827599e-02 + 7.4087858250756233e-01 5.6414034093543293e-02 + 7.2237747918556383e-01 5.8376260582677121e-02 + 7.0254843840982739e-01 6.0241724511755523e-02 + 6.8156162994356317e-01 6.1966591801912045e-02 + 6.5964497531944932e-01 6.3550220234462371e-02 + 6.3707195157249308e-01 6.4989076095361989e-02 + 6.1414944243021252e-01 6.6265300665990928e-02 + 5.9120372816425359e-01 6.7372631683142670e-02 + 5.6856189869861951e-01 6.8312604029416038e-02 + 5.4653319380895848e-01 6.9079483660261065e-02 + 5.2539323310040120e-01 6.9669653797845787e-02 + 5.0537214466282832e-01 7.0105307111333892e-02 + 4.8664588251380547e-01 7.0395537209279380e-02 + 4.6933423805126240e-01 7.0562755866830071e-02 + 4.5350231255772033e-01 7.0616440771497591e-02 + 4.3916616219135085e-01 7.0580629487166660e-02 + 4.2630028092534777e-01 7.0480390077946667e-02 + 4.1484641812662915e-01 7.0334614112717117e-02 + 4.0472245912618887e-01 7.0155919784831239e-02 + 3.9583072968214833e-01 6.9948762828168823e-02 + 3.8806443776297117e-01 6.9740152909041384e-02 + 3.8131448784200667e-01 6.9518333346302114e-02 + 3.7547241044211160e-01 6.9305142225339025e-02 + 8.7418801692322712e-01 3.1149526030489715e-02 + 8.7316714903251103e-01 3.1555351297514002e-02 + 8.7194337555655876e-01 3.2022368478395333e-02 + 8.7047749856695034e-01 3.2556021898771138e-02 + 8.6872451479713586e-01 3.3161360628951211e-02 + 8.6663358068830876e-01 3.3844089396141225e-02 + 8.6414633664165363e-01 3.4606898487099524e-02 + 8.6119839650725583e-01 3.5453838637609168e-02 + 8.5771666111039491e-01 3.6387886630068055e-02 + 8.5362076817109711e-01 3.7411640228016525e-02 + 8.4882233787552908e-01 3.8528498821024430e-02 + 8.4322511079672258e-01 3.9740732199335528e-02 + 8.3672646448802024e-01 4.1051796438780673e-02 + 8.2922025373574437e-01 4.2472710318052886e-02 + 8.2059762626057708e-01 4.4007280563108847e-02 + 8.1075390525028757e-01 4.5662050232210871e-02 + 7.9958949235371457e-01 4.7428106222377947e-02 + 7.8701722260037321e-01 4.9284619573869086e-02 + 7.7297379321092607e-01 5.1211864103593754e-02 + 7.5742672344293926e-01 5.3174757706856889e-02 + 7.4038488957851689e-01 5.5136233828990217e-02 + 7.2190635112496371e-01 5.7057167059711422e-02 + 7.0210344817008130e-01 5.8892065983834403e-02 + 6.8114577255629216e-01 6.0597091520009000e-02 + 6.5926029781045636e-01 6.2167662940937979e-02 + 6.3671970047816318e-01 6.3596447797078653e-02 + 6.1383021987587005e-01 6.4863031353952980e-02 + 5.9091761120719377e-01 6.5960260030323861e-02 + 5.6830849211081436e-01 6.6889727131802246e-02 + 5.4631165390525815e-01 6.7645559837658284e-02 + 5.2520232866914196e-01 6.8224378013731740e-02 + 5.0521036501625793e-01 6.8650689077295060e-02 + 4.8651145156658321e-01 6.8934525563605784e-02 + 4.6922516173055556e-01 6.9098190928996578e-02 + 4.5341646434960253e-01 6.9150898479708706e-02 + 4.3910135547830775e-01 6.9117072035935756e-02 + 4.2625432421332443e-01 6.9022043855419241e-02 + 4.1481716639137128e-01 6.8884485523497699e-02 + 4.0470785880850330e-01 6.8716392909237922e-02 + 3.9582886752126750e-01 6.8521147792687115e-02 + 3.8807353732012373e-01 6.8326266252348999e-02 + 3.8133296136386108e-01 6.8118165262667715e-02 + 3.7549882793336076e-01 6.7919202669507697e-02 + 8.7398126000904885e-01 3.1145419105229399e-02 + 8.7293564596653772e-01 3.1517423964275357e-02 + 8.7168629380964568e-01 3.1946309458470205e-02 + 8.7019460400359150e-01 3.2437534340715959e-02 + 8.6841620518753859e-01 3.2996377054813147e-02 + 8.6630084568176735e-01 3.3629021008949163e-02 + 8.6379071702722521e-01 3.4338533207738609e-02 + 8.6082178012353350e-01 3.5129614616566364e-02 + 8.5732131186759719e-01 3.6005694365465281e-02 + 8.5320912581416331e-01 3.6969913885927269e-02 + 8.4839697964584837e-01 3.8026212172782202e-02 + 8.4278871889089624e-01 3.9177331325732929e-02 + 8.3628181480652530e-01 4.0427281385136120e-02 + 8.2877025817858530e-01 4.1788052467297804e-02 + 8.2014527775230417e-01 4.3264154936069284e-02 + 8.1030183470200545e-01 4.4861231027412560e-02 + 7.9914019119364310e-01 4.6569700305576237e-02 + 7.8657350963990824e-01 4.8369958695986856e-02 + 7.7253879214772603e-01 5.0244045385150156e-02 + 7.5700371193617333e-01 5.2158309102027095e-02 + 7.3997718994627848e-01 5.4077289878905296e-02 + 7.2151718604149784e-01 5.5963449925237690e-02 + 7.0173577438887869e-01 5.7772417993263686e-02 + 6.8080207376631874e-01 5.9460373066088000e-02 + 6.5894227780872383e-01 6.1019496732059586e-02 + 6.3642840423902547e-01 6.2439329082057717e-02 + 6.1356616174798229e-01 6.3697351130196186e-02 + 5.9068087275645775e-01 6.4785679602658061e-02 + 5.6809876483056632e-01 6.5705962106804877e-02 + 5.4612825791647590e-01 6.6452213557689280e-02 + 5.2504426226746259e-01 6.7021250332559082e-02 + 5.0507639352971878e-01 6.7439501091250867e-02 + 4.8640011836337016e-01 6.7717777067479015e-02 + 4.6913482707296450e-01 6.7878289084290402e-02 + 4.5334537616548232e-01 6.7930026741866545e-02 + 4.3904770937357729e-01 6.7897730736141401e-02 + 4.2621630942447652e-01 6.7806948857565913e-02 + 4.1479300863483065e-01 6.7676165490205276e-02 + 4.0469585793237139e-01 6.7516854422116621e-02 + 3.9582743841039408e-01 6.7331499262337571e-02 + 3.8808120725828849e-01 6.7148034393682152e-02 + 3.8134841348427045e-01 6.6951352450708185e-02 + 3.7552087568888415e-01 6.6764241619793566e-02 + 8.7381085391882607e-01 3.1142013008711639e-02 + 8.7274484350479697e-01 3.1486117258069969e-02 + 8.7147440746400462e-01 3.1883542506009548e-02 + 8.6996143907618839e-01 3.2339757857705986e-02 + 8.6816208739535528e-01 3.2860228968358093e-02 + 8.6602658815423605e-01 3.3451531630739044e-02 + 8.6349758673068955e-01 3.4117040832570389e-02 + 8.6051132962719534e-01 3.4861990629544967e-02 + 8.5699540329243140e-01 3.5690179743427135e-02 + 8.5286976577717932e-01 3.6605194118494486e-02 + 8.4804628768456602e-01 3.7611413594477040e-02 + 8.4242890068981779e-01 3.8711965370581934e-02 + 8.3591515301440911e-01 3.9911311803821084e-02 + 8.2839914745421706e-01 4.1222239777369878e-02 + 8.1977217963915805e-01 4.2649836128846132e-02 + 8.0992891222708663e-01 4.4198996076574758e-02 + 7.9876949260903751e-01 4.5859584943110036e-02 + 7.8620735419878562e-01 4.7613007465060669e-02 + 7.7217975225157731e-01 4.9442760629624993e-02 + 7.5665448927770007e-01 5.1316378263067813e-02 + 7.3964052597100838e-01 5.3199734864407648e-02 + 7.2119574335481307e-01 5.5056616196637979e-02 + 7.0143199972731007e-01 5.6843592760885103e-02 + 6.8051802674454553e-01 5.8516877080052293e-02 + 6.5867937654138897e-01 6.0065989598074077e-02 + 6.3618752468476258e-01 6.1477895916060239e-02 + 6.1334774298680894e-01 6.2728344928020027e-02 + 5.9048499718666936e-01 6.3808856153173721e-02 + 5.6792519270066966e-01 6.4721127119469646e-02 + 5.4597644194658923e-01 6.5459082001325830e-02 + 5.2491338791707898e-01 6.6019700359987943e-02 + 5.0496545206058641e-01 6.6431005474541685e-02 + 4.8630791541054813e-01 6.6704454382986153e-02 + 4.6906001447850804e-01 6.6862178745459203e-02 + 4.5328651052445118e-01 6.6912978923650973e-02 + 4.3900330182057090e-01 6.6881855514956456e-02 + 4.2618486386925286e-01 6.6794532071888596e-02 + 4.1477305752015659e-01 6.6669333749885679e-02 + 4.0468599374004882e-01 6.6517296378940299e-02 + 3.9582634792387228e-01 6.6340152424743393e-02 + 3.8808766957973190e-01 6.6166181775400942e-02 + 3.8136133643538445e-01 6.5979004799928048e-02 + 3.7553927473808740e-01 6.5801765978903873e-02 + 8.7367039238969346e-01 3.1139187933227834e-02 + 8.7258756896684375e-01 3.1460272689287860e-02 + 8.7129975210042687e-01 3.1831739090812744e-02 + 8.6976924097727548e-01 3.2259063507069564e-02 + 8.6795261329214213e-01 3.2747864392949931e-02 + 8.6580050620499471e-01 3.3305039209245907e-02 + 8.6325593884627616e-01 3.3934214743504033e-02 + 8.6025539277831697e-01 3.4641062135364921e-02 + 8.5672670927482719e-01 3.5429682092527878e-02 + 8.5258996514074692e-01 3.6304024012836424e-02 + 8.4775712372470502e-01 3.7268827903795293e-02 + 8.4213218741721529e-01 3.8327534950995182e-02 + 8.3561276766059134e-01 3.9484976836136172e-02 + 8.2809305951232470e-01 4.0754594065945386e-02 + 8.1946441382078272e-01 4.2141945800623457e-02 + 8.0962124705964744e-01 4.3651307737499000e-02 + 7.9846361216645723e-01 4.5272084856592461e-02 + 7.8590516690490431e-01 4.6986512837215597e-02 + 7.7188337673321850e-01 4.8779292612679347e-02 + 7.5636615271194885e-01 5.0618939661874356e-02 + 7.3936249073266436e-01 5.2472436983408165e-02 + 7.2093020954320741e-01 5.4304673738727750e-02 + 7.0118099222851482e-01 5.6073011972238344e-02 + 6.8028325363666953e-01 5.7733707242278033e-02 + 6.5846201818313410e-01 5.9274092507224888e-02 + 6.3598831523933708e-01 6.0679013852525526e-02 + 6.1316705688559237e-01 6.1922794221716572e-02 + 5.9032291486745569e-01 6.2996464332699106e-02 + 5.6778152851922647e-01 6.3901767124037098e-02 + 5.4585075557607343e-01 6.4632553448355487e-02 + 5.2480501707081617e-01 6.5185938383926889e-02 + 5.0487357257377663e-01 6.5591268821791240e-02 + 4.8623154789122830e-01 6.5860537430886393e-02 + 4.6899805039111414e-01 6.6015808295972089e-02 + 4.5323776062697019e-01 6.6065721781524894e-02 + 4.3896653747064879e-01 6.6035491673438640e-02 + 4.2615884883925026e-01 6.5950984851568265e-02 + 4.1475657783651171e-01 6.5830391147471870e-02 + 4.0467788404374511e-01 6.5684379067576584e-02 + 3.9582552016519545e-01 6.5514052948792353e-02 + 3.8809311154186898e-01 6.5347978085227992e-02 + 3.8137214222487020e-01 6.5168713008162654e-02 + 3.7555462738927664e-01 6.4999697214034327e-02 + 8.7355457781978729e-01 3.1136844391646566e-02 + 8.7245789095159831e-01 3.1438931329802786e-02 + 8.7115574155327746e-01 3.1788972094077481e-02 + 8.6961076324435516e-01 3.2192448015763098e-02 + 8.6777988688375918e-01 3.2655102310994298e-02 + 8.6561408034820220e-01 3.3184096235139009e-02 + 8.6305667066752578e-01 3.3783262521702377e-02 + 8.6004433292937710e-01 3.4458630810434647e-02 + 8.5650511825029707e-01 3.5214548652910294e-02 + 8.5235920106730090e-01 3.6055262736980564e-02 + 8.4751862093132213e-01 3.6985807438725919e-02 + 8.4188743830177348e-01 3.8009880047248798e-02 + 8.3536331657094409e-01 3.9132613921289951e-02 + 8.2784052681560127e-01 4.0367985962306029e-02 + 8.1921046548359755e-01 4.1721942465401354e-02 + 8.0936734596187287e-01 4.3198245259262691e-02 + 7.9821114343169697e-01 4.4785916927609179e-02 + 7.8565570142571561e-01 4.6467877803522711e-02 + 7.7163865996697578e-01 4.8229823385356092e-02 + 7.5612802122154743e-01 5.0041082445340217e-02 + 7.3913281207108583e-01 5.1869558882387944e-02 + 7.2071080211082261e-01 5.3681061705817032e-02 + 7.0097353216256164e-01 5.5433617988925134e-02 + 6.8008915770942568e-01 5.7083531238603914e-02 + 6.5828226890043839e-01 5.8616335652673913e-02 + 6.3582352776552853e-01 6.0015131798441243e-02 + 6.1301755008102177e-01 6.1253068335106783e-02 + 5.9018876519510555e-01 6.2320775753349739e-02 + 5.6766259261126883e-01 6.3220037886538044e-02 + 5.4574667910442864e-01 6.3944646324763973e-02 + 5.2471526134793234e-01 6.4491828700767209e-02 + 5.0479746397695313e-01 6.4892030718738364e-02 + 4.8616828301076742e-01 6.5157689371943772e-02 + 4.6894671741065103e-01 6.5310811145593187e-02 + 4.5319737940607741e-01 6.5359901231870410e-02 + 4.3893609382029514e-01 6.5330348352645312e-02 + 4.2613732099594043e-01 6.5248136310991370e-02 + 4.1474296136114663e-01 6.5131340058762588e-02 + 4.0467121387319488e-01 6.4990320110169419e-02 + 3.9582489463888276e-01 6.4825655618619790e-02 + 3.8809769131226574e-01 6.4666147701387927e-02 + 3.8138117579170994e-01 6.4493468730752582e-02 + 3.7556743673532250e-01 6.4331302530554538e-02 + 8.7345903923818868e-01 3.1134899854834079e-02 + 8.7235091553076194e-01 3.1421300988420324e-02 + 8.7103694161062106e-01 3.1753649802383120e-02 + 8.6948002678165281e-01 3.2137430904050301e-02 + 8.6763739302830134e-01 3.2578489452558049e-02 + 8.6546028082864168e-01 3.3084203176620523e-02 + 8.6289227099191279e-01 3.3658573371881023e-02 + 8.5987019802052944e-01 3.4307923911520356e-02 + 8.5632228592305504e-01 3.5036804263775971e-02 + 8.5216878944986785e-01 3.5849704459139362e-02 + 8.4732181079898361e-01 3.6751899637586946e-02 + 8.4168545814318596e-01 3.7747296137553656e-02 + 8.3515743758842265e-01 3.8841273918301583e-02 + 8.2763208287951118e-01 4.0048250350011992e-02 + 8.1900082813642028e-01 4.1374489249058913e-02 + 8.0915771913401779e-01 4.2823326108746118e-02 + 7.9800266700844924e-01 4.4383465811812566e-02 + 7.8544966916331693e-01 4.6038393096971698e-02 + 7.7143651061668050e-01 4.7774625399427360e-02 + 7.5593126996501459e-01 4.9562165496070509e-02 + 7.3894300122059853e-01 5.1369682459260421e-02 + 7.2052943517808543e-01 5.3163752112610436e-02 + 7.0080199705688906e-01 5.4902959977937676e-02 + 6.7992862985702363e-01 5.6543659032975459e-02 + 6.5813356616819074e-01 5.8069903514927919e-02 + 6.3568716543584391e-01 5.9463355723299582e-02 + 6.1289379925006904e-01 6.0696196774004785e-02 + 5.9007769700630375e-01 6.1758729230192405e-02 + 5.6756409651481921e-01 6.2652773406853421e-02 + 5.4566046975458971e-01 6.3372072956454639e-02 + 5.2464090024443100e-01 6.3913949010668797e-02 + 5.0473440014456683e-01 6.4309759647216136e-02 + 4.8611585697945675e-01 6.4572310527715698e-02 + 4.6890417875213097e-01 6.4723559124771818e-02 + 4.5316391991434468e-01 6.4771896537634127e-02 + 4.3891087595897349e-01 6.4742855126361229e-02 + 4.2611949992997283e-01 6.4662514148899689e-02 + 4.1473170573153723e-01 6.4548851163550636e-02 + 4.0466572423986308e-01 6.4411968537157846e-02 + 3.9582442359267539e-01 6.4252006398746203e-02 + 3.8810154267795549e-01 6.4097960798292802e-02 + 3.8138872600523405e-01 6.3930764623975747e-02 + 3.7557812297759202e-01 6.3774304109870172e-02 + 8.7338017766249099e-01 3.1133285924035265e-02 + 8.7226261310850961e-01 3.1406728390166790e-02 + 8.7093887776862877e-01 3.1724459941969776e-02 + 8.6937210835313794e-01 3.2091967251587875e-02 + 8.6751976699017241e-01 3.2515178863018905e-02 + 8.6533331900561739e-01 3.3001650300718062e-02 + 8.6275655452052591e-01 3.3555520959822914e-02 + 8.5972643944546256e-01 3.4183356409969147e-02 + 8.5617134033473530e-01 3.4889871451682528e-02 + 8.5201157805576810e-01 3.5679755494243612e-02 + 8.4715930635063297e-01 3.6558480796074801e-02 + 8.4151867262855340e-01 3.7530124519087306e-02 + 8.3498741814266553e-01 3.8600268408608390e-02 + 8.2745992833347248e-01 3.9783691837549338e-02 + 8.1882766846068489e-01 4.1086919281149339e-02 + 8.0898454588230462e-01 4.2512932415647638e-02 + 7.9783041894557205e-01 4.4050172118446473e-02 + 7.8527941255474454e-01 4.5682588712253773e-02 + 7.7126943218847210e-01 4.7397379261625273e-02 + 7.5576862052948823e-01 4.9165105317783640e-02 + 7.3878605521001905e-01 5.0955071860215979e-02 + 7.2037943636328472e-01 5.2734493936498303e-02 + 7.0066009515807959e-01 5.4462425739203256e-02 + 6.7979580035493614e-01 5.6095268838675022e-02 + 6.5801048993038314e-01 5.7615858889521004e-02 + 6.3557427391225696e-01 5.9004672281237465e-02 + 6.1279132251932866e-01 6.0233092382576028e-02 + 5.8998570010348461e-01 6.1291152816480489e-02 + 5.6748249422512786e-01 6.2180706159836271e-02 + 5.4558903197774256e-01 6.2895457238085054e-02 + 5.2457926962193280e-01 6.3432804869244006e-02 + 5.0468212556654124e-01 6.3824864883322743e-02 + 4.8607239666145885e-01 6.4084748924969473e-02 + 4.6886891463147523e-01 6.4234372838704437e-02 + 4.5313618512900244e-01 6.4282031524057204e-02 + 4.3888997846447869e-01 6.4253375380786501e-02 + 4.2610474083551703e-01 6.4174561678811429e-02 + 4.1472239663229571e-01 6.4063485529033001e-02 + 4.0466120263729266e-01 6.3930033024327357e-02 + 3.9582406972455048e-01 6.3773977377898944e-02 + 3.8810477893970946e-01 6.3624475855277765e-02 + 3.8139503484075693e-01 6.3461844319533625e-02 + 3.7558703707159524e-01 6.3310136753763402e-02 + 8.7331503478362726e-01 3.1131945952907289e-02 + 8.7218967139914449e-01 3.1394675604360725e-02 + 8.7085787198824605e-01 3.1700322243523316e-02 + 8.6928296098853797e-01 3.2054373756039062e-02 + 8.6742259877091454e-01 3.2462826977184160e-02 + 8.6522843626437484e-01 3.2933383612202355e-02 + 8.6264443636054089e-01 3.3470296332375034e-02 + 8.5960767338012622e-01 3.4080329452138097e-02 + 8.5604663149766291e-01 3.4768333313259556e-02 + 8.5188168605979808e-01 3.5539160874940232e-02 + 8.4702503325695988e-01 3.6398445977276803e-02 + 8.4138085279516051e-01 3.7350405553589129e-02 + 8.3484691487548823e-01 3.8400786670792032e-02 + 8.2731764761548299e-01 3.9564666515332393e-02 + 8.1868454203121965e-01 4.0848783770720071e-02 + 8.0884139109429731e-01 4.2255826381406986e-02 + 7.9768800960520125e-01 4.3774015788990733e-02 + 7.8513862816543478e-01 4.5387686676349591e-02 + 7.7113125235638647e-01 4.7084598409050396e-02 + 7.5563407856667286e-01 4.8835775974439062e-02 + 7.3865620488300565e-01 5.0611052948902280e-02 + 7.2025530716321817e-01 5.2378177228355742e-02 + 7.0054263994338850e-01 5.4096596079070129e-02 + 6.7968582894312757e-01 5.5722757184590022e-02 + 6.5790856918563079e-01 5.7238491941491311e-02 + 6.3548076493812011e-01 5.8623298127589811e-02 + 6.1270642022500532e-01 5.9847900836375173e-02 + 5.8990946306999770e-01 6.0902112878672462e-02 + 5.6741485671131564e-01 6.1787815135645137e-02 + 5.4552980809785190e-01 6.2498680932051888e-02 + 5.2452816772443223e-01 6.3032173649368500e-02 + 5.0463877585703110e-01 6.3421038625733742e-02 + 4.8603635358316027e-01 6.3678641545294595e-02 + 4.6883966869681060e-01 6.3826862964176917e-02 + 4.5311318568751674e-01 6.3873916759454044e-02 + 4.3887265331536796e-01 6.3845550432119771e-02 + 4.2609251148992255e-01 6.3767985091835996e-02 + 4.1471469277211004e-01 6.3659046162570135e-02 + 4.0465747500455396e-01 6.3528438630605435e-02 + 3.9582380419957497e-01 6.3375629136061221e-02 + 3.8810749612442241e-01 6.3229908353562805e-02 + 3.8140030502603306e-01 6.3071077357427896e-02 + 3.7559447212554709e-01 6.2923329215230694e-02 + 8.7326118186310064e-01 3.1130833051746663e-02 + 8.7212937103645605e-01 3.1384700136384440e-02 + 8.7079090458229880e-01 3.1680348368168534e-02 + 8.6920926203970861e-01 3.2023266262056337e-02 + 8.6734226756910893e-01 3.2419506662857020e-02 + 8.6514172543678147e-01 3.2876891601153514e-02 + 8.6255174126360434e-01 3.3399766785172293e-02 + 8.5950947888656792e-01 3.3995060141541536e-02 + 8.5594351961832416e-01 3.4667733280413983e-02 + 8.5177428373941877e-01 3.5422773496747204e-02 + 8.4691400243382697e-01 3.6265947262349711e-02 + 8.4126688202032140e-01 3.7201586043948139e-02 + 8.3473071656628939e-01 3.8235572544045381e-02 + 8.2719996945058638e-01 3.9383229225420903e-02 + 8.1856615300723934e-01 4.0651471015258449e-02 + 8.0872296560895129e-01 4.2042741921299101e-02 + 7.9757018610140940e-01 4.3545080949839811e-02 + 7.8502213275088317e-01 4.5143140354851841e-02 + 7.7101689434597243e-01 4.6825145032868692e-02 + 7.5552271225654344e-01 4.8562504505219595e-02 + 7.3854870219504487e-01 5.0325491848169514e-02 + 7.2015252074996661e-01 5.2082299119418814e-02 + 7.0044535990838774e-01 5.3792703039021568e-02 + 6.7959472781374819e-01 5.5413193947365748e-02 + 6.5782411895299464e-01 5.6924774808593412e-02 + 6.3540326769707400e-01 5.8306135150832841e-02 + 6.1263604079074696e-01 5.9527456406997477e-02 + 5.8984625356020459e-01 6.0578369865268440e-02 + 5.6735876630849003e-01 6.1460781061583390e-02 + 5.4548068631076929e-01 6.2168337713756891e-02 + 5.2448577613659486e-01 6.2698556874373160e-02 + 5.0460281092014159e-01 6.3084707002438511e-02 + 4.8600644846325292e-01 6.3340364769387980e-02 + 4.6881540300882163e-01 6.3487380874156993e-02 + 4.5309410437038367e-01 6.3533901030900036e-02 + 4.3885828292419149e-01 6.3505752706049273e-02 + 4.2608237290122408e-01 6.3429209328489708e-02 + 4.1470831324405810e-01 6.3322037511710436e-02 + 4.0465439894791816e-01 6.3193790658772231e-02 + 3.9582360494922370e-01 6.3043679322802817e-02 + 3.8810977564154148e-01 6.2901104647423239e-02 + 3.8140470641463414e-01 6.2745438264059303e-02 + 3.7560067291908972e-01 6.2600988612089722e-02 + 8.7321662628205465e-01 3.1129908416448561e-02 + 8.7207948094577969e-01 3.1376438200463597e-02 + 8.7073549804645178e-01 3.1663808230329986e-02 + 8.6914828537943234e-01 3.1997507261652007e-02 + 8.6727580254581715e-01 3.2383634144529078e-02 + 8.6506998060249762e-01 3.2830110071069486e-02 + 8.6247504318450174e-01 3.3341357269324703e-02 + 8.5942822811208552e-01 3.3924438515601021e-02 + 8.5585819699272592e-01 3.4584406892672670e-02 + 8.5168540720569796e-01 3.5326360187521645e-02 + 8.4682211881372182e-01 3.6156173896326436e-02 + 8.4117256008884644e-01 3.7078273485707761e-02 + 8.3463454479596877e-01 3.8098653102178096e-02 + 8.2710256547295524e-01 3.9232837447837308e-02 + 8.1846815211053581e-01 4.0487886636416372e-02 + 8.0862492478684411e-01 4.1866042019545809e-02 + 7.9747263263365831e-01 4.3355190892565884e-02 + 7.8492566666144747e-01 4.4940248122255812e-02 + 7.7092218484093256e-01 4.6609824277379239e-02 + 7.5543046619452114e-01 4.8335648087818317e-02 + 7.3845964155442834e-01 5.0088358137682448e-02 + 7.2006735216527196e-01 5.1836516709845189e-02 + 7.0036473886529316e-01 5.3540176476386293e-02 + 6.7951921302598306e-01 5.5155866469801029e-02 + 6.5775410345208640e-01 5.6663905577102228e-02 + 6.3533900410256583e-01 5.8042315183849433e-02 + 6.1257766822639448e-01 5.9260827317856181e-02 + 5.8979381791145824e-01 6.0308923847953895e-02 + 5.6731222817730420e-01 6.1188531650030457e-02 + 5.4543992356984006e-01 6.1893277581332048e-02 + 5.2445059354583845e-01 6.2420723322303404e-02 + 5.0457295895375365e-01 6.2804572173461165e-02 + 4.8598162474528872e-01 6.3058576099264949e-02 + 4.6879526033299956e-01 6.3204560582895364e-02 + 4.5307826635558024e-01 6.3250614057010088e-02 + 4.3884635755346341e-01 6.3222629917901646e-02 + 4.2607396309921741e-01 6.3146924538919319e-02 + 4.1470302693594152e-01 6.3041214975811138e-02 + 4.0465185805673703e-01 6.2914927821082933e-02 + 3.9582345523562373e-01 6.2767059768752423e-02 + 3.8811168649200584e-01 6.2627103495365904e-02 + 3.8140838130460142e-01 6.2474072427065062e-02 + 3.7560584385292189e-01 6.2332370751093394e-02 + 8.7317973348011757e-01 3.1129139934597944e-02 + 8.7203817094706537e-01 3.1369590750712849e-02 + 8.7068962002197903e-01 3.1650101873202906e-02 + 8.6909779464834125e-01 3.1976162049408452e-02 + 8.6722076652124735e-01 3.2353907974533663e-02 + 8.6501057162764861e-01 3.2791342658880070e-02 + 8.6241153126567005e-01 3.3292951352960939e-02 + 8.5936094445648192e-01 3.3865908108643782e-02 + 8.5578753923907247e-01 3.4515341315226530e-02 + 8.5161180365366596e-01 3.5246439765969251e-02 + 8.4674602162045687e-01 3.6065168705518631e-02 + 8.4109443954116936e-01 3.6976030870575514e-02 + 8.3455488745452389e-01 3.7985112110802334e-02 + 8.2702188203198501e-01 3.9108104073156895e-02 + 8.1838696789827270e-01 4.0352186621851707e-02 + 8.0854370028185540e-01 4.1719432687862081e-02 + 7.9739180373571539e-01 4.3197603374920013e-02 + 7.8484572966270272e-01 4.4771830900379589e-02 + 7.7084369356940208e-01 4.6431045555677675e-02 + 7.5535400597924540e-01 4.8147241167924161e-02 + 7.3838581064174513e-01 4.9891360365079865e-02 + 7.1999673654036522e-01 5.1632274017520560e-02 + 7.0029788260714221e-01 5.3330265792751470e-02 + 6.7945658045920920e-01 5.4941899280890424e-02 + 6.5769602188624687e-01 5.6446927928370486e-02 + 6.3528568469693558e-01 5.7822820308235524e-02 + 6.1252922822566191e-01 5.9038936626692608e-02 + 5.8975029735931117e-01 6.0084635597519052e-02 + 5.6727359641284292e-01 6.0961862464338525e-02 + 5.4540608123550782e-01 6.1664227052737559e-02 + 5.2442138047336528e-01 6.2189328161025223e-02 + 5.0454816972988881e-01 6.2571230653474891e-02 + 4.8596100983267426e-01 6.2823832182288916e-02 + 4.6877853268503211e-01 6.2968936971159559e-02 + 4.5306511440879860e-01 6.3014585365706158e-02 + 4.3883645648190595e-01 6.2986725182561251e-02 + 4.2606698362160628e-01 6.2911708100401018e-02 + 4.1469864370422949e-01 6.2807209472900555e-02 + 4.0464975717033147e-01 6.2682549855438127e-02 + 3.9582334246273548e-01 6.2536547392639322e-02 + 3.8811328712023646e-01 6.2398770652620748e-02 + 3.8141144888429196e-01 6.2247934309596055e-02 + 3.7561015558902777e-01 6.2108522049712171e-02 + 8.7314916220321237e-01 3.1128501026301977e-02 + 8.7200393925834607e-01 3.1363911887630991e-02 + 8.7065160280240217e-01 3.1638736128584699e-02 + 8.6905595470152752e-01 3.1958462337228224e-02 + 8.6717515949889323e-01 3.2329258387231781e-02 + 8.6496134009144288e-01 3.2759194875267253e-02 + 8.6235889866585569e-01 3.3252809027970787e-02 + 8.5930518491481200e-01 3.3817366825140055e-02 + 8.5572898188603330e-01 3.4458058740270345e-02 + 8.5155080298475538e-01 3.5180148624576239e-02 + 8.4668295186081288e-01 3.5989675707014661e-02 + 8.4102968990370630e-01 3.6891206340833142e-02 + 8.3448886061118566e-01 3.7890901944038595e-02 + 8.2695500064501093e-01 3.9004592126318065e-02 + 8.1831966676688161e-01 4.0239555640752704e-02 + 8.0847636045238147e-01 4.1597725402965628e-02 + 7.9732478590555056e-01 4.3066757527775272e-02 + 7.8477944468998917e-01 4.4631964268887762e-02 + 7.7077860017439082e-01 4.6282541134850468e-02 + 7.5529058922331427e-01 4.7990702203591737e-02 + 7.3832456658231160e-01 4.9727643074803082e-02 + 7.1993815140038098e-01 5.1462491823272713e-02 + 7.0024240821109784e-01 5.3155725368100121e-02 + 6.7940460281799364e-01 5.4763937784869744e-02 + 6.5764781359975144e-01 5.6266414691550644e-02 + 6.3524142220006952e-01 5.7640166881289194e-02 + 6.1248901017631774e-01 5.8854246665313560e-02 + 5.8971415844413888e-01 5.9897911120813968e-02 + 5.6724151266414191e-01 6.0773121224009734e-02 + 5.4537797161668911e-01 6.1473472864364026e-02 + 5.2439711335723960e-01 6.1996595719016084e-02 + 5.0452757578000362e-01 6.2376855368981431e-02 + 4.8594388288253970e-01 6.2628270588739099e-02 + 4.6876463520069461e-01 6.2772627706053061e-02 + 4.5305418827639365e-01 6.2817926736897303e-02 + 4.3882823236584689e-01 6.2790160468253350e-02 + 4.2606118829849365e-01 6.2715709648436743e-02 + 4.1469500705793116e-01 6.2612214584831349e-02 + 4.0464801846551357e-01 6.2488907204915740e-02 + 3.9582325721195977e-01 6.2344456618987472e-02 + 3.8811462697923321e-01 6.2208494356582378e-02 + 3.8141400895538013e-01 6.2059485951614590e-02 + 3.7561375059948943e-01 6.1921981127078141e-02 + 8.7312381112634163e-01 3.1127969683247589e-02 + 8.7197555273432559e-01 3.1359199289213380e-02 + 8.7062007697908672e-01 3.1629305356560604e-02 + 8.6902125860930068e-01 3.1943776230306198e-02 + 8.6713733913352409e-01 3.2308805506328711e-02 + 8.6492051348903665e-01 3.2732519672399867e-02 + 8.6231525090978511e-01 3.3219498876008377e-02 + 8.5925894307623885e-01 3.3777085123454356e-02 + 8.5568041862300670e-01 3.4410520139232986e-02 + 8.5150021195842052e-01 3.5125129758058059e-02 + 8.4663064306394076e-01 3.5927014279238847e-02 + 8.4097598573184718e-01 3.6820792508749492e-02 + 8.3443409460156936e-01 3.7812688222402913e-02 + 8.2689952290583246e-01 3.8918645161147063e-02 + 8.1826383747849951e-01 4.0146023831710495e-02 + 8.0842049520991177e-01 4.1496640712808203e-02 + 7.9726918344316522e-01 4.2958064552131761e-02 + 7.8472444542218289e-01 4.4515756845520615e-02 + 7.7072458433965296e-01 4.6159133234141822e-02 + 7.5523795907637958e-01 4.7860590858022543e-02 + 7.3827373370883276e-01 4.9591535838445562e-02 + 7.1988951946792135e-01 5.1321310622384854e-02 + 7.0019635260062840e-01 5.3010553718181481e-02 + 6.7936144453493730e-01 5.4615885827260964e-02 + 6.5760777969624185e-01 5.6116205150432641e-02 + 6.3520466004441090e-01 5.7488143094223038e-02 + 6.1245560267376953e-01 5.8700496806282892e-02 + 5.8968413545322040e-01 5.9742439384927064e-02 + 5.6721485535724714e-01 6.0615945225265741e-02 + 5.4535461373788918e-01 6.1314598789131702e-02 + 5.2437694655319389e-01 6.1836055447990840e-02 + 5.0451046026950508e-01 6.2214930955967584e-02 + 4.8592964814924416e-01 6.2465344816800571e-02 + 4.6875308450911723e-01 6.2609068315069308e-02 + 4.5304510763331668e-01 6.2654067672773955e-02 + 4.3882139830383188e-01 6.2626372877168962e-02 + 4.2605637398360047e-01 6.2552388646921087e-02 + 4.1469198812226488e-01 6.2449725871189854e-02 + 4.0464657824363298e-01 6.2327542429912383e-02 + 3.9582319247508524e-01 6.2184383062188466e-02 + 3.8811574786206804e-01 6.2049931561730907e-02 + 3.8141614505509641e-01 6.1902445714999046e-02 + 3.7561674780440552e-01 6.1766530122156389e-02 + 8.7310277507595735e-01 3.1127527674161531e-02 + 8.7195199785270339e-01 3.1355286348141283e-02 + 8.7059391702013034e-01 3.1621475623960955e-02 + 8.6899246778469286e-01 3.1931583565014070e-02 + 8.6710595549940062e-01 3.2291825015441006e-02 + 8.6488663485866091e-01 3.2710372729129814e-02 + 8.6227903071045109e-01 3.3191842338783917e-02 + 8.5922056955372461e-01 3.3743638789037092e-02 + 8.5564011782971927e-01 3.4371046164448416e-02 + 8.5145822735271204e-01 3.5079441546560702e-02 + 8.4658723163491512e-01 3.5874975707390115e-02 + 8.4093141474177691e-01 3.6762310760241841e-02 + 8.3438864054406303e-01 3.7747722003242348e-02 + 8.2685347602077908e-01 3.8847247684106426e-02 + 8.1821749636898256e-01 4.0068315968088526e-02 + 8.0837412147476639e-01 4.1412646477300905e-02 + 7.9722302469974204e-01 4.2867735242491559e-02 + 7.8467878393508306e-01 4.4419167561261665e-02 + 7.7067973551611801e-01 4.6056541884925736e-02 + 7.5519425671751361e-01 4.7752407560000140e-02 + 7.3823151951200838e-01 4.9478345935358298e-02 + 7.1984912873142015e-01 5.1203878126574127e-02 + 7.0015809732269274e-01 5.2889777692487455e-02 + 6.7932559173827334e-01 5.4492688400531585e-02 + 6.5757451850866699e-01 5.5991187357900138e-02 + 6.3517411351672848e-01 5.7361591322652387e-02 + 6.1242784038987008e-01 5.8572485823840850e-02 + 5.8965918298018682e-01 5.9612974493527204e-02 + 5.6719269782889092e-01 6.0485043131132031e-02 + 5.4533519685717080e-01 6.1182266808971389e-02 + 5.2436018098609027e-01 6.1702322283097716e-02 + 5.0449623048953385e-01 6.2080033480008998e-02 + 4.8591781298600178e-01 6.2329603696952902e-02 + 4.6874348088592621e-01 6.2472791588839192e-02 + 4.5303755801442380e-01 6.2517535082349973e-02 + 4.3881571717000351e-01 6.2489894967363985e-02 + 4.2605237291927428e-01 6.2416295755000253e-02 + 4.1468948067809247e-01 6.2314323665959008e-02 + 4.0464538430654501e-01 6.2193074736861122e-02 + 3.9582314305489091e-01 6.2050989937553612e-02 + 3.8811668504080787e-01 6.1917796468876095e-02 + 3.8141792707861349e-01 6.1771578900575802e-02 + 3.7561924644918809e-01 6.1636987453397338e-02 + 8.7308530925953665e-01 3.1127159888512442e-02 + 8.7193244066463360e-01 3.1352035731912364e-02 + 8.7057219680135300e-01 3.1614971751493290e-02 + 8.6896856305890469e-01 3.1921455719346604e-02 + 8.6707989778445127e-01 3.2277720052961603e-02 + 8.6485850527240404e-01 3.2691975839864870e-02 + 8.6224895653073719e-01 3.3168868082120030e-02 + 8.5918870695134564e-01 3.3715853874851029e-02 + 8.5560665435058991e-01 3.4338252353007991e-02 + 8.5142336497863780e-01 3.5041483013641260e-02 + 8.4655118356688697e-01 3.5831738389559172e-02 + 8.4089440269708837e-01 3.6713716395295547e-02 + 8.3435089389460626e-01 3.7693734947777793e-02 + 8.2681523554880310e-01 3.8787910619970986e-02 + 8.1817900980432423e-01 4.0003727623163156e-02 + 8.0833560581777397e-01 4.1342824990420024e-02 + 7.9718468534914289e-01 4.2792638218476217e-02 + 7.8464085510042114e-01 4.4338855368142409e-02 + 7.7064247899443428e-01 4.5971226779368116e-02 + 7.5515794966763383e-01 4.7662428390732758e-02 + 7.3819644575909149e-01 4.9384187425995263e-02 + 7.1981556691045845e-01 5.1106173909241735e-02 + 7.0012630684677801e-01 5.2789274222165297e-02 + 6.7929579478180546e-01 5.4390151981317157e-02 + 6.5754687261934874e-01 5.5887117969754839e-02 + 6.3514872141119327e-01 5.7256227815738969e-02 + 6.1240476040941050e-01 5.8465891426813604e-02 + 5.8963843692039586e-01 5.9505154915888349e-02 + 5.6717427388987773e-01 6.0376013744180473e-02 + 5.4531905044627527e-01 6.1072035254942425e-02 + 5.2434623834493332e-01 6.1590914005183808e-02 + 5.0448439603068418e-01 6.1967647180463041e-02 + 4.8590796972984596e-01 6.2216507799998211e-02 + 4.6873549355683708e-01 6.2359243927320666e-02 + 4.5303127923198244e-01 6.2403769814098557e-02 + 4.3881099283796837e-01 6.2376171777715976e-02 + 4.2604904646254060e-01 6.2302890692409130e-02 + 4.1468739709684277e-01 6.2201492112302241e-02 + 4.0464439382202283e-01 6.2081020439742403e-02 + 3.9582310510442725e-01 6.1939830079929648e-02 + 3.8811746824277721e-01 6.1807684301598907e-02 + 3.8141941348198383e-01 6.1662523260182241e-02 + 3.7562132934602271e-01 6.1529035114631508e-02 + 8.7307080010642879e-01 3.1126853795516191e-02 + 8.7191619414768740e-01 3.1349334119138234e-02 + 8.7055415335582054e-01 3.1609566730619230e-02 + 8.6894870479793829e-01 3.1913039118942825e-02 + 8.6705825083376231e-01 3.2265998251005394e-02 + 8.6483513695040282e-01 3.2676687001621040e-02 + 8.6222397249092220e-01 3.3149774703698245e-02 + 8.5916223683758230e-01 3.3692761698976142e-02 + 8.5557885385979493e-01 3.4310996153632048e-02 + 8.5139440178851578e-01 3.5009932704287580e-02 + 8.4652123466447449e-01 3.5795798471330083e-02 + 8.4086365213432701e-01 3.6673320998527568e-02 + 8.3431953207527765e-01 3.7648853493312179e-02 + 8.2678346235324007e-01 3.8738577493343945e-02 + 8.1814703088722007e-01 3.9950023676123124e-02 + 8.0830360130223067e-01 4.1284764005769477e-02 + 7.9715282572544210e-01 4.2730183579155569e-02 + 7.8460933482393025e-01 4.4272055805027022e-02 + 7.7061151548784801e-01 4.5900257274861703e-02 + 7.5512777317888680e-01 4.7587569245048603e-02 + 7.3816729215273824e-01 4.9305840396402623e-02 + 7.1978766782731751e-01 5.1024864856219355e-02 + 7.0009987804771989e-01 5.2705623224968697e-02 + 6.7927102116708160e-01 5.4304796106708381e-02 + 6.5752388543693174e-01 5.5800473239525118e-02 + 6.3512760638225196e-01 5.7168493410059362e-02 + 6.1238556640402952e-01 5.8377120692358730e-02 + 5.8962118244994732e-01 5.9415353528942540e-02 + 5.6715894953989798e-01 6.0285195545448318e-02 + 5.4530561952222689e-01 6.0980207712235168e-02 + 5.2433463986988615e-01 6.1498099406443588e-02 + 5.0447455083561854e-01 6.1874012040989169e-02 + 4.8589978080304047e-01 6.2122276661669085e-02 + 4.6872884861075426e-01 6.2264632458280948e-02 + 4.5302605585245109e-01 6.2308973885244638e-02 + 4.3880706296926431e-01 6.2281408432398148e-02 + 4.2604627993705729e-01 6.2208390516972085e-02 + 4.1468566501449672e-01 6.2107468392902702e-02 + 4.0464357159169617e-01 6.1987643364404016e-02 + 3.9582307577732273e-01 6.1847197635060712e-02 + 3.8811812248845146e-01 6.1715924455711633e-02 + 3.8142065313404100e-01 6.1571643588763519e-02 + 3.7562306558437558e-01 6.1439074752314617e-02 + 8.7305874152581309e-01 3.1126598997993402e-02 + 8.7190269162294287e-01 3.1347087901544557e-02 + 8.7053915735689613e-01 3.1605073086005943e-02 + 8.6893220042616681e-01 3.1906041775925389e-02 + 8.6704025976199040e-01 3.2256252995391817e-02 + 8.6481571507897437e-01 3.2663975996931834e-02 + 8.6220320757295932e-01 3.3133900287446144e-02 + 8.5914023655630556e-01 3.3673562097334797e-02 + 8.5555574754373087e-01 3.4288333659475770e-02 + 8.5137032871523166e-01 3.4983698747254779e-02 + 8.4649634184077871e-01 3.5765913152879643e-02 + 8.4083809243213914e-01 3.6639728965810081e-02 + 8.3429346364034329e-01 3.7611528642763896e-02 + 8.2675705120580900e-01 3.8697547641497951e-02 + 8.1812044784855886e-01 3.9905355192090521e-02 + 8.0827699597140668e-01 4.1236467430664912e-02 + 7.9712633969919133e-01 4.2678227486299139e-02 + 7.8458312963875776e-01 4.4216479686781884e-02 + 7.7058577180370669e-01 4.5841205604773880e-02 + 7.5510268236056721e-01 4.7525274137172308e-02 + 7.3814305028881155e-01 4.9240635104283510e-02 + 7.1976446755840373e-01 5.0957186061780055e-02 + 7.0007789887941685e-01 5.2635986267432960e-02 + 6.7925041700927680e-01 5.4233730797748091e-02 + 6.5750476563314975e-01 5.5728325818977069e-02 + 6.3511004245472957e-01 5.7095429959521812e-02 + 6.1236959925668011e-01 5.8303186132073422e-02 + 5.8960682775574480e-01 5.9340553240133834e-02 + 5.6714619975025649e-01 6.0209541792815693e-02 + 5.4529444438855368e-01 6.0903707497864640e-02 + 5.2432498892422774e-01 6.1420772072750825e-02 + 5.0446635844895804e-01 6.1795997009824223e-02 + 4.8589296646624613e-01 6.2043761657101140e-02 + 4.6872331906425352e-01 6.2185797775924874e-02 + 4.5302170936982999e-01 6.2229983274860873e-02 + 4.3880379309106299e-01 6.2202443216179432e-02 + 4.2604397841108099e-01 6.2129643237014476e-02 + 4.1468422461286203e-01 6.2029117119415438e-02 + 4.0464288864762477e-01 6.1909830202942870e-02 + 3.9582305296572967e-01 6.1770004477544688e-02 + 3.8811866880981605e-01 6.1639458126471446e-02 + 3.8142168687260197e-01 6.1495910550817726e-02 + 3.7562451279652281e-01 6.1364107728046242e-02 + 8.7304871557798713e-01 3.1126386864428968e-02 + 8.7189146511393023e-01 3.1345219674136671e-02 + 8.7052668908734021e-01 3.1601335825904103e-02 + 8.6891847798550792e-01 3.1900222303689274e-02 + 8.6702530114125587e-01 3.2248148131674301e-02 + 8.6479956672182379e-01 3.2653404464979330e-02 + 8.6218594240107205e-01 3.3120697550430039e-02 + 8.5912194405624365e-01 3.3657593419377525e-02 + 8.5553653519323314e-01 3.4269484271433802e-02 + 8.5135031225844826e-01 3.4961878057345151e-02 + 8.4647564344279314e-01 3.5741054355668288e-02 + 8.4081683912964367e-01 3.6611785608030877e-02 + 8.3427178685133607e-01 3.7580478532831384e-02 + 8.2673508889437652e-01 3.8663413368027554e-02 + 8.1809834197195230e-01 3.9868191351182324e-02 + 8.0825487083989478e-01 4.1196282139495187e-02 + 7.9710431297205731e-01 4.2634993911512778e-02 + 7.8456133556978314e-01 4.4170229949962517e-02 + 7.7056436057172595e-01 4.5792059150542810e-02 + 7.5508181307703159e-01 4.7473423356017078e-02 + 7.3812288603233833e-01 4.9186356616893141e-02 + 7.1974516858498627e-01 5.0900842685635501e-02 + 7.0005961456855770e-01 5.2578006467563013e-02 + 6.7923327549650114e-01 5.4174555323150936e-02 + 6.5748885801718437e-01 5.5668242888473954e-02 + 6.3509542839945732e-01 5.7034578043688201e-02 + 6.1235631297500348e-01 5.8241602992759836e-02 + 5.8959488248285818e-01 5.9278243821396112e-02 + 5.6713558940525710e-01 6.0146516831395103e-02 + 5.4528514399745587e-01 6.0839973378968216e-02 + 5.2431695667484590e-01 6.1356345458150975e-02 + 5.0445953989433490e-01 6.1730994550060841e-02 + 4.8588729475125936e-01 6.1978340216676052e-02 + 4.6871871669392923e-01 6.2120108005302634e-02 + 4.5301809177376595e-01 6.2164162002311105e-02 + 4.3880107173219529e-01 6.2136641863240506e-02 + 4.2604206323509541e-01 6.2064022528694814e-02 + 4.1468302639663013e-01 6.1963825681758074e-02 + 4.0464232111446830e-01 6.1844986656524277e-02 + 3.9582303510495181e-01 6.1705677232858143e-02 + 3.8811912486568811e-01 6.1575736333566063e-02 + 3.8142254881177956e-01 6.1432799701577778e-02 + 3.7562571905094622e-01 6.1301635169058954e-02 + 8.7304405726513712e-01 3.1126242249669651e-02 + 8.7188624690219496e-01 3.1344248513761393e-02 + 8.7052088889122436e-01 3.1599425423990940e-02 + 8.6891208628523808e-01 3.1897256514126837e-02 + 8.6701832168859694e-01 3.2244011474087106e-02 + 8.6479201560683860e-01 3.2647986999896517e-02 + 8.6217784713634482e-01 3.3113891685097346e-02 + 8.5911333891560615e-01 3.3649299294332038e-02 + 8.5552746193687346e-01 3.4259604299968799e-02 + 8.5134081556444108e-01 3.4950318141277165e-02 + 8.4646577009752133e-01 3.5727723010033713e-02 + 8.4080663740868800e-01 3.6596591754069180e-02 + 8.3426130648763608e-01 3.7563333137725891e-02 + 8.2672438248762758e-01 3.8644239970125255e-02 + 8.1808746420317136e-01 3.9846920865556995e-02 + 8.0824386786137647e-01 4.1172813965722838e-02 + 7.9709322824439677e-01 4.2609202021481024e-02 + 7.8455022281351405e-01 4.4142014141783675e-02 + 7.7055328495173891e-01 4.5761365887045741e-02 + 7.5507084911044431e-01 4.7440245628571659e-02 + 7.3811211647031505e-01 4.9150748985511000e-02 + 7.1973468199550661e-01 5.0862932431698510e-02 + 7.0004950162661628e-01 5.2537991557855469e-02 + 6.7922362302384076e-01 5.4132679894998315e-02 + 6.5747973840200891e-01 5.5624696066048571e-02 + 6.3508690124682365e-01 5.6989486138850590e-02 + 6.1234842706195081e-01 5.8195050241658712e-02 + 5.8958767687508318e-01 5.9230308313822103e-02 + 5.6712909277679702e-01 6.0097290556029782e-02 + 5.4527937311092334e-01 6.0789550177105425e-02 + 5.2431191610226358e-01 6.1304826597606180e-02 + 5.0445522359515882e-01 6.1678551963552777e-02 + 4.8588368508785057e-01 6.1925173225702686e-02 + 4.6871578484133808e-01 6.2066406935457487e-02 + 4.5301579984517876e-01 6.2110100206424941e-02 + 4.3879937492753013e-01 6.2082396735107161e-02 + 4.2604091176317660e-01 6.2009771712212114e-02 + 4.1468236752457827e-01 6.1909730482767607e-02 + 4.0464210117798194e-01 6.1791177807648985e-02 + 3.9582320177676483e-01 6.1652238526562542e-02 + 3.8811962756531848e-01 6.1522762814163912e-02 + 3.8142334113066845e-01 6.1380312992412200e-02 + 3.7562675810015894e-01 6.1249670548335189e-02 + 8.7304029365784452e-01 3.1126122764291612e-02 + 8.7188203081372706e-01 3.1343457954505993e-02 + 8.7051620230877658e-01 3.1597871949358446e-02 + 8.6890692130177016e-01 3.1894845303482348e-02 + 8.6701268107053597e-01 3.2240648015718382e-02 + 8.6478591203845245e-01 3.2643580992426528e-02 + 8.6217130247993201e-01 3.3108354411154860e-02 + 8.5910638044240095e-01 3.3642547933148137e-02 + 8.5552012291635549e-01 3.4251557464621399e-02 + 8.5133313157060742e-01 3.4940896818262977e-02 + 8.4645777835741109e-01 3.5716849812217809e-02 + 8.4079837630791587e-01 3.6584189102541152e-02 + 8.3425281555616737e-01 3.7549324576389174e-02 + 8.2671570356146507e-01 3.8628558726280481e-02 + 8.1807864081282067e-01 3.9829505695806254e-02 + 8.0823493662775536e-01 4.1153577594215583e-02 + 7.9708422363672915e-01 4.2588036100475811e-02 + 7.8454118773670101e-01 4.4118831099432064e-02 + 7.7054427178940654e-01 4.5736116203542586e-02 + 7.5506191810121925e-01 4.7412918102182310e-02 + 7.3810333487251711e-01 4.9121383446888010e-02 + 7.1972612217671250e-01 5.0831629343022676e-02 + 7.0004123806823915e-01 5.2504910799370946e-02 + 6.7921572743977221e-01 5.4098020974741867e-02 + 6.5747227100449301e-01 5.5588614956279300e-02 + 6.3507991202470204e-01 5.6952088452367003e-02 + 6.1234195731318930e-01 5.8156407867842361e-02 + 5.8958176005362550e-01 5.9190488699201356e-02 + 5.6712375385935709e-01 6.0056373020543702e-02 + 5.4527462727067944e-01 6.0747615760121235e-02 + 5.2430776841224935e-01 6.1261962490966944e-02 + 5.0445167028169591e-01 6.1634903842723084e-02 + 4.8588071267251176e-01 6.1880909394602675e-02 + 4.6871337044830658e-01 6.2021688078786476e-02 + 4.5301391294549564e-01 6.2065072689946904e-02 + 4.3879797911542290e-01 6.2037210031832025e-02 + 4.2603996635397712e-01 6.1964575263303345e-02 + 4.1468182926589464e-01 6.1864659913567266e-02 + 4.0464192593258341e-01 6.1746343086568345e-02 + 3.9582334642388761e-01 6.1607710340766175e-02 + 3.8812005035553199e-01 6.1478621034417813e-02 + 3.8142400371872398e-01 6.1336576184828573e-02 + 3.7562762501413616e-01 6.1206368512443987e-02 + 8.7303723863730520e-01 3.1126023899069821e-02 + 8.7187860841699272e-01 3.1342812035603622e-02 + 8.7051239779450817e-01 3.1596603866276343e-02 + 8.6890272809869085e-01 3.1892877391256277e-02 + 8.6700810123651251e-01 3.2237902698244572e-02 + 8.6478095564604629e-01 3.2639983922229263e-02 + 8.6216598701593383e-01 3.3103832305471162e-02 + 8.5910072774600243e-01 3.3637032046414106e-02 + 8.5551415966022970e-01 3.4244979930065270e-02 + 8.5132688626036468e-01 3.4933191380147846e-02 + 8.4645128080487375e-01 3.5707951191255929e-02 + 8.4079165723383964e-01 3.6574031495106865e-02 + 8.3424590658656772e-01 3.7537842714499461e-02 + 8.2670863818715590e-01 3.8615694866862796e-02 + 8.1807145390926428e-01 3.9815206278667872e-02 + 8.0822765744831604e-01 4.1137767523956384e-02 + 7.9707687970431529e-01 4.2570622802720962e-02 + 7.8453381352565943e-01 4.4099738800397872e-02 + 7.7053690963290000e-01 4.5715300265484884e-02 + 7.5505461692043496e-01 4.7390365505826551e-02 + 7.3809614954703318e-01 4.9097123511060672e-02 + 7.1971911202373795e-01 5.0805741933572804e-02 + 7.0003446441256445e-01 5.2477525650154205e-02 + 6.7920924960485907e-01 5.4069301634818767e-02 + 6.5746613909049667e-01 5.5558690281246249e-02 + 6.3507416790760063e-01 5.6921046695362146e-02 + 6.1233663585490250e-01 5.8124310099843299e-02 + 5.8957688975032740e-01 5.9157392755622769e-02 + 5.6711935626845966e-01 6.0022346831168277e-02 + 5.4527071586410858e-01 6.0712728808297818e-02 + 5.2430434828550587e-01 6.1226289362203097e-02 + 5.0444873915612609e-01 6.1598567581228288e-02 + 4.8587826015423968e-01 6.1844051767209869e-02 + 4.6871137826107884e-01 6.1984444418925463e-02 + 4.5301235636556569e-01 6.2027566278189221e-02 + 4.3879682844219664e-01 6.1999566559322247e-02 + 4.2603918823898396e-01 6.1926920229538496e-02 + 4.1468138814078637e-01 6.1827107166770645e-02 + 4.0464178541702478e-01 6.1708984971168945e-02 + 3.9582347091747777e-01 6.1570606353839707e-02 + 3.8812040534274095e-01 6.1441838193353249e-02 + 3.8142455747097648e-01 6.1300130337080816e-02 + 3.7562834815620982e-01 6.1170284766461691e-02 + 8.7303474860950314e-01 3.1125941995959749e-02 + 8.7187581889520738e-01 3.1342282611973353e-02 + 8.7050929667921284e-01 3.1595565307512022e-02 + 8.6889930992607456e-01 3.1891265904980301e-02 + 8.6700436755160804e-01 3.2235654450150204e-02 + 8.6477691450105054e-01 3.2637037576476999e-02 + 8.6216165248080101e-01 3.3100127238185298e-02 + 8.5909611741127678e-01 3.3632511156227445e-02 + 8.5550929503106954e-01 3.4239586630974386e-02 + 8.5132179030931321e-01 3.4926870176903449e-02 + 8.4644597754403328e-01 3.5700647142107314e-02 + 8.4078617139388467e-01 3.6565688971293767e-02 + 8.3424026361940906e-01 3.7528406258942951e-02 + 8.2670286505962398e-01 3.8605114919320740e-02 + 8.1806557872326058e-01 3.9803436473206957e-02 + 8.0822170371388746e-01 4.1124743657270826e-02 + 7.9707086953252171e-01 4.2556266161355452e-02 + 7.8452777476657154e-01 4.4083984319442507e-02 + 7.7053087665816289e-01 4.5698108432667098e-02 + 7.5504862962060704e-01 4.7371722942600072e-02 + 7.3809025285255236e-01 4.9077051990934720e-02 + 7.1971335468670361e-01 5.0784305366740071e-02 + 7.0002889702680260e-01 5.2454829745777004e-02 + 6.7920392130577822e-01 5.4045480824918168e-02 + 6.5746109157565069e-01 5.5533851175881700e-02 + 6.3506943622355783e-01 5.6895263005107291e-02 + 6.1233224936008790e-01 5.8097633515573711e-02 + 5.8957287261576363e-01 5.9129872592294137e-02 + 5.6711572696887602e-01 5.9994040953071731e-02 + 5.4526748619423726e-01 6.0683696457047638e-02 + 5.2430152308746114e-01 6.1196594014141688e-02 + 5.0444631712542265e-01 6.1568312904427110e-02 + 4.8587623320475903e-01 6.1813356939637742e-02 + 4.6870973170276914e-01 6.1953423199568640e-02 + 4.5301107008755931e-01 6.1996322299329117e-02 + 4.3879587813163251e-01 6.1968205339454116e-02 + 4.2603854648675427e-01 6.1895547013996577e-02 + 4.1468102563287496e-01 6.1795817396784969e-02 + 4.0464167211162083e-01 6.1677856083711902e-02 + 3.9582357737658974e-01 6.1539688335457754e-02 + 3.8812070299256773e-01 6.1411187206516615e-02 + 3.8142502002613349e-01 6.1269759845885119e-02 + 3.7562895126418061e-01 6.1140215883739302e-02 + 8.7303271190201526e-01 3.1125874076060725e-02 + 8.7187353717584348e-01 3.1341847494772430e-02 + 8.7050675999184846e-01 3.1594712318465529e-02 + 8.6889651372606413e-01 3.1889942521032104e-02 + 8.6700131300984773e-01 3.2233808033711807e-02 + 8.6477360809323522e-01 3.2634617440236262e-02 + 8.6215810558707529e-01 3.3097083167760250e-02 + 8.5909234427265091e-01 3.3628795695264564e-02 + 8.5550531307276567e-01 3.4235152603614004e-02 + 8.5131761813837070e-01 3.4921671143408183e-02 + 8.4644163460005595e-01 3.5694636945585521e-02 + 8.4078167768862655e-01 3.6558820710581606e-02 + 8.3423563974302717e-01 3.7520632987408951e-02 + 8.2669813283773175e-01 3.8596394347791850e-02 + 8.1806076091450608e-01 3.9793728774299118e-02 + 8.0821681931434675e-01 4.1113994213759518e-02 + 7.9706593640206291e-01 4.2544408302433133e-02 + 7.8452281551059322e-01 4.4070962506502574e-02 + 7.7052591929783421e-01 4.5683888150513517e-02 + 7.5504370679604449e-01 4.7356291306513774e-02 + 7.3808540145499979e-01 4.9060425320533362e-02 + 7.1970861487678239e-01 5.0766535105317721e-02 + 7.0002431061588855e-01 5.2436002335362310e-02 + 6.7919952903357084e-01 5.4025707016357845e-02 + 6.5745692815397461e-01 5.5513219282418688e-02 + 6.3506553096084417e-01 5.6873834566421609e-02 + 6.1232862693223533e-01 5.8075452155415305e-02 + 5.8956955345634710e-01 5.9106980174292008e-02 + 5.6711272682377112e-01 5.9970486559521446e-02 + 5.4526481528230630e-01 6.0659530374941553e-02 + 5.2429918585276514e-01 6.1171870047580519e-02 + 5.0444431288896696e-01 6.1543118219788091e-02 + 4.8587455562293902e-01 6.1787791564967172e-02 + 4.6870836890467515e-01 6.1927582607303570e-02 + 4.5301000565196609e-01 6.1970293466387681e-02 + 4.3879509209827200e-01 6.1942076730375099e-02 + 4.2603801627636889e-01 6.1869406787820935e-02 + 4.1468072704111775e-01 6.1769745477562310e-02 + 4.0464158029248926e-01 6.1651917333769291e-02 + 3.9582366795554758e-01 6.1513924688703980e-02 + 3.8812095228807830e-01 6.1385645681006906e-02 + 3.8142540624012411e-01 6.1244451838646796e-02 + 3.7562945418993859e-01 6.1115159118628526e-02 + 8.7303104424813893e-01 3.1125817733098554e-02 + 8.7187166887648648e-01 3.1341489585564521e-02 + 8.7050468284893212e-01 3.1594011132540352e-02 + 8.6889422395957927e-01 3.1888854781398773e-02 + 8.6699881150642377e-01 3.2232290306534232e-02 + 8.6477090006902324e-01 3.2632627815003840e-02 + 8.6215520026035830e-01 3.3094580035154308e-02 + 8.5908925318949969e-01 3.3625739607231399e-02 + 8.5550205037289540e-01 3.4231504230838698e-02 + 8.5131419891466120e-01 3.4917391636483490e-02 + 8.4643807461354592e-01 3.5689687552846454e-02 + 8.4077799315688551e-01 3.6553161927422355e-02 + 8.3423184734818456e-01 3.7514225125832627e-02 + 8.2669425027123589e-01 3.8589201402757720e-02 + 8.1805680663555380e-01 3.9785716637538979e-02 + 8.0821280869652490e-01 4.1105116509868513e-02 + 7.9706188389516763e-01 4.2534608640892348e-02 + 7.8451873949073025e-01 4.4060193586958146e-02 + 7.7052184263987544e-01 4.5672119983137943e-02 + 7.5503965623938996e-01 4.7343511812997140e-02 + 7.3808140732120808e-01 4.9046646690740783e-02 + 7.1970471027723026e-01 5.0751798806345623e-02 + 7.0002053012684318e-01 5.2420379128520392e-02 + 6.7919590644867922e-01 5.4009288208512182e-02 + 6.5745349237455541e-01 5.5496078060025281e-02 + 6.3506230649208106e-01 5.6856022300817870e-02 + 6.1232563450108624e-01 5.8057005623191882e-02 + 5.8956681031575597e-01 5.9087934855228022e-02 + 5.6711024636505980e-01 5.9950884021532230e-02 + 5.4526260632058876e-01 6.0639413233914814e-02 + 5.2429725240478209e-01 6.1151283841240966e-02 + 5.0444265470083438e-01 6.1522136186631875e-02 + 4.8587316770960270e-01 6.1766497612630686e-02 + 4.6870724165598787e-01 6.1906056816532412e-02 + 4.5300912564026879e-01 6.1948608794409665e-02 + 4.3879444291756636e-01 6.1920307309065961e-02 + 4.2603757930850966e-01 6.1847626434342849e-02 + 4.1468048228462534e-01 6.1748021096285313e-02 + 4.0464150718425690e-01 6.1630303232981035e-02 + 3.9582374630133255e-01 6.1492456028410920e-02 + 3.8812116245022021e-01 6.1364361809673092e-02 + 3.8142573013273107e-01 6.1223362390556708e-02 + 3.7562987503868822e-01 6.1094278963942372e-02 + 8.7302967514895369e-01 3.1125770959506496e-02 + 8.7187013502932809e-01 3.1341194592735384e-02 + 8.7050297749027183e-01 3.1593433522652564e-02 + 8.6889234394402926e-01 3.1887958833081591e-02 + 8.6699675750998006e-01 3.2231040124895256e-02 + 8.6476867631244470e-01 3.2630988703715488e-02 + 8.6215281423997747e-01 3.3092517484079605e-02 + 8.5908671430225114e-01 3.3623220811948060e-02 + 8.5549937013522048e-01 3.4228496405561956e-02 + 8.5131138961521169e-01 3.4913862302411482e-02 + 8.4643514907960071e-01 3.5685604216710652e-02 + 8.4077496458181622e-01 3.6548491376053663e-02 + 8.3422872930035186e-01 3.7508933891794209e-02 + 8.2669105714553226e-01 3.8583258949658396e-02 + 8.1805355345981601e-01 3.9779093902084742e-02 + 8.0820950796161106e-01 4.1097774246190585e-02 + 7.9705854733805703e-01 4.2526499277749555e-02 + 7.8451538210044280e-01 4.4051276998218744e-02 + 7.7051848314423577e-01 4.5662370322802799e-02 + 7.5503631659740156e-01 4.7332918081751024e-02 + 7.3807811250450472e-01 4.9035218064944694e-02 + 7.1970148762791564e-01 5.0739568865453444e-02 + 7.0001740827013303e-01 5.2407405953062723e-02 + 6.7919291343483290e-01 5.3995647201291248e-02 + 6.5745065226868882e-01 5.5481829925499430e-02 + 6.3505963977050828e-01 5.6841209910044911e-02 + 6.1232315854962271e-01 5.8041659918169224e-02 + 5.8956453966853906e-01 5.9072085815551366e-02 + 5.6710819236991894e-01 5.9934566751146209e-02 + 5.4526077653330740e-01 6.0622663740432320e-02 + 5.2429565039265436e-01 6.1134140560867335e-02 + 5.0444128047178982e-01 6.1504660569348210e-02 + 4.8587201732196245e-01 6.1748759965169875e-02 + 4.6870630730072371e-01 6.1888124235238935e-02 + 4.5300839630943951e-01 6.1930542408845393e-02 + 4.3879390510113270e-01 6.1902169182332205e-02 + 4.2603721763211022e-01 6.1829478325528119e-02 + 4.1468028020084957e-01 6.1729918968723145e-02 + 4.0464144765879473e-01 6.1612292522021134e-02 + 3.9582381259010951e-01 6.1474566183960695e-02 + 3.8812133825843076e-01 6.1346625738359292e-02 + 3.8142600044604591e-01 6.1205788216170759e-02 + 3.7563022592531109e-01 6.1076879148075150e-02 + 8.7302854857040668e-01 3.1125732105995851e-02 + 8.7186887286949244e-01 3.1340951036324401e-02 + 8.7050157416038110e-01 3.1592956849540492e-02 + 8.6889079682602455e-01 3.1887219513950800e-02 + 8.6699506712364494e-01 3.2230008456039544e-02 + 8.6476684608727028e-01 3.2629635930777806e-02 + 8.6215085029391447e-01 3.3090814962907972e-02 + 8.5908462430972965e-01 3.3621141253402632e-02 + 8.5549716350776261e-01 3.4226012480392774e-02 + 8.5130907639250919e-01 3.4910946872469026e-02 + 8.4643273973756883e-01 3.5682230064904112e-02 + 8.4077246989152254e-01 3.6544630621211882e-02 + 8.3422616033675612e-01 3.7504558370269780e-02 + 8.2668842566240375e-01 3.8578342844264694e-02 + 8.1805087173352153e-01 3.9773612548348630e-02 + 8.0820678617832065e-01 4.1091694522197957e-02 + 7.9705579506674928e-01 4.2519781137887354e-02 + 7.8451261160631458e-01 4.4043886510937838e-02 + 7.7051570980112238e-01 4.5654285355258284e-02 + 7.5503355847921549e-01 4.7324128818235535e-02 + 7.3807539021475399e-01 4.9025731469480471e-02 + 7.1969882377736327e-01 5.0729412241568801e-02 + 7.0001482658211012e-01 5.2396627084330315e-02 + 6.7919043720730354e-01 5.3984308445843940e-02 + 6.5744830154236200e-01 5.5469981672867978e-02 + 6.3505743164760753e-01 5.6828887928716196e-02 + 6.1232110759710523e-01 5.8028890198297205e-02 + 5.8956265810713626e-01 5.9058893627595581e-02 + 5.6710648978723244e-01 5.9920981670929338e-02 + 5.4525925937179287e-01 6.0608716118318369e-02 + 5.2429432177805302e-01 6.1119862766575654e-02 + 5.0444014056343389e-01 6.1490104101723113e-02 + 4.8587106298289812e-01 6.1733983680135933e-02 + 4.6870553216217864e-01 6.1873184298414111e-02 + 4.5300779132457059e-01 6.1915489992430385e-02 + 4.3879345912399703e-01 6.1887056204896020e-02 + 4.2603691794861848e-01 6.1814356423135076e-02 + 4.1468011310533576e-01 6.1714834923386190e-02 + 4.0464139902664276e-01 6.1597284320712063e-02 + 3.9582386852676277e-01 6.1459658472436951e-02 + 3.8812148523340761e-01 6.1331846019712241e-02 + 3.8142622598726778e-01 6.1191143326432593e-02 + 3.7563051845550732e-01 6.1062379520535656e-02 + 8.7302761971991705e-01 3.1125699814525020e-02 + 8.7186783222217923e-01 3.1340749651009241e-02 + 8.7050041709193504e-01 3.1592562866749642e-02 + 8.6888952115701745e-01 3.1886608491554204e-02 + 8.6699367325682031e-01 3.2229155785945186e-02 + 8.6476533681955148e-01 3.2628517761814718e-02 + 8.6214923063395987e-01 3.3089407504435134e-02 + 8.5908290054418690e-01 3.3619421797739045e-02 + 8.5549534335072419e-01 3.4223958247680458e-02 + 8.5130716807065321e-01 3.4908535197247369e-02 + 8.4643075183250371e-01 3.5679438169382800e-02 + 8.4077041122383256e-01 3.6541435129622039e-02 + 8.3422403997441064e-01 3.7500935622355437e-02 + 8.2668625323196221e-01 3.8574271068527469e-02 + 8.1804865729374754e-01 3.9769070881747463e-02 + 8.0820453806277870e-01 4.1086655073166473e-02 + 7.9705352110236616e-01 4.2514210255164220e-02 + 7.8451032185726055e-01 4.4037755575389331e-02 + 7.7051341691715969e-01 4.5647575509741016e-02 + 7.5503127736535924e-01 4.7316831431417419e-02 + 7.3807313789739681e-01 4.9017851870090973e-02 + 7.1969661897758030e-01 5.0720972710437559e-02 + 7.0001268897826929e-01 5.2387667012156032e-02 + 6.7918838616068389e-01 5.3974879466090336e-02 + 6.5744635374422455e-01 5.5460125639294568e-02 + 6.3505560137652894e-01 5.6818634678227932e-02 + 6.1231940704701360e-01 5.8018261531829526e-02 + 5.8956109753769526e-01 5.9047910803585721e-02 + 5.6710507727923010e-01 5.9909669560255924e-02 + 5.4525800039532124e-01 6.0597100251911638e-02 + 5.2429321904435855e-01 6.1107970355223890e-02 + 5.0443919431137973e-01 6.1477978263106393e-02 + 4.8587027070107136e-01 6.1721673646282497e-02 + 4.6870488863969223e-01 6.1860737049272758e-02 + 4.5300728911025528e-01 6.1902948331912643e-02 + 4.3879308900769792e-01 6.1874463537037787e-02 + 4.2603666940336071e-01 6.1801755896240838e-02 + 4.1467997476795665e-01 6.1702265623886025e-02 + 4.0464135917570193e-01 6.1584777990695810e-02 + 3.9582391562434011e-01 6.1447235722461420e-02 + 3.8812160803791357e-01 6.1319529825212313e-02 + 3.8142641413297074e-01 6.1178939430142548e-02 + 3.7563076231728232e-01 6.1050296650620353e-02 + 3.5935454467235883e-01 -7.9218294761185346e-02 + 3.6516407612089929e-01 -7.9491496976561174e-02 + 3.7165253538127957e-01 -7.9750483120632459e-02 + 3.7886531366434145e-01 -7.9981436037855680e-02 + 3.8684145598786240e-01 -8.0154979570040710e-02 + 3.9561137346009445e-01 -8.0253949175015188e-02 + 4.0519275155399292e-01 -8.0262077547048200e-02 + 4.1558786173767942e-01 -8.0141835076274981e-02 + 4.2678061040595039e-01 -7.9863059995675459e-02 + 4.3873415130485754e-01 -7.9410759357689070e-02 + 4.5138753774391827e-01 -7.8723010258177864e-02 + 4.6465954277268778e-01 -7.7811542615228754e-02 + 4.7844228799048000e-01 -7.6617757249943338e-02 + 4.9261347183173576e-01 -7.5169010565325725e-02 + 5.0703037309230636e-01 -7.3437580611205963e-02 + 5.2154427238922174e-01 -7.1458469472909389e-02 + 5.3599878558967018e-01 -6.9235942792909400e-02 + 5.5024215349709349e-01 -6.6807279331991792e-02 + 5.6413221488112408e-01 -6.4219385073552612e-02 + 5.7753944604859520e-01 -6.1508519719748224e-02 + 5.9035454648558061e-01 -5.8724988738501453e-02 + 6.0249030191456265e-01 -5.5922106480804958e-02 + 6.1388156272106587e-01 -5.3144736950029713e-02 + 6.2448591121488850e-01 -5.0431144679889579e-02 + 6.3428234382115145e-01 -4.7818536366319171e-02 + 6.4326877072627486e-01 -4.5333287482470175e-02 + 6.5145857212654312e-01 -4.2994751793115384e-02 + 6.5887870204826360e-01 -4.0815816913508211e-02 + 6.6556559108688240e-01 -3.8804622786856681e-02 + 6.7156309998497232e-01 -3.6963266838385654e-02 + 6.7691918079084712e-01 -3.5289163937152215e-02 + 6.8168394326374648e-01 -3.3776613554737302e-02 + 6.8590830295884531e-01 -3.2417464152603402e-02 + 6.8964228021079987e-01 -3.1201980035691513e-02 + 6.9293397084449049e-01 -3.0119532905802750e-02 + 6.9582884102564613e-01 -2.9159125415577161e-02 + 6.9836945757553159e-01 -2.8309671188553837e-02 + 7.0059512045212891e-01 -2.7560401505908633e-02 + 7.0254178332229233e-01 -2.6901158316223146e-02 + 7.0424207588259746e-01 -2.6322486392888315e-02 + 7.0572536433741262e-01 -2.5815430243543016e-02 + 7.0701797215096474e-01 -2.5371847715706268e-02 + 7.0814339225652645e-01 -2.4984458493548113e-02 + 3.5932129347556468e-01 -7.5075104064932285e-02 + 3.6509546028667800e-01 -7.5293807861175996e-02 + 3.7154398540146971e-01 -7.5499475389163753e-02 + 3.7871195269646335e-01 -7.5680496155897989e-02 + 3.8663798000443178e-01 -7.5799986853014742e-02 + 3.9535231216826128e-01 -7.5846752491343081e-02 + 4.0487275540601608e-01 -7.5814351464534316e-02 + 4.1520142112643815e-01 -7.5659919805288842e-02 + 4.2632254696527866e-01 -7.5355703096847346e-02 + 4.3820031556383732e-01 -7.4901950016741534e-02 + 4.5077327233029069e-01 -7.4211424157175077e-02 + 4.6396272789897769e-01 -7.3328246238013303e-02 + 4.7765990715843781e-01 -7.2162043299582479e-02 + 4.9174608998232666e-01 -7.0772267364555067e-02 + 5.0607805617443047e-01 -6.9108419325581552e-02 + 5.2051021486001781e-01 -6.7224925110830044e-02 + 5.3488618850801384e-01 -6.5110032738256107e-02 + 5.4905565797728262e-01 -6.2803449521094373e-02 + 5.6287813687188304e-01 -6.0355220361270417e-02 + 5.7622370996378314e-01 -5.7790955029287619e-02 + 5.8898351740784416e-01 -5.5159568059691431e-02 + 6.0107110444132805e-01 -5.2515580032433000e-02 + 6.1242113369120266e-01 -4.9900493989013604e-02 + 6.2299048050962191e-01 -4.7348103106898291e-02 + 6.3275809557503415e-01 -4.4895589671155582e-02 + 6.4172114711013750e-01 -4.2566648313704214e-02 + 6.4989230089534722e-01 -4.0378260842018475e-02 + 6.5729775692625925e-01 -3.8341753438062835e-02 + 6.6397349328383160e-01 -3.6465000079277166e-02 + 6.6996277172672036e-01 -3.4749655635709704e-02 + 6.7531296922324691e-01 -3.3192544661193278e-02 + 6.8007372885256290e-01 -3.1787717580530950e-02 + 6.8429552455506881e-01 -3.0527028605891796e-02 + 6.8802801173176020e-01 -2.9400919585302811e-02 + 6.9131900093525134e-01 -2.8399092375199414e-02 + 6.9421374506827493e-01 -2.7510993143653961e-02 + 6.9675461977567232e-01 -2.6726026465996325e-02 + 6.9898078038766587e-01 -2.6033977489773080e-02 + 7.0092808852473565e-01 -2.5425350207188852e-02 + 7.0262912072839478e-01 -2.4891406492518593e-02 + 7.0411317951528563e-01 -2.4423716909528551e-02 + 7.0540655209728498e-01 -2.4014695542409099e-02 + 7.0653272558296076e-01 -2.3657679854850153e-02 + 3.5929367844128562e-01 -7.1622736181946964e-02 + 3.6503854050277423e-01 -7.1796185914825339e-02 + 3.7145397473297403e-01 -7.1957622963565102e-02 + 3.7858481116835585e-01 -7.2097281215349932e-02 + 3.8646931406775947e-01 -7.2172032296820662e-02 + 3.9513759202696491e-01 -7.2175661219374895e-02 + 4.0460755381276270e-01 -7.2109912811973848e-02 + 4.1488117938645147e-01 -7.1927486009584110e-02 + 4.2594298349736781e-01 -7.1602633287880468e-02 + 4.3775800562882561e-01 -7.1148282387642314e-02 + 4.5026436887104809e-01 -7.0456135863684044e-02 + 4.6338549351245040e-01 -6.9597245611511399e-02 + 4.7701185721362521e-01 -6.8454809166324709e-02 + 4.9102771401114009e-01 -6.7114942886328535e-02 + 5.0528942510595132e-01 -6.5508199735553857e-02 + 5.1965399376834631e-01 -6.3705119601487101e-02 + 5.3396504229455277e-01 -6.1680622881817408e-02 + 5.4807344151993309e-01 -5.9476411965613672e-02 + 5.6184008911380479e-01 -5.7145113467295040e-02 + 5.7513473943833515e-01 -5.4703480547796467e-02 + 5.8784889362473258e-01 -5.2199259606833678e-02 + 5.9989672276315109e-01 -4.9687958917342991e-02 + 6.1121273059968806e-01 -4.7208285414950840e-02 + 6.2175320442653814e-01 -4.4790321248098681e-02 + 6.3149705577727888e-01 -4.2471226768367280e-02 + 6.4044083765730531e-01 -4.0272476541212660e-02 + 6.4859662423621212e-01 -3.8209091221060691e-02 + 6.5598999169786165e-01 -3.6291109469359442e-02 + 6.6265654434049748e-01 -3.4526191562306782e-02 + 6.6863904907200955e-01 -3.2915633082680640e-02 + 6.7398440792380210e-01 -3.1455777241376735e-02 + 6.7874187879966252e-01 -3.0140475605975898e-02 + 6.8296157118340639e-01 -2.8961594203480753e-02 + 6.8669283941045678e-01 -2.7909728413633639e-02 + 6.8998325879188627e-01 -2.6974859348443295e-02 + 6.9287790646414860e-01 -2.6146805618467765e-02 + 6.9541900047621164e-01 -2.5415382906401593e-02 + 6.9764557697785212e-01 -2.4770838931282985e-02 + 6.9959342182154327e-01 -2.4204229191183823e-02 + 7.0129506787628704e-01 -2.3707412093516109e-02 + 7.0277976521048158e-01 -2.3272396247138439e-02 + 7.0407377123105008e-01 -2.2892058348746358e-02 + 7.0520056836718292e-01 -2.2560249023909441e-02 + 3.5927075607902276e-01 -6.8746001796750417e-02 + 3.6499134712983144e-01 -6.8881885329992107e-02 + 3.7137937489934320e-01 -6.9006645714124487e-02 + 3.7847945994600274e-01 -6.9112058804578408e-02 + 3.8632957406049589e-01 -6.9149801810397996e-02 + 3.9495971438675276e-01 -6.9117814639368863e-02 + 4.0438787689405886e-01 -6.9024662721112878e-02 + 4.1461593374637906e-01 -6.8819354781281761e-02 + 4.2562863160639708e-01 -6.8477816425667803e-02 + 4.3739172348350414e-01 -6.8023521217229738e-02 + 4.4984298137236534e-01 -6.7330651022420376e-02 + 4.6290757910355335e-01 -6.6492645275551862e-02 + 4.7647537166854409e-01 -6.5370720714667624e-02 + 4.9043308222880871e-01 -6.4073140033777676e-02 + 5.0463672063157006e-01 -6.2514695976296206e-02 + 5.1894544024462619e-01 -6.0779291199160146e-02 + 5.3320285810250045e-01 -5.8830758138234962e-02 + 5.4726082758500949e-01 -5.6712435763863561e-02 + 5.6098138925065444e-01 -5.4479071367006124e-02 + 5.7423401838346888e-01 -5.2140054112706322e-02 + 5.8691051127872917e-01 -4.9742148766194164e-02 + 5.9892555418225901e-01 -4.7341670881289898e-02 + 6.1021351625593290e-01 -4.4975001538783241e-02 + 6.2073019570397925e-01 -4.2669143970722710e-02 + 6.3045447051736581e-01 -4.0461238828380285e-02 + 6.3938238380436052e-01 -3.8370923221982489e-02 + 6.4752552010094444e-01 -3.6411597508187336e-02 + 6.5490893985305909e-01 -3.4592239753874182e-02 + 6.6156793886757936e-01 -3.2920339343175703e-02 + 6.6754487556147635e-01 -3.1396901035163224e-02 + 6.7288626006667163e-01 -3.0017876491624650e-02 + 6.7764103267250064e-01 -2.8776959423721306e-02 + 6.8185900236046781e-01 -2.7666032048100999e-02 + 6.8558927532902969e-01 -2.6675822730224504e-02 + 6.8887923309979959e-01 -2.5796549029804636e-02 + 6.9177380810134481e-01 -2.5018342507463480e-02 + 6.9431508860416569e-01 -2.4331363227655719e-02 + 6.9654201265365445e-01 -2.3726245306822033e-02 + 6.9849030380867771e-01 -2.3194503656380580e-02 + 7.0019245910738870e-01 -2.2728492848229059e-02 + 7.0167768547569942e-01 -2.2320586229041626e-02 + 7.0297221584861391e-01 -2.1964045179230170e-02 + 7.0409952891356387e-01 -2.1653146466814037e-02 + 3.5925173959283102e-01 -6.6348918968753431e-02 + 3.6495223887583711e-01 -6.6453627725358094e-02 + 3.7131757962250000e-01 -6.6547987425109381e-02 + 3.7839220967137560e-01 -6.6625063383896149e-02 + 3.8621385904022942e-01 -6.6632212894121079e-02 + 3.9481243387017140e-01 -6.6570842700812038e-02 + 4.0420600436772985e-01 -6.6455200831094977e-02 + 4.1439635442418460e-01 -6.6231227422660743e-02 + 4.2536842485449045e-01 -6.5876243021346773e-02 + 4.3708856282147240e-01 -6.5422491434064312e-02 + 4.4949424848573999e-01 -6.4729580921696020e-02 + 4.6251211293431105e-01 -6.3909557878822118e-02 + 4.7603149228188252e-01 -6.2805360874705354e-02 + 4.8994115892910006e-01 -6.1543641664805276e-02 + 5.0409682766351582e-01 -6.0026086041224322e-02 + 5.1835943311922206e-01 -5.8347673550945965e-02 + 5.3257258336058000e-01 -5.6463013120014650e-02 + 5.4658894238639699e-01 -5.4416784204881136e-02 + 5.6027149375137686e-01 -5.2265473750970522e-02 + 5.7348947681928097e-01 -5.0012349032989595e-02 + 5.8613492878454443e-01 -4.7703349416373636e-02 + 5.9812295946141480e-01 -4.5395449025897108e-02 + 6.0938782389919677e-01 -4.3123094519423880e-02 + 6.1988491358734266e-01 -4.0910735547975863e-02 + 6.2959307773890416e-01 -3.8795495079320730e-02 + 6.3850793704268149e-01 -3.6795490300909110e-02 + 6.4664067103468226e-01 -3.4922783884945546e-02 + 6.5401591405951998e-01 -3.3185481129303473e-02 + 6.6066870753445583e-01 -3.1590935474080692e-02 + 6.6664107295088049e-01 -3.0139917019464071e-02 + 6.7197919733873712e-01 -2.8828059725479707e-02 + 6.7673175932726171e-01 -2.7648932814965270e-02 + 6.8094832035929664e-01 -2.6594437686934490e-02 + 6.8467778231974474e-01 -2.5655418054281075e-02 + 6.8796736725259844e-01 -2.4822291871057188e-02 + 6.9086188857860720e-01 -2.4085453811959392e-02 + 6.9340332781085501e-01 -2.3435352536687607e-02 + 6.9563054232846777e-01 -2.2862944988077054e-02 + 6.9757920453785982e-01 -2.2360128767609642e-02 + 6.9928178212276182e-01 -2.1919671071156169e-02 + 7.0076744656279411e-01 -2.1534248926695303e-02 + 7.0206241072775544e-01 -2.1197443544888631e-02 + 7.0319015032782828e-01 -2.0903885475556171e-02 + 3.5923597224626769e-01 -6.4351510091437927e-02 + 3.6491984730022570e-01 -6.4430355505442932e-02 + 3.7126641673252270e-01 -6.4499526088509729e-02 + 3.7831998608735162e-01 -6.4553165701212958e-02 + 3.8611808563474231e-01 -6.4535039464459792e-02 + 3.9469054734452025e-01 -6.4449447104421728e-02 + 4.0405550468159063e-01 -6.4315371082168560e-02 + 4.1421466935775836e-01 -6.4076200206569456e-02 + 4.2515314477712396e-01 -6.3710418077174188e-02 + 4.3683777283335368e-01 -6.3257561153023195e-02 + 4.4920579115081855e-01 -6.2565116889362227e-02 + 4.6218504162873009e-01 -6.1760593779857362e-02 + 4.7566442799360337e-01 -6.0671733262950479e-02 + 4.8953442293269811e-01 -5.9440452611034728e-02 + 5.0365049333538137e-01 -5.7957538670611007e-02 + 5.1787504892419289e-01 -5.6327149601973665e-02 + 5.3205168622132404e-01 -5.4496222653317508e-02 + 5.4603373748937489e-01 -5.2510533624816606e-02 + 5.5968496376294075e-01 -5.0427994699182487e-02 + 5.7287440482495977e-01 -4.8246784661151211e-02 + 5.8549429411587861e-01 -4.6012148482509715e-02 + 5.9746008934107586e-01 -4.3781596528169174e-02 + 6.0870594871616612e-01 -4.1587966794416203e-02 + 6.1918692556122812e-01 -3.9453591746173397e-02 + 6.2888184437537642e-01 -3.7415578496399503e-02 + 6.3778597604400367e-01 -3.5490787643898861e-02 + 6.4591016529094658e-01 -3.3690178281623760e-02 + 6.5327869464217847e-01 -3.2021138212151849e-02 + 6.5992639590862501e-01 -3.0490913338447761e-02 + 6.6589501290156861e-01 -2.9100085039098146e-02 + 6.7123046648908380e-01 -2.7844030150682996e-02 + 6.7598121992957272e-01 -2.6716220428391800e-02 + 6.8019663093960014e-01 -2.5708578309286044e-02 + 6.8392543333260081e-01 -2.4812047648333616e-02 + 6.8721471804153855e-01 -2.4017216376529416e-02 + 6.9010920071824200e-01 -2.3314700496649406e-02 + 6.9265077514588180e-01 -2.2695190595589790e-02 + 6.9487823244660496e-01 -2.2149913375795662e-02 + 6.9682720307325263e-01 -2.1671085211954610e-02 + 6.9853013069513137e-01 -2.1251816403741842e-02 + 7.0001615770212744e-01 -2.0885036811486977e-02 + 7.0131148053373626e-01 -2.0564593516064798e-02 + 7.0243957254418388e-01 -2.0285410700132792e-02 + 3.5922290560492443e-01 -6.2687133116307595e-02 + 3.6489303120197081e-01 -6.2744526947743823e-02 + 3.7122407561633913e-01 -6.2792833348705585e-02 + 3.7826022724948105e-01 -6.2827098472963139e-02 + 3.8603885142865285e-01 -6.2788100745889072e-02 + 3.9458971977270080e-01 -6.2682554187770717e-02 + 4.0393101968412098e-01 -6.2533385712961229e-02 + 4.1406440393319455e-01 -6.2281863114474166e-02 + 4.2497511211474298e-01 -6.1907439741041563e-02 + 4.3663039805323123e-01 -6.1455715379421787e-02 + 4.4896729783480249e-01 -6.0764097663338033e-02 + 4.6191465924898661e-01 -5.9972941952740347e-02 + 4.7536102570498506e-01 -5.8897355718470851e-02 + 4.8919828031155882e-01 -5.7691926141364092e-02 + 5.0328168160900388e-01 -5.6238378159522338e-02 + 5.1747486041790025e-01 -5.4648473139041476e-02 + 5.3162140008186765e-01 -5.2862768010998852e-02 + 5.4557518339787880e-01 -5.0927934029874763e-02 + 5.5920061198984250e-01 -4.8903049642209366e-02 + 5.7236655671134506e-01 -4.6782064664729152e-02 + 5.8496541059584528e-01 -4.4609639650307793e-02 + 5.9691291680770309e-01 -4.2443720823915641e-02 + 6.0814315134376240e-01 -4.0315808566523004e-02 + 6.1861088637954065e-01 -3.8246480467696346e-02 + 6.2829492517840091e-01 -3.6272829451879263e-02 + 6.3719024905960431e-01 -3.4410677725705753e-02 + 6.4530742609112712e-01 -3.2670074508222943e-02 + 6.5267044847578637e-01 -3.1057818280067061e-02 + 6.5931397544180437e-01 -2.9581070371754014e-02 + 6.6527952210709718e-01 -2.8240260872656318e-02 + 6.7061279024386611e-01 -2.7030559032901032e-02 + 6.7536206598143100e-01 -2.5945360882949825e-02 + 6.7957653950254615e-01 -2.4976610817780555e-02 + 6.8330480647858827e-01 -2.4115339666017838e-02 + 6.8659385014837371e-01 -2.3352279619778725e-02 + 6.8948830591918209e-01 -2.2678232934871697e-02 + 6.9202999554703681e-01 -2.2084093059351786e-02 + 6.9425765578471366e-01 -2.1561312142659980e-02 + 6.9620688271332032e-01 -2.1102372086705533e-02 + 6.9791010038204027e-01 -2.0700668455866055e-02 + 6.9939642733220264e-01 -2.0349341599292498e-02 + 7.0069204656584760e-01 -2.0042459583585557e-02 + 7.0182042958324309e-01 -1.9775190248259446e-02 + 3.5921208170737984e-01 -6.1300257882848569e-02 + 3.6487083908159135e-01 -6.1339862587555867e-02 + 3.7118904742213138e-01 -6.1370891395301837e-02 + 3.7821079874963515e-01 -6.1389145398966526e-02 + 3.8597332224332942e-01 -6.1332919946115130e-02 + 3.9450634048727029e-01 -6.1210943977290579e-02 + 4.0382808688626026e-01 -6.1049430684947420e-02 + 4.1394016613331930e-01 -6.0787884729055344e-02 + 4.2482793192085694e-01 -6.0406568052641600e-02 + 4.3645898105343239e-01 -5.9956121268362250e-02 + 4.4877018216346126e-01 -5.9265570096891491e-02 + 4.6169121859697215e-01 -5.8485942714609350e-02 + 4.7511033350238097e-01 -5.7421844371242377e-02 + 4.8892057975602538e-01 -5.6238376270413726e-02 + 5.0297704074856453e-01 -5.4809729439153569e-02 + 5.1714435786518209e-01 -5.3253961917047746e-02 + 5.3126610039982980e-01 -5.1506324677303032e-02 + 5.4519660445174956e-01 -4.9614219519069809e-02 + 5.5880079916872427e-01 -4.7637678298470605e-02 + 5.7194741237718350e-01 -4.5567136540810502e-02 + 5.8452896670302079e-01 -4.3446762811825905e-02 + 5.9646143935734108e-01 -4.1334857065451501e-02 + 6.0767883650697818e-01 -3.9261807530580513e-02 + 6.1813569661121726e-01 -3.7246737537374966e-02 + 6.2781080468462114e-01 -3.5326727347056920e-02 + 6.3669890241030025e-01 -3.3516741392063940e-02 + 6.4481032933902194e-01 -3.1826079092428385e-02 + 6.5216883820195848e-01 -3.0261055231324732e-02 + 6.5880894620941355e-01 -2.8828765012708552e-02 + 6.6477198023444883e-01 -2.7529517605192660e-02 + 6.7010346180187597e-01 -2.6358315033367573e-02 + 6.7485153145602261e-01 -2.5308494966713144e-02 + 6.7906524169746618e-01 -2.4372023914911958e-02 + 6.8279307473192197e-01 -2.3540008221919512e-02 + 6.8608192540205093e-01 -2.2803302552338339e-02 + 6.8897636330461320e-01 -2.2152865938030383e-02 + 6.9151815110461889e-01 -2.1579761961023208e-02 + 6.9374598097532247e-01 -2.1075631202271537e-02 + 6.9569542086271019e-01 -2.0633176736512004e-02 + 6.9739887880359464e-01 -2.0246031284846928e-02 + 6.9888545380387723e-01 -1.9907510427833758e-02 + 7.0018131788716031e-01 -1.9611865893969720e-02 + 7.0130994110280309e-01 -1.9354467676554507e-02 + 3.5920311837980934e-01 -6.0144613317163580e-02 + 3.6485247814735849e-01 -6.0169467576355426e-02 + 3.7116007564904896e-01 -6.0186190888958865e-02 + 3.7816992363711066e-01 -6.0191216032738595e-02 + 3.8591913893848961e-01 -6.0120774059460529e-02 + 3.9443740434049546e-01 -5.9985275566508102e-02 + 4.0374299247708767e-01 -5.9813671673440635e-02 + 4.1383746885763972e-01 -5.9544001467588960e-02 + 4.2470628277016370e-01 -5.9157201122331318e-02 + 4.3631731658678474e-01 -5.8708101832029888e-02 + 4.4860729981367553e-01 -5.8018759561144162e-02 + 4.6150660982141439e-01 -5.7249068652195180e-02 + 4.7490323954367891e-01 -5.6194904572245873e-02 + 4.8869121193656540e-01 -5.5030092764368085e-02 + 5.0272546313950506e-01 -5.3622560950653708e-02 + 5.1687147073235529e-01 -5.2095581088817629e-02 + 5.3097278970290052e-01 -5.0379991804260275e-02 + 5.4488412926310859e-01 -4.8523790407086341e-02 + 5.5847085282799103e-01 -4.6587787609082755e-02 + 5.7160156712571830e-01 -4.4559498692946869e-02 + 5.8416889989350873e-01 -4.2482678018842139e-02 + 5.9608902013274534e-01 -4.0415912277751584e-02 + 6.0729587470506663e-01 -3.8388665043897374e-02 + 6.1774380778899529e-01 -3.6418854652667344e-02 + 6.2741158872401503e-01 -3.4543550102712310e-02 + 6.3629376090975598e-01 -3.2777007410601737e-02 + 6.4440047518510546e-01 -3.1127908305722041e-02 + 6.5175528680859951e-01 -2.9602170761140009e-02 + 6.5839259616808499e-01 -2.8206838563295544e-02 + 6.6435357524192418e-01 -2.6942124479095230e-02 + 6.6968359732440241e-01 -2.5802896061652071e-02 + 6.7443068335252521e-01 -2.4782446366234921e-02 + 6.7864377272567711e-01 -2.3872763564970645e-02 + 6.8237125449491876e-01 -2.3065019505058459e-02 + 6.8565995098201371e-01 -2.2350172822829906e-02 + 6.8855437783933049e-01 -2.1719314524166172e-02 + 6.9109624927859303e-01 -2.1163650887587551e-02 + 6.9332422094005419e-01 -2.0674979994486160e-02 + 6.9527383775412455e-01 -2.0246189146463017e-02 + 6.9697749469983916e-01 -1.9871108218059395e-02 + 6.9846427479037332e-01 -1.9543198667695612e-02 + 6.9976034108614726e-01 -1.9256864858168899e-02 + 7.0088916250715971e-01 -1.9007644487946205e-02 + 3.5919569705085963e-01 -5.9181643629736908e-02 + 3.6483728858212178e-01 -5.9194267221889099e-02 + 3.7113611511426869e-01 -5.9199146192480054e-02 + 3.7813612421494325e-01 -5.9193241861860237e-02 + 3.8587434000216952e-01 -5.9111069135665370e-02 + 3.9438041298571547e-01 -5.8964442123039071e-02 + 4.0367264923414364e-01 -5.8784593026227107e-02 + 4.1375258233607864e-01 -5.8508342699180101e-02 + 4.2460574167073739e-01 -5.8117189510815431e-02 + 4.3620024737707175e-01 -5.7669448411385653e-02 + 4.4847271337016198e-01 -5.6981379835633048e-02 + 4.6135409348650142e-01 -5.6220243457804679e-02 + 4.7473217214880009e-01 -5.5174658258778410e-02 + 4.8850177678499146e-01 -5.4025688757907427e-02 + 5.0251771974908743e-01 -5.2636055677923246e-02 + 5.1664617050902906e-01 -5.1133348213455235e-02 + 5.3073066997083040e-01 -4.9444735746335192e-02 + 5.4462623441584346e-01 -4.7618700801963294e-02 + 5.5819858471157269e-01 -4.5716690122391372e-02 + 5.7131622508307411e-01 -4.3723792378644294e-02 + 5.8387186846344408e-01 -4.1683413250170991e-02 + 5.9578184097774489e-01 -3.9654371691968726e-02 + 6.0698003914054544e-01 -3.7665362509559416e-02 + 6.1742064563070009e-01 -3.5733305601257460e-02 + 6.2708241633632111e-01 -3.3895259990674241e-02 + 6.3595973059579802e-01 -3.2164896665479316e-02 + 6.4406258341757605e-01 -3.0550388552472729e-02 + 6.5141436723513191e-01 -2.9057328164316512e-02 + 6.5804938635301402e-01 -2.7692719507829106e-02 + 6.6400868531385859e-01 -2.6456698645677644e-02 + 6.6933751552935128e-01 -2.5344025133055181e-02 + 6.7408379968853083e-01 -2.4347958190706055e-02 + 6.7829638429849726e-01 -2.3460506732380662e-02 + 6.8202358194562285e-01 -2.2672899332182275e-02 + 6.8531215546758495e-01 -2.1976182859806161e-02 + 6.8820657630970938e-01 -2.1361559404102087e-02 + 6.9074851896200884e-01 -2.0820354921383271e-02 + 6.9297660913340842e-01 -2.0344499138378078e-02 + 6.9492637293238813e-01 -1.9927032809562102e-02 + 6.9663019469419563e-01 -1.9561949707867305e-02 + 6.9811714434306293e-01 -1.9242832733273194e-02 + 6.9941337762444467e-01 -1.8964213097579518e-02 + 7.0054236258333302e-01 -1.8721767624572644e-02 + 3.5918955256995377e-01 -5.8379221960177384e-02 + 3.6482472205422939e-01 -5.8381703401573337e-02 + 3.7111629769480592e-01 -5.8376774839316005e-02 + 3.7810817345092956e-01 -5.8361839792908460e-02 + 3.8583729693234675e-01 -5.8269986389404865e-02 + 3.9433329247431315e-01 -5.8114200073745244e-02 + 4.0361449461455096e-01 -5.7927613528275884e-02 + 4.1368241093857050e-01 -5.7646034921302672e-02 + 4.2452263791843731e-01 -5.7251431394639889e-02 + 4.3610349366421469e-01 -5.6805014182386045e-02 + 4.4836149604847031e-01 -5.6118224384719494e-02 + 4.6122807775621022e-01 -5.5364440578392099e-02 + 4.7459084945181501e-01 -5.4326249622223162e-02 + 4.8834530575223722e-01 -5.3190723208862443e-02 + 5.0234615497836199e-01 -5.1816253023306072e-02 + 5.1646013913990318e-01 -5.0334003358615695e-02 + 5.3053078564546186e-01 -4.8668092183221962e-02 + 5.4441336351891301e-01 -4.6867397353652869e-02 + 5.5797388788449787e-01 -4.4993885014124199e-02 + 5.7108077625176401e-01 -4.3030627306054399e-02 + 5.8362681059386190e-01 -4.1020736475589875e-02 + 5.9552844576773833e-01 -3.9023219576267296e-02 + 6.0671953557611435e-01 -3.7066132222096412e-02 + 6.1715412844189077e-01 -3.5165566951507909e-02 + 6.2681096872627140e-01 -3.3358573994592647e-02 + 6.3568430000881360e-01 -3.1658341154072185e-02 + 6.4378398860577712e-01 -3.0072622202669340e-02 + 6.5113329267930742e-01 -2.8606742691596312e-02 + 6.5776643750019836e-01 -2.7267675983043308e-02 + 6.6372436275534996e-01 -2.6055497182542974e-02 + 6.6905221962842654e-01 -2.4964879162257824e-02 + 6.7379785009792414e-01 -2.3989055677563709e-02 + 6.7801002436961744e-01 -2.3120055122152247e-02 + 6.8173699225922546e-01 -2.2349155090228463e-02 + 6.8502546780978635e-01 -2.1667477277563626e-02 + 6.8791988623649858e-01 -2.1066317244264891e-02 + 6.9046188946346843e-01 -2.0537101302095569e-02 + 6.9269007867526045e-01 -2.0071869204715459e-02 + 6.9463996458728339e-01 -1.9663789527753810e-02 + 6.9634392285898750e-01 -1.9306992302875779e-02 + 6.9783101270153858e-01 -1.8995161531311033e-02 + 6.9912738389051199e-01 -1.8722933849520430e-02 + 7.0025650379572779e-01 -1.8486101506158328e-02 + 3.5918446463389359e-01 -5.7710578503386623e-02 + 3.6481432365113764e-01 -5.7704648261912503e-02 + 3.7109990354106620e-01 -5.7691597026845100e-02 + 3.7808505415976462e-01 -5.7669198217823313e-02 + 3.8580665996009794e-01 -5.7569353656575284e-02 + 3.9429432404494713e-01 -5.7406026299687822e-02 + 4.0356640516301789e-01 -5.7213932227368133e-02 + 4.1362438970900628e-01 -5.6928037712194852e-02 + 4.2445393034651613e-01 -5.6530700762557617e-02 + 4.3602351002743289e-01 -5.6085540701003855e-02 + 4.4826956681588681e-01 -5.5399990740412998e-02 + 4.6112393120421791e-01 -5.4652513427873299e-02 + 4.7447406905869949e-01 -5.3620680824439604e-02 + 4.8821602842071127e-01 -5.2496550263759628e-02 + 5.0220443021274064e-01 -5.1134914008601547e-02 + 5.1630649033291487e-01 -4.9669897496217176e-02 + 5.3036572352981792e-01 -4.8023080886623923e-02 + 5.4423760692356327e-01 -4.6243664255003293e-02 + 5.5778839795164814e-01 -4.4394038068874687e-02 + 5.7088644082204254e-01 -4.2455598550391854e-02 + 5.8342457347361010e-01 -4.0471211120222020e-02 + 5.9531935627376387e-01 -3.8500035210150545e-02 + 6.0650460682623364e-01 -3.6569594935018955e-02 + 6.1693426193564471e-01 -3.4695297107875681e-02 + 6.2658705610342436e-01 -3.2914184245983899e-02 + 6.3545712054464809e-01 -3.1239044974130083e-02 + 6.4355421526704182e-01 -2.9677287654495624e-02 + 6.5090148767439482e-01 -2.8234018779729798e-02 + 6.5753309800575832e-01 -2.6916188182897437e-02 + 6.6348989964255578e-01 -2.5723822545816347e-02 + 6.6881696131923296e-01 -2.4651525161433749e-02 + 6.7356205868721719e-01 -2.3692510751888295e-02 + 6.7777389925613141e-01 -2.2838825703121061e-02 + 6.8150068129400732e-01 -2.2081789860041352e-02 + 6.8478907880294548e-01 -2.1412588313952804e-02 + 6.8768349729424572e-01 -2.0822595241002467e-02 + 6.9022555198285551e-01 -2.0303321082421423e-02 + 6.9245382395149646e-01 -1.9846897539680514e-02 + 6.9440381132200157e-01 -1.9446599661107022e-02 + 6.9610788267926782e-01 -1.9096670768478683e-02 + 6.9759508846268259e-01 -1.8790879033960387e-02 + 6.9889157357381848e-01 -1.8523948721610679e-02 + 7.0002080486293816e-01 -1.8291767856541009e-02 + 3.5918025052701341e-01 -5.7153407329704656e-02 + 3.6480571661284850e-01 -5.7140498922018668e-02 + 3.7108633676779690e-01 -5.7120718363577044e-02 + 3.7806592454437560e-01 -5.7092148427386823e-02 + 3.8578131223712986e-01 -5.6985704453581025e-02 + 3.9426208571164229e-01 -5.6816165093920117e-02 + 4.0352662427559743e-01 -5.6619565664858748e-02 + 4.1357639704133781e-01 -5.6330172439400125e-02 + 4.2439710372005990e-01 -5.5930669324119379e-02 + 4.3595736452642264e-01 -5.5486678068957823e-02 + 4.4819355119604565e-01 -5.4802298451648836e-02 + 4.6103782475715194e-01 -5.4060217766709107e-02 + 4.7437753041120756e-01 -5.3033838495653296e-02 + 4.8810917536688747e-01 -5.1919356667672993e-02 + 5.0208730716021954e-01 -5.0568571407028397e-02 + 5.1617953405397199e-01 -4.9118061520176816e-02 + 5.3022935913526559e-01 -4.7487296289348356e-02 + 5.4409243095168680e-01 -4.5725738617564009e-02 + 5.5763520658541399e-01 -4.3896125874327639e-02 + 5.7072596834182820e-01 -4.1978461240647462e-02 + 5.8325759956378598e-01 -4.0015402639825635e-02 + 5.9514674715376037e-01 -3.8066233044831900e-02 + 6.0632719807267121e-01 -3.6158034567494050e-02 + 6.1675279631611379e-01 -3.4305645527782119e-02 + 6.2640226796872378e-01 -3.2546101712627479e-02 + 6.3526965121327816e-01 -3.0891861834562669e-02 + 6.4336461820269519e-01 -2.9350049472201399e-02 + 6.5071022493533170e-01 -2.7925591253224091e-02 + 6.5734057811029667e-01 -2.6625418983984756e-02 + 6.6329646003345899e-01 -2.5449520862169728e-02 + 6.6862287157721800e-01 -2.4392444289733060e-02 + 6.7336753385370129e-01 -2.3447389850192461e-02 + 6.7757910282523648e-01 -2.2606420308252245e-02 + 6.8130573440254738e-01 -2.1860891820326619e-02 + 6.8459406970913217e-01 -2.1202043126665855e-02 + 6.8748848988746658e-01 -2.0621314486207777e-02 + 6.9003058823239749e-01 -2.0110286841995804e-02 + 6.9225892933910638e-01 -1.9661168722351349e-02 + 6.9420900101870442e-01 -1.9267323867607145e-02 + 6.9591316608297882e-01 -1.8923089804461529e-02 + 6.9740046778414166e-01 -1.8622304784360517e-02 + 6.9869704704141589e-01 -1.8359765916374525e-02 + 6.9982637030622097e-01 -1.8131440715835709e-02 + 3.5917675895686130e-01 -5.6689122092703534e-02 + 3.6479858939736864e-01 -5.6670422990118055e-02 + 3.7107510487376438e-01 -5.6645065302574675e-02 + 3.7805008903351278e-01 -5.6611390452374677e-02 + 3.8576033107147056e-01 -5.6499493341945733e-02 + 3.9423540284236164e-01 -5.6324833223300029e-02 + 4.0349370108307187e-01 -5.6124544574528666e-02 + 4.1353668079557399e-01 -5.5832311559084420e-02 + 4.2435008106892375e-01 -5.5431089801820987e-02 + 4.3590263642195137e-01 -5.4988166403843519e-02 + 4.4813066345468272e-01 -5.4304868288725473e-02 + 4.6096659789092076e-01 -5.3567394165616455e-02 + 4.7429768437813502e-01 -5.2545679157208043e-02 + 4.8802081120082119e-01 -5.1439355813647128e-02 + 5.0199046430999461e-01 -5.0097733915693311e-02 + 5.1607457697060011e-01 -4.8659425709233102e-02 + 5.3011664169102068e-01 -4.7042144478809750e-02 + 5.4397244833730851e-01 -4.5295567745754918e-02 + 5.5750861859406819e-01 -4.3482716775572527e-02 + 5.7059338254797887e-01 -4.1582436636205762e-02 + 5.8311966042276664e-01 -3.9637210934573244e-02 + 5.9500417015673956e-01 -3.7706422930271731e-02 + 6.0618067280600618e-01 -3.5816787106072910e-02 + 6.1660293518455966e-01 -3.3982670317656997e-02 + 6.2624967620824123e-01 -3.2241102508622457e-02 + 6.3511485700097103e-01 -3.0604269583677533e-02 + 6.4320807707311745e-01 -2.9079060169893017e-02 + 6.5055231694356086e-01 -2.7670253085988077e-02 + 6.5718163920044770e-01 -2.6384766340472030e-02 + 6.6313676757495532e-01 -2.5222557508344585e-02 + 6.6846264704252145e-01 -2.4178129035506687e-02 + 6.7320695383394091e-01 -2.3244671057541976e-02 + 6.7741830149678750e-01 -2.2414261060520219e-02 + 6.8114481110810210e-01 -2.1678286314541478e-02 + 6.8443309677129716e-01 -2.1028030902003836e-02 + 6.8732751961883487e-01 -2.0454990591845260e-02 + 6.8986965494039532e-01 -1.9950805383840191e-02 + 6.9209805379574763e-01 -1.9507747986437847e-02 + 6.9404819554639141e-01 -1.9119256022745126e-02 + 6.9575243828782996e-01 -1.8779745365905650e-02 + 6.9723981937793233e-01 -1.8483112618101313e-02 + 6.9853647647866646e-01 -1.8224215454710101e-02 + 6.9966587573546291e-01 -1.7999087382550294e-02 + 3.5917386482061309e-01 -5.6302235802445713e-02 + 3.6479268472470872e-01 -5.6278729764963960e-02 + 3.7106580132313233e-01 -5.6248747841606668e-02 + 3.7803697360770572e-01 -5.6210847648102948e-02 + 3.8574295513590151e-01 -5.6094441631870606e-02 + 3.9421330635632101e-01 -5.5915556864036250e-02 + 4.0346643875656091e-01 -5.5712243637542541e-02 + 4.1350379580249935e-01 -5.5417701957222815e-02 + 4.2431114952887727e-01 -5.5015113984374128e-02 + 4.3585732964592105e-01 -5.4573152066835100e-02 + 4.4807860691282847e-01 -5.3890836235638839e-02 + 4.6090764539350848e-01 -5.3157284356037615e-02 + 4.7423160594040842e-01 -5.2139547644958255e-02 + 4.8794769320872555e-01 -5.1040112968569855e-02 + 5.0191034150099778e-01 -4.9706219420643460e-02 + 5.1598775341553293e-01 -4.8278165362533217e-02 + 5.3002341198878133e-01 -4.6672203086559123e-02 + 5.4387322367892121e-01 -4.4938185602107168e-02 + 5.5740394599075149e-01 -4.3139366796340069e-02 + 5.7048376501202791e-01 -4.1253628743534006e-02 + 5.8300563097158054e-01 -3.9323308717471757e-02 + 5.9488632018293852e-01 -3.7407871517374902e-02 + 6.0605957183301917e-01 -3.5533725807412694e-02 + 6.1647908853962319e-01 -3.3714847295287356e-02 + 6.2612358312624861e-01 -3.1988260876375955e-02 + 6.3498695285825812e-01 -3.0365926731605774e-02 + 6.4307873714518193e-01 -2.8854539501794563e-02 + 6.5042185413387676e-01 -2.7458756417020311e-02 + 6.5705033003932301e-01 -2.6185484921769770e-02 + 6.6300484027977813e-01 -2.5034658176239996e-02 + 6.6833028374953918e-01 -2.4000742398628434e-02 + 6.7307429971136867e-01 -2.3076920035749984e-02 + 6.7728546678047097e-01 -2.2255281659882092e-02 + 6.8101187735965008e-01 -2.1527241120581676e-02 + 6.8430012332436785e-01 -2.0884120769552761e-02 + 6.8719454935908020e-01 -2.0317462970738505e-02 + 6.8973671594866337e-01 -1.9818957170497021e-02 + 6.9196516302916944e-01 -1.9380929681275152e-02 + 6.9391536302942447e-01 -1.8996879674358317e-02 + 6.9561967018703297e-01 -1.8661288191467822e-02 + 6.9710711702020844e-01 -1.8368100423232656e-02 + 6.9840383852353427e-01 -1.8112224411781629e-02 + 6.9953330060743601e-01 -1.7889748465891593e-02 + 3.5917146477451001e-01 -5.5979843988166335e-02 + 3.6478779032247549e-01 -5.5952346201673310e-02 + 3.7105809084259911e-01 -5.5918528336845699e-02 + 3.7802610498015571e-01 -5.5877128661478551e-02 + 3.8572855680462609e-01 -5.5756991845996230e-02 + 3.9419499746248410e-01 -5.5574618635176765e-02 + 4.0344385090404000e-01 -5.5368822386070764e-02 + 4.1347655114912452e-01 -5.5072400339836347e-02 + 4.2427889778569161e-01 -5.4668723516846818e-02 + 4.3581979980363311e-01 -5.4227616721872603e-02 + 4.4803548984051295e-01 -5.3546180448635260e-02 + 4.6085882181284654e-01 -5.2815959908547656e-02 + 4.7417688674396136e-01 -5.1801607246818489e-02 + 4.8788715203375305e-01 -5.0707980814186121e-02 + 5.0184400869770729e-01 -4.9380596965322134e-02 + 5.1591588264884658e-01 -4.7961152823447838e-02 + 5.2994624853591998e-01 -4.6364684947150861e-02 + 5.4379110909462292e-01 -4.4641190056709246e-02 + 5.5731733399815531e-01 -4.2854112911528172e-02 + 5.7039307230496383e-01 -4.0980534671818086e-02 + 5.8291129869929525e-01 -3.9062669861963564e-02 + 5.9478883752272804e-01 -3.7160049701086884e-02 + 6.0595940952583338e-01 -3.5298828410149453e-02 + 6.1637666392096191e-01 -3.3492657048754863e-02 + 6.2601930836585895e-01 -3.1778556170793046e-02 + 6.3488118717895681e-01 -3.0168299070326206e-02 + 6.4297179001306437e-01 -2.8668420092743434e-02 + 6.5031398343522795e-01 -2.7283476337317911e-02 + 6.5694176363986900e-01 -2.6020367148420227e-02 + 6.6289576616047052e-01 -2.4879006171461198e-02 + 6.6822085186622315e-01 -2.3853830364985781e-02 + 6.7296462953929681e-01 -2.2938016534554306e-02 + 6.7717564899541971e-01 -2.2123666773326243e-02 + 6.8090197900852434e-01 -2.1402217571023813e-02 + 6.8419019314819662e-01 -2.0765023534694317e-02 + 6.8708462256308867e-01 -2.0203666110874076e-02 + 6.8962681555059202e-01 -1.9709876126594278e-02 + 6.9185530289453545e-01 -1.9276024654955572e-02 + 6.9380555132831789e-01 -1.8895662141911778e-02 + 6.9550991192878719e-01 -1.8563323845783075e-02 + 6.9699741323577824e-01 -1.8272995419722503e-02 + 6.9829418805624166e-01 -1.8019626798989649e-02 + 6.9942370211991189e-01 -1.7799351816990813e-02 + 3.5916947350090067e-01 -5.5711194024025017e-02 + 3.6478373114412760e-01 -5.5680380212544997e-02 + 3.7105169706752894e-01 -5.5643378808496638e-02 + 3.7801709310920834e-01 -5.5599078988450380e-02 + 3.8571661892159181e-01 -5.5475852970630554e-02 + 3.9417981805027830e-01 -5.5290596593280707e-02 + 4.0342512495779520e-01 -5.5082759014950036e-02 + 4.1345396591683320e-01 -5.4784802362218478e-02 + 4.2425216354970657e-01 -5.4380255096637950e-02 + 4.3578869287781102e-01 -5.3939900979640597e-02 + 4.4799975482992366e-01 -5.3259243026886879e-02 + 4.6081836121243885e-01 -5.2531845309123630e-02 + 4.7413154485780645e-01 -5.1520363855504930e-02 + 4.8783699145254433e-01 -5.0431627965442455e-02 + 5.0178905575617638e-01 -4.9109720484296820e-02 + 5.1585634893702781e-01 -4.7697499459915076e-02 + 5.2988233828683162e-01 -4.6108989647720880e-02 + 5.4372310611579511e-01 -4.4394305646321609e-02 + 5.5724561481623780e-01 -4.2617049059871188e-02 + 5.7031798231837616e-01 -4.0753634795379884e-02 + 5.8283320327786603e-01 -3.8846174487290379e-02 + 5.9470814160011531e-01 -3.6954253567075115e-02 + 6.0587650251431546e-01 -3.5103814521193578e-02 + 6.1629189079644098e-01 -3.3308238842196233e-02 + 6.2593300973309918e-01 -3.1604543366058148e-02 + 6.3479365972030954e-01 -3.0004346552076105e-02 + 6.4288328919007309e-01 -2.8514050177378684e-02 + 6.5022472202152792e-01 -2.7138128786120909e-02 + 6.5685192960786409e-01 -2.5883475495476815e-02 + 6.6280551452485703e-01 -2.4749988306510935e-02 + 6.6813030623361924e-01 -2.3732080486326541e-02 + 6.7287388835827622e-01 -2.2822924709203739e-02 + 6.7708478694612018e-01 -2.2014633127114464e-02 + 6.8081105127850883e-01 -2.1298661461003759e-02 + 6.8409923983180720e-01 -2.0666391468581097e-02 + 6.8699367260161892e-01 -2.0109437353625043e-02 + 6.8953588784101139e-01 -1.9619564557355616e-02 + 6.9176440879391765e-01 -1.9189181520884321e-02 + 6.9371469750846715e-01 -1.8811881407397681e-02 + 6.9541910246811933e-01 -1.8482244588639701e-02 + 6.9690664893764709e-01 -1.8194290415636402e-02 + 6.9820346792739385e-01 -1.7943003675868069e-02 + 6.9933302502764949e-01 -1.7724556032945812e-02 + 3.5916782057936042e-01 -5.5487326263727522e-02 + 3.6478036286084659e-01 -5.5453756774875886e-02 + 3.7104639221648472e-01 -5.5414112045737957e-02 + 3.7800961658786786e-01 -5.5367407278921914e-02 + 3.8570671539457563e-01 -5.5241621494189826e-02 + 3.9416722595918130e-01 -5.5053980043353684e-02 + 4.0340959159772383e-01 -5.4844461856986312e-02 + 4.1343523221850592e-01 -5.4545250183449079e-02 + 4.2422998969311948e-01 -5.4140004728387058e-02 + 4.3576289404379254e-01 -5.3700307336041225e-02 + 4.4797011981856288e-01 -5.3020331362063119e-02 + 4.6078481016303108e-01 -5.2295320369073188e-02 + 4.7409394941720867e-01 -5.1286269244530260e-02 + 4.8779540468207699e-01 -5.0201645853779363e-02 + 5.0174350036905557e-01 -4.8884340000981311e-02 + 5.1580700140740632e-01 -4.7478173704916408e-02 + 5.2982936868758956e-01 -4.5896329514575708e-02 + 5.4366675034896816e-01 -4.4189018876209372e-02 + 5.5718618549427557e-01 -4.2419972467668834e-02 + 5.7025576591449567e-01 -4.0565050849649738e-02 + 5.8276850260800128e-01 -3.8666279474212639e-02 + 5.9464129211166961e-01 -3.6783288112714640e-02 + 6.0580782660428811e-01 -3.4941843028035491e-02 + 6.1622167388142957e-01 -3.3155101789474166e-02 + 6.2586153353857310e-01 -3.1460078061086139e-02 + 6.3472116951673940e-01 -2.9868261938857096e-02 + 6.4280999607610323e-01 -2.8385945470303455e-02 + 6.5015080173998507e-01 -2.7017535056712998e-02 + 6.5677753739271072e-01 -2.5769919010740293e-02 + 6.6273077835101435e-01 -2.4642982751258584e-02 + 6.6805532810830781e-01 -2.3631120311519281e-02 + 6.7279874950212970e-01 -2.2727501342230002e-02 + 6.7700954894287968e-01 -2.1924246714731005e-02 + 6.8073575961384447e-01 -2.1212828444559687e-02 + 6.8402392753255548e-01 -2.0584651114232449e-02 + 6.8691836349401847e-01 -2.0031356364083992e-02 + 6.8946059746307575e-01 -1.9544738576223103e-02 + 6.9168914646462099e-01 -1.9117237381574663e-02 + 6.9363946868715798e-01 -1.8742481532449957e-02 + 6.9534391048264577e-01 -1.8415088945571440e-02 + 6.9683149441671144e-01 -1.8129107038346384e-02 + 6.9812835002152129e-01 -1.7879549598431597e-02 + 6.9925794277956044e-01 -1.7662619736141388e-02 + 3.5916644787900276e-01 -5.5300775018392485e-02 + 3.6477756644756570e-01 -5.5264914729855730e-02 + 3.7104198850839837e-01 -5.5223074248188515e-02 + 3.7800341050232711e-01 -5.5174373993778496e-02 + 3.8569849507197357e-01 -5.5046465694032744e-02 + 3.9415677443513708e-01 -5.4856849491769201e-02 + 4.0339669935379052e-01 -5.4645945748559140e-02 + 4.1341968449935179e-01 -5.4345705594183356e-02 + 4.2421158782379781e-01 -5.3939898136054765e-02 + 4.3574148516480410e-01 -5.3500769523206919e-02 + 4.4794552911811947e-01 -5.2821386207368058e-02 + 4.6075697210677435e-01 -5.2098389219695992e-02 + 4.7406275806036757e-01 -5.1091390831516002e-02 + 4.8776090490064766e-01 -5.0010221542224738e-02 + 5.0170571165029776e-01 -4.8696778085056396e-02 + 5.1576607092195137e-01 -4.7295683260227081e-02 + 5.2978543807457879e-01 -4.5719418479901013e-02 + 5.4362001575260810e-01 -4.4018274887387965e-02 + 5.5713690657926840e-01 -4.2256089532908062e-02 + 5.7020418041771170e-01 -4.0408261652482499e-02 + 5.8271486166615905e-01 -3.8516744558075272e-02 + 5.9458587380786165e-01 -3.6641204360444289e-02 + 6.0575089806149218e-01 -3.4807260631177318e-02 + 6.1616347144223926e-01 -3.3027884859117403e-02 + 6.2580229043415081e-01 -3.1340088011327157e-02 + 6.3466108870612137e-01 -2.9755253699598392e-02 + 6.4274925217265844e-01 -2.8279583072908943e-02 + 6.5008954005206920e-01 -2.6917426222930169e-02 + 6.5671588625393407e-01 -2.5675667739186381e-02 + 6.6266884352915900e-01 -2.4554182887008794e-02 + 6.6799319388146594e-01 -2.3547350042654899e-02 + 6.7273648295622912e-01 -2.2648336643036941e-02 + 6.7694720092391081e-01 -2.1849271071338772e-02 + 6.8067336765897724e-01 -2.1141639117636630e-02 + 6.8396151888342294e-01 -2.0516864530740354e-02 + 6.8685595779321196e-01 -1.9966611915683229e-02 + 6.8939820750611280e-01 -1.9482699842187718e-02 + 6.9162677991147214e-01 -1.9057593968685928e-02 + 6.9357713001397947e-01 -1.8684952698991921e-02 + 6.9528160241109338e-01 -1.8359425201273843e-02 + 6.9676921744074027e-01 -1.8075082270462901e-02 + 6.9806610341756448e-01 -1.7826961829448346e-02 + 6.9919572574016520e-01 -1.7611293136658678e-02 + 3.5916530739585650e-01 -5.5145319404457216e-02 + 3.6477524370141962e-01 -5.5107554166932707e-02 + 3.7103833106166023e-01 -5.5063888970038645e-02 + 3.7799825639117862e-01 -5.5013532057486512e-02 + 3.8569166841242469e-01 -5.4883862683098340e-02 + 3.9414809514776983e-01 -5.4692610124021358e-02 + 4.0338599361335553e-01 -5.4480562568328575e-02 + 4.1340677416488397e-01 -5.4179477916034183e-02 + 4.2419630818315635e-01 -5.3773216465463868e-02 + 4.3572370967196905e-01 -5.3334577400389237e-02 + 4.4792511295628873e-01 -5.2655705581642398e-02 + 4.6073386139937889e-01 -5.1934405072249321e-02 + 4.7403686525535482e-01 -5.0929137170685854e-02 + 4.8773226787100404e-01 -4.9850865851486216e-02 + 5.0167434704045832e-01 -4.8540661106471678e-02 + 5.1573210145283588e-01 -4.7143811224727647e-02 + 5.2974898171479101e-01 -4.5572213845587364e-02 + 5.4358123563689809e-01 -4.3876225795968490e-02 + 5.5709601848289525e-01 -4.2119771909638691e-02 + 5.7016138173770392e-01 -4.0277867441345705e-02 + 5.8267036080772094e-01 -3.8392405353887861e-02 + 5.9453990145294844e-01 -3.6523081598970573e-02 + 6.0570367569746553e-01 -3.4695393622625706e-02 + 6.1611519493252087e-01 -3.2922158224293674e-02 + 6.2575315302350665e-01 -3.1240384084681119e-02 + 6.3461125849036071e-01 -2.9661366430117360e-02 + 6.4269887372036938e-01 -2.8191231053311359e-02 + 6.5003873362592102e-01 -2.6834281465864990e-02 + 6.5666475805476332e-01 -2.5597399357861855e-02 + 6.6261748106137652e-01 -2.4480451773341075e-02 + 6.6794166685001755e-01 -2.3477804309534302e-02 + 6.7268484683345608e-01 -2.2582622779820479e-02 + 6.7689549773864366e-01 -2.1787042005255910e-02 + 6.8062162842623575e-01 -2.1082559396289054e-02 + 6.8390976610141296e-01 -2.0460614778796543e-02 + 6.8680420767684558e-01 -1.9912891968414545e-02 + 6.8934647060790177e-01 -1.9431229741734574e-02 + 6.9157506253803769e-01 -1.9008115472994764e-02 + 6.9352543584245818e-01 -1.8637232271168140e-02 + 6.9522993367217745e-01 -1.8313255321101275e-02 + 6.9671757452453165e-01 -1.8030274890959101e-02 + 6.9801448570965008e-01 -1.7783348993544671e-02 + 6.9914413256061203e-01 -1.7568728635948681e-02 + 3.5916435946635283e-01 -5.5015775747930068e-02 + 3.6477331354617470e-01 -5.4976425964748256e-02 + 3.7103529204293634e-01 -5.4931243822436915e-02 + 3.7799397397389739e-01 -5.4879510852927534e-02 + 3.8568599650519131e-01 -5.4748379442656807e-02 + 3.9414088420497811e-01 -5.4555769916319545e-02 + 4.0337709933662963e-01 -5.4342776960211114e-02 + 4.1339604869418145e-01 -5.4040997595334130e-02 + 4.2418361486958411e-01 -5.3634368128845623e-02 + 4.3570894366207152e-01 -5.3196148209307119e-02 + 4.4790815418745711e-01 -5.2517715301249469e-02 + 4.6071466550300127e-01 -5.1797841564469406e-02 + 4.7401535980007625e-01 -5.0794030021211106e-02 + 4.8770848475993744e-01 -4.9718187732755124e-02 + 5.0164830043511832e-01 -4.8410696327437545e-02 + 5.1570389367730229e-01 -4.7017397353627477e-02 + 5.2971871103031032e-01 -4.5449702338373511e-02 + 5.4354903775981844e-01 -4.3758022319877632e-02 + 5.5706207278607101e-01 -4.2006354666198988e-02 + 5.7012585220334255e-01 -4.0169394975862041e-02 + 5.8263342047744249e-01 -3.8288985753268542e-02 + 5.9450174180411497e-01 -3.6424847500185452e-02 + 6.0566448050126875e-01 -3.4602375975282096e-02 + 6.1607512662582331e-01 -3.2834259341896238e-02 + 6.2571237184251283e-01 -3.1157504347475641e-02 + 6.3456990376955236e-01 -2.9583332816215478e-02 + 6.4265706525623567e-01 -2.8117808026280000e-02 + 6.4999657104228048e-01 -2.6765194920173003e-02 + 6.5662232931751718e-01 -2.5532372917779829e-02 + 6.6257485863422383e-01 -2.4419202384549473e-02 + 6.6789890844176125e-01 -2.3420038461736167e-02 + 6.7264199836008554e-01 -2.2528045768793890e-02 + 6.7685259397764452e-01 -2.1735364619487461e-02 + 6.8057869503237167e-01 -2.1033502209689366e-02 + 6.8386682167707658e-01 -2.0413911838630224e-02 + 6.8676126562391704e-01 -1.9868293383324204e-02 + 6.8930353964071189e-01 -1.9388502495809635e-02 + 6.9153214785699191e-01 -1.8967044665682727e-02 + 6.9348254047373659e-01 -1.8597623586368107e-02 + 6.9518705944786474e-01 -1.8274936104488604e-02 + 6.9667472175419709e-01 -1.7993088710127194e-02 + 6.9797165387306281e-01 -1.7747156141253967e-02 + 6.9910132108608347e-01 -1.7533407498972947e-02 + 3.5916357129572618e-01 -5.4907824615338809e-02 + 3.6477170899390460e-01 -5.4867156458821120e-02 + 3.7103276585871514e-01 -5.4820712804896296e-02 + 3.7799041435618447e-01 -5.4767836331918909e-02 + 3.8568128205309926e-01 -5.4635490508857326e-02 + 3.9413489066930224e-01 -5.4441754939602405e-02 + 4.0336970686623996e-01 -5.4227979708953655e-02 + 4.1338713449461723e-01 -5.3925627876023105e-02 + 4.2417306550369233e-01 -5.3518699100299265e-02 + 4.3569667218195263e-01 -5.3080836467241939e-02 + 4.4789406098272183e-01 -5.2402778370207265e-02 + 4.6069871397774997e-01 -5.1684102932771266e-02 + 4.7399748997263602e-01 -5.0681515233976855e-02 + 4.8768872346097047e-01 -4.9607707185546884e-02 + 5.0162665967405440e-01 -4.8302487199832649e-02 + 5.1568045876464497e-01 -4.6912156934664891e-02 + 5.2969356381763399e-01 -4.5347723084530042e-02 + 5.4352229118020290e-01 -4.3659641488230677e-02 + 5.5703387600246668e-01 -4.1911969517113581e-02 + 5.7009634149913224e-01 -4.0079136623870755e-02 + 5.8260273960419695e-01 -3.8202943144622650e-02 + 5.9447004978473739e-01 -3.6343129812518991e-02 + 6.0563192990535697e-01 -3.4525007707000156e-02 + 6.1604185225799979e-01 -3.2761157988684349e-02 + 6.2567850666033031e-01 -3.1088585774053729e-02 + 6.3453556335228656e-01 -2.9518451899232013e-02 + 6.4262234895001802e-01 -2.8056767748789971e-02 + 6.4996156144160755e-01 -2.6707766301409634e-02 + 6.5658709934511283e-01 -2.5478325189421353e-02 + 6.6253946835008404e-01 -2.4368299336170456e-02 + 6.6786340566578883e-01 -2.3372035307612480e-02 + 6.7260642113331015e-01 -2.2482696841929464e-02 + 6.7681697110517047e-01 -2.1692428921606742e-02 + 6.8054304775647789e-01 -2.0992746969791663e-02 + 6.8383116539545874e-01 -2.0375115567584506e-02 + 6.8672561142568866e-01 -1.9831248014151717e-02 + 6.8926789473101080e-01 -1.9353014050400352e-02 + 6.9149651653015376e-01 -1.8932934275518402e-02 + 6.9344692522434181e-01 -1.8564729534266963e-02 + 6.9515146178348608e-01 -1.8243114711504537e-02 + 6.9663914192166287e-01 -1.7962209811254314e-02 + 6.9793609143302315e-01 -1.7717103497555599e-02 + 6.9906577555853111e-01 -1.7504079928481703e-02 + 3.5916291574821602e-01 -5.4817866696024085e-02 + 3.6477037465065126e-01 -5.4776101375901796e-02 + 3.7103066521128614e-01 -5.4728608318880746e-02 + 3.7798745445780957e-01 -5.4674781210577977e-02 + 3.8567736197960278e-01 -5.4541426187382877e-02 + 3.9412990714458357e-01 -5.4346755637892201e-02 + 4.0336356029702686e-01 -5.4132332466875134e-02 + 4.1337972285265007e-01 -5.3829508172649192e-02 + 4.2416429456885851e-01 -5.3422335216711109e-02 + 4.3568646980364661e-01 -5.2984776013041662e-02 + 4.4788234446655195e-01 -5.2307036698958587e-02 + 4.6068545309592790e-01 -5.1589366476832245e-02 + 4.7398263500928950e-01 -5.0587805914244589e-02 + 4.8767229694915754e-01 -4.9515700214653756e-02 + 5.0160867176964763e-01 -4.8212380409119314e-02 + 5.1566098058858112e-01 -4.6824530911400285e-02 + 5.2967266355614473e-01 -4.5262821241058675e-02 + 5.4350006282768282e-01 -4.3577744303822580e-02 + 5.5701044363763275e-01 -4.1833407159207046e-02 + 5.7007181842934274e-01 -4.0004017638271036e-02 + 5.8257724530240240e-01 -3.8131340852135182e-02 + 5.9444371638475113e-01 -3.6275134231760368e-02 + 6.0560488414085312e-01 -3.4460638333373025e-02 + 6.1601420606807999e-01 -3.2700345286771314e-02 + 6.2565037043556759e-01 -3.1031258835071979e-02 + 6.3450703302964961e-01 -2.9464489119434070e-02 + 6.4259350697348905e-01 -2.8006004423374916e-02 + 6.4993247633734197e-01 -2.6660011214843439e-02 + 6.5655783161009051e-01 -2.5433385710996216e-02 + 6.6251006780194133e-01 -2.4325978387763694e-02 + 6.6783391196197628e-01 -2.3332128763156955e-02 + 6.7257686581651810e-01 -2.2444999921942935e-02 + 6.7678737805430300e-01 -2.1656740802226807e-02 + 6.8051343457622615e-01 -2.0958873735038172e-02 + 6.8380154484288547e-01 -2.0342872741449670e-02 + 6.8669599268558212e-01 -1.9800462332523167e-02 + 6.8923828376724017e-01 -1.9323524008392174e-02 + 6.9146691689332263e-01 -1.8904590969279562e-02 + 6.9341733897381608e-01 -1.8537398350936235e-02 + 6.9512189016195514e-01 -1.8216676060586176e-02 + 6.9660958512696325e-01 -1.7936555361043816e-02 + 6.9790654909487682e-01 -1.7692136512874764e-02 + 6.9903624727433034e-01 -1.7479716206561753e-02 + 3.5916237035336052e-01 -5.4742902723060892e-02 + 3.6476926467145554e-01 -5.4700224149238599e-02 + 3.7102891786581338e-01 -5.4651857905297654e-02 + 3.7798499244711736e-01 -5.4597240219535638e-02 + 3.8567410137275621e-01 -5.4463046187904748e-02 + 3.9412576206568589e-01 -5.4267598889665515e-02 + 4.0335844795210379e-01 -5.4052638571106364e-02 + 4.1337355843102225e-01 -5.3749423815613880e-02 + 4.2415699977404558e-01 -5.3342051092319716e-02 + 4.3567798472691993e-01 -5.2904748779195092e-02 + 4.4787260041868648e-01 -5.2227279681502176e-02 + 4.6067442507757889e-01 -5.1510451838911314e-02 + 4.7397028178106820e-01 -5.0509752372194336e-02 + 4.8765863741197674e-01 -4.9439070362584089e-02 + 5.0159371449173606e-01 -4.8137339235252471e-02 + 5.1564478485774556e-01 -4.6751561893427933e-02 + 5.2965528617769053e-01 -4.5192127009184985e-02 + 5.4348158204767016e-01 -4.3509558187961150e-02 + 5.5699096269647164e-01 -4.1768003673138474e-02 + 5.7005143156417759e-01 -3.9941486729472321e-02 + 5.8255605184713610e-01 -3.8071743053433062e-02 + 5.9442182617787920e-01 -3.6218543876469431e-02 + 6.0558240250486040e-01 -3.4407071015717827e-02 + 6.1599122600358192e-01 -3.2649742506560470e-02 + 6.2562698364593428e-01 -3.0983560937567427e-02 + 6.3448331919379342e-01 -2.9419594295102543e-02 + 6.4256953455051147e-01 -2.7963775046682276e-02 + 6.4990830221797691e-01 -2.6620287657575022e-02 + 6.5653350601578275e-01 -2.5396007217973946e-02 + 6.6248563208283195e-01 -2.4290780559904749e-02 + 6.6780939902945258e-01 -2.3298941397651249e-02 + 6.7255230184407544e-01 -2.2413652328874909e-02 + 6.7676278285222113e-01 -2.1627065634002879e-02 + 6.8048882274616529e-01 -2.0930709437347067e-02 + 6.8377692696312897e-01 -2.0316065654010430e-02 + 6.8667137637027720e-01 -1.9774868157194331e-02 + 6.8921367395760058e-01 -1.9299008259513788e-02 + 6.9144231652831667e-01 -1.8881029668754469e-02 + 6.9339274975595377e-01 -1.8514679428894655e-02 + 6.9509731311710388e-01 -1.8194699958792651e-02 + 6.9658502041435566e-01 -1.7915231901606512e-02 + 6.9788199640303239e-01 -1.7671385175726737e-02 + 6.9901170626590492e-01 -1.7459466904664198e-02 + 3.5916191649015572e-01 -5.4680433422032659e-02 + 3.6476834108313538e-01 -5.4636994544617887e-02 + 3.7102746400097725e-01 -5.4587901574051467e-02 + 3.7798294400063864e-01 -5.4532626216981891e-02 + 3.8567138852399135e-01 -5.4397734418287415e-02 + 3.9412231338389458e-01 -5.4201641525494483e-02 + 4.0335419458379773e-01 -5.3986235563541284e-02 + 4.1336842985101929e-01 -5.3682697723613240e-02 + 4.2415093089086153e-01 -5.3275161152219662e-02 + 4.3567092576972910e-01 -5.2838075762733361e-02 + 4.4786449430375025e-01 -5.2160835068804055e-02 + 4.6066525110668788e-01 -5.1444712528739084e-02 + 4.7396000572260405e-01 -5.0444734278573662e-02 + 4.8764727510385880e-01 -4.9375242255341449e-02 + 5.0158127314820422e-01 -4.8074838695498820e-02 + 5.1563131389977546e-01 -4.6690791575556674e-02 + 5.2964083293135789e-01 -4.5133255620882155e-02 + 5.4346621165963260e-01 -4.3452779886365124e-02 + 5.5697476108851984e-01 -4.1713546777884435e-02 + 5.7003447713597000e-01 -3.9889425838367312e-02 + 5.8253842721685867e-01 -3.8022128209405100e-02 + 5.9440362268478453e-01 -3.6171436542204109e-02 + 6.0556370771360624e-01 -3.4362483725984813e-02 + 6.1597211721546963e-01 -3.2607626119854662e-02 + 6.2560753707653460e-01 -3.0943865343189228e-02 + 6.3446360105245903e-01 -2.9382234317551523e-02 + 6.4254960171417030e-01 -2.7928635735860963e-02 + 6.4988820194407337e-01 -2.6587235790543177e-02 + 6.5651328001937126e-01 -2.5364908670112596e-02 + 6.6246531470616232e-01 -2.4261498213703651e-02 + 6.6778901760227238e-01 -2.3271333348531643e-02 + 6.7253187809846204e-01 -2.2387576306612741e-02 + 6.7674233323407695e-01 -2.1602382186272896e-02 + 6.8046835937483408e-01 -2.0907283965541451e-02 + 6.8375645861676937e-01 -2.0293770157052766e-02 + 6.8665090936570650e-01 -1.9753582449196710e-02 + 6.8919321239238374e-01 -1.9278620340978520e-02 + 6.9142186283757601e-01 -1.8861436301275271e-02 + 6.9337230534873107e-01 -1.8495787296624069e-02 + 6.9507687884144609e-01 -1.8176426167669266e-02 + 6.9656459639907709e-01 -1.7897501372984799e-02 + 6.9786158238638318e-01 -1.7654130875015456e-02 + 6.9899130196551518e-01 -1.7442630483699404e-02 + 3.5916164558712949e-01 -5.4628812355612059e-02 + 3.6476780254103519e-01 -5.4584861977822675e-02 + 3.7102662362829508e-01 -5.4535315278653136e-02 + 3.7798176617712109e-01 -5.4479677480157404e-02 + 3.8566983482929956e-01 -5.4344432010947893e-02 + 3.9412034577211008e-01 -5.4148074765775038e-02 + 4.0335177857742588e-01 -5.3932615183936508e-02 + 4.1336553100001372e-01 -5.3629176277918467e-02 + 4.2414752007274709e-01 -5.3221922227681642e-02 + 4.3566698615748961e-01 -5.2785470281118435e-02 + 4.4786000368457629e-01 -5.2108932322126135e-02 + 4.6066021377204436e-01 -5.1393922747482418e-02 + 4.7395441475888184e-01 -5.0395121157295455e-02 + 4.8764115750481091e-01 -4.9327184622587089e-02 + 5.0157464669338614e-01 -4.8028464970683866e-02 + 5.1562422181079137e-01 -4.6646396362716516e-02 + 5.2963331253345103e-01 -4.5090954589098224e-02 + 5.4345830760669078e-01 -4.3412688491371282e-02 + 5.5696652669338864e-01 -4.1675783673340024e-02 + 5.7002595642244913e-01 -3.9853995683755791e-02 + 5.8252966308472620e-01 -3.7989008555839268e-02 + 5.9439466005196584e-01 -3.6140601510523819e-02 + 6.0555458658750838e-01 -3.4333870330427674e-02 + 6.1596286987617710e-01 -3.2581131322955884e-02 + 6.2559819415572948e-01 -3.0919384166480227e-02 + 6.3445418715880852e-01 -2.9359642989916269e-02 + 6.4254013648135566e-01 -2.7907797274095994e-02 + 6.4987870038299911e-01 -2.6568008131149748e-02 + 6.5650375499523783e-01 -2.5347154918904050e-02 + 6.6245577614360329e-01 -2.4245085999367855e-02 + 6.6777947278330640e-01 -2.3256134166700550e-02 + 6.7252233241382042e-01 -2.2373467798700863e-02 + 6.7673279031386580e-01 -2.1589249515102243e-02 + 6.8045882150841486e-01 -2.0895020443873414e-02 + 6.8374692715585028e-01 -2.0282277629860131e-02 + 6.8664138506121031e-01 -1.9742771365854776e-02 + 6.8918369542049673e-01 -1.9268409406175465e-02 + 6.9141235298467352e-01 -1.8851752239197224e-02 + 6.9336280223982405e-01 -1.8486564917888273e-02 + 6.9506738209417041e-01 -1.8167608152253205e-02 + 6.9655510549362787e-01 -1.7889036637924832e-02 + 6.9785209677613302e-01 -1.7645974332935958e-02 + 6.9898182121351571e-01 -1.7434743030776145e-02 + 3.5916142322509120e-01 -5.4585802861455847e-02 + 3.6476736109643870e-01 -5.4541430099647979e-02 + 3.7102593512742088e-01 -5.4491510124057271e-02 + 3.7798080151000674e-01 -5.4435576217307290e-02 + 3.8566856261010712e-01 -5.4300043306333291e-02 + 3.9411873498221012e-01 -5.4103474535430317e-02 + 4.0334980121798136e-01 -5.3887980480900585e-02 + 4.1336315914067684e-01 -5.3584635869218585e-02 + 4.2414473024930777e-01 -5.3177630760229980e-02 + 4.3566376513800065e-01 -5.2741721311198309e-02 + 4.4785633377116613e-01 -5.2065785521457561e-02 + 4.6065609923405876e-01 -5.1351720434352904e-02 + 4.7394985052917060e-01 -5.0353918039374529e-02 + 4.8763616652490882e-01 -4.9287296054585948e-02 + 5.0156924416000470e-01 -4.7989998426227205e-02 + 5.1561844381246003e-01 -4.6609596062874369e-02 + 5.2962719011091131e-01 -4.5055916136884096e-02 + 5.4345187766693925e-01 -4.3379506623320227e-02 + 5.5695983308192154e-01 -4.1644554978528335e-02 + 5.7001903514556473e-01 -3.9824722196723110e-02 + 5.8252254906287149e-01 -3.7961669503769231e-02 + 5.9438738971875971e-01 -3.6115172845623322e-02 + 6.0554719222717057e-01 -3.4310297196168502e-02 + 6.1595537735912798e-01 -3.2559325846532101e-02 + 6.2559062795457443e-01 -3.0899256820970833e-02 + 6.3444656680071132e-01 -2.9341088920956070e-02 + 6.4253247743733277e-01 -2.7890700988661813e-02 + 6.4987101438018191e-01 -2.6552250228347080e-02 + 6.5649605205198758e-01 -2.5332620496639705e-02 + 6.6244806393044908e-01 -2.4231664150688868e-02 + 6.6777175687122292e-01 -2.3243717460131642e-02 + 6.7251461688673742e-01 -2.2361954132292017e-02 + 6.7672507787332359e-01 -2.1578543222203737e-02 + 6.8045111381122148e-01 -2.0885032782173966e-02 + 6.8373922513690233e-01 -2.0272927065802932e-02 + 6.8663368920111889e-01 -1.9733983604522939e-02 + 6.8917600576197258e-01 -1.9260117079136371e-02 + 6.9140466927759836e-01 -1.8843894684973241e-02 + 6.9335512412182132e-01 -1.8479088208701616e-02 + 6.9505970921144644e-01 -1.8160464892842815e-02 + 6.9654743739279246e-01 -1.7882184622407468e-02 + 6.9784443299104892e-01 -1.7639376329838613e-02 + 6.9897416137352131e-01 -1.7428366755069112e-02 + 3.5916124025272872e-01 -5.4549967250945144e-02 + 3.6476699827026204e-01 -5.4505245160264837e-02 + 3.7102536949284304e-01 -5.4455017441637478e-02 + 3.7798000920298092e-01 -5.4398840851232769e-02 + 3.8566751790956899e-01 -5.4263073411403524e-02 + 3.9411741251093396e-01 -5.4066334394958178e-02 + 4.0334817814705332e-01 -5.3850818630079095e-02 + 4.1336121272957460e-01 -5.3547560739768178e-02 + 4.2414244149727298e-01 -5.3140772363380863e-02 + 4.3566112356187764e-01 -5.2705325047180396e-02 + 4.4785332518130988e-01 -5.2029902441800051e-02 + 4.6065272766456145e-01 -5.1316636119326318e-02 + 4.7394611223446304e-01 -5.0319679198026157e-02 + 4.8763208092987936e-01 -4.9254165250916519e-02 + 5.0156482419001547e-01 -4.7958065535948925e-02 + 5.1561371958966296e-01 -4.6579063721662588e-02 + 5.2962218745883805e-01 -4.5026863472369484e-02 + 5.4344662713193581e-01 -4.3352011567488989e-02 + 5.5695437080187871e-01 -4.1618696449216300e-02 + 5.7001339065834100e-01 -3.9800500619190118e-02 + 5.8251675089876132e-01 -3.7939066148037735e-02 + 5.9438146755327503e-01 -3.6094165966229247e-02 + 6.0554117223843940e-01 -3.4290839451923114e-02 + 6.1594928039824015e-01 -3.2541342630249222e-02 + 6.2558447369117187e-01 -3.0882672121815530e-02 + 6.3444037083389282e-01 -2.9325814184143529e-02 + 6.4252625204761460e-01 -2.7876639049263508e-02 + 6.4986476880283617e-01 -2.6539300888582293e-02 + 6.5648979415267961e-01 -2.5320687438916339e-02 + 6.6244179968903560e-01 -2.4220654542172190e-02 + 6.6776549058835621e-01 -2.3233541538128396e-02 + 6.7250835168502543e-01 -2.2352526718488041e-02 + 6.7671881578168558e-01 -2.1569784615645654e-02 + 6.8044485603790694e-01 -2.0876869143715438e-02 + 6.8373297232927244e-01 -2.0265290631295906e-02 + 6.8662744166010281e-01 -1.9726812688896152e-02 + 6.8916976345150316e-01 -1.9253355801699533e-02 + 6.9139843193964201e-01 -1.8837492770564547e-02 + 6.9334889142014211e-01 -1.8473000990373616e-02 + 6.9505348082710305e-01 -1.8154653129821327e-02 + 6.9654121293407689e-01 -1.7876613392952333e-02 + 6.9783821206221730e-01 -1.7634014842225137e-02 + 6.9896794366111770e-01 -1.7423188312388049e-02 + 3.5916108937414909e-01 -5.4520108172710996e-02 + 3.6476669937739670e-01 -5.4475096799591088e-02 + 3.7102490370185237e-01 -5.4424614908216581e-02 + 3.7797935689785472e-01 -5.4368238877716843e-02 + 3.8566665795377120e-01 -5.4232279433778577e-02 + 3.9411632408072367e-01 -5.4035402682474601e-02 + 4.0334684256383230e-01 -5.3819873641985094e-02 + 4.1335961140994315e-01 -5.3516693608569671e-02 + 4.2414055898691239e-01 -5.3110092213222208e-02 + 4.3565895149774975e-01 -5.2675036906262206e-02 + 4.4785085212215603e-01 -5.2000049762539059e-02 + 4.6064995729909319e-01 -5.1287457101042322e-02 + 4.7394304176877666e-01 -5.0291213533142705e-02 + 4.8762872676211461e-01 -4.9226631583423594e-02 + 5.0156119727068038e-01 -4.7931538977688599e-02 + 5.1560984505369511e-01 -4.6553712530106810e-02 + 5.2961808679576428e-01 -4.5002753215378735e-02 + 5.4344232565318540e-01 -4.3329206491442160e-02 + 5.5694989834787323e-01 -4.1597261239195590e-02 + 5.7000877152297724e-01 -3.9780434757508316e-02 + 5.8251200846597240e-01 -3.7920353052332718e-02 + 5.9437662608167896e-01 -3.6076786344583660e-02 + 6.0553625304539116e-01 -3.4274752736411083e-02 + 6.1594430037385228e-01 -3.2526485701142679e-02 + 6.2557944872962434e-01 -3.0868980672453184e-02 + 6.3443531347216520e-01 -2.9313213611773005e-02 + 6.4252117209929682e-01 -2.7865047751178023e-02 + 6.4985967359517272e-01 -2.6528634888379171e-02 + 6.5648468990897346e-01 -2.5310866083841810e-02 + 6.6243669110937042e-01 -2.4211600189956790e-02 + 6.6776038102203150e-01 -2.3225179224325057e-02 + 6.7250324354154833e-01 -2.2344785397150783e-02 + 6.7671371059917518e-01 -2.1562597884211061e-02 + 6.8043975470494666e-01 -2.0870175547043891e-02 + 6.8372787529491819e-01 -2.0259033823277428e-02 + 6.8662234910661590e-01 -1.9720941421465417e-02 + 6.8916467529977876e-01 -1.9247823685880343e-02 + 6.9139334794061369e-01 -1.8832258100141542e-02 + 6.9334381127006695e-01 -1.8468026730068872e-02 + 6.9504840424366110e-01 -1.8149906754413223e-02 + 6.9653613958127392e-01 -1.7872065972480217e-02 + 6.9783314160523846e-01 -1.7629640877939126e-02 + 6.9896287583567640e-01 -1.7418965699259638e-02 + 3.5916096473871723e-01 -5.4495228345614842e-02 + 3.6476645267615004e-01 -5.4449977156731472e-02 + 3.7102451936643122e-01 -5.4399285019726178e-02 + 3.7797881876741218e-01 -5.4342744708633789e-02 + 3.8566594861892312e-01 -5.4206627620074666e-02 + 3.9411542641059732e-01 -5.4009638928844972e-02 + 4.0334574123010242e-01 -5.3794102130991013e-02 + 4.1335829117849521e-01 -5.3490990814120988e-02 + 4.2413900723951642e-01 -5.3084549608203309e-02 + 4.3565716152132583e-01 -5.2649825709800868e-02 + 4.4784881464547149e-01 -5.1975206808957550e-02 + 4.6064767562044479e-01 -5.1263181037583302e-02 + 4.7394051378470209e-01 -5.0267537964043797e-02 + 4.8762596628222504e-01 -4.9203738602228583e-02 + 5.0155821354352081e-01 -4.7909491325505794e-02 + 5.1560665904781522e-01 -4.6532650005679473e-02 + 5.2961471639838820e-01 -4.4982730203122059e-02 + 5.4343879185847055e-01 -4.3310276051774420e-02 + 5.5694622583424080e-01 -4.1579476534995330e-02 + 5.7000498031514157e-01 -3.9763794759028581e-02 + 5.8250811778183353e-01 -3.7904843272317662e-02 + 5.9437265581374066e-01 -3.6062389903053202e-02 + 6.0553222061621825e-01 -3.4261435060174678e-02 + 6.1594021952515643e-01 -3.2514193540578724e-02 + 6.2557533236535912e-01 -3.0857659776927469e-02 + 6.3443117172243890e-01 -2.9302801258452381e-02 + 6.4251701285387652e-01 -2.7855475504295200e-02 + 6.4985550270683445e-01 -2.6519832439474648e-02 + 6.5648051233628935e-01 -2.5302765955954674e-02 + 6.6243251057487407e-01 -2.4204137488067899e-02 + 6.6775620015573289e-01 -2.3218291366942423e-02 + 6.7249906421915950e-01 -2.2338413135412585e-02 + 6.7670953399770306e-01 -2.1556685892858252e-02 + 6.8043558148359018e-01 -2.0864672666857383e-02 + 6.8372370576588981e-01 -2.0253893184314628e-02 + 6.8661818337484859e-01 -1.9716120424188199e-02 + 6.8916051326564032e-01 -1.9243283795325042e-02 + 6.9138918937315630e-01 -1.8827964691290631e-02 + 6.9333965590003754e-01 -1.8463949068851071e-02 + 6.9504425182444463e-01 -1.8146017856873902e-02 + 6.9653198982631559e-01 -1.7868341848010772e-02 + 6.9782899423205480e-01 -1.7626060388177493e-02 + 6.9895873062196012e-01 -1.7415510521072108e-02 + 3.5916084437204504e-01 -5.4474497164882320e-02 + 3.6476623185932716e-01 -5.4429047096184076e-02 + 3.7102418528858461e-01 -5.4378180962525925e-02 + 3.7797835813986497e-01 -5.4321505232959429e-02 + 3.8566534712882228e-01 -5.4185258595506616e-02 + 3.9411466999246508e-01 -5.3988178814006249e-02 + 4.0334481733305405e-01 -5.3772638105666855e-02 + 4.1335718734163618e-01 -5.3469587016588341e-02 + 4.2413771318797239e-01 -5.3063282680671266e-02 + 4.3565567189582111e-01 -5.2628838615528500e-02 + 4.4784712195793019e-01 -5.1954530725792772e-02 + 4.6064578282361951e-01 -5.1242981619953221e-02 + 4.7393841932514041e-01 -5.0247843622928688e-02 + 4.8762368179982490e-01 -4.9184700998570051e-02 + 5.0155574685402493e-01 -4.7891162858050541e-02 + 5.1560402764886426e-01 -4.6515146852555957e-02 + 5.2961193517902849e-01 -4.4966097487801455e-02 + 5.4343587822904571e-01 -4.3294557621848952e-02 + 5.5694320019914356e-01 -4.1564716120263412e-02 + 5.7000185916951496e-01 -3.9749991039045987e-02 + 5.8250491690575168e-01 -3.7891983657560267e-02 + 5.9436939150244961e-01 -3.6050459706034162e-02 + 6.0552890708913476e-01 -3.4250404877356568e-02 + 6.1593686793814251e-01 -3.2504018494835467e-02 + 6.2557195316884995e-01 -3.0848294147789817e-02 + 6.3442777307337272e-01 -2.9294192348603542e-02 + 6.4251360106497801e-01 -2.7847565948550510e-02 + 6.4985208242164239e-01 -2.6512563393583686e-02 + 6.5647708747464784e-01 -2.5296080983042660e-02 + 6.6242908405428580e-01 -2.4197982359442132e-02 + 6.6775277401117794e-01 -2.3212613845064116e-02 + 6.7249563988168526e-01 -2.2333163812124125e-02 + 6.7670611233989142e-01 -2.1551818671543294e-02 + 6.8043216296711639e-01 -2.0860144955694264e-02 + 6.8372029058048300e-01 -2.0249665990565387e-02 + 6.8661477155146000e-01 -1.9712158331020673e-02 + 6.8915710467701163e-01 -1.9239554784702979e-02 + 6.9138578379272408e-01 -1.8824440009553221e-02 + 6.9333625307666036e-01 -1.8460603203463991e-02 + 6.9504085153114659e-01 -1.8142828414073837e-02 + 6.9652859180811144e-01 -1.7865288926490436e-02 + 6.9782559824110713e-01 -1.7623126458080150e-02 + 6.9895533646274866e-01 -1.7412680388478128e-02 + 3.5916074459037534e-01 -5.4457222570913615e-02 + 3.6476604905839088e-01 -5.4411607442525878e-02 + 3.7102390888323522e-01 -5.4360597153119118e-02 + 3.7797797715623893e-01 -5.4303809607190404e-02 + 3.8566484974965587e-01 -5.4167456281205999e-02 + 3.9411404461618715e-01 -5.3970302118642767e-02 + 4.0334405362833053e-01 -5.3754759930427831e-02 + 4.1335627506014577e-01 -5.3451761095614489e-02 + 4.2413664390750999e-01 -5.3045573171282050e-02 + 4.3565444128831454e-01 -5.2611364849255285e-02 + 4.4784572392497590e-01 -5.1937319020101104e-02 + 4.6064421994673299e-01 -5.1226170100442961e-02 + 4.7393669043086029e-01 -5.0231456249299873e-02 + 4.8762179666591560e-01 -4.9168864096425076e-02 + 5.0155371206003396e-01 -4.7875920172720347e-02 + 5.1560185778840162e-01 -4.6500594975987429e-02 + 5.2960964264854948e-01 -4.4952273885534598e-02 + 5.4343347748419402e-01 -4.3281498576313263e-02 + 5.5694070814201146e-01 -4.1552457674321808e-02 + 5.6999928942760170e-01 -3.9738531770191897e-02 + 5.8250228248442637e-01 -3.7881312714782914e-02 + 5.9436670580717399e-01 -3.6040564417244375e-02 + 6.0552618178540740e-01 -3.4241260327060666e-02 + 6.1593411214300853e-01 -3.2495586935450592e-02 + 6.2556917540730861e-01 -3.0840537122710940e-02 + 6.3442497997190295e-01 -2.9287065645147346e-02 + 6.4251079772893593e-01 -2.7841021528798447e-02 + 6.4984927258434044e-01 -2.6506552043867926e-02 + 6.5647427428005278e-01 -2.5290555529066717e-02 + 6.6242626982889918e-01 -2.4192897506522430e-02 + 6.6774996036411627e-01 -2.3207926001830123e-02 + 6.7249282793421339e-01 -2.2328831781379059e-02 + 6.7670330276271917e-01 -2.1547804044714822e-02 + 6.8042935610112654e-01 -2.0856412268130717e-02 + 6.8371748655028342e-01 -2.0246182794082166e-02 + 6.8661197035750543e-01 -1.9708895169045476e-02 + 6.8915430619510631e-01 -1.9236485041384942e-02 + 6.9138298782139351e-01 -1.8821539793347573e-02 + 6.9333345939783197e-01 -1.8457851323115781e-02 + 6.9503805994959178e-01 -1.8140206272803824e-02 + 6.9652580210775394e-01 -1.7862780003199463e-02 + 6.9782281021347403e-01 -1.7620716203894229e-02 + 6.9895254994374734e-01 -1.7410356194405754e-02 + 3.5916066180326212e-01 -5.4442828045861778e-02 + 3.6476589756789923e-01 -5.4397075836116131e-02 + 3.7102367993148488e-01 -5.4345946002256423e-02 + 3.7797766166790087e-01 -5.4289065994168474e-02 + 3.8566443795356692e-01 -5.4152624643605769e-02 + 3.9411352692770824e-01 -5.3955409559249996e-02 + 4.0334342152679664e-01 -5.3739867375113048e-02 + 4.1335552009969784e-01 -5.3436913521434391e-02 + 4.2413575916724144e-01 -5.3030824243596668e-02 + 4.3565342325739825e-01 -5.2596814146920100e-02 + 4.4784456762001329e-01 -5.1922988708041878e-02 + 4.6064292760303455e-01 -5.1212175339091962e-02 + 4.7393526115469847e-01 -5.0217817202410558e-02 + 4.8762023865969617e-01 -4.9155685994708417e-02 + 5.0155203085274569e-01 -4.7863239526150195e-02 + 5.1560006555004290e-01 -4.6488492122419241e-02 + 5.2960774970180702e-01 -4.4940779950832919e-02 + 5.4343149583841965e-01 -4.3270643616890578e-02 + 5.5693865181179358e-01 -4.1542271448532127e-02 + 5.6999716968669567e-01 -3.9729012868616888e-02 + 5.8250011007011349e-01 -3.7872451844646292e-02 + 5.9436449176960171e-01 -3.6032350717772554e-02 + 6.0552393571787599e-01 -3.4233672748268822e-02 + 6.1593184151823921e-01 -3.2488593777682540e-02 + 6.2556688720157339e-01 -3.0834106090932518e-02 + 6.3442267958848142e-01 -2.9281159687965540e-02 + 6.4250848931424975e-01 -2.7835600452359714e-02 + 6.4984695915459412e-01 -2.6501574713659628e-02 + 6.5647195836995809e-01 -2.5285982533372341e-02 + 6.6242395330449777e-01 -2.4188691027344392e-02 + 6.6774764450594115e-01 -2.3204049671317506e-02 + 6.7249051362711032e-01 -2.2325251251924479e-02 + 6.7670099052628696e-01 -2.1544487312947686e-02 + 6.8042704618895777e-01 -2.0853329799944337e-02 + 6.8371517904302470e-01 -2.0243307581136117e-02 + 6.8660966523782663e-01 -1.9706202704280293e-02 + 6.8915200334684790e-01 -1.9233953190584425e-02 + 6.9138068706787914e-01 -1.8819148695705262e-02 + 6.9333116055128652e-01 -1.8455583367190748e-02 + 6.9503576284298074e-01 -1.8138046006295157e-02 + 6.9652350655853168e-01 -1.7860713702613728e-02 + 6.9782051604661977e-01 -1.7618731786480466e-02 + 6.9895025702171421e-01 -1.7408443189120999e-02 + 3.5916059306709386e-01 -5.4430833284353282e-02 + 3.6476577191214887e-01 -5.4384967165755339e-02 + 3.7102349010163171e-01 -5.4333738118358399e-02 + 3.7797740014961395e-01 -5.4276781557561354e-02 + 3.8566409665738965e-01 -5.4140267466649829e-02 + 3.9411309792425991e-01 -5.3943002352582176e-02 + 4.0334289777740545e-01 -5.3727461031783164e-02 + 4.1335489463164454e-01 -5.3424545660388754e-02 + 4.2413502628099276e-01 -5.3018539725575277e-02 + 4.3565258009386520e-01 -5.2584696048765839e-02 + 4.4784361009492540e-01 -5.1911055662941213e-02 + 4.6064185763755594e-01 -5.1200523352765460e-02 + 4.7393407806263177e-01 -5.0206463215250505e-02 + 4.8761894931397060e-01 -4.9144717670717701e-02 + 5.0155063989296400e-01 -4.7852687328756180e-02 + 5.1559858312383544e-01 -4.6478422891907872e-02 + 5.2960618440600205e-01 -4.4931219559059897e-02 + 5.4342985765515506e-01 -4.3261616986526030e-02 + 5.5693695237092566e-01 -4.1533803185443634e-02 + 5.6999541832563994e-01 -3.9721101642611598e-02 + 5.8249831566665922e-01 -3.7865089737791215e-02 + 5.9436266344819788e-01 -3.6025528470345826e-02 + 6.0552208138393526e-01 -3.4227372619183606e-02 + 6.1592996731216665e-01 -3.2482789181413931e-02 + 6.2556499884820382e-01 -3.0828769942699886e-02 + 6.3442078150795245e-01 -2.9276260967490975e-02 + 6.4250658488678947e-01 -2.7831105551724983e-02 + 6.4984505082781119e-01 -2.6497449268758504e-02 + 6.5647004819687937e-01 -2.5282193631751607e-02 + 6.6242204278951233e-01 -2.4185207103583548e-02 + 6.6774573467422882e-01 -2.3200840389902892e-02 + 6.7248860518160125e-01 -2.2322287978395951e-02 + 6.7669908387263278e-01 -2.1541743380337944e-02 + 6.8042514151740485e-01 -2.0850780610372315e-02 + 6.8371327640449087e-01 -2.0240930649675897e-02 + 6.8660776460566675e-01 -1.9703977636223793e-02 + 6.8915010461545256e-01 -1.9231861572586401e-02 + 6.9137879008390846e-01 -1.8817174010871143e-02 + 6.9332926515402138e-01 -1.8453710972772479e-02 + 6.9503386889026331e-01 -1.8136263056701438e-02 + 6.9652161389651446e-01 -1.7859008792042306e-02 + 6.9781862452861998e-01 -1.7617094874834729e-02 + 6.9894836653242376e-01 -1.7406865575962476e-02 + 3.4904629891264977e-01 -7.8787801787484568e-02 + 3.4906571762713046e-01 -7.4719962179273083e-02 + 3.4908183766798834e-01 -7.1330278035645581e-02 + 3.4909522096681544e-01 -6.8505680326751334e-02 + 3.4910633434529198e-01 -6.6151954028526735e-02 + 3.4911556511871078e-01 -6.4190594127651587e-02 + 3.4912323435937037e-01 -6.2556185892529911e-02 + 3.4912960809712690e-01 -6.1194221944649158e-02 + 3.4913490671833358e-01 -6.0059283321709379e-02 + 3.4913931281006194e-01 -5.9113523867521160e-02 + 3.4914297768034647e-01 -5.8325407387527811e-02 + 3.4914602676106354e-01 -5.7668655425558740e-02 + 3.4914856407719852e-01 -5.7121370536805216e-02 + 3.4915067593919680e-01 -5.6665305785713826e-02 + 3.4915243399236623e-01 -5.6285256076108681e-02 + 3.4915389773499023e-01 -5.5968550990897370e-02 + 3.4915511659869597e-01 -5.5704632207422833e-02 + 3.4915613166749287e-01 -5.5484701380748902e-02 + 3.4915697709966420e-01 -5.5301426740570037e-02 + 3.4915768130418445e-01 -5.5148698609173152e-02 + 3.4915826791521098e-01 -5.5021425681317737e-02 + 3.4915875659938039e-01 -5.4915365268229266e-02 + 3.4915916372543171e-01 -5.4826981842211353e-02 + 3.4915950291973874e-01 -5.4753329162792824e-02 + 3.4915978552765647e-01 -5.4691952052308757e-02 + 3.4916001778692790e-01 -5.4641142192634377e-02 + 3.4916021117406693e-01 -5.4598805718517870e-02 + 3.4916037221286705e-01 -5.4563528912338025e-02 + 3.4916050632766388e-01 -5.4534134104148674e-02 + 3.4916061802981624e-01 -5.4509640210257712e-02 + 3.4916069375576531e-01 -5.4489229899710619e-02 + 3.4916075676323061e-01 -5.4472222182779570e-02 + 3.4916080920105447e-01 -5.4458049697615030e-02 + 3.4916085285146642e-01 -5.4446239721215740e-02 + 3.4289398580223224e-01 -7.8591533080810891e-02 + 3.4293908881853108e-01 -7.4547640907837734e-02 + 3.4297659989638346e-01 -7.1177935079091648e-02 + 3.4300779897041300e-01 -6.8370003882847460e-02 + 3.4303375077804055e-01 -6.6030180723316415e-02 + 3.4305534053634851e-01 -6.4080418204667491e-02 + 3.4307330392737229e-01 -6.2455683463608358e-02 + 3.4308825222811307e-01 -6.1101787794616010e-02 + 3.4310069331198223e-01 -5.9973578178233518e-02 + 3.4311104915621649e-01 -5.9033430398909806e-02 + 3.4311967041027719e-01 -5.8249993479932642e-02 + 3.4312684850100250e-01 -5.7597143533200744e-02 + 3.4313282568321468e-01 -5.7053112099097802e-02 + 3.4313780337956723e-01 -5.6599759872739241e-02 + 3.4314194909963158e-01 -5.6221971563147122e-02 + 3.4314540218010331e-01 -5.5907151679164713e-02 + 3.4314827854719138e-01 -5.5644804404110459e-02 + 3.4315067466879989e-01 -5.5426183532745199e-02 + 3.4315267083516382e-01 -5.5244000783233105e-02 + 3.4315433388291328e-01 -5.5092182746847129e-02 + 3.4315571945764523e-01 -5.4965668363621489e-02 + 3.4315687389369126e-01 -5.4860240164458673e-02 + 3.4315783577690701e-01 -5.4772383649321910e-02 + 3.4315863724347512e-01 -5.4699170108648304e-02 + 3.4315930506045628e-01 -5.4638158979741690e-02 + 3.4315985667304627e-01 -5.4587651298203914e-02 + 3.4316031610401942e-01 -5.4545566709740173e-02 + 3.4316069878270600e-01 -5.4510499865385226e-02 + 3.4316101755037315e-01 -5.4481280070266938e-02 + 3.4316128309525112e-01 -5.4456932055004209e-02 + 3.4316148734563462e-01 -5.4436643334593235e-02 + 3.4316165744013200e-01 -5.4419736961305643e-02 + 3.4316179910529832e-01 -5.4405648942832591e-02 + 3.4316191710319982e-01 -5.4393909365245435e-02 + 3.3557121015963975e-01 -7.8346141084836049e-02 + 3.3564681298808663e-01 -7.4332716534342883e-02 + 3.3570972537821037e-01 -7.0988427400919263e-02 + 3.3576207999166185e-01 -6.8201698665333474e-02 + 3.3580565166363363e-01 -6.5879561784441293e-02 + 3.3584191692196735e-01 -6.3944551797149043e-02 + 3.3587210383445032e-01 -6.2332121837909239e-02 + 3.3589723368357449e-01 -6.0988488747202994e-02 + 3.3591815574857314e-01 -5.9868837927229877e-02 + 3.3593557629091741e-01 -5.8935827572878741e-02 + 3.3595008268125337e-01 -5.8158342376102838e-02 + 3.3596216346539748e-01 -5.7510455107660584e-02 + 3.3597222504341423e-01 -5.6970561408462572e-02 + 3.3598060552976711e-01 -5.6520658898577381e-02 + 3.3598758626803898e-01 -5.6145746529523421e-02 + 3.3599340139776235e-01 -5.5833324119703320e-02 + 3.3599824580218179e-01 -5.5572975359908128e-02 + 3.3600228171255375e-01 -5.5356020364087044e-02 + 3.3600564419620271e-01 -5.5175226163513003e-02 + 3.3600844571815569e-01 -5.5024565478731802e-02 + 3.3601077993370537e-01 -5.4899015716642907e-02 + 3.3601272484184463e-01 -5.4794391482701599e-02 + 3.3601434540803155e-01 -5.4707205019113303e-02 + 3.3601569574632439e-01 -5.4634549911426661e-02 + 3.3601682093483320e-01 -5.4574004183109232e-02 + 3.3601775173669690e-01 -5.4523880804791848e-02 + 3.3601852705773971e-01 -5.4482116553805748e-02 + 3.3601917290206479e-01 -5.4447316726195294e-02 + 3.3601971091774047e-01 -5.4418319499238137e-02 + 3.3602015912757327e-01 -5.4394156999066315e-02 + 3.3602051598180283e-01 -5.4374022904209222e-02 + 3.3602081322620320e-01 -5.4357245408068668e-02 + 3.3602106083517447e-01 -5.4343264803733617e-02 + 3.3602126710932090e-01 -5.4331614749926843e-02 + 3.2693744953301651e-01 -7.8039777644420355e-02 + 3.2704890862329516e-01 -7.4065116411588652e-02 + 3.2714168295128004e-01 -7.0753162699886379e-02 + 3.2721890781192692e-01 -6.7993406608976695e-02 + 3.2728319295799896e-01 -6.5693768170944244e-02 + 3.2733671015657517e-01 -6.3777523778838399e-02 + 3.2738126639256715e-01 -6.2180745129393575e-02 + 3.2741836499944543e-01 -6.0850165193688903e-02 + 3.2744925664666674e-01 -5.9741400046665505e-02 + 3.2747498182183238e-01 -5.8817467251541092e-02 + 3.2749640619821718e-01 -5.8047551368531132e-02 + 3.2751425006132778e-01 -5.7405975383289808e-02 + 3.2752911278299773e-01 -5.6871343712714406e-02 + 3.2754149317168385e-01 -5.6425828168443104e-02 + 3.2755180639175902e-01 -5.6054573028475829e-02 + 3.2756039802896880e-01 -5.5745199347029484e-02 + 3.2756755578414370e-01 -5.5487391944978981e-02 + 3.2757351919522054e-01 -5.5272555287373848e-02 + 3.2757848772081771e-01 -5.5093526755157995e-02 + 3.2758262746243882e-01 -5.4944337736202442e-02 + 3.2758607675559065e-01 -5.4820014557733998e-02 + 3.2758895082047096e-01 -5.4716412615078980e-02 + 3.2759134563137582e-01 -5.4630078158467654e-02 + 3.2759334113658206e-01 -5.4558133125198055e-02 + 3.2759500393818125e-01 -5.4498179173819196e-02 + 3.2759638046908085e-01 -5.4448544511158256e-02 + 3.2759752711051321e-01 -5.4407187623744545e-02 + 3.2759848229754790e-01 -5.4372727347639031e-02 + 3.2759927803110284e-01 -5.4344013144831609e-02 + 3.2759994095604333e-01 -5.4320086547718333e-02 + 3.2760047719070162e-01 -5.4300149074148145e-02 + 3.2760092389488871e-01 -5.4283535455964066e-02 + 3.2760129603642213e-01 -5.4269691436345843e-02 + 3.2760160607536620e-01 -5.4258155217524945e-02 + 3.1687126903346668e-01 -7.7644056206111103e-02 + 3.1702453161484617e-01 -7.3706783489811009e-02 + 3.1715212036874013e-01 -7.0426027262782367e-02 + 3.1725833970425465e-01 -6.7692301778094460e-02 + 3.1734677290886948e-01 -6.5414381745610525e-02 + 3.1742040240215158e-01 -6.3516256877988397e-02 + 3.1748171017736437e-01 -6.1934594258301397e-02 + 3.1753276162159955e-01 -6.0616623834907755e-02 + 3.1757527540141728e-01 -5.9518376529259086e-02 + 3.1761068168517670e-01 -5.8603216197622481e-02 + 3.1764017061834204e-01 -5.7840616466065989e-02 + 3.1766473266607403e-01 -5.7205141609628606e-02 + 3.1768519217713664e-01 -5.6675597445362769e-02 + 3.1770223530278591e-01 -5.6234323879010617e-02 + 3.1771643321756016e-01 -5.5866605473184450e-02 + 3.1772826143108918e-01 -5.5560180346418520e-02 + 3.1773811584918210e-01 -5.5304830996561805e-02 + 3.1774632613125037e-01 -5.5092043380000177e-02 + 3.1775316680027615e-01 -5.4914722857390075e-02 + 3.1775886648401735e-01 -5.4766957518381787e-02 + 3.1776361560307331e-01 -5.4643820980203373e-02 + 3.1776757276716766e-01 -5.4541208074496694e-02 + 3.1777087009793031e-01 -5.4455697935267722e-02 + 3.1777361765886947e-01 -5.4384439917512822e-02 + 3.1777590714255666e-01 -5.4325058538267676e-02 + 3.1777780326597460e-01 -5.4275896430906585e-02 + 3.1777938275850232e-01 -5.4234933474993828e-02 + 3.1778069854709801e-01 -5.4200801584100448e-02 + 3.1778179470176698e-01 -5.4172361120780804e-02 + 3.1778270791845542e-01 -5.4148662704988131e-02 + 3.1778345325506191e-01 -5.4128915428986464e-02 + 3.1778407418243765e-01 -5.4112460343729546e-02 + 3.1778459148951477e-01 -5.4098748460617456e-02 + 3.1778502248504414e-01 -5.4087322374115822e-02 + 3.0528648383781670e-01 -7.7150809179244051e-02 + 3.0548765557698104e-01 -7.3259110615566281e-02 + 3.0565514288005702e-01 -7.0016381196124647e-02 + 3.0579459029438427e-01 -6.7314383866743502e-02 + 3.0591069703308321e-01 -6.5062935370163152e-02 + 3.0600737471504502e-01 -6.3186895081869227e-02 + 3.0608787903505597e-01 -6.1623655944825870e-02 + 3.0615491959642910e-01 -6.0321053774122543e-02 + 3.0621075146329546e-01 -5.9235625216833558e-02 + 3.0625725142769539e-01 -5.8331156270495489e-02 + 3.0629598151267590e-01 -5.7577472930020385e-02 + 3.0632824182896840e-01 -5.6949433591483939e-02 + 3.0635511455918468e-01 -5.6426089562691573e-02 + 3.0637750055318297e-01 -5.5989985637083350e-02 + 3.0639614977262580e-01 -5.5626577363909746e-02 + 3.0641168661647888e-01 -5.5323745542580127e-02 + 3.0642463098830830e-01 -5.5071391719678786e-02 + 3.0643541582081246e-01 -5.4861101170956772e-02 + 3.0644440165445297e-01 -5.4685862107461958e-02 + 3.0645188876592849e-01 -5.4539831723218413e-02 + 3.0645812725938992e-01 -5.4418141268598674e-02 + 3.0646332546372929e-01 -5.4316733636127879e-02 + 3.0646765692057071e-01 -5.4232228034777563e-02 + 3.0647126620107989e-01 -5.4161807233000986e-02 + 3.0647427374778813e-01 -5.4103123604676007e-02 + 3.0647676525546347e-01 -5.4054537394916599e-02 + 3.0647884073478765e-01 -5.4014054514887118e-02 + 3.0648056971975107e-01 -5.3980322817081046e-02 + 3.0648201011084641e-01 -5.3952215949468682e-02 + 3.0648321012206575e-01 -5.3928795607758477e-02 + 3.0648419505804547e-01 -5.3909280115572764e-02 + 3.0648501561827896e-01 -5.3893018225308210e-02 + 3.0648569926201086e-01 -5.3879467368545653e-02 + 3.0648626885421604e-01 -5.3868175492993921e-02 + 2.9215232270727431e-01 -7.6533184369850391e-02 + 2.9240768292427832e-01 -7.2691350902331434e-02 + 2.9262029726587907e-01 -6.9490233608759028e-02 + 2.9279732638986172e-01 -6.6822959908747245e-02 + 2.9294473193799919e-01 -6.4600485353379200e-02 + 2.9306747669295480e-01 -6.2748619886831780e-02 + 2.9316969158343054e-01 -6.1205549960545252e-02 + 2.9325481495072675e-01 -5.9919773825503959e-02 + 2.9332570861665375e-01 -5.8848381161032755e-02 + 2.9338475456814350e-01 -5.7955619667024602e-02 + 2.9343393546380109e-01 -5.7211700790361128e-02 + 2.9347490164947632e-01 -5.6591804711928227e-02 + 2.9350902693230591e-01 -5.6075251359786187e-02 + 2.9353745499267181e-01 -5.5644809751385083e-02 + 2.9356113800098099e-01 -5.5286122584092823e-02 + 2.9358086874703421e-01 -5.4987226844161796e-02 + 2.9359730737064937e-01 -5.4738154410529205e-02 + 2.9361100360025028e-01 -5.4530599303404870e-02 + 2.9362241525503452e-01 -5.4357640454739453e-02 + 2.9363192363979174e-01 -5.4213510734257397e-02 + 2.9363984635429358e-01 -5.4093404509984566e-02 + 2.9364644795348765e-01 -5.3993317312716727e-02 + 2.9365194881957385e-01 -5.3909912245686080e-02 + 2.9365653254693114e-01 -5.3840408676521151e-02 + 2.9366035208996960e-01 -5.3782489493499688e-02 + 2.9366351689850534e-01 -5.3734534060650180e-02 + 2.9366615326934403e-01 -5.3694577026043279e-02 + 2.9366834951840148e-01 -5.3661283691609184e-02 + 2.9367017918769617e-01 -5.3633542250739658e-02 + 2.9367170351741428e-01 -5.3610426525833671e-02 + 2.9367295940254518e-01 -5.3591164948568068e-02 + 2.9367400571515173e-01 -5.3575114704854369e-02 + 2.9367487745803417e-01 -5.3561740257421560e-02 + 2.9367560377955221e-01 -5.3550595416595549e-02 + 2.7751206843235238e-01 -7.5764862505863478e-02 + 2.7782764687629913e-01 -7.1975136191155642e-02 + 2.7809040857913697e-01 -6.8817510332619389e-02 + 2.7830919941629861e-01 -6.6186535186743570e-02 + 2.7849138423551228e-01 -6.3994354084511540e-02 + 2.7864309417059652e-01 -6.2167768647767289e-02 + 2.7876943293156908e-01 -6.0645793355076423e-02 + 2.7887464879468982e-01 -5.9377617883404954e-02 + 2.7896227792551337e-01 -5.8320909293078822e-02 + 2.7903526376277166e-01 -5.7440397436904128e-02 + 2.7909605642746199e-01 -5.6706696387706458e-02 + 2.7914669547903698e-01 -5.6095322531334035e-02 + 2.7918887879585774e-01 -5.5585876520922249e-02 + 2.7922401989904649e-01 -5.5161361754954868e-02 + 2.7925329565420787e-01 -5.4807616598807805e-02 + 2.7927768596321578e-01 -5.4512841368321539e-02 + 2.7929800678969263e-01 -5.4267204260085543e-02 + 2.7931493763724308e-01 -5.4062513051562143e-02 + 2.7932904441283291e-01 -5.3891941591956503e-02 + 2.7934079845070381e-01 -5.3749801937129825e-02 + 2.7935059234351894e-01 -5.3631354508865990e-02 + 2.7935875311704966e-01 -5.3532649930133368e-02 + 2.7936555319569889e-01 -5.3450397248710112e-02 + 2.7937121953024013e-01 -5.3381854144063767e-02 + 2.7937594119684617e-01 -5.3324735448640304e-02 + 2.7937985407843074e-01 -5.3277440252754660e-02 + 2.7938311362466511e-01 -5.3238033658452942e-02 + 2.7938582902102899e-01 -5.3205199218437881e-02 + 2.7938809118953029e-01 -5.3177840340512955e-02 + 2.7938997584415221e-01 -5.3155043532978966e-02 + 2.7939153276102308e-01 -5.3136047802308760e-02 + 2.7939282988936037e-01 -5.3120219159039625e-02 + 2.7939391061361929e-01 -5.3107029423727907e-02 + 2.7939481106350533e-01 -5.3096038542349740e-02 + 2.6149909018415723e-01 -7.4819534835455517e-02 + 2.6188044343887140e-01 -7.1082200254649910e-02 + 2.6219797850591603e-01 -6.7968315125963852e-02 + 2.6246238244730680e-01 -6.5373856090614704e-02 + 2.6268255314469408e-01 -6.3212157591689716e-02 + 2.6286589814642713e-01 -6.1411016039555705e-02 + 2.6301858388755034e-01 -5.9910276823698067e-02 + 2.6314574343913150e-01 -5.8659823700529523e-02 + 2.6325164961575198e-01 -5.7617903534725678e-02 + 2.6333985916354463e-01 -5.6749730528478121e-02 + 2.6341333282519536e-01 -5.6026323358536870e-02 + 2.6347453529553883e-01 -5.5423536384111252e-02 + 2.6352551842328753e-01 -5.4921252554364891e-02 + 2.6356799045793011e-01 -5.4502711035894130e-02 + 2.6360337367743553e-01 -5.4153947079171559e-02 + 2.6363285234251305e-01 -5.3863325391460791e-02 + 2.6365741259956388e-01 -5.3621151408748027e-02 + 2.6367787568310080e-01 -5.3419347461413871e-02 + 2.6369492554298773e-01 -5.3251182999673255e-02 + 2.6370913183370170e-01 -5.3111049851025556e-02 + 2.6372096904528314e-01 -5.2994274989941588e-02 + 2.6373083242512618e-01 -5.2896964555770538e-02 + 2.6373905123002456e-01 -5.2815873900285866e-02 + 2.6374589975744755e-01 -5.2748299318608007e-02 + 2.6375160652923568e-01 -5.2691987843615506e-02 + 2.6375633634038431e-01 -5.2645358042850303e-02 + 2.6376027641656213e-01 -5.2606506239663287e-02 + 2.6376355873596780e-01 -5.2574134360439319e-02 + 2.6376629320211942e-01 -5.2547161131914509e-02 + 2.6376857133603093e-01 -5.2524685837294034e-02 + 2.6377045698330293e-01 -5.2505958132880205e-02 + 2.6377202800419325e-01 -5.2490352918793670e-02 + 2.6377333693655358e-01 -5.2477349428556357e-02 + 2.6377442753429781e-01 -5.2466513790562587e-02 + 2.4434306435337411e-01 -7.3683785237249763e-02 + 2.4479433022351796e-01 -7.0006055621190749e-02 + 2.4517008273338239e-01 -6.6941932726418046e-02 + 2.4548296654634666e-01 -6.4389016201655991e-02 + 2.4574350945834653e-01 -6.2261995772099579e-02 + 2.4596047605086702e-01 -6.0489799728313330e-02 + 2.4614116256658888e-01 -5.9013218862329277e-02 + 2.4629164268934414e-01 -5.7782926633441367e-02 + 2.4641697232625837e-01 -5.6757829578492035e-02 + 2.4652136017414411e-01 -5.5903692958689993e-02 + 2.4660830975090561e-01 -5.5191995772145723e-02 + 2.4668073764119458e-01 -5.4598976887147141e-02 + 2.4674107192678565e-01 -5.4104840412774205e-02 + 2.4679133411166401e-01 -5.3693093738045296e-02 + 2.4683320730400199e-01 -5.3349996096881680e-02 + 2.4686809295578199e-01 -5.3064099211736084e-02 + 2.4689715807741741e-01 -5.2825864642711003e-02 + 2.4692137452619603e-01 -5.2627345034861654e-02 + 2.4694155169772619e-01 -5.2461918592383000e-02 + 2.4695836373047247e-01 -5.2324067888361490e-02 + 2.4697237214472811e-01 -5.2209195605255339e-02 + 2.4698404468399995e-01 -5.2113471035253156e-02 + 2.4699377099752612e-01 -5.2033702202917184e-02 + 2.4700187569470886e-01 -5.1967229330384578e-02 + 2.4700862921337882e-01 -5.1911836079509270e-02 + 2.4701422713061932e-01 -5.1865963196998474e-02 + 2.4701889036131822e-01 -5.1827742491957977e-02 + 2.4702277510705664e-01 -5.1795896792764737e-02 + 2.4702601144386752e-01 -5.1769362253125707e-02 + 2.4702870769174157e-01 -5.1747252688635267e-02 + 2.4703094265627490e-01 -5.1728829870933905e-02 + 2.4703280472067793e-01 -5.1713478812612124e-02 + 2.4703435615018257e-01 -5.1700687179900041e-02 + 2.4703564880084342e-01 -5.1690028133987841e-02 + 2.2636589987684516e-01 -7.2341720379908575e-02 + 2.2688968233617113e-01 -6.8731355110965911e-02 + 2.2732581886006098e-01 -6.5723469452286659e-02 + 2.2768898527293960e-01 -6.3217498438853215e-02 + 2.2799140047605163e-01 -6.1129664326846862e-02 + 2.2824323698078378e-01 -5.9390175233353569e-02 + 2.2845296316943647e-01 -5.7940890850452155e-02 + 2.2862762854482607e-01 -5.6733377435066526e-02 + 2.2877310138567966e-01 -5.5727287261916954e-02 + 2.2889426668949781e-01 -5.4889008501040656e-02 + 2.2899519099959387e-01 -5.4190540454306352e-02 + 2.2907925963226758e-01 -5.3608556571751856e-02 + 2.2914929090993860e-01 -5.3123623921485202e-02 + 2.2920763124241897e-01 -5.2719553004200947e-02 + 2.2925623426038483e-01 -5.2382856157129336e-02 + 2.2929672667052239e-01 -5.2102296419354828e-02 + 2.2933046305688401e-01 -5.1868511753559589e-02 + 2.2935857148268587e-01 -5.1673702038575985e-02 + 2.2938199143637233e-01 -5.1511368347141005e-02 + 2.2940150540861862e-01 -5.1376095771820202e-02 + 2.2941776517022869e-01 -5.1263372522674586e-02 + 2.2943131364209760e-01 -5.1169439233978778e-02 + 2.2944260309867487e-01 -5.1091163432110044e-02 + 2.2945201032070767e-01 -5.1025934959786967e-02 + 2.2945984921046733e-01 -5.0971578855401239e-02 + 2.2946634733094062e-01 -5.0926561024258923e-02 + 2.2947176044589720e-01 -5.0889053225091782e-02 + 2.2947626987906622e-01 -5.0857801903295217e-02 + 2.2948002662718273e-01 -5.0831762902497801e-02 + 2.2948315643179171e-01 -5.0810066457557750e-02 + 2.2948575362407680e-01 -5.0791988028126477e-02 + 2.2948791748688108e-01 -5.0776924051267165e-02 + 2.2948972037314710e-01 -5.0764371719770218e-02 + 2.2949122254105420e-01 -5.0753912139915189e-02 + 2.0796277509986802e-01 -7.0776100600638395e-02 + 2.0856030583581650e-01 -6.7233297469880687e-02 + 2.0905785023472365e-01 -6.4281822799835617e-02 + 2.0947215041106038e-01 -6.1822949303300852e-02 + 2.0981714556515141e-01 -5.9774433952974000e-02 + 2.1010444039560314e-01 -5.8067766759317616e-02 + 2.1034369557727467e-01 -5.6645878250998927e-02 + 2.1054295317366098e-01 -5.5461229280486544e-02 + 2.1070890774226647e-01 -5.4474219514095715e-02 + 2.1084713213328365e-01 -5.3651861539714435e-02 + 2.1096226551171254e-01 -5.2966676328092807e-02 + 2.1105816989713672e-01 -5.2395773137614288e-02 + 2.1113806047518466e-01 -5.1920083088656012e-02 + 2.1120461406418703e-01 -5.1523720762072699e-02 + 2.1126005939012096e-01 -5.1193452450429569e-02 + 2.1130625221498436e-01 -5.0918253254674264e-02 + 2.1134473785583996e-01 -5.0688938187785165e-02 + 2.1137680320906405e-01 -5.0497854922648959e-02 + 2.1140352004089158e-01 -5.0338627882690515e-02 + 2.1142578101171261e-01 -5.0205945093120923e-02 + 2.1144432965499776e-01 -5.0095380644189474e-02 + 2.1145978532757198e-01 -5.0003246812120046e-02 + 2.1147266397654974e-01 -4.9926470879393996e-02 + 2.1148339542602970e-01 -4.9862492524591538e-02 + 2.1149233776874934e-01 -4.9809178343731074e-02 + 2.1149975115166272e-01 -4.9765019213318967e-02 + 2.1150592668774992e-01 -4.9728227399560045e-02 + 2.1151107124609442e-01 -4.9697573051383843e-02 + 2.1151535709632110e-01 -4.9672031775895936e-02 + 2.1151892769452854e-01 -4.9650750289760348e-02 + 2.1152189316631478e-01 -4.9633017793631745e-02 + 2.1152436386786888e-01 -4.9618242194890153e-02 + 2.1152642240918068e-01 -4.9605930251824137e-02 + 2.1152813759143357e-01 -4.9595671048687895e-02 + 1.8956821566048226e-01 -6.9000840167815422e-02 + 1.9023810607712563e-01 -6.5534834505111231e-02 + 1.9079590015438921e-01 -6.2647469448569387e-02 + 1.9126036809286748e-01 -6.0242111041041761e-02 + 1.9164713752425125e-01 -5.8238264085436038e-02 + 1.9196921875055417e-01 -5.6568878143657408e-02 + 1.9223744256181938e-01 -5.5178102685864018e-02 + 1.9246082508012813e-01 -5.4019416629957719e-02 + 1.9264687170550548e-01 -5.3054069968185326e-02 + 1.9280183026228429e-01 -5.2249785520549735e-02 + 1.9293090179273609e-01 -5.1579677469240984e-02 + 1.9303841605542166e-01 -5.1021350524684331e-02 + 1.9312797762100736e-01 -5.0556149583335125e-02 + 1.9320258747752148e-01 -5.0168534759427730e-02 + 1.9326474424198545e-01 -4.9845560858449371e-02 + 1.9331652839071922e-01 -4.9576443851327652e-02 + 1.9335967235323945e-01 -4.9352199816360000e-02 + 1.9339561883937556e-01 -4.9165344239119523e-02 + 1.9342556937494682e-01 -4.9009641580502493e-02 + 1.9345052469020560e-01 -4.8879896707225340e-02 + 1.9347131833057563e-01 -4.8771781183139892e-02 + 1.9348864462903018e-01 -4.8681688589573127e-02 + 1.9350308198820321e-01 -4.8606614018799711e-02 + 1.9351511226111012e-01 -4.8544053697716139e-02 + 1.9352513688524520e-01 -4.8491921374610454e-02 + 1.9353344804171896e-01 -4.8448736686556380e-02 + 1.9354037142187544e-01 -4.8412757310729859e-02 + 1.9354613895532782e-01 -4.8382780315070435e-02 + 1.9355094378066146e-01 -4.8357803749034714e-02 + 1.9355494673180226e-01 -4.8336993043475676e-02 + 1.9355827344868815e-01 -4.8319653000081599e-02 + 1.9356104512618316e-01 -4.8305204546598306e-02 + 1.9356335443623782e-01 -4.8293165298707010e-02 + 1.9356527856051714e-01 -4.8283133395263564e-02 + 1.7161785429519022e-01 -6.7036243860101180e-02 + 1.7235627146021903e-01 -6.3659770587518219e-02 + 1.7297112179458785e-01 -6.0847123868236361e-02 + 1.7348309685999583e-01 -5.8504118180205678e-02 + 1.7390942380739036e-01 -5.6552301951335350e-02 + 1.7426444447003761e-01 -5.4926330680811132e-02 + 1.7456009804418363e-01 -5.3571778007292660e-02 + 1.7480632330144302e-01 -5.2443311856500599e-02 + 1.7501139365585092e-01 -5.1503174931590054e-02 + 1.7518219622558623e-01 -5.0719918883711683e-02 + 1.7532446420469350e-01 -5.0067349893962519e-02 + 1.7544297032648454e-01 -4.9523650411001756e-02 + 1.7554168791484720e-01 -4.9070647650237401e-02 + 1.7562392493868992e-01 -4.8693204355286103e-02 + 1.7569243558530290e-01 -4.8378711406397767e-02 + 1.7574951311406486e-01 -4.8116665265735575e-02 + 1.7579706712586390e-01 -4.7898316083899835e-02 + 1.7583668786148421e-01 -4.7716374656883935e-02 + 1.7586969970526134e-01 -4.7564768392019147e-02 + 1.7589720570725692e-01 -4.7438438084012567e-02 + 1.7592012463360851e-01 -4.7333168672378641e-02 + 1.7593922180115390e-01 -4.7245448292867309e-02 + 1.7595513474188218e-01 -4.7172350887121177e-02 + 1.7596839456552887e-01 -4.7111438428655533e-02 + 1.7597944374482541e-01 -4.7060679482496266e-02 + 1.7598860486437862e-01 -4.7018627889610240e-02 + 1.7599623625369565e-01 -4.6983593132929657e-02 + 1.7600259357185968e-01 -4.6954403618937282e-02 + 1.7600788971740142e-01 -4.6930083520663149e-02 + 1.7601230197850368e-01 -4.6909820049283242e-02 + 1.7601597071620123e-01 -4.6892936161678951e-02 + 1.7601902735072120e-01 -4.6878867933440614e-02 + 1.7602157408136235e-01 -4.6867145609764162e-02 + 1.7602369602483917e-01 -4.6857377860502612e-02 + 1.5450884592502945e-01 -6.4907151387032250e-02 + 1.5531022631852340e-01 -6.1629159251138557e-02 + 1.5597749890899582e-01 -5.8898680815241050e-02 + 1.5653312125340424e-01 -5.6624230220873130e-02 + 1.5699579062669894e-01 -5.4729608643264940e-02 + 1.5738107262982279e-01 -5.3151351580067764e-02 + 1.5770192511853995e-01 -5.1836601709324255e-02 + 1.5796913477249122e-01 -5.0741336536670185e-02 + 1.5819168077519763e-01 -4.9828891823092643e-02 + 1.5837703770136566e-01 -4.9068731565525228e-02 + 1.5853142772628973e-01 -4.8435423450029741e-02 + 1.5866003060481890e-01 -4.7907785513160349e-02 + 1.5876715847084669e-01 -4.7468175438666244e-02 + 1.5885640133586656e-01 -4.7101898677297221e-02 + 1.5893074818673869e-01 -4.6796715545951571e-02 + 1.5899268776544248e-01 -4.6542430771139856e-02 + 1.5904429243413246e-01 -4.6330551698261183e-02 + 1.5908728796107202e-01 -4.6154003686183068e-02 + 1.5912311158995773e-01 -4.6006893119937005e-02 + 1.5915296036079038e-01 -4.5884310072622399e-02 + 1.5917783132101221e-01 -4.5782163978045916e-02 + 1.5919855499005847e-01 -4.5697046786997604e-02 + 1.5921582321226282e-01 -4.5626119004239407e-02 + 1.5923021234119830e-01 -4.5567014775442886e-02 + 1.5924220254080607e-01 -4.5517762835217017e-02 + 1.5925214439179253e-01 -4.5476955196973506e-02 + 1.5926042611328514e-01 -4.5442957401103823e-02 + 1.5926732516393199e-01 -4.5414632288838158e-02 + 1.5927307259511059e-01 -4.5391032734899021e-02 + 1.5927786081053427e-01 -4.5371369877533929e-02 + 1.5928184373131496e-01 -4.5354986616514416e-02 + 1.5928516212790281e-01 -4.5341335663521429e-02 + 1.5928792695231828e-01 -4.5329961132494677e-02 + 1.5929023061093942e-01 -4.5320483256460584e-02 + 1.3856546037082093e-01 -6.2660028255834041e-02 + 1.3942200135265498e-01 -5.9493893496094762e-02 + 1.4013519813674230e-01 -5.6856715789259618e-02 + 1.4072905603584962e-01 -5.4660085703840830e-02 + 1.4122356071907066e-01 -5.2830370674038216e-02 + 1.4163535023221643e-01 -5.1306247050630860e-02 + 1.4197827509015379e-01 -5.0036643578166055e-02 + 1.4226386496698210e-01 -4.8979027896759730e-02 + 1.4250171746015630e-01 -4.8097979033837467e-02 + 1.4269982186534347e-01 -4.7363998293632463e-02 + 1.4286482877600623e-01 -4.6752518827446299e-02 + 1.4300227453972147e-01 -4.6243080750414764e-02 + 1.4311676810942991e-01 -4.5818644175199034e-02 + 1.4321214657273423e-01 -4.5465017135526802e-02 + 1.4329160459791665e-01 -4.5170379209309823e-02 + 1.4335780216040350e-01 -4.4924884851638973e-02 + 1.4341295418825034e-01 -4.4720333113801240e-02 + 1.4345890515691953e-01 -4.4549892644084758e-02 + 1.4349719115948431e-01 -4.4407872719858625e-02 + 1.4352909155621502e-01 -4.4289532603471508e-02 + 1.4355567195473853e-01 -4.4190922802300685e-02 + 1.4357781997898958e-01 -4.4108752888547480e-02 + 1.4359627503912828e-01 -4.4040281428450997e-02 + 1.4361165311199448e-01 -4.3983224316988791e-02 + 1.4362446736996398e-01 -4.3935678435388870e-02 + 1.4363509298416186e-01 -4.3896280006108318e-02 + 1.4364394425756935e-01 -4.3863456806431708e-02 + 1.4365131774387491e-01 -4.3836110733664058e-02 + 1.4365746039491789e-01 -4.3813327211581807e-02 + 1.4366257785419467e-01 -4.3794344508517047e-02 + 1.4366683597634106e-01 -4.3778528134437673e-02 + 1.4367038365569046e-01 -4.3765349656552495e-02 + 1.4367333951167355e-01 -4.3754368905837136e-02 + 1.4367580233644345e-01 -4.3745219217285518e-02 + 1.2402104487557987e-01 -6.0337384049077215e-02 + 1.2492417835097079e-01 -5.7290380489019792e-02 + 1.2567616452870869e-01 -5.4752549361403481e-02 + 1.2630231656412874e-01 -5.2638765348955577e-02 + 1.2682370876583779e-01 -5.0878134726723333e-02 + 1.2725788531280735e-01 -4.9411618081320108e-02 + 1.2761945091552990e-01 -4.8190049330073009e-02 + 1.2792056296622728e-01 -4.7172485178191101e-02 + 1.2817134150562606e-01 -4.6324830086572559e-02 + 1.2838021065175570e-01 -4.5618690909860933e-02 + 1.2855418289754550e-01 -4.5030422944037314e-02 + 1.2869909580327962e-01 -4.4540335460368091e-02 + 1.2881980903264117e-01 -4.4132030106780164e-02 + 1.2892036835924373e-01 -4.3791849988280923e-02 + 1.2900414216718656e-01 -4.3508420938820479e-02 + 1.2907393504809925e-01 -4.3272269577115850e-02 + 1.2913208233018830e-01 -4.3075505308848641e-02 + 1.2918052873671929e-01 -4.2911555576935392e-02 + 1.2922089383621416e-01 -4.2774945445557613e-02 + 1.2925452650409591e-01 -4.2661114091742676e-02 + 1.2928255024224025e-01 -4.2566262019988373e-02 + 1.2930590089402874e-01 -4.2487223849718377e-02 + 1.2932535803418616e-01 -4.2421362389091784e-02 + 1.2934157109666539e-01 -4.2366480427204700e-02 + 1.2935508112514515e-01 -4.2320747275652632e-02 + 1.2936628411771570e-01 -4.2282846885483602e-02 + 1.2937561632144806e-01 -4.2251272231763691e-02 + 1.2938339041669336e-01 -4.2224966764989977e-02 + 1.2938986678362546e-01 -4.2203050536173986e-02 + 1.2939526224697492e-01 -4.2184790672283902e-02 + 1.2939975280306187e-01 -4.2169576732432358e-02 + 1.2940349413232860e-01 -4.2156900335142848e-02 + 1.2940661133071085e-01 -4.2146338023442413e-02 + 1.2940920858411961e-01 -4.2137537062245364e-02 + 1.1100951288367410e-01 -5.7997414366979493e-02 + 1.1194936249596743e-01 -5.5079936083726237e-02 + 1.1273191436915833e-01 -5.2650092852878090e-02 + 1.1338351277132011e-01 -5.0626339540836084e-02 + 1.1392609025732511e-01 -4.8940767347551220e-02 + 1.1437790533269200e-01 -4.7536825597685337e-02 + 1.1475415722631790e-01 -4.6367423305452155e-02 + 1.1506749812198147e-01 -4.5393347420964826e-02 + 1.1532845984706631e-01 -4.4581945130228354e-02 + 1.1554580922464606e-01 -4.3906026282283739e-02 + 1.1572684396239581e-01 -4.3342949273577576e-02 + 1.1587763899425395e-01 -4.2873859792945973e-02 + 1.1600325154785394e-01 -4.2483056911192522e-02 + 1.1610789183559753e-01 -4.2157465247880228e-02 + 1.1619506511772136e-01 -4.1886195493032720e-02 + 1.1626768992757996e-01 -4.1660178516065689e-02 + 1.1632819645153765e-01 -4.1471860755462428e-02 + 1.1637860839011148e-01 -4.1314950634470014e-02 + 1.1642061107317184e-01 -4.1184207457474094e-02 + 1.1645560813769151e-01 -4.1075265668522369e-02 + 1.1648476869105066e-01 -4.0984488543882022e-02 + 1.1650906656016972e-01 -4.0908846382050029e-02 + 1.1652931295733508e-01 -4.0845815083071578e-02 + 1.1654618367011078e-01 -4.0793291698034757e-02 + 1.1656024169566635e-01 -4.0749524103614869e-02 + 1.1657189950619440e-01 -4.0713248949342015e-02 + 1.1658161054623126e-01 -4.0683028739461224e-02 + 1.1658970020198930e-01 -4.0657852050483778e-02 + 1.1659643943364553e-01 -4.0636876533567033e-02 + 1.1660205387497527e-01 -4.0619400647956112e-02 + 1.1660672760342305e-01 -4.0604840060620567e-02 + 1.1661062153969050e-01 -4.0592708153195711e-02 + 1.1661386588397561e-01 -4.0582599605213390e-02 + 1.1661656907316049e-01 -4.0574176796807360e-02 + 9.9573963779880717e-02 -5.5690864837798171e-02 + 1.0054053213120280e-01 -5.2910020349893852e-02 + 1.0134532568751217e-01 -5.0594068254244826e-02 + 1.0201543953867361e-01 -4.8665248438786210e-02 + 1.0257343114231174e-01 -4.7058807086033251e-02 + 1.0303807908064230e-01 -4.5720823404116817e-02 + 1.0342501540107270e-01 -4.4606398629632414e-02 + 1.0374725247791475e-01 -4.3678147137120309e-02 + 1.0401562188327795e-01 -4.2904939461299765e-02 + 1.0423913988150102e-01 -4.2260855330958004e-02 + 1.0442531176151770e-01 -4.1724311732387283e-02 + 1.0458038520658988e-01 -4.1277336809890465e-02 + 1.0470956121166837e-01 -4.0904965257744334e-02 + 1.0481716964283935e-01 -4.0594734912850115e-02 + 1.0490681535108809e-01 -4.0336267637122024e-02 + 1.0498149976824415e-01 -4.0120920400261474e-02 + 1.0504372209042896e-01 -3.9941494820161197e-02 + 1.0509556347159370e-01 -3.9791995375785094e-02 + 1.0513875707814528e-01 -3.9667428139728234e-02 + 1.0517474638030952e-01 -3.9563633237213527e-02 + 1.0520473365746778e-01 -3.9477145375676065e-02 + 1.0522972036338619e-01 -3.9405077735003124e-02 + 1.0525054072089368e-01 -3.9345025299104414e-02 + 1.0526788968446621e-01 -3.9294984367236829e-02 + 1.0528234621763136e-01 -3.9253285530938188e-02 + 1.0529433484587929e-01 -3.9218721736167507e-02 + 1.0530432143072260e-01 -3.9189927643537903e-02 + 1.0531264060284740e-01 -3.9165939385673712e-02 + 1.0531957101961256e-01 -3.9145954235201591e-02 + 1.0532534472363211e-01 -3.9129303664446717e-02 + 1.0533015178692352e-01 -3.9115430846569259e-02 + 1.0533415680761608e-01 -3.9103872087613442e-02 + 1.0533749370211055e-01 -3.9094241169328567e-02 + 1.0534027400197213e-01 -3.9086216390534605e-02 + 8.9681140833524381e-02 -5.3464721017817178e-02 + 9.0664813029274094e-02 -5.0824344394567379e-02 + 9.1483843093633735e-02 -4.8625459273372786e-02 + 9.2165807242683154e-02 -4.6794203969108501e-02 + 9.2733663325254137e-02 -4.5269073553205287e-02 + 9.3206523112314268e-02 -4.3998854841728094e-02 + 9.3600295906673875e-02 -4.2940905601253528e-02 + 9.3928224788040707e-02 -4.2059720823015567e-02 + 9.4201333295669681e-02 -4.1325738381185959e-02 + 9.4428797426451078e-02 -4.0714344262139379e-02 + 9.4618255380429908e-02 -4.0205044124289886e-02 + 9.4776065436481982e-02 -3.9780773445142581e-02 + 9.4907520619722019e-02 -3.9427323120447180e-02 + 9.5017027381225402e-02 -3.9132861229601336e-02 + 9.5108254308640200e-02 -3.8887534897410203e-02 + 9.5184255881816379e-02 -3.8683138861157401e-02 + 9.5247575452707373e-02 -3.8512839582933174e-02 + 9.5300330933409491e-02 -3.8370945608020228e-02 + 9.5344286093128144e-02 -3.8252716419660743e-02 + 9.5380909882933157e-02 -3.8154203335435476e-02 + 9.5411425800377078e-02 -3.8072117068705787e-02 + 9.5436852969556202e-02 -3.8003717480220189e-02 + 9.5458040330166957e-02 -3.7946721794324838e-02 + 9.5475695094762780e-02 -3.7899228182181312e-02 + 9.5490406437555950e-02 -3.7859652132138807e-02 + 9.5502606674553944e-02 -3.7826845073877353e-02 + 9.5512769505529560e-02 -3.7799514825419170e-02 + 9.5521235476998548e-02 -3.7776746370238513e-02 + 9.5528288172072359e-02 -3.7757777677652954e-02 + 9.5534163734140740e-02 -3.7741974126049439e-02 + 9.5539056221778842e-02 -3.7728807136983109e-02 + 9.5543132410467260e-02 -3.7717836555583674e-02 + 9.5546528597870176e-02 -3.7708695776584415e-02 + 9.5549358298563272e-02 -3.7701079441331525e-02 + 8.1240983440307765e-02 -5.1356811021193098e-02 + 8.2233255589803197e-02 -4.8855697524684223e-02 + 8.3059442287415824e-02 -4.6772859808803323e-02 + 8.3747362235768869e-02 -4.5038306752483666e-02 + 8.4320175025420593e-02 -4.3593758615321783e-02 + 8.4797160264496615e-02 -4.2390689641604466e-02 + 8.5194366881903114e-02 -4.1388696936961691e-02 + 8.5525154110884266e-02 -4.0554141462321058e-02 + 8.5800642115425652e-02 -3.9859015952584786e-02 + 8.6030087270824424e-02 -3.9280002024752569e-02 + 8.6221194640518528e-02 -3.8797684964193828e-02 + 8.6380378125350751e-02 -3.8395899889550243e-02 + 8.6512977022372248e-02 -3.8061187362273437e-02 + 8.6623436278563656e-02 -3.7782340157902994e-02 + 8.6715456510593300e-02 -3.7550025963212712e-02 + 8.6792118849292124e-02 -3.7356473304128543e-02 + 8.6855988825167083e-02 -3.7195210124252122e-02 + 8.6909202808871919e-02 -3.7060846196921987e-02 + 8.6953539934260290e-02 -3.6948892024255352e-02 + 8.6990481943038045e-02 -3.6855608103137948e-02 + 8.7021262982102929e-02 -3.6777879460756738e-02 + 8.7046911042882369e-02 -3.6713111217820740e-02 + 8.7068282449451903e-02 -3.6659141647674490e-02 + 8.7086090564261795e-02 -3.6614169794702230e-02 + 8.7100929683877323e-02 -3.6576695207983095e-02 + 8.7113236134203229e-02 -3.6545627770208471e-02 + 8.7123487420317156e-02 -3.6519747036221586e-02 + 8.7132027061411182e-02 -3.6498186390388390e-02 + 8.7139141115239752e-02 -3.6480224121674905e-02 + 8.7145067785353691e-02 -3.6465259197713089e-02 + 8.7150003336194604e-02 -3.6452791023150438e-02 + 8.7154115400114626e-02 -3.6442402758239303e-02 + 8.7157541475581274e-02 -3.6433747222871939e-02 + 8.7160396077351932e-02 -3.6426535243179500e-02 + 7.4126024257016185e-02 -4.9397359268012822e-02 + 7.5119740572258453e-02 -4.7030586523914002e-02 + 7.5947126600589124e-02 -4.5059682297567703e-02 + 7.6636042645274863e-02 -4.3418393571636321e-02 + 7.7209682822954651e-02 -4.2051555045877709e-02 + 7.7687355398184665e-02 -4.0913235777803834e-02 + 7.8085133084671243e-02 -3.9965194748729047e-02 + 7.8416394856361690e-02 -3.9175594091727640e-02 + 7.8692277260672516e-02 -3.8517927197187628e-02 + 7.8922050268568328e-02 -3.7970125967360026e-02 + 7.9113430225626613e-02 -3.7513817382359288e-02 + 7.9272840394324751e-02 -3.7133704473288905e-02 + 7.9405627840120924e-02 -3.6817050930932863e-02 + 7.9516243956671964e-02 -3.6553252036353540e-02 + 7.9608394711316408e-02 -3.6333477485667287e-02 + 7.9685165676694661e-02 -3.6150374085875597e-02 + 7.9749126071562856e-02 -3.5997818302630435e-02 + 7.9802415329937745e-02 -3.5870710310573352e-02 + 7.9846815130730456e-02 -3.5764802587761289e-02 + 7.9883809330882738e-02 -3.5676557259177295e-02 + 7.9914633835587862e-02 -3.5603027362126165e-02 + 7.9940318098505589e-02 -3.5541758015878985e-02 + 7.9961719659954480e-02 -3.5490704152335108e-02 + 7.9979552894240413e-02 -3.5448162026367330e-02 + 7.9994412940050358e-02 -3.5412712192081468e-02 + 8.0006736944071635e-02 -3.5383321286869447e-02 + 8.0017002835732515e-02 -3.5358837447528879e-02 + 8.0025554630553428e-02 -3.5338440724555838e-02 + 8.0032678799014878e-02 -3.5321448279274442e-02 + 8.0038613887830790e-02 -3.5307291461193241e-02 + 8.0043556863239329e-02 -3.5295496651070804e-02 + 8.0047675110536662e-02 -3.5285669482886028e-02 + 8.0051106336102365e-02 -3.5277481499602803e-02 + 8.0053965227539881e-02 -3.5270659126579201e-02 + 6.8188677475529050e-02 -4.7610960138852999e-02 + 6.9177612697916391e-02 -4.5373626762535590e-02 + 7.0001015515706935e-02 -4.3510561302570722e-02 + 7.0686613040732940e-02 -4.1959116358603006e-02 + 7.1257488422710000e-02 -4.0667130352759380e-02 + 7.1732857484812104e-02 -3.9591174612147277e-02 + 7.2128715936898943e-02 -3.8695092630682389e-02 + 7.2458378610526730e-02 -3.7948783034798921e-02 + 7.2732928624319446e-02 -3.7327185793307870e-02 + 7.2961591443929011e-02 -3.6809437880356746e-02 + 7.3152046341633706e-02 -3.6378170169206671e-02 + 7.3310685696504507e-02 -3.6018922000457365e-02 + 7.3442830845887194e-02 -3.5719653776018913e-02 + 7.3552911749462310e-02 -3.5470341201721475e-02 + 7.3644616517001632e-02 -3.5262637530229096e-02 + 7.3721015843013687e-02 -3.5089592431836208e-02 + 7.3784666549940883e-02 -3.4945418015203282e-02 + 7.3837697742995548e-02 -3.4825294100007870e-02 + 7.3881882494952561e-02 -3.4725206159071730e-02 + 7.3918697491579755e-02 -3.4641810448183562e-02 + 7.3949372662697799e-02 -3.4572321756987691e-02 + 7.3974932482816474e-02 -3.4514419981922388e-02 + 7.3996230343231717e-02 -3.4466172356976431e-02 + 7.4013977160848080e-02 -3.4425968713525594e-02 + 7.4028765193436222e-02 -3.4392467579768667e-02 + 7.4041029631203348e-02 -3.4364690606286268e-02 + 7.4051245891283576e-02 -3.4341551455146606e-02 + 7.4059756331245369e-02 -3.4322275118573956e-02 + 7.4066846040693565e-02 -3.4306216192609394e-02 + 7.4072752415965767e-02 -3.4292837208801406e-02 + 7.4077671814905530e-02 -3.4281690523831107e-02 + 7.4081770417628853e-02 -3.4272403409962224e-02 + 7.4085185274428728e-02 -3.4264665436415043e-02 + 7.4088030526451354e-02 -3.4258218046322585e-02 + 6.3276313075977419e-02 -4.6008912849460779e-02 + 6.4255738524703163e-02 -4.3893559200312120e-02 + 6.5071221625551179e-02 -4.2132109446901884e-02 + 6.5750223480469702e-02 -4.0665316981084831e-02 + 6.6315605721940799e-02 -3.9443853058788031e-02 + 6.6786399720998091e-02 -3.8426648690014532e-02 + 6.7178447606851002e-02 -3.7579512901113499e-02 + 6.7504936339020952e-02 -3.6873981525909337e-02 + 6.7776842570162990e-02 -3.6286358257919329e-02 + 6.8003303122213143e-02 -3.5796916000828086e-02 + 6.8191923461052156e-02 -3.5389231821775773e-02 + 6.8349034511385562e-02 -3.5049633221498303e-02 + 6.8479906439076574e-02 -3.4766737134682320e-02 + 6.8588926592636101e-02 -3.4531066166657888e-02 + 6.8679747597125071e-02 -3.4334729154743490e-02 + 6.8755410595331481e-02 -3.4171155295887226e-02 + 6.8818447797527271e-02 -3.4034872874194502e-02 + 6.8870967809610606e-02 -3.3921325115706259e-02 + 6.8914726629367859e-02 -3.3826716944126603e-02 + 6.8951186719512031e-02 -3.3747887450708336e-02 + 6.8981566161358088e-02 -3.3682203758750813e-02 + 6.9006879558889636e-02 -3.3627472687648000e-02 + 6.9027972080120903e-02 -3.3581867225400443e-02 + 6.9045547790903522e-02 -3.3543865320417587e-02 + 6.9060193240842199e-02 -3.3512198924050232e-02 + 6.9072339548570241e-02 -3.3485941780049690e-02 + 6.9082457396889937e-02 -3.3464068877512985e-02 + 6.9090885849378891e-02 -3.3445847543994024e-02 + 6.9097907252435573e-02 -3.3430667637567413e-02 + 6.9103756717817502e-02 -3.3418021061429749e-02 + 6.9108628992120627e-02 -3.3407484638494453e-02 + 6.9112688331659206e-02 -3.3398706020867981e-02 + 6.9116070474346814e-02 -3.3391391754541290e-02 + 6.9118888468344172e-02 -3.3385297425603602e-02 + 5.9239413701921179e-02 -4.4594776081323409e-02 + 6.0206019853699472e-02 -4.2593188624256199e-02 + 6.1010828256338377e-02 -4.0926505643988038e-02 + 6.1680941004328034e-02 -3.9538654702732032e-02 + 6.2238920810704430e-02 -3.8382950913416550e-02 + 6.2703550175817427e-02 -3.7420527375037781e-02 + 6.3090464037982810e-02 -3.6619027218496435e-02 + 6.3412676870461981e-02 -3.5951513874993547e-02 + 6.3681021733060075e-02 -3.5395563346896461e-02 + 6.3904515907858103e-02 -3.4932508225352876e-02 + 6.4090665343144393e-02 -3.4546808183789836e-02 + 6.4245718112337521e-02 -3.4225525850542879e-02 + 6.4374875402558346e-02 -3.3957890464205720e-02 + 6.4482467130512797e-02 -3.3734934643814357e-02 + 6.4572098100989114e-02 -3.3549192051037159e-02 + 6.4646769636774223e-02 -3.3394445758471024e-02 + 6.4708980788112172e-02 -3.3265518836297761e-02 + 6.4760812544805105e-02 -3.3158100082242188e-02 + 6.4803997904420763e-02 -3.3068599001107139e-02 + 6.4839980172203604e-02 -3.2994025122344083e-02 + 6.4869961472078880e-02 -3.2931887567494843e-02 + 6.4894943115196377e-02 -3.2880111463365273e-02 + 6.4915759195967718e-02 -3.2836968369787493e-02 + 6.4933104554905960e-02 -3.2801018365725750e-02 + 6.4947558055611421e-02 -3.2771061835555421e-02 + 6.4959545259185625e-02 -3.2746221309417872e-02 + 6.4969530567297165e-02 -3.2725528635645720e-02 + 6.4977848604670832e-02 -3.2708290613393712e-02 + 6.4984778021163495e-02 -3.2693929976426374e-02 + 6.4990550850240900e-02 -3.2681966010566180e-02 + 6.4995359516154372e-02 -3.2671998348029904e-02 + 6.4999365859536126e-02 -3.2663693638818103e-02 + 6.5002703846561552e-02 -3.2656774254271867e-02 + 6.5005485049693570e-02 -3.2651008963704334e-02 + 5.5942029916969969e-02 -4.3359664112046788e-02 + 5.6894394004474463e-02 -4.1458606656345397e-02 + 5.7687343574229250e-02 -3.9875661166450610e-02 + 5.8347581649769040e-02 -3.8557561363707825e-02 + 5.8897338687013433e-02 -3.7459959579862062e-02 + 5.9355120576814545e-02 -3.6545935502705733e-02 + 5.9736331987100627e-02 -3.5784753477065195e-02 + 6.0053795702867778e-02 -3.5150827144652126e-02 + 6.0318185215327828e-02 -3.4622857011573631e-02 + 6.0538384975273037e-02 -3.4183112199347158e-02 + 6.0721790355180057e-02 -3.3816832367679940e-02 + 6.0874557376973719e-02 -3.3511729764145876e-02 + 6.1001810593971917e-02 -3.3257574680762979e-02 + 6.1107816121585723e-02 -3.3045850379837503e-02 + 6.1196125643866714e-02 -3.2869465875622401e-02 + 6.1269696252721925e-02 -3.2722516892705979e-02 + 6.1330990166858196e-02 -3.2600086936228991e-02 + 6.1382057704257087e-02 -3.2498081751386035e-02 + 6.1424606317956293e-02 -3.2413091571386395e-02 + 6.1460058037788590e-02 -3.2342276487655114e-02 + 6.1489597266644207e-02 -3.2283271056926910e-02 + 6.1514210554161543e-02 -3.2234104911325827e-02 + 6.1534719697914811e-02 -3.2193136681073979e-02 + 6.1551809294245419e-02 -3.2158998991293153e-02 + 6.1566049672290173e-02 -3.2130552672655584e-02 + 6.1577860185209381e-02 -3.2106963474135622e-02 + 6.1587698305970606e-02 -3.2087313305070128e-02 + 6.1595893728693389e-02 -3.2070943836644258e-02 + 6.1602720997114821e-02 -3.2057306846966518e-02 + 6.1608408725526059e-02 -3.2045945812585186e-02 + 6.1613146689417517e-02 -3.2036480515942024e-02 + 6.1617094126980361e-02 -3.2028594389573270e-02 + 6.1620383034850928e-02 -3.2022023784393359e-02 + 6.1623123345083984e-02 -3.2016549114957257e-02 + 5.3261604067910508e-02 -4.2286935777836016e-02 + 5.4200616155585579e-02 -4.0467531952567755e-02 + 5.4982448352666066e-02 -3.8952600106444225e-02 + 5.5633429430980486e-02 -3.7691153419210394e-02 + 5.6175478264590774e-02 -3.6640742740732500e-02 + 5.6626841356396271e-02 -3.5766028953242553e-02 + 5.7002707448260706e-02 -3.5037593283771901e-02 + 5.7315719584399585e-02 -3.4430946113073214e-02 + 5.7576401638454629e-02 -3.3925701340873818e-02 + 5.7793513518396032e-02 -3.3504888789846560e-02 + 5.7974346924628550e-02 -3.3154381660264631e-02 + 5.8124971577643306e-02 -3.2862419844346326e-02 + 5.8250440187078985e-02 -3.2619213092740913e-02 + 5.8354959057140027e-02 -3.2416610689392542e-02 + 5.8442030074868506e-02 -3.2247826514233552e-02 + 5.8514568870226769e-02 -3.2107210229324182e-02 + 5.8575003137324923e-02 -3.1990056864540706e-02 + 5.8625354443958326e-02 -3.1892448367881181e-02 + 5.8667306300013211e-02 -3.1811121757809070e-02 + 5.8702260793933335e-02 -3.1743359409258959e-02 + 5.8731385718905335e-02 -3.1686897754550886e-02 + 5.8755653789291332e-02 -3.1639851302170806e-02 + 5.8775875277562846e-02 -3.1600649398310823e-02 + 5.8792725178937889e-02 -3.1567983587632201e-02 + 5.8806765823689704e-02 -3.1540763793171112e-02 + 5.8818410729731339e-02 -3.1518190885276187e-02 + 5.8828110897909833e-02 -3.1499387404675894e-02 + 5.8836191400193201e-02 -3.1483723345442374e-02 + 5.8842922931557295e-02 -3.1470674075333605e-02 + 5.8848530901098713e-02 -3.1459802718555543e-02 + 5.8853202578152804e-02 -3.1450745423196876e-02 + 5.8857094788717527e-02 -3.1443199252262591e-02 + 5.8860337682742847e-02 -3.1436911910642872e-02 + 5.8863039654319958e-02 -3.1431673270898963e-02 + 5.1090472497647567e-02 -4.1364129746731100e-02 + 5.2017861810158154e-02 -3.9608889832612647e-02 + 5.2790016664693906e-02 -3.8147403799641384e-02 + 5.3432939974520290e-02 -3.6930475935766947e-02 + 5.3968279328070579e-02 -3.5917148880800422e-02 + 5.4414055392254398e-02 -3.5073325973479681e-02 + 5.4785268918086050e-02 -3.4370623215448634e-02 + 5.5094406466861957e-02 -3.3785412784849041e-02 + 5.5351861658478108e-02 -3.3298026314424266e-02 + 5.5566285979522824e-02 -3.2892091380174911e-02 + 5.5744880880680268e-02 -3.2553979017136137e-02 + 5.5893640956743769e-02 -3.2272343742433061e-02 + 5.6017556378613602e-02 -3.2037740637092596e-02 + 5.6120781387180615e-02 -3.1842306609489807e-02 + 5.6206774524525216e-02 -3.1679495108646955e-02 + 5.6278415331277594e-02 -3.1543855346142520e-02 + 5.6338101451508804e-02 -3.1430848573520319e-02 + 5.6387829429496744e-02 -3.1336695204330328e-02 + 5.6429261935783182e-02 -3.1258247605548989e-02 + 5.6463783702775258e-02 -3.1192884246990474e-02 + 5.6492548067795738e-02 -3.1138421618620678e-02 + 5.6516515703894613e-02 -3.1093040928311135e-02 + 5.6536486853102877e-02 -3.1055227093744468e-02 + 5.6553128154563655e-02 -3.1023717961303501e-02 + 5.6566994977349003e-02 -3.0997462032899631e-02 + 5.6578495751409649e-02 -3.0975687769213282e-02 + 5.6588075856787573e-02 -3.0957549653364787e-02 + 5.6596056342443080e-02 -3.0942439936466816e-02 + 5.6602704553228377e-02 -3.0929852523626889e-02 + 5.6608243108592221e-02 -3.0919365978661385e-02 + 5.6612857087750094e-02 -3.0910629310425947e-02 + 5.6616701227469722e-02 -3.0903350293257421e-02 + 5.6619904070112449e-02 -3.0897285554203392e-02 + 5.6622572671057365e-02 -3.0892232398542437e-02 + 4.9337919366148841e-02 -4.0576725652895392e-02 + 5.0255950898478730e-02 -3.8869533821606898e-02 + 5.1020314429288990e-02 -3.7448070863977619e-02 + 5.1656750464546812e-02 -3.6264481928975335e-02 + 5.2186688136015506e-02 -3.5278926473982661e-02 + 5.2627966256975779e-02 -3.4458238022477487e-02 + 5.2995434202619873e-02 -3.3774807301766796e-02 + 5.3301452532663433e-02 -3.3205651731093820e-02 + 5.3556309987732587e-02 -3.2731640339491080e-02 + 5.3768570756488707e-02 -3.2336848281004908e-02 + 5.3945363624811962e-02 -3.2008019365974499e-02 + 5.4092622701138293e-02 -3.1734118590207729e-02 + 5.4215287805348830e-02 -3.1505959633164791e-02 + 5.4317471262203425e-02 -3.1315894795483024e-02 + 5.4402596717429780e-02 -3.1157556937017529e-02 + 5.4473514657459240e-02 -3.1025644714119786e-02 + 5.4532598534350787e-02 -3.0915743866643055e-02 + 5.4581824747401538e-02 -3.0824178511480102e-02 + 5.4622839190955050e-02 -3.0747887407443279e-02 + 5.4657012625497943e-02 -3.0684320997252615e-02 + 5.4685486751155254e-02 -3.0631355733277046e-02 + 5.4709212547752843e-02 -3.0587222781193114e-02 + 5.4728982182763723e-02 -3.0550448682333739e-02 + 5.4745455568964062e-02 -3.0519805963933711e-02 + 5.4759182471602906e-02 -3.0494272024497997e-02 + 5.4770567220209412e-02 -3.0473095952785825e-02 + 5.4780050676356475e-02 -3.0455456206069990e-02 + 5.4787950650180099e-02 -3.0440761704298252e-02 + 5.4794531789568120e-02 -3.0428520235886942e-02 + 5.4800014468178018e-02 -3.0418321928209625e-02 + 5.4804582003349450e-02 -3.0409825422182641e-02 + 5.4808387448496185e-02 -3.0402746514653183e-02 + 5.4811558051967600e-02 -3.0396848515380229e-02 + 5.4814199791420000e-02 -3.0391934296460442e-02 + 4.7928042460900107e-02 -3.9904048716379655e-02 + 4.8840755156266374e-02 -3.8226619168182423e-02 + 4.9600690325469154e-02 -3.6829950742505752e-02 + 5.0233439281433680e-02 -3.5667018021806836e-02 + 5.0760306954459482e-02 -3.4698671404631759e-02 + 5.1199028769674262e-02 -3.3892319977778466e-02 + 5.1564368044908167e-02 -3.3220833915251109e-02 + 5.1868613710596506e-02 -3.2661630014871240e-02 + 5.2121994888147255e-02 -3.2195909987635066e-02 + 5.2333026143352543e-02 -3.1808026112457734e-02 + 5.2508794958563081e-02 -3.1484953047282667e-02 + 5.2655201062462118e-02 -3.1215848088848436e-02 + 5.2777155656955593e-02 -3.0991685109412935e-02 + 5.2878747243755027e-02 -3.0804949858236313e-02 + 5.2963379635741201e-02 -3.0649386366860629e-02 + 5.3033886807263397e-02 -3.0519785907287635e-02 + 5.3092628461826177e-02 -3.0411811378328917e-02 + 5.3141569550469225e-02 -3.0321851180318035e-02 + 5.3182346433850246e-02 -3.0246897629950795e-02 + 5.3216321932467614e-02 -3.0184445792812643e-02 + 5.3244631133474996e-02 -3.0132409300762209e-02 + 5.3268219508371933e-02 -3.0089050297746656e-02 + 5.3287874636195012e-02 -3.0052921137070136e-02 + 5.3304252607426827e-02 -3.0022815853499189e-02 + 5.3317900002991109e-02 -2.9997729766876081e-02 + 5.3329218823818782e-02 -2.9976924647897338e-02 + 5.3338647362409099e-02 -2.9959593965187922e-02 + 5.3346501588443146e-02 -2.9945156970100566e-02 + 5.3353044617288924e-02 -2.9933130056548435e-02 + 5.3358495546362433e-02 -2.9923110519860185e-02 + 5.3363036718337795e-02 -2.9914762971998209e-02 + 5.3366820199294042e-02 -2.9907808183665435e-02 + 5.3369972502993100e-02 -2.9902013608122495e-02 + 5.3372598995278457e-02 -2.9897185569268455e-02 + 4.6796874545280677e-02 -3.9332141108743862e-02 + 4.7708655476166588e-02 -3.7669485747071650e-02 + 4.8467815038568507e-02 -3.6285129809219954e-02 + 4.9099918350711098e-02 -3.5132458060526457e-02 + 4.9626248539368728e-02 -3.4172662727305146e-02 + 5.0064522884440861e-02 -3.3373437762859420e-02 + 5.0429489604624962e-02 -3.2707890739814317e-02 + 5.0733425066781232e-02 -3.2153636297905942e-02 + 5.0986547938827016e-02 -3.1692041025678415e-02 + 5.1197364088530921e-02 -3.1307594608577446e-02 + 5.1372953761018435e-02 -3.0987386217759642e-02 + 5.1519210662331803e-02 -3.0720668584493179e-02 + 5.1641040982623419e-02 -3.0498495115878651e-02 + 5.1742529052534889e-02 -3.0313417845249543e-02 + 5.1827075213096888e-02 -3.0159236044980272e-02 + 5.1897510548712951e-02 -3.0030787024642788e-02 + 5.1956192356996708e-02 -2.9923772050267416e-02 + 5.2005083585932296e-02 -2.9834611496852403e-02 + 5.2045818928199650e-02 -2.9760324328364618e-02 + 5.2079759815427659e-02 -2.9698427817635320e-02 + 5.2108040177914108e-02 -2.9646854103361875e-02 + 5.2131604523776742e-02 -2.9603880752617329e-02 + 5.2151239629628060e-02 -2.9568072971784432e-02 + 5.2167600917336694e-02 -2.9538235506791466e-02 + 5.2181234411034054e-02 -2.9513372603730659e-02 + 5.2192541711050505e-02 -2.9492752197867834e-02 + 5.2201960653135836e-02 -2.9475575430055270e-02 + 5.2209806885265671e-02 -2.9461266688770131e-02 + 5.2216343254812593e-02 -2.9449346647652433e-02 + 5.2221788636259717e-02 -2.9439416167349516e-02 + 5.2226325257784388e-02 -2.9431142830389931e-02 + 5.2230104947902749e-02 -2.9424249882666224e-02 + 5.2233254093424018e-02 -2.9418506839689940e-02 + 5.2235877954449228e-02 -2.9413721743836163e-02 + 4.4900576732342705e-02 -9.1529441822737253e-03 + 4.4896025152511683e-02 -9.1516313064859169e-03 + 4.4890562368419505e-02 -9.1500555993511493e-03 + 4.4884005786755263e-02 -9.1481643928436919e-03 + 4.4876136166109824e-02 -9.1458944481713350e-03 + 4.4866690251602427e-02 -9.1431698310207588e-03 + 4.4855351838009885e-02 -9.1398993339027075e-03 + 4.4841741251619535e-02 -9.1359734422553334e-03 + 4.4825402540332092e-02 -9.1312606393927007e-03 + 4.4805788160931677e-02 -9.1256029897976640e-03 + 4.4782138628363430e-02 -9.1187814245756362e-03 + 4.4753757289555503e-02 -9.1105949983471737e-03 + 4.4719696976351329e-02 -9.1007705061513962e-03 + 4.4678820752104921e-02 -9.0889800054867083e-03 + 4.4629763824095267e-02 -9.0748298300695352e-03 + 4.4570887788525873e-02 -9.0578473922561936e-03 + 4.4500225657981542e-02 -9.0374653263296089e-03 + 4.4415415807216252e-02 -9.0130024356937614e-03 + 4.4313622595084021e-02 -8.9836407968135260e-03 + 4.4191440968846099e-02 -8.9483982426798482e-03 + 4.4044781812577545e-02 -8.9060952924170933e-03 + 4.3868734150962083e-02 -8.8553154048155950e-03 + 4.3657399541826986e-02 -8.7943572097798801e-03 + 4.3403693053970294e-02 -8.7211771015346766e-03 + 4.3099104110395518e-02 -8.6333202553986778e-03 + 4.2733409131343915e-02 -8.5278377413827919e-03 + 4.2294326298694757e-02 -8.4011869430752426e-03 + 4.1767100828408690e-02 -8.2491119318318477e-03 + 4.1134006818096439e-02 -8.0664997779107319e-03 + 4.0373748967327351e-02 -7.8472079801764922e-03 + 3.9460744167014471e-02 -7.5838572448670080e-03 + 3.8364259013262965e-02 -7.2675827068156085e-03 + 3.7047374590737307e-02 -6.8877353271785992e-03 + 3.5465744207352115e-02 -6.4315235697842846e-03 + 4.4651494565766746e-02 -1.0009562523021485e-02 + 4.4646755937004290e-02 -1.0008489683392727e-02 + 4.4641068657714840e-02 -1.0007202066448865e-02 + 4.4634242630763321e-02 -1.0005656633695842e-02 + 4.4626049605007226e-02 -1.0003801708311959e-02 + 4.4616215507019816e-02 -1.0001575239272399e-02 + 4.4604411136937916e-02 -9.9989026947750470e-03 + 4.4590241218205484e-02 -9.9956945830822468e-03 + 4.4573231061283247e-02 -9.9918434329989616e-03 + 4.4552810621357408e-02 -9.9872201846832181e-03 + 4.4528189202110872e-02 -9.9816458221933906e-03 + 4.4498641521187078e-02 -9.9749561393874583e-03 + 4.4463181486236639e-02 -9.9669278821035972e-03 + 4.4420625437731821e-02 -9.9572930662357919e-03 + 4.4369552496289016e-02 -9.9457300004953224e-03 + 4.4308256927239914e-02 -9.9318525014662744e-03 + 4.4234690909139743e-02 -9.9151969363045350e-03 + 4.4146395764735460e-02 -9.8952066531690346e-03 + 4.4040419321142402e-02 -9.8712132713525483e-03 + 4.3913216593716331e-02 -9.8424141957589150e-03 + 4.3760530422648762e-02 -9.8078455928169578e-03 + 4.3577248014286613e-02 -9.7663499108046423e-03 + 4.3357228527580692e-02 -9.7165368450328176e-03 + 4.3093095873433900e-02 -9.6567364270464043e-03 + 4.2775989729377198e-02 -9.5849426535032974e-03 + 4.2395266373681156e-02 -9.4987457541428275e-03 + 4.1938139262114732e-02 -9.3952508173763202e-03 + 4.1389247257136053e-02 -9.2709800359917615e-03 + 4.0730136003495107e-02 -9.1217552890855494e-03 + 3.9938635062193931e-02 -8.9425571234026495e-03 + 3.8988109976300138e-02 -8.7273554187117346e-03 + 3.7846564340881642e-02 -8.4689060938217282e-03 + 3.6475562043430172e-02 -8.1585070986358137e-03 + 3.4828933947446551e-02 -7.7857056034499935e-03 + 4.4445302008942790e-02 -1.0785810661214208e-02 + 4.4440408732927428e-02 -1.0784961700371277e-02 + 4.4434535846715695e-02 -1.0783942781656897e-02 + 4.4427487049325538e-02 -1.0782719847780640e-02 + 4.4419026640497308e-02 -1.0781252005815065e-02 + 4.4408871602286168e-02 -1.0779490153437205e-02 + 4.4396681991280655e-02 -1.0777375312099957e-02 + 4.4382049630914702e-02 -1.0774836664933635e-02 + 4.4364484339891569e-02 -1.0771789167859373e-02 + 4.4343397469748365e-02 -1.0768130693006519e-02 + 4.4317972519421697e-02 -1.0763719581217780e-02 + 4.4287460536686543e-02 -1.0758425892743525e-02 + 4.4250843247596677e-02 -1.0752072961762227e-02 + 4.4206898363371536e-02 -1.0744448726737552e-02 + 4.4154158633571437e-02 -1.0735298626497363e-02 + 4.4090862656143051e-02 -1.0724317065961747e-02 + 4.4014895778030645e-02 -1.0711137162513972e-02 + 4.3923719081967884e-02 -1.0695318425672612e-02 + 4.3814284049631454e-02 -1.0676331951583622e-02 + 4.3682930004139142e-02 -1.0653542629708615e-02 + 4.3525260851356912e-02 -1.0626187757875948e-02 + 4.3335996939410384e-02 -1.0593351340869939e-02 + 4.3108797018103981e-02 -1.0553933200978098e-02 + 4.2836044276295560e-02 -1.0506611856481702e-02 + 4.2508589231039631e-02 -1.0449799914308645e-02 + 4.2115440797836225e-02 -1.0381590471919052e-02 + 4.1643395137938882e-02 -1.0299692724057199e-02 + 4.1076589796190721e-02 -1.0201354607868115e-02 + 4.0395968151129745e-02 -1.0083269887256045e-02 + 3.9578636221614553e-02 -9.9414665619346598e-03 + 3.8597090323206504e-02 -9.7711728693578668e-03 + 3.7418289833958590e-02 -9.5666564137880713e-03 + 3.6002544261601252e-02 -9.3210310775930939e-03 + 3.4302177719135400e-02 -9.0260253139770649e-03 + 4.4277038375168269e-02 -1.1495357895771146e-02 + 4.4272016166370436e-02 -1.1494718326672189e-02 + 4.4265988535624745e-02 -1.1493950718950900e-02 + 4.4258754009696165e-02 -1.1493029415325637e-02 + 4.4250070677797695e-02 -1.1491923608896233e-02 + 4.4239648064788674e-02 -1.1490596308241114e-02 + 4.4227137270091949e-02 -1.1489003081442125e-02 + 4.4212119362061000e-02 -1.1487090578375945e-02 + 4.4194091243721527e-02 -1.1484794730512130e-02 + 4.4172448756259260e-02 -1.1482038599402136e-02 + 4.4146353884640624e-02 -1.1478715465321348e-02 + 4.4115037942567589e-02 -1.1474727437450758e-02 + 4.4077455825601665e-02 -1.1469941423703684e-02 + 4.4032353038866524e-02 -1.1464197666461437e-02 + 4.3978223671484407e-02 -1.1457304390680170e-02 + 4.3913259910185964e-02 -1.1449031374672838e-02 + 4.3835291383036747e-02 -1.1439102225600160e-02 + 4.3741712274880828e-02 -1.1427185097594019e-02 + 4.3629393742058924e-02 -1.1412881538197609e-02 + 4.3494578652642217e-02 -1.1395713083536192e-02 + 4.3332755079976089e-02 -1.1375105147982690e-02 + 4.3138504258690376e-02 -1.1350367661782879e-02 + 4.2905317853272174e-02 -1.1320671800240776e-02 + 4.2625378357460018e-02 -1.1285022018291332e-02 + 4.2289295208752749e-02 -1.1242222444998054e-02 + 4.1885787718953668e-02 -1.1190836505370427e-02 + 4.1401304141764655e-02 -1.1129138409380233e-02 + 4.0819564062594633e-02 -1.1055054876031678e-02 + 4.0121008737669890e-02 -1.0966095135138888e-02 + 3.9282140952972111e-02 -1.0859266859519004e-02 + 3.8274732330335209e-02 -1.0730975216966287e-02 + 3.7064871661371936e-02 -1.0576901677176223e-02 + 3.5611822650240890e-02 -1.0391858547583774e-02 + 3.3866653199369344e-02 -1.0169614415073176e-02 + 4.4143380917899468e-02 -1.2149089567852137e-02 + 4.4138250016725826e-02 -1.2148646418301677e-02 + 4.4132091933950214e-02 -1.2148114552345695e-02 + 4.4124700835922258e-02 -1.2147476192393834e-02 + 4.4115829576362786e-02 -1.2146709992721712e-02 + 4.4105181393575797e-02 -1.2145790322405078e-02 + 4.4092399835954088e-02 -1.2144686395158092e-02 + 4.4077056905226293e-02 -1.2143361245276664e-02 + 4.4058638616132163e-02 -1.2141770480551385e-02 + 4.4036527734514622e-02 -1.2139860791163430e-02 + 4.4009868108743036e-02 -1.2137558232422428e-02 + 4.3977874416263399e-02 -1.2134794976970426e-02 + 4.3939478934206806e-02 -1.2131478806876353e-02 + 4.3893400017496496e-02 -1.2127499028094282e-02 + 4.3838099163718364e-02 -1.2122722762055619e-02 + 4.3771729434356227e-02 -1.2116990491020902e-02 + 4.3692073485562755e-02 -1.2110110705689271e-02 + 4.3596469106192193e-02 -1.2101853474232482e-02 + 4.3481719737087830e-02 -1.2091942713835260e-02 + 4.3343986933195723e-02 -1.2080046902722240e-02 + 4.3178661119152473e-02 -1.2065767917588432e-02 + 4.2980206254886008e-02 -1.2048627617529194e-02 + 4.2741973149144567e-02 -1.2028051720219719e-02 + 4.2455975106566485e-02 -1.2003350424661463e-02 + 4.2112618330839340e-02 -1.1973695126597225e-02 + 4.1700377993315253e-02 -1.1938090440890909e-02 + 4.1205409056054479e-02 -1.1895340588820255e-02 + 4.0611078758217733e-02 -1.1844009019496312e-02 + 3.9897405058921954e-02 -1.1782369908898239e-02 + 3.9040382209387922e-02 -1.1708349910290385e-02 + 3.8011170903138755e-02 -1.1619458208626022e-02 + 3.6775126013907880e-02 -1.1512702547446395e-02 + 3.5290629616762305e-02 -1.1384488438233980e-02 + 3.3507690608964975e-02 -1.1230498211560448e-02 + 4.4034372693742045e-02 -1.2754196877549620e-02 + 4.4029152040199471e-02 -1.2753938864200962e-02 + 4.4022886237077161e-02 -1.2753629197776385e-02 + 4.4015365850128219e-02 -1.2753257527776046e-02 + 4.4006339409967919e-02 -1.2752811426114567e-02 + 4.3995504963703400e-02 -1.2752275969802654e-02 + 4.3982499824508865e-02 -1.2751633234202333e-02 + 4.3966888507337251e-02 -1.2750861696971743e-02 + 4.3948148036082810e-02 -1.2749935511720586e-02 + 4.3925650379551109e-02 -1.2748823640208401e-02 + 4.3898524409873650e-02 -1.2747483029698697e-02 + 4.3865971067339998e-02 -1.2745874189419932e-02 + 4.3826903951782750e-02 -1.2743943427665027e-02 + 4.3780018999002454e-02 -1.2741626295436733e-02 + 4.3723750794281750e-02 -1.2738845427292997e-02 + 4.3656220091543560e-02 -1.2735507947766501e-02 + 4.3575170759968439e-02 -1.2731502355151601e-02 + 4.3477894019660228e-02 -1.2726694777057793e-02 + 4.3361137395628288e-02 -1.2720924470741518e-02 + 4.3220995298803869e-02 -1.2713998415506461e-02 + 4.3052777520709080e-02 -1.2705684813454415e-02 + 4.2850851182006384e-02 -1.2695705278361087e-02 + 4.2608450780373626e-02 -1.2683725447829156e-02 + 4.2317449913124208e-02 -1.2669343701532295e-02 + 4.1968086964344758e-02 -1.2652077604258728e-02 + 4.1548635507048216e-02 -1.2631347616434795e-02 + 4.1045008318881873e-02 -1.2606457524157968e-02 + 4.0440281690166287e-02 -1.2576570929583003e-02 + 3.9714124043902815e-02 -1.2540683012390207e-02 + 3.8842109710453314e-02 -1.2497586615438584e-02 + 3.7794894911356541e-02 -1.2445831520382171e-02 + 3.6537228489927222e-02 -1.2383675556577925e-02 + 3.5026764519274910e-02 -1.2309025917928183e-02 + 3.3212637426495266e-02 -1.2219368743320953e-02 + 4.3945781644940417e-02 -1.3317488190294175e-02 + 4.3940487516951822e-02 -1.3317405491982851e-02 + 4.3934133530111150e-02 -1.3317306237882041e-02 + 4.3926507302727048e-02 -1.3317187110458428e-02 + 4.3917353826165788e-02 -1.3317044126200432e-02 + 4.3906366898034128e-02 -1.3316872502031708e-02 + 4.3893178727031211e-02 -1.3316666492784273e-02 + 4.3877347699245381e-02 -1.3316419200151655e-02 + 4.3858343478214899e-02 -1.3316122339816251e-02 + 4.3835529194084545e-02 -1.3315765963383916e-02 + 4.3808021458811804e-02 -1.3315336271702605e-02 + 4.3775009966877339e-02 -1.3314820607178236e-02 + 4.3735393028334880e-02 -1.3314201760522591e-02 + 4.3687848225886255e-02 -1.3313459074666729e-02 + 4.3630788113399419e-02 -1.3312567752422347e-02 + 4.3562306996705755e-02 -1.3311498025473640e-02 + 4.3480116992635452e-02 -1.3310214155297356e-02 + 4.3381471198457956e-02 -1.3308673233169813e-02 + 4.3263071364477483e-02 -1.3306823737964097e-02 + 4.3120956935062460e-02 -1.3304603802809473e-02 + 4.2950371692733955e-02 -1.3301939131964835e-02 + 4.2745603482077218e-02 -1.3298740497249792e-02 + 4.2499791584498452e-02 -1.3294900728981441e-02 + 4.2204695227719802e-02 -1.3290291100107671e-02 + 4.1850415412872245e-02 -1.3284756980726720e-02 + 4.1425060677524425e-02 -1.3278112617203909e-02 + 4.0914345538452801e-02 -1.3270134859415092e-02 + 4.0301108105018517e-02 -1.3260555625668285e-02 + 3.9564730657572031e-02 -1.3249052851511622e-02 + 3.8680443764350710e-02 -1.3235239619651661e-02 + 3.7618490668221476e-02 -1.3218651106960709e-02 + 3.6343124094728188e-02 -1.3198728913899560e-02 + 3.4811402148486235e-02 -1.3174802255542278e-02 + 3.2971743384550632e-02 -1.3146065390517757e-02 + 4.3879418370964020e-02 -1.3845275777212541e-02 + 4.3874062927429520e-02 -1.3845359108921301e-02 + 4.3867635350018565e-02 -1.3845459123261997e-02 + 4.3859920797241173e-02 -1.3845579163243927e-02 + 4.3850661307000285e-02 -1.3845723242685232e-02 + 4.3839547130484359e-02 -1.3845896181408586e-02 + 4.3826206216788274e-02 -1.3846103768600028e-02 + 4.3810191837250816e-02 -1.3846352955440039e-02 + 4.3790967513215845e-02 -1.3846652089654330e-02 + 4.3767888998684529e-02 -1.3847011195764519e-02 + 4.3740062674437787e-02 -1.3847444178750883e-02 + 4.3706668850087178e-02 -1.3847963793125534e-02 + 4.3666593076278196e-02 -1.3848587379882890e-02 + 4.3618497619587297e-02 -1.3849335754486084e-02 + 4.3560776648539620e-02 -1.3850233903923594e-02 + 4.3491502397512691e-02 -1.3851311824623874e-02 + 4.3408360485535202e-02 -1.3852605528839658e-02 + 4.3308572195894228e-02 -1.3854158253892229e-02 + 4.3188801079164230e-02 -1.3856021915558151e-02 + 4.3045040709398082e-02 -1.3858258854682804e-02 + 4.2872479783566425e-02 -1.3860943935981501e-02 + 4.2665339989247562e-02 -1.3864167071176761e-02 + 4.2416681148344355e-02 -1.3868036250742037e-02 + 4.2118167045735878e-02 -1.3872681187806457e-02 + 4.1759784034307627e-02 -1.3878257696647063e-02 + 4.1329502927080548e-02 -1.3884952953731960e-02 + 4.0812872789413229e-02 -1.3892991818395857e-02 + 4.0192532964976657e-02 -1.3902644425827584e-02 + 3.9447626944049165e-02 -1.3914235307283753e-02 + 3.8553098420251654e-02 -1.3928154343787177e-02 + 3.7478845999896947e-02 -1.3944869918789156e-02 + 3.6188708390681376e-02 -1.3964944709044929e-02 + 3.4639246353059754e-02 -1.3989054637419521e-02 + 3.2778281036300150e-02 -1.4018011616988039e-02 + 4.3835158608478052e-02 -1.4342488039941953e-02 + 4.3829751186773999e-02 -1.4342729197090660e-02 + 4.3823261225359053e-02 -1.4343018632716902e-02 + 4.3815471797584715e-02 -1.4343366021249174e-02 + 4.3806122437742283e-02 -1.4343782978716689e-02 + 4.3794900390607246e-02 -1.4344283453227061e-02 + 4.3781429994310506e-02 -1.4344884198365599e-02 + 4.3765260184373760e-02 -1.4345605330390759e-02 + 4.3745849275212564e-02 -1.4346471007144148e-02 + 4.3722546768073800e-02 -1.4347510239218767e-02 + 4.3694450370490780e-02 -1.4348763266482937e-02 + 4.3660732436476841e-02 -1.4350266999841214e-02 + 4.3620267700106269e-02 -1.4352071623335410e-02 + 4.3571705444414043e-02 -1.4354237375357577e-02 + 4.3513424252199027e-02 -1.4356836567060334e-02 + 4.3443477647657040e-02 -1.4359956006217098e-02 + 4.3359528787080874e-02 -1.4363699910077811e-02 + 4.3258771984454582e-02 -1.4368193405076127e-02 + 4.3137838407885966e-02 -1.4373586732432404e-02 + 4.2992682746315874e-02 -1.4380060302642071e-02 + 4.2818446999725493e-02 -1.4387830770061807e-02 + 4.2609296773329509e-02 -1.4397158333736145e-02 + 4.2358224529885448e-02 -1.4408355511818663e-02 + 4.2056813145602306e-02 -1.4421797686523562e-02 + 4.1694951784149899e-02 -1.4437935775149010e-02 + 4.1260494507226408e-02 -1.4457311455402140e-02 + 4.0738850123921595e-02 -1.4480575456957535e-02 + 4.0112489481116564e-02 -1.4508509535147599e-02 + 3.9360353642448880e-02 -1.4542052864498521e-02 + 3.8457143113122524e-02 -1.4582333737533879e-02 + 3.7372464345010861e-02 -1.4630707628639333e-02 + 3.6069805075997032e-02 -1.4688802890970170e-02 + 3.4505304459288885e-02 -1.4758575605863572e-02 + 3.2626277212969575e-02 -1.4842375401715135e-02 + 4.3803814220977629e-02 -1.4812283869828264e-02 + 4.3798365580405473e-02 -1.4812675619518188e-02 + 4.3791826148340519e-02 -1.4813145795601489e-02 + 4.3783977344552680e-02 -1.4813710113740190e-02 + 4.3774556717835172e-02 -1.4814387443724382e-02 + 4.3763249129057026e-02 -1.4815200443664371e-02 + 4.3749676052712703e-02 -1.4816176328992051e-02 + 4.3733382986092813e-02 -1.4817347777892556e-02 + 4.3713824114513987e-02 -1.4818754033626631e-02 + 4.3690343980644253e-02 -1.4820442222671183e-02 + 4.3662033414253967e-02 -1.4822477713096279e-02 + 4.3628058460419707e-02 -1.4824920465159121e-02 + 4.3587285275777883e-02 -1.4827852000550441e-02 + 4.3538352847336245e-02 -1.4831370174263678e-02 + 4.3479627398379517e-02 -1.4835592452570210e-02 + 4.3409147615777639e-02 -1.4840659851131408e-02 + 4.3324558842971560e-02 -1.4846741666531132e-02 + 4.3223034007134960e-02 -1.4854041161356590e-02 + 4.3101178597012860e-02 -1.4862802396279894e-02 + 4.2954916465568781e-02 -1.4873318440578339e-02 + 4.2779352581989401e-02 -1.4885941240208743e-02 + 4.2568608077965912e-02 -1.4901093477632583e-02 + 4.2315622000261115e-02 -1.4919282825601695e-02 + 4.2011913064460428e-02 -1.4941119076666754e-02 + 4.1647293362827680e-02 -1.4967334727287687e-02 + 4.1209524372930940e-02 -1.4998809710248910e-02 + 4.0683903680417077e-02 -1.5036601108732287e-02 + 4.0052768513703332e-02 -1.5081978851525655e-02 + 3.9294899411592955e-02 -1.5136468588393315e-02 + 3.8384804030324737e-02 -1.5201903183562883e-02 + 3.7291857142548540e-02 -1.5280484548268036e-02 + 3.5979268166231086e-02 -1.5374857874415551e-02 + 3.4402841918941877e-02 -1.5488200734290563e-02 + 3.2509491517650875e-02 -1.5624330001046339e-02 + 4.3783695385740118e-02 -1.5258159590855584e-02 + 4.3778215056674501e-02 -1.5258695427428481e-02 + 4.3771637592297831e-02 -1.5259338535914203e-02 + 4.3763743141041901e-02 -1.5260110412140674e-02 + 4.3754267725418530e-02 -1.5261036866437384e-02 + 4.3742894373394868e-02 -1.5262148890528663e-02 + 4.3729242358090281e-02 -1.5263483709844658e-02 + 4.3712854533441349e-02 -1.5265086021670937e-02 + 4.3693181910436280e-02 -1.5267009503077073e-02 + 4.3669565219660443e-02 -1.5269318613817896e-02 + 4.3641090003294615e-02 -1.5272102764626443e-02 + 4.3606917456251212e-02 -1.5275443969230080e-02 + 4.3565907140981484e-02 -1.5279453733398753e-02 + 4.3516690128926207e-02 -1.5284265903474472e-02 + 4.3457623141623360e-02 -1.5290041150194399e-02 + 4.3386733459238075e-02 -1.5296972355315316e-02 + 4.3301652730977802e-02 -1.5305291083279514e-02 + 4.3199537442036196e-02 -1.5315275357309210e-02 + 4.3076973339254011e-02 -1.5327259004464621e-02 + 4.2929860569380883e-02 -1.5341642885914001e-02 + 4.2753275632841856e-02 -1.5358908394488726e-02 + 4.2541305470629877e-02 -1.5379633676800262e-02 + 4.2286848064209459e-02 -1.5404513129282295e-02 + 4.1981372803147114e-02 -1.5434380828337429e-02 + 4.1614632528478065e-02 -1.5470238685138351e-02 + 4.1174317540331767e-02 -1.5513290274695377e-02 + 4.0645639917386477e-02 -1.5564981479071451e-02 + 4.0010834163993730e-02 -1.5627049311189328e-02 + 3.9248557409819647e-02 -1.5701580560044344e-02 + 3.8333169051508242e-02 -1.5791082223551599e-02 + 3.7233865749940379e-02 -1.5898566083572489e-02 + 3.5913642954641591e-02 -1.6027650242526462e-02 + 3.4328048450755780e-02 -1.6182680994721262e-02 + 3.2423686609910719e-02 -1.6368879072411177e-02 + 4.3776495477650099e-02 -1.5683160208011630e-02 + 4.3770990732666423e-02 -1.5683834366933762e-02 + 4.3764383964370275e-02 -1.5684643489238880e-02 + 4.3756454341795994e-02 -1.5685614619795462e-02 + 4.3746936711315222e-02 -1.5686780231593311e-02 + 4.3735512688748243e-02 -1.5688179316669427e-02 + 4.3721799851070733e-02 -1.5689858710032957e-02 + 4.3705339015434275e-02 -1.5691874647089311e-02 + 4.3685578747018110e-02 -1.5694294661386703e-02 + 4.3661856839251709e-02 -1.5697199852439760e-02 + 4.3633254760205416e-02 -1.5700702711754364e-02 + 4.3598929967770809e-02 -1.5704906424275546e-02 + 4.3557736943456868e-02 -1.5709951280200547e-02 + 4.3508300659945431e-02 -1.5716005677333507e-02 + 4.3448970517633627e-02 -1.5723271762425325e-02 + 4.3377765007805970e-02 -1.5731992208301834e-02 + 4.3292305228131427e-02 -1.5742458355973012e-02 + 4.3189734995551586e-02 -1.5755019998508042e-02 + 4.3066624845622389e-02 -1.5770097137916980e-02 + 4.2918856659462691e-02 -1.5788194114790446e-02 + 4.2741485002332671e-02 -1.5809916590199962e-02 + 4.2528570471441263e-02 -1.5835991954901152e-02 + 4.2272979407231154e-02 -1.5867293859002717e-02 + 4.1966143193879708e-02 -1.5904871689585001e-02 + 4.1597769019247811e-02 -1.5949985993983843e-02 + 4.1155492341346953e-02 -1.6004151041556260e-02 + 4.0624459355720004e-02 -1.6069185958272104e-02 + 3.9986825418013107e-02 -1.6147276154483529e-02 + 3.9221152571145050e-02 -1.6241047108776576e-02 + 3.8301685977825566e-02 -1.6353652982484267e-02 + 3.7197485064114577e-02 -1.6488883027346996e-02 + 3.5871380416932303e-02 -1.6651289332851128e-02 + 3.4278721778020507e-02 -1.6846340157820848e-02 + 3.2365875631082897e-02 -1.7080603929017994e-02 + 4.3783324733893410e-02 -1.6089634726283365e-02 + 4.3777801128505052e-02 -1.6090441802754568e-02 + 4.3771171724043781e-02 -1.6091410452078660e-02 + 4.3763214932922914e-02 -1.6092573051193330e-02 + 4.3753664693063826e-02 -1.6093968475661618e-02 + 4.3742201529411807e-02 -1.6095643405151787e-02 + 4.3728441708701708e-02 -1.6097653908630653e-02 + 4.3711924474808463e-02 -1.6100067308926221e-02 + 4.3692096503606517e-02 -1.6102964454546512e-02 + 4.3668293319649117e-02 -1.6106442434704608e-02 + 4.3639593243891515e-02 -1.6110635919659447e-02 + 4.3605150847596225e-02 -1.6115668438473563e-02 + 4.3563816687397172e-02 -1.6121707940953911e-02 + 4.3514211024893050e-02 -1.6128956026349783e-02 + 4.3454677605143606e-02 -1.6137654696734668e-02 + 4.3383228130432119e-02 -1.6148094470509019e-02 + 4.3297475547763226e-02 -1.6160624129611272e-02 + 4.3194553888171477e-02 -1.6175662432459596e-02 + 4.3071021937237476e-02 -1.6193712188922394e-02 + 4.2922747466484806e-02 -1.6215377175740273e-02 + 4.2744768097116748e-02 -1.6241382466233724e-02 + 4.2531124076668314e-02 -1.6272598864162522e-02 + 4.2274657304269624e-02 -1.6310072268822719e-02 + 4.1966769806156101e-02 -1.6355058965075348e-02 + 4.1597133504871993e-02 -1.6409068030512182e-02 + 4.1153341494976008e-02 -1.6473912288489542e-02 + 4.0620489079735735e-02 -1.6551769525065568e-02 + 3.9980670475358901e-02 -1.6645256027132203e-02 + 3.9212374273858500e-02 -1.6757514914202923e-02 + 3.8289757396487482e-02 -1.6892322223693770e-02 + 3.7181773260493246e-02 -1.7054214298338928e-02 + 3.5851125102605193e-02 -1.7248640720037275e-02 + 3.4253009683506065e-02 -1.7482147872580452e-02 + 3.2333609727274920e-02 -1.7762599217365942e-02 + 4.3799638381513878e-02 -1.6479926441461137e-02 + 4.3794102207093587e-02 -1.6480861793690457e-02 + 4.3787457717355122e-02 -1.6481984398937943e-02 + 4.3779482820468424e-02 -1.6483331780190406e-02 + 4.3769910848922657e-02 -1.6484948991692082e-02 + 4.3758421600742316e-02 -1.6486890132441576e-02 + 4.3744630469419440e-02 -1.6489220182862249e-02 + 4.3728075650359161e-02 -1.6492017166086795e-02 + 4.3708202560403878e-02 -1.6495374780475979e-02 + 4.3684345212050939e-02 -1.6499405546554224e-02 + 4.3655579828960366e-02 -1.6504265538912998e-02 + 4.3621059058600670e-02 -1.6510097920104338e-02 + 4.3579630842069214e-02 -1.6517097333746799e-02 + 4.3529912301374686e-02 -1.6525497420957498e-02 + 4.3470243412687765e-02 -1.6535578647435108e-02 + 4.3398631353903878e-02 -1.6547677706071857e-02 + 4.3312683640297750e-02 -1.6562198813858293e-02 + 4.3209527781400775e-02 -1.6579627286205385e-02 + 4.3085714732186121e-02 -1.6600545848916744e-02 + 4.2937102861281155e-02 -1.6625654242290070e-02 + 4.2758718497951029e-02 -1.6655792781932691e-02 + 4.2544588328241095e-02 -1.6691970676021184e-02 + 4.2287537962970682e-02 -1.6735400057854177e-02 + 4.1978949863516961e-02 -1.6787536884706408e-02 + 4.1608472450881548e-02 -1.6850130085018171e-02 + 4.1163670587472695e-02 -1.6925280610252048e-02 + 4.0629605660839757e-02 -1.7015512380893969e-02 + 3.9988331142339392e-02 -1.7123857513482141e-02 + 3.9218286674588959e-02 -1.7253958690985505e-02 + 3.8293570372633541e-02 -1.7410192109661802e-02 + 3.7183065006815216e-02 -1.7597815112933946e-02 + 3.5849388944727674e-02 -1.7823143432703789e-02 + 3.4247636996825800e-02 -1.8093763926980342e-02 + 3.2323869425411177e-02 -1.8418789866050143e-02 + 4.3823000732287974e-02 -1.6856079508072778e-02 + 4.3817458382263766e-02 -1.6857138775445299e-02 + 4.3810806480583851e-02 -1.6858410103028403e-02 + 4.3802822687687842e-02 -1.6859935984879827e-02 + 4.3793240038596103e-02 -1.6861767443988020e-02 + 4.3781737974164590e-02 -1.6863965746410869e-02 + 4.3767931458788573e-02 -1.6866604481109687e-02 + 4.3751358172829116e-02 -1.6869772007667139e-02 + 4.3731462914416382e-02 -1.6873574437682434e-02 + 4.3707578953147232e-02 -1.6878139198255520e-02 + 4.3678781482266352e-02 -1.6883643040672008e-02 + 4.3644222203950901e-02 -1.6890248093702747e-02 + 4.3602747774196073e-02 -1.6898174787230082e-02 + 4.3552973772372459e-02 -1.6907687715076423e-02 + 4.3493238322983629e-02 -1.6919104498953813e-02 + 4.3421546380857164e-02 -1.6932806436700001e-02 + 4.3335502792476222e-02 -1.6949251295799349e-02 + 4.3232231863087493e-02 -1.6968988686159661e-02 + 4.3108280700252757e-02 -1.6992678532773819e-02 + 4.2959503052643400e-02 -1.7021113277380710e-02 + 4.2780919701358160e-02 -1.7055244560268683e-02 + 4.2566550669150237e-02 -1.7096215289257682e-02 + 4.2309213563889954e-02 -1.7145398180503559e-02 + 4.2000281234057239e-02 -1.7204442076093181e-02 + 4.1629390553431289e-02 -1.7275327601837465e-02 + 4.1184092512999385e-02 -1.7360434042544691e-02 + 4.0649431836300272e-02 -1.7462619686867725e-02 + 4.0007441975291123e-02 -1.7585318345013319e-02 + 3.9236538522025105e-02 -1.7732655281349229e-02 + 3.8310790697902511e-02 -1.7909586449118681e-02 + 3.7199046562002132e-02 -1.8122065682787455e-02 + 3.5863882782665613e-02 -1.8377245420136790e-02 + 3.4260344078555750e-02 -1.8683717623584638e-02 + 3.2334430542064259e-02 -1.9051802886270619e-02 + 4.3853734871269832e-02 -1.7219788954224744e-02 + 4.3848191875461913e-02 -1.7220968140676800e-02 + 4.3841539198743139e-02 -1.7222383394559979e-02 + 4.3833554475625848e-02 -1.7224082020676289e-02 + 4.3823970710001457e-02 -1.7226120818286592e-02 + 4.3812467305393975e-02 -1.7228567989340093e-02 + 4.3798659181356302e-02 -1.7231505453741226e-02 + 4.3782083964369015e-02 -1.7235031574306496e-02 + 4.3762186387845986e-02 -1.7239264475383244e-02 + 4.3738299643743414e-02 -1.7244346010021644e-02 + 4.3709498817516214e-02 -1.7250472939456547e-02 + 4.3674935512526832e-02 -1.7257825746999803e-02 + 4.3633456250392270e-02 -1.7266649817235177e-02 + 4.3583676449125891e-02 -1.7277239698505722e-02 + 4.3523934039644059e-02 -1.7289948970306005e-02 + 4.3452233744341692e-02 -1.7305202097024994e-02 + 4.3366180130586414e-02 -1.7323508669851495e-02 + 4.3262897168540204e-02 -1.7345480519456963e-02 + 4.3138931563583324e-02 -1.7371852280836011e-02 + 4.2990136581111511e-02 -1.7403506107560165e-02 + 4.2811532422143472e-02 -1.7441501374581628e-02 + 4.2597138412738177e-02 -1.7487110377705107e-02 + 4.2339771323810886e-02 -1.7541861237522442e-02 + 4.2030802998686417e-02 -1.7607589460727824e-02 + 4.1659869103682592e-02 -1.7686499898634328e-02 + 4.1214519179320640e-02 -1.7781241193621147e-02 + 4.0679796206611420e-02 -1.7894995219652578e-02 + 4.0037731544089759e-02 -1.8031584526713509e-02 + 3.9266738268920985e-02 -1.8195601398164028e-02 + 3.8340882581220877e-02 -1.8392562848034484e-02 + 3.7229008910360024e-02 -1.8629096741179709e-02 + 3.5893689564285382e-02 -1.8913165239025226e-02 + 3.4289964023709187e-02 -1.9254332995370983e-02 + 3.2363826089231169e-02 -1.9664088992191010e-02 + 4.3888935039436160e-02 -1.7572886365601982e-02 + 4.3883397516960597e-02 -1.7574182017894076e-02 + 4.3876751409330075e-02 -1.7575737053524033e-02 + 4.3868774570586778e-02 -1.7577603449509215e-02 + 4.3859200268332912e-02 -1.7579843615030483e-02 + 4.3847708222582396e-02 -1.7582532488209013e-02 + 4.3833913733156371e-02 -1.7585760080013130e-02 + 4.3817354883080424e-02 -1.7589634468325465e-02 + 4.3797476954094174e-02 -1.7594285444434567e-02 + 4.3773613796592815e-02 -1.7599868871957525e-02 + 4.3744841409305624e-02 -1.7606600945771447e-02 + 4.3710312233304030e-02 -1.7614679975170654e-02 + 4.3668873929155014e-02 -1.7624375580911081e-02 + 4.3619143282197653e-02 -1.7636011403285967e-02 + 4.3559459864403731e-02 -1.7649975944084264e-02 + 4.3487830368410925e-02 -1.7666735591151648e-02 + 4.3401861726933715e-02 -1.7686850266943183e-02 + 4.3298680750031439e-02 -1.7710992231587321e-02 + 4.3174837552900670e-02 -1.7739968678343841e-02 + 4.3026189495681252e-02 -1.7774748889225617e-02 + 4.2847761696525183e-02 -1.7816496871661751e-02 + 4.2633579387082156e-02 -1.7866610583440870e-02 + 4.2376466431168262e-02 -1.7926769074550018e-02 + 4.2067803191892239e-02 -1.7998989140935423e-02 + 4.1697235569667597e-02 -1.8085693402625218e-02 + 4.1252325398975546e-02 -1.8189792102986560e-02 + 4.0718130429926683e-02 -1.8314781383223514e-02 + 4.0076699763968729e-02 -1.8464861338910409e-02 + 3.9306467793810126e-02 -1.8645077823829400e-02 + 3.8381526327583730e-02 -1.8861492756306664e-02 + 3.7270750558652276e-02 -1.9121388621903324e-02 + 3.5936749752379427e-02 -1.9433513988689272e-02 + 3.4334607785040175e-02 -1.9808378191811239e-02 + 3.2410371784774329e-02 -2.0258604956671301e-02 + 4.3930293774031570e-02 -1.7916744710066858e-02 + 4.3924766676176168e-02 -1.7918153519104921e-02 + 4.3918133080094526e-02 -1.7919844364874878e-02 + 4.3910171258060821e-02 -1.7921873763854068e-02 + 4.3900614979775036e-02 -1.7924309575854096e-02 + 4.3889144568224715e-02 -1.7927233283691078e-02 + 4.3875376047472998e-02 -1.7930742759550863e-02 + 4.3858848370064991e-02 -1.7934955520350571e-02 + 4.3839007862053345e-02 -1.7940012692794913e-02 + 4.3815189627849138e-02 -1.7946083752936614e-02 + 4.3786471405682217e-02 -1.7953403777274370e-02 + 4.3752007232176593e-02 -1.7962188394496429e-02 + 4.3710646937271135e-02 -1.7972730772901308e-02 + 4.3661009910152669e-02 -1.7985382818158060e-02 + 4.3601438848719296e-02 -1.8000566962119734e-02 + 4.3529944197977864e-02 -1.8018790324977500e-02 + 4.3444137395796299e-02 -1.8040661730414385e-02 + 4.3341150661034576e-02 -1.8066912150776146e-02 + 4.3217540603505557e-02 -1.8098419276303263e-02 + 4.3069172381967724e-02 -1.8136237041805385e-02 + 4.2891080480030763e-02 -1.8181631114220869e-02 + 4.2677301377036937e-02 -1.8236121542916088e-02 + 4.2420672446188287e-02 -1.8301534018948924e-02 + 4.2112590277357385e-02 -1.8380061476566002e-02 + 4.1742720262906603e-02 -1.8474338117090164e-02 + 4.1298647652791488e-02 -1.8587528351988476e-02 + 4.0765458326344248e-02 -1.8723433660626877e-02 + 4.0125235178290086e-02 -1.8886620956764407e-02 + 3.9356453199496932e-02 -1.9082576777520149e-02 + 3.8433252971179228e-02 -1.9317892463116802e-02 + 3.7324568280433894e-02 -1.9600486520385148e-02 + 3.5993078782107259e-02 -1.9939871579673155e-02 + 3.4393952908708225e-02 -2.0347474816551948e-02 + 3.2473339356836550e-02 -2.0837022458491162e-02 + 4.3981626301234832e-02 -1.8252016368804608e-02 + 4.3976112666623594e-02 -1.8253535601811050e-02 + 4.3969495229086615e-02 -1.8255358977884013e-02 + 4.3961552800982899e-02 -1.8257547443350980e-02 + 4.3952019800475042e-02 -1.8260174176848467e-02 + 4.3940577329326727e-02 -1.8263327048047579e-02 + 4.3926842346788994e-02 -1.8267111600366773e-02 + 4.3910354928590259e-02 -1.8271654561872384e-02 + 4.3890562749371899e-02 -1.8277108120856336e-02 + 4.3866802533142228e-02 -1.8283655037166741e-02 + 4.3838154264667854e-02 -1.8291548812854955e-02 + 4.3803774041211101e-02 -1.8301021977735036e-02 + 4.3762514494345012e-02 -1.8312390679014964e-02 + 4.3712998376262205e-02 -1.8326034405092770e-02 + 4.3653572421859209e-02 -1.8342408698430873e-02 + 4.3582251922399708e-02 -1.8362060427947424e-02 + 4.3496654133931174e-02 -1.8385646137460847e-02 + 4.3393918260851233e-02 -1.8413954093845133e-02 + 4.3270609300609879e-02 -1.8447930781434748e-02 + 4.3122602483944394e-02 -1.8488712743789399e-02 + 4.2944944389685248e-02 -1.8537664852047865e-02 + 4.2731686023545941e-02 -1.8596426298671906e-02 + 4.2475682205920989e-02 -1.8666965874431046e-02 + 4.2168350483409042e-02 -1.8751648397980852e-02 + 4.1799381422126594e-02 -1.8853314542156052e-02 + 4.1356390512529415e-02 -1.8975376748514416e-02 + 4.0824499962848738e-02 -1.9121934460258606e-02 + 4.0185836311440688e-02 -1.9297912550811362e-02 + 3.9418926981144888e-02 -1.9509227597934858e-02 + 3.8497975543222769e-02 -1.9762987578157063e-02 + 3.7391991457764409e-02 -2.0067731659207683e-02 + 3.6063745287029325e-02 -2.0433718081656900e-02 + 3.4468514667052683e-02 -2.0873269695267063e-02 + 3.2552579468958467e-02 -2.1401188603834994e-02 + 4.4037180526068517e-02 -1.8580752507317496e-02 + 4.4031685457334831e-02 -1.8582379619227977e-02 + 4.4025090302432096e-02 -1.8584332471094429e-02 + 4.4017174618574254e-02 -1.8586676336890241e-02 + 4.4007673718220036e-02 -1.8589489591636130e-02 + 4.3996269776876838e-02 -1.8592866344477415e-02 + 4.3982581043651034e-02 -1.8596919633353182e-02 + 4.3966149142962832e-02 -1.8601785185140395e-02 + 4.3946423609206808e-02 -1.8607625994860717e-02 + 4.3922743399932948e-02 -1.8614637799956375e-02 + 4.3894191597731676e-02 -1.8623092103240486e-02 + 4.3859927141567702e-02 -1.8633237946303956e-02 + 4.3818806526504633e-02 -1.8645413925583002e-02 + 4.3769457142291135e-02 -1.8660026476425232e-02 + 4.3710231290734355e-02 -1.8677563488893212e-02 + 4.3639150946249872e-02 -1.8698610664358795e-02 + 4.3553841388134652e-02 -1.8723871167125646e-02 + 4.3451451453898518e-02 -1.8754189237853373e-02 + 4.3328557707483117e-02 -1.8790578569678518e-02 + 4.3181049268860405e-02 -1.8834256410741587e-02 + 4.3003989396354116e-02 -1.8886684550039980e-02 + 4.2791449127447805e-02 -1.8949618577210035e-02 + 4.2536307342280713e-02 -1.9025167084407733e-02 + 4.2230010486858753e-02 -1.9115862813379195e-02 + 4.1862283841843789e-02 -1.9224748149724750e-02 + 4.1420784599693790e-02 -1.9355477848364434e-02 + 4.0890685065981355e-02 -1.9512442449112613e-02 + 4.0254171963744742e-02 -1.9700916534901389e-02 + 3.9489845019721533e-02 -1.9927236812491162e-02 + 3.8571994668546578e-02 -2.0199015987454213e-02 + 3.7469734723678448e-02 -2.0525399583715947e-02 + 3.6145961108602090e-02 -2.0917374267294245e-02 + 3.4556102051495792e-02 -2.1388137918872376e-02 + 3.2646618313282728e-02 -2.1953543722081598e-02 + 4.4103561508770095e-02 -1.8902896393824344e-02 + 4.4098087231518771e-02 -1.8904629404867913e-02 + 4.4091517030450438e-02 -1.8906709356373477e-02 + 4.4083631296842819e-02 -1.8909205770535915e-02 + 4.4074166344664580e-02 -1.8912202123433721e-02 + 4.4062805551952702e-02 -1.8915798649218024e-02 + 4.4049168612226144e-02 -1.8920115742773233e-02 + 4.4032798884247534e-02 -1.8925297964642606e-02 + 4.4013147985196878e-02 -1.8931518918279273e-02 + 4.3989557373742022e-02 -1.8938987080403542e-02 + 4.3961113601825801e-02 -1.8947991624429512e-02 + 4.3926978790699761e-02 -1.8958797800621603e-02 + 4.3886013762035617e-02 -1.8971766242614770e-02 + 4.3836851099088019e-02 -1.8987329838253689e-02 + 4.3777849337973324e-02 -1.9006008231500008e-02 + 4.3707037937282256e-02 -1.9028425243504902e-02 + 4.3622051161479797e-02 -1.9055329803478575e-02 + 4.3520048635898097e-02 -1.9087621098691446e-02 + 4.3397619877559079e-02 -1.9126378797622582e-02 + 4.3250669560577541e-02 -1.9172899371881161e-02 + 4.3074279622315942e-02 -1.9228739749678429e-02 + 4.2862543533399404e-02 -1.9295769781692233e-02 + 4.2608367117819089e-02 -1.9376235295865740e-02 + 4.2303229185374241e-02 -1.9472833875141760e-02 + 4.1936893892665139e-02 -1.9588805916114893e-02 + 4.1497065133253491e-02 -1.9728044040178357e-02 + 4.0968971315603099e-02 -1.9895224541443195e-02 + 4.0334866562128938e-02 -2.0095965294373585e-02 + 3.9573431570851601e-02 -2.0337015424614736e-02 + 3.8659054052704957e-02 -2.0626483103949166e-02 + 3.7560964683940670e-02 -2.0974109084403975e-02 + 3.6242199777255013e-02 -2.1391595089378976e-02 + 3.4658356205195695e-02 -2.1892997971771994e-02 + 3.2756097302898128e-02 -2.2495202705547276e-02 + 4.4173911716641839e-02 -1.9220737749974355e-02 + 4.4168463070805908e-02 -1.9222574386982699e-02 + 4.4161923632415175e-02 -1.9224778709842225e-02 + 4.4154074821031022e-02 -1.9227424397920356e-02 + 4.4144654185225576e-02 -1.9230599918702417e-02 + 4.4133346585476629e-02 -1.9234411499894920e-02 + 4.4119773496036914e-02 -1.9238986735487663e-02 + 4.4103480413628160e-02 -1.9244478830017901e-02 + 4.4083921523111518e-02 -1.9251071767541816e-02 + 4.4060441366541116e-02 -1.9258986490868324e-02 + 4.4032130772758242e-02 -1.9268529464540052e-02 + 4.3998155786077617e-02 -1.9279981799542156e-02 + 4.3957382562023119e-02 -1.9293725693700026e-02 + 4.3908450086223079e-02 -1.9310219919603355e-02 + 4.3849724580464738e-02 -1.9330015193418149e-02 + 4.3779244729686619e-02 -1.9353772637970224e-02 + 4.3694655875075310e-02 -1.9382285964837820e-02 + 4.3593130941035167e-02 -1.9416508128486498e-02 + 4.3471275413041230e-02 -1.9457583356611963e-02 + 4.3325013140113534e-02 -1.9506885643707506e-02 + 4.3149449086741343e-02 -1.9566065015055756e-02 + 4.2938704378853637e-02 -1.9637103129497291e-02 + 4.2685718056474503e-02 -1.9722380105207549e-02 + 4.2382008826889320e-02 -1.9824754827880042e-02 + 4.2017388772578025e-02 -1.9947661454708054e-02 + 4.1579619359211527e-02 -2.0095225367526837e-02 + 4.1053998158304052e-02 -2.0272402481154455e-02 + 4.0422862381113034e-02 -2.0485146592505842e-02 + 3.9664992545942690e-02 -2.0740610393487475e-02 + 3.8754896284397669e-02 -2.1047386886631610e-02 + 3.7661948339447242e-02 -2.1415799275371770e-02 + 3.6349358093516949e-02 -2.1858248991430795e-02 + 3.4772930321401135e-02 -2.2389633421862867e-02 + 3.2879578088755496e-02 -2.3027847183078171e-02 + 4.4248361094621907e-02 -1.9535414986292448e-02 + 4.4242942867312084e-02 -1.9537353372551674e-02 + 4.4236439937097215e-02 -1.9539679814373111e-02 + 4.4228634943789293e-02 -1.9542472072950779e-02 + 4.4219266901206068e-02 -1.9545823516852634e-02 + 4.4208022429207260e-02 -1.9549846258769658e-02 + 4.4194525115164161e-02 -1.9554674961284525e-02 + 4.4178322993274483e-02 -1.9560471316552256e-02 + 4.4158873295540517e-02 -1.9567429501293532e-02 + 4.4135524223254972e-02 -1.9575782698410649e-02 + 4.4107371680971008e-02 -1.9585854350594900e-02 + 4.4073586368763996e-02 -1.9597941142265540e-02 + 4.4033040772169574e-02 -1.9612446444924103e-02 + 4.3984381475090019e-02 -1.9629854447060779e-02 + 4.3925983820244270e-02 -1.9650746374409778e-02 + 4.3855897442169486e-02 -1.9675819975773834e-02 + 4.3771780827554597e-02 -1.9705912934227854e-02 + 4.3670822683741700e-02 -1.9742030997733195e-02 + 4.3549647446977355e-02 -1.9785381783819389e-02 + 4.3404201722499834e-02 -1.9837415405987713e-02 + 4.3229617802598819e-02 -1.9899873300573745e-02 + 4.3020049633676768e-02 -1.9974846909889266e-02 + 4.2768475675397183e-02 -2.0064848209983666e-02 + 4.2466461984185105e-02 -2.0172894468231561e-02 + 4.2103877519291712e-02 -2.0302610093253293e-02 + 4.1668552071346371e-02 -2.0458349012173471e-02 + 4.1145865292012210e-02 -2.0645341696180691e-02 + 4.0518252999834317e-02 -2.0869871781229517e-02 + 3.9764614176656353e-02 -2.1139488216731433e-02 + 3.8859598772019978e-02 -2.1463260055436580e-02 + 3.7772752502650421e-02 -2.1852082403851138e-02 + 3.6467490144421265e-02 -2.2319043730102347e-02 + 3.4899863203899588e-02 -2.2879866732988974e-02 + 3.3017081118798426e-02 -2.3553437386430918e-02 + 4.4330516674231629e-02 -1.9847010769793186e-02 + 4.4325132214947160e-02 -1.9849049550866728e-02 + 4.4318669812974283e-02 -1.9851496486056195e-02 + 4.4310913462768317e-02 -1.9854433364025682e-02 + 4.4301603804692981e-02 -1.9857958389269008e-02 + 4.4290429411648367e-02 -1.9862189480975061e-02 + 4.4277016216962076e-02 -1.9867268276470930e-02 + 4.4260915071629256e-02 -1.9873364842254663e-02 + 4.4241586590340040e-02 -1.9880683412225153e-02 + 4.4218383036574486e-02 -1.9889469246379576e-02 + 4.4190405949503464e-02 -1.9900062539520036e-02 + 4.4156831197647989e-02 -1.9912775342262989e-02 + 4.4116538293562352e-02 -1.9928031917885392e-02 + 4.4068182256015796e-02 -1.9946341532474321e-02 + 4.4010148553110577e-02 -1.9968315515200175e-02 + 4.3940498974702494e-02 -1.9994687753310814e-02 + 4.3856906600415184e-02 -2.0026339316061126e-02 + 4.3756577658516031e-02 -2.0064328041996760e-02 + 4.3636157622688167e-02 -2.0109924094853682e-02 + 4.3491618360209448e-02 -2.0164652693878793e-02 + 4.3318122500496083e-02 -2.0230345469514077e-02 + 4.3109860424159104e-02 -2.0309202186140851e-02 + 4.2859854351391731e-02 -2.0403864922570847e-02 + 4.2559722901408630e-02 -2.0517507219480535e-02 + 4.2199398173261439e-02 -2.0653941204415105e-02 + 4.1766785805991823e-02 -2.0817746307429275e-02 + 4.1247356569728590e-02 -2.1014423901448236e-02 + 4.0623655748420674e-02 -2.1250583070752616e-02 + 3.9874713831772338e-02 -2.1534163747274911e-02 + 3.8975338758573633e-02 -2.1874704697220897e-02 + 3.7895266045973978e-02 -2.2283665317201398e-02 + 3.6598138480026597e-02 -2.2774811966281443e-02 + 3.5040281467738632e-02 -2.3364681668720497e-02 + 3.3169233453660955e-02 -2.4073138559563743e-02 + 4.4415636176685272e-02 -2.0157818666176597e-02 + 4.4410290772957453e-02 -2.0159955990404300e-02 + 4.4403875245268405e-02 -2.0162521196540439e-02 + 4.4396175154876975e-02 -2.0165600026638000e-02 + 4.4386933023322889e-02 -2.0169295431602490e-02 + 4.4375839682470782e-02 -2.0173731030354566e-02 + 4.4362523778855682e-02 -2.0179055306059044e-02 + 4.4346539421318248e-02 -2.0185446545369249e-02 + 4.4327351136946073e-02 -2.0193118853569558e-02 + 4.4304315887498634e-02 -2.0202329345238468e-02 + 4.4276541729009904e-02 -2.0213434658217011e-02 + 4.4243210507761796e-02 -2.0226761925883352e-02 + 4.4203209863609816e-02 -2.0242755918047806e-02 + 4.4155204571060681e-02 -2.0261950515774174e-02 + 4.4097591808984239e-02 -2.0284986596422527e-02 + 4.4028447425757844e-02 -2.0312633519296242e-02 + 4.3945461379173184e-02 -2.0345814939446427e-02 + 4.3845860161728957e-02 -2.0385639825420299e-02 + 4.3726313578770201e-02 -2.0433439733423597e-02 + 4.3582822715283916e-02 -2.0490813603146307e-02 + 4.3410585287826556e-02 -2.0559681595784696e-02 + 4.3203833816570350e-02 -2.0642349799786075e-02 + 4.2955641134129759e-02 -2.0741587997164856e-02 + 4.2657686653151873e-02 -2.0860723119497493e-02 + 4.2299975499086997e-02 -2.1003751551134542e-02 + 4.1870501035919078e-02 -2.1175474065756816e-02 + 4.1354839419997576e-02 -2.1381657941546433e-02 + 4.0735662540969761e-02 -2.1629231708516102e-02 + 3.9992152988525848e-02 -2.1926519070005840e-02 + 3.9099301429173304e-02 -2.2283519842143190e-02 + 3.8027062899951704e-02 -2.2712247303983087e-02 + 3.6739343899883967e-02 -2.3227133202363630e-02 + 3.5192786624563668e-02 -2.3845513867794217e-02 + 3.3335310042406800e-02 -2.4588213555168402e-02 + 4.4510744296234084e-02 -2.0466879818086502e-02 + 4.4505440629858048e-02 -2.0469114985455870e-02 + 4.4499075195126220e-02 -2.0471797622506636e-02 + 4.4491435227663599e-02 -2.0475017396315812e-02 + 4.4482265259412394e-02 -2.0478881970790869e-02 + 4.4471258536235091e-02 -2.0483520623912763e-02 + 4.4458046604270822e-02 -2.0489088636111350e-02 + 4.4442187053891725e-02 -2.0495772455760179e-02 + 4.4423148593189320e-02 -2.0503795989498030e-02 + 4.4400293204796007e-02 -2.0513428122200139e-02 + 4.4372735909201044e-02 -2.0525041817947454e-02 + 4.4339664940814108e-02 -2.0538979185843687e-02 + 4.4299976624909018e-02 -2.0555705356429144e-02 + 4.4252346161515965e-02 -2.0575778651021892e-02 + 4.4195183244521513e-02 -2.0599869285234718e-02 + 4.4126578746217657e-02 -2.0628781838368582e-02 + 4.4044240661345657e-02 -2.0663482248863829e-02 + 4.3945417138197947e-02 -2.0705130252068216e-02 + 4.3826803984594292e-02 -2.0755118360582969e-02 + 4.3684433509313239e-02 -2.0815118710885372e-02 + 4.3513540925537449e-02 -2.0887139365967755e-02 + 4.3308403786387194e-02 -2.0973591983235451e-02 + 4.3062149012390062e-02 -2.1077373140684585e-02 + 4.2766520983978908e-02 -2.1201962071287994e-02 + 4.2411602867302750e-02 -2.1351538107253987e-02 + 4.1985481775311799e-02 -2.1531121793714192e-02 + 4.1473846486743349e-02 -2.1746744425342950e-02 + 4.0859504190582624e-02 -2.2005651708667355e-02 + 4.0121800020496333e-02 -2.2316548392466159e-02 + 3.9235919917906412e-02 -2.2689892067712453e-02 + 3.8172053513338314e-02 -2.3138245961544898e-02 + 3.6894389126767291e-02 -2.3676702482285972e-02 + 3.5359907495006747e-02 -2.4323391588790638e-02 + 3.3516934239387543e-02 -2.5100090835841107e-02 + 4.4610904285207961e-02 -2.0776604928498803e-02 + 4.4605647276279616e-02 -2.0778936895307826e-02 + 4.4599337839548545e-02 -2.0781735710572166e-02 + 4.4591765082436952e-02 -2.0785094924641364e-02 + 4.4582675784248377e-02 -2.0789126864047398e-02 + 4.4571765889408428e-02 -2.0793966405463792e-02 + 4.4558670185481139e-02 -2.0799775554223771e-02 + 4.4542950154765386e-02 -2.0806748833180677e-02 + 4.4524079179245918e-02 -2.0815119845877913e-02 + 4.4501424854317254e-02 -2.0825169121835071e-02 + 4.4474109985764225e-02 -2.0837285777403732e-02 + 4.4441329949349309e-02 -2.0851826737413145e-02 + 4.4401990779557247e-02 -2.0869277276119643e-02 + 4.4354779330931952e-02 -2.0890219894297953e-02 + 4.4298119287641054e-02 -2.0915353832933189e-02 + 4.4230118316918969e-02 -2.0945518515617319e-02 + 4.4148504576769880e-02 -2.0981721713070552e-02 + 4.4050550424053932e-02 -2.1025173385879722e-02 + 4.3932980734254640e-02 -2.1077326352866518e-02 + 4.3791862720681356e-02 -2.1139925166551162e-02 + 4.3622473513393781e-02 -2.1215064853919326e-02 + 4.3419141006981882e-02 -2.1305261515294657e-02 + 4.3175052585785294e-02 -2.1413537172008997e-02 + 4.2882025256671459e-02 -2.1543521733960343e-02 + 4.2530229426169151e-02 -2.1699575529538606e-02 + 4.2107857007187867e-02 -2.1886936531060993e-02 + 4.1600722677308251e-02 -2.2111897233230576e-02 + 4.0991784874022580e-02 -2.2382017135853791e-02 + 4.0260570436087675e-02 -2.2706377968275255e-02 + 3.9382483599150891e-02 -2.3095890213378659e-02 + 3.8327976241568175e-02 -2.3563661179818719e-02 + 3.7061551725898853e-02 -2.4125436889884153e-02 + 3.5540569238064881e-02 -2.4800132465227238e-02 + 3.3713808989250152e-02 -2.5610468591216993e-02 + 4.4718912130165510e-02 -2.1087276900117413e-02 + 4.4713705781228998e-02 -2.1089704830810463e-02 + 4.4707457146399961e-02 -2.1092618821470989e-02 + 4.4699957365381043e-02 -2.1096116272112397e-02 + 4.4690955657650022e-02 -2.1100314131830753e-02 + 4.4680150897804118e-02 -2.1105352827518943e-02 + 4.4667181392711315e-02 -2.1111401031305373e-02 + 4.4651612850602075e-02 -2.1118661270975250e-02 + 4.4632923728270983e-02 -2.1127376763189400e-02 + 4.4610487715388183e-02 -2.1137839581712083e-02 + 4.4583436070972676e-02 -2.1150454855543867e-02 + 4.4550971924627578e-02 -2.1165594197498163e-02 + 4.4512011853095945e-02 -2.1183762851663315e-02 + 4.4465255365197486e-02 -2.1205567289456408e-02 + 4.4409141335523088e-02 -2.1231735526782782e-02 + 4.4341795667052618e-02 -2.1263141530653198e-02 + 4.4260968410855257e-02 -2.1300834543126226e-02 + 4.4163958209069251e-02 -2.1346074316397762e-02 + 4.4047521498527073e-02 -2.1400373454980554e-02 + 4.3907763391374165e-02 -2.1465548302188581e-02 + 4.3740006530412198e-02 -2.1543780098596674e-02 + 4.3538633470400864e-02 -2.1637688485697002e-02 + 4.3296897246510688e-02 -2.1750419845517378e-02 + 4.3006693722402144e-02 -2.1885753464033521e-02 + 4.2658288028959858e-02 -2.2048229103617683e-02 + 4.2239985869741661e-02 -2.2243300286874032e-02 + 4.1737738621364318e-02 -2.2477518453953821e-02 + 4.1134668945126199e-02 -2.2758754189240261e-02 + 4.0410500972703912e-02 -2.3096462948628091e-02 + 3.9540875960785864e-02 -2.3502004197519685e-02 + 3.8496530532933115e-02 -2.3989024629568860e-02 + 3.7242310120727012e-02 -2.4573918239235996e-02 + 3.5735984825188749e-02 -2.5276378533259841e-02 + 3.3926828445278931e-02 -2.6120061186851246e-02 + 4.4834824867977262e-02 -2.1399892999012741e-02 + 4.4829673596007827e-02 -2.1402416369891365e-02 + 4.4823491064319383e-02 -2.1405444907387754e-02 + 4.4816070622061756e-02 -2.1409079840289200e-02 + 4.4807164141694500e-02 -2.1413442714761591e-02 + 4.4796473683348416e-02 -2.1418679477889627e-02 + 4.4783641380235169e-02 -2.1424965432174464e-02 + 4.4768237534769759e-02 -2.1432511066535334e-02 + 4.4749746121132389e-02 -2.1441569158369266e-02 + 4.4727547454605589e-02 -2.1452443262617429e-02 + 4.4700781984410312e-02 -2.1465554433632090e-02 + 4.4668661270185442e-02 -2.1481288892033174e-02 + 4.4630113349863061e-02 -2.1500171742701156e-02 + 4.4583851490018617e-02 -2.1522833296984036e-02 + 4.4528331080061101e-02 -2.1550030188549535e-02 + 4.4461697848761257e-02 -2.1582670739462330e-02 + 4.4381725648834990e-02 -2.1621845436669382e-02 + 4.4285741699696332e-02 -2.1668863552349364e-02 + 4.4170536751082186e-02 -2.1725297150282763e-02 + 4.4032257118601731e-02 -2.1793033973054054e-02 + 4.3866274925810293e-02 -2.1874341004163713e-02 + 4.3667032153368257e-02 -2.1971940861220438e-02 + 4.3427853211409281e-02 -2.2089103608280206e-02 + 4.3140719695584175e-02 -2.2229757092247639e-02 + 4.2795999720276118e-02 -2.2398619530349436e-02 + 4.2382122700630021e-02 -2.2601358819002687e-02 + 4.1885188631134440e-02 -2.2844783930849981e-02 + 4.1288498715203938e-02 -2.3137074837023631e-02 + 4.0571991579099007e-02 -2.3488058680611386e-02 + 3.9711566166037979e-02 -2.3909541459156622e-02 + 3.8678268671405988e-02 -2.4415706307960031e-02 + 3.7437316420276402e-02 -2.5023591657367724e-02 + 3.5946926255798116e-02 -2.5753665151395697e-02 + 3.4156908599837853e-02 -2.6630512352618152e-02 + 4.4955835681571112e-02 -2.1716790520042370e-02 + 4.4950745561581268e-02 -2.1719408563976084e-02 + 4.4944636424225068e-02 -2.1722550727729162e-02 + 4.4937304071801493e-02 -2.1726322037897212e-02 + 4.4928503322438619e-02 -2.1730848600909840e-02 + 4.4917939773086071e-02 -2.1736281839563564e-02 + 4.4905259805297616e-02 -2.1742803633427395e-02 + 4.4890038822616628e-02 -2.1750632368762048e-02 + 4.4871766924961400e-02 -2.1760030306692144e-02 + 4.4849831784133730e-02 -2.1771312391135722e-02 + 4.4823384053259439e-02 -2.1784915473714320e-02 + 4.4791644651751242e-02 -2.1801240265543784e-02 + 4.4753554343048660e-02 -2.1820831572595123e-02 + 4.4707841668854005e-02 -2.1844343354584930e-02 + 4.4652980354998567e-02 -2.1872560632997473e-02 + 4.4587138142767664e-02 -2.1906425808649693e-02 + 4.4508115312014866e-02 -2.1947070282065079e-02 + 4.4413270811354939e-02 -2.1995852447287995e-02 + 4.4299433488376658e-02 -2.2054403349654566e-02 + 4.4162795406578234e-02 -2.2124681556986495e-02 + 4.3998783628252949e-02 -2.2209039106597148e-02 + 4.3801906114569363e-02 -2.2310300764713676e-02 + 4.3565566523217553e-02 -2.2431859283285685e-02 + 4.3281841638295605e-02 -2.2577789876179095e-02 + 4.2941213916506675e-02 -2.2752987781045602e-02 + 4.2532250130314420e-02 -2.2963333545432778e-02 + 4.2041215284385369e-02 -2.3215891604308290e-02 + 4.1451608817674054e-02 -2.3519148829321910e-02 + 4.0743607509731841e-02 -2.3883301063135343e-02 + 3.9893396413259868e-02 -2.4320597246836897e-02 + 3.8872365441152745e-02 -2.4845752645772420e-02 + 3.7646144832027197e-02 -2.5476444946729324e-02 + 3.6173447446865119e-02 -2.6233909709218670e-02 + 3.4404679520084559e-02 -2.7143654909490333e-02 + 4.5085686819989958e-02 -2.2037862161742566e-02 + 4.5080662869761520e-02 -2.2040574501334603e-02 + 4.5074633149006463e-02 -2.2043829838202928e-02 + 4.5067396114604766e-02 -2.2047736981802391e-02 + 4.5058709771866504e-02 -2.2052426580707555e-02 + 4.5048283544937610e-02 -2.2058055511527827e-02 + 4.5035768412263595e-02 -2.2064812204666825e-02 + 4.5020745296947724e-02 -2.2072922912136035e-02 + 4.5002710927568509e-02 -2.2082659341114683e-02 + 4.4981060935825719e-02 -2.2094347778937682e-02 + 4.4954957016153076e-02 -2.2108440811740713e-02 + 4.4923630215663278e-02 -2.2125353583126825e-02 + 4.4886035067538216e-02 -2.2145650521742066e-02 + 4.4840916641983135e-02 -2.2170009141339979e-02 + 4.4786768505882708e-02 -2.2199242737946653e-02 + 4.4721782219186733e-02 -2.2234327655431839e-02 + 4.4643786657363384e-02 -2.2276436044669685e-02 + 4.4550175101805964e-02 -2.2326975225630978e-02 + 4.4437817623888411e-02 -2.2387634990117318e-02 + 4.4302955788965780e-02 -2.2460444448746911e-02 + 4.4141076105937142e-02 -2.2547840353560798e-02 + 4.3946757930516486e-02 -2.2652749212050446e-02 + 4.3713490670560295e-02 -2.2778685974850419e-02 + 4.3433454109084411e-02 -2.2929872635297010e-02 + 4.3097254427594336e-02 -2.3111380745571116e-02 + 4.2693607026451599e-02 -2.3329302656374905e-02 + 4.2208955460404124e-02 -2.3590957246594449e-02 + 4.1627013669868353e-02 -2.3905137064444474e-02 + 4.0928216129345496e-02 -2.4282405182275146e-02 + 4.0089057477379890e-02 -2.4735451718381526e-02 + 3.9081299547941331e-02 -2.5279521946474041e-02 + 3.7871019374418412e-02 -2.5932930260922540e-02 + 3.6417466536039701e-02 -2.6717677074791526e-02 + 3.4671691968738483e-02 -2.7660189100054182e-02 + 4.5223704993068860e-02 -2.2364767863646551e-02 + 4.5218753212608979e-02 -2.2367574152093742e-02 + 4.5212810109649344e-02 -2.2370942245912281e-02 + 4.5205677036233190e-02 -2.2374984723545269e-02 + 4.5197115474029277e-02 -2.2379836758772774e-02 + 4.5186839021302320e-02 -2.2385660662093458e-02 + 4.5174503670272093e-02 -2.2392651390686573e-02 + 4.5159696364122266e-02 -2.2401043033395275e-02 + 4.5141921060969162e-02 -2.2411116708622600e-02 + 4.5120582074371661e-02 -2.2423210005624639e-02 + 4.5094853141169254e-02 -2.2437791186871961e-02 + 4.5063976354558229e-02 -2.2455289775647289e-02 + 4.5026921266007221e-02 -2.2476289750966882e-02 + 4.4982450972943774e-02 -2.2501492094091326e-02 + 4.4929080682393048e-02 -2.2531738271565072e-02 + 4.4865027932834485e-02 -2.2568038445482535e-02 + 4.4788152788156850e-02 -2.2611605367129778e-02 + 4.4695885975703932e-02 -2.2663895102764592e-02 + 4.4585142528693569e-02 -2.2726655974322201e-02 + 4.4452218002892958e-02 -2.2801987375968672e-02 + 4.4292663744183128e-02 -2.2892410462942367e-02 + 4.4101136976557029e-02 -2.3000953109798817e-02 + 4.3871220633456977e-02 -2.3131252016609774e-02 + 4.3595206836396380e-02 -2.3287675416212024e-02 + 4.3263836710392543e-02 -2.3475470527130154e-02 + 4.2865987760682671e-02 -2.3700940724309720e-02 + 4.2388298282245732e-02 -2.3971658394855631e-02 + 4.1814716167022981e-02 -2.4296720639426304e-02 + 4.1125956951032813e-02 -2.4687056409716440e-02 + 4.0298852930564934e-02 -2.5155795378873993e-02 + 3.9305571584905490e-02 -2.5718710879869891e-02 + 3.8112677255549850e-02 -2.6394751673346931e-02 + 3.6680004907226636e-02 -2.7206680213281927e-02 + 3.4959308636002086e-02 -2.8181838568780690e-02 + 4.5371023831075774e-02 -2.2698734761219724e-02 + 4.5366150646483951e-02 -2.2701634937771574e-02 + 4.5360301873884602e-02 -2.2705115715624512e-02 + 4.5353282018333711e-02 -2.2709293439695317e-02 + 4.5344856347278799e-02 -2.2714307806141698e-02 + 4.5334743004873536e-02 -2.2720326555869894e-02 + 4.5322603443482039e-02 -2.2727551168528905e-02 + 4.5308031162451544e-02 -2.2736223564734495e-02 + 4.5290537993159463e-02 -2.2746634268073898e-02 + 4.5269537704094323e-02 -2.2759132162292098e-02 + 4.5244217146660590e-02 -2.2774201176261184e-02 + 4.5213830443785137e-02 -2.2792285203464897e-02 + 4.5177363502478932e-02 -2.2813987760684683e-02 + 4.5133599052578931e-02 -2.2840033281525198e-02 + 4.5081075868057950e-02 -2.2871291384859355e-02 + 4.5018039779040106e-02 -2.2908806029093100e-02 + 4.4942384815097616e-02 -2.2953830539691175e-02 + 4.4851582483547592e-02 -2.3007869697565013e-02 + 4.4742596783033238e-02 -2.3072730317053647e-02 + 4.4611782067180784e-02 -2.3150582030325231e-02 + 4.4454760291842421e-02 -2.3244030341188906e-02 + 4.4266273482957898e-02 -2.3356204425794877e-02 + 4.4040006427059436e-02 -2.3490862654767634e-02 + 4.3768373587100451e-02 -2.3652519405970709e-02 + 4.3442263047093782e-02 -2.3846597450585535e-02 + 4.3050728851174287e-02 -2.4079611051263189e-02 + 4.2580621374523231e-02 -2.4359385939348378e-02 + 4.2016143291950463e-02 -2.4695323571066036e-02 + 4.1338316227116735e-02 -2.5098718540532059e-02 + 4.0524340199770588e-02 -2.5583139791544425e-02 + 3.9546824453426860e-02 -2.6164888374776710e-02 + 3.8372864028472009e-02 -2.6863547006664157e-02 + 3.6962931398716682e-02 -2.7702639689206787e-02 + 3.5269546430707746e-02 -2.8710423256591983e-02 + 4.5533580664413049e-02 -2.3038742661355239e-02 + 4.5528790923750347e-02 -2.3041737527788042e-02 + 4.5523042300174114e-02 -2.3045331952006025e-02 + 4.5516142646185649e-02 -2.3049646077445019e-02 + 4.5507861248595009e-02 -2.3054824161478638e-02 + 4.5497921077789466e-02 -2.3061039421577539e-02 + 4.5485989383117341e-02 -2.3068499915638082e-02 + 4.5471666624466431e-02 -2.3077455462924921e-02 + 4.5454472992159614e-02 -2.3088206072614498e-02 + 4.5433832292771703e-02 -2.3101112019318720e-02 + 4.5408945301345843e-02 -2.3116673031992691e-02 + 4.5379078912509502e-02 -2.3135347497202450e-02 + 4.5343236397651691e-02 -2.3157758636358470e-02 + 4.5300221330067801e-02 -2.3184654535583580e-02 + 4.5248597504406088e-02 -2.3216933206498400e-02 + 4.5186640787578079e-02 -2.3255672692528127e-02 + 4.5112281269874668e-02 -2.3302167239776825e-02 + 4.5023033754177579e-02 -2.3357970759789713e-02 + 4.4915914224887811e-02 -2.3424949058863810e-02 + 4.4787339460285493e-02 -2.3505342607037939e-02 + 4.4633006381799595e-02 -2.3601841976926587e-02 + 4.4447747048211528e-02 -2.3717678511459877e-02 + 4.4225354381911469e-02 -2.3856733290870107e-02 + 4.3958372733611965e-02 -2.4023668086044822e-02 + 4.3637846211461107e-02 -2.4224082720081683e-02 + 4.3253016288077518e-02 -2.4464704144250494e-02 + 4.2790958500782066e-02 -2.4753613597738394e-02 + 4.2236146023300267e-02 -2.5100519491445324e-02 + 4.1569925447569163e-02 -2.5517085184587389e-02 + 4.0769887199302655e-02 -2.6017322642752444e-02 + 3.9809109536247340e-02 -2.6618065141147191e-02 + 3.8655250933116427e-02 -2.7339534765894440e-02 + 3.7269460696859255e-02 -2.8206023570558247e-02 + 3.5605071700260220e-02 -2.9246710966327343e-02 + 4.5706871548810708e-02 -2.3388841398556064e-02 + 4.5702173042254580e-02 -2.3391930906439207e-02 + 4.5696533917378060e-02 -2.3395638918871406e-02 + 4.5689765686709766e-02 -2.3400089375988552e-02 + 4.5681642031659919e-02 -2.3405431093808004e-02 + 4.5671891199390337e-02 -2.3411842763721609e-02 + 4.5660186777411307e-02 -2.3419539018590372e-02 + 4.5646136836042003e-02 -2.3428777572192482e-02 + 4.5629270704847472e-02 -2.3439867914319797e-02 + 4.5609023165723114e-02 -2.3453181704752586e-02 + 4.5584610217061290e-02 -2.3469234464585105e-02 + 4.5555312717686883e-02 -2.3488499065777609e-02 + 4.5520152924434634e-02 -2.3511618424464649e-02 + 4.5477957199858338e-02 -2.3539364267122727e-02 + 4.5427316695283319e-02 -2.3572662983639310e-02 + 4.5366540118536983e-02 -2.3612626684965284e-02 + 4.5293596987159075e-02 -2.3660590516996712e-02 + 4.5206049441646190e-02 -2.3718157496745166e-02 + 4.5100970305299012e-02 -2.3787252392296013e-02 + 4.4974844608987027e-02 -2.3870186475250025e-02 + 4.4823451238462458e-02 -2.3969735343726543e-02 + 4.4641720690379721e-02 -2.4089232454926505e-02 + 4.4423564118378153e-02 -2.4232681536034362e-02 + 4.4161667887122821e-02 -2.4404891675700979e-02 + 4.3847246694852599e-02 -2.4611639658189740e-02 + 4.3469746940630313e-02 -2.4859865014732967e-02 + 4.3016490344548776e-02 -2.5157904361591960e-02 + 4.2472245832435404e-02 -2.5515772907382769e-02 + 4.1818715302944634e-02 -2.5945502587744189e-02 + 4.1033916035116406e-02 -2.6461548163675037e-02 + 4.0091439087187271e-02 -2.7081274862436236e-02 + 3.8959558969178548e-02 -2.7825543812945840e-02 + 3.7600165008834417e-02 -2.8719414727444471e-02 + 3.5967478985772156e-02 -2.9792989122435446e-02 + 4.5893121856964827e-02 -2.3750283717447290e-02 + 4.5888522871184431e-02 -2.3753468215472581e-02 + 4.5883003190680345e-02 -2.3757290234628671e-02 + 4.5876378320400445e-02 -2.3761877525706618e-02 + 4.5868426735445653e-02 -2.3767383480235847e-02 + 4.5858882439105755e-02 -2.3773992283651929e-02 + 4.5847425932805816e-02 -2.3781925167910563e-02 + 4.5833673588334685e-02 -2.3791447770506777e-02 + 4.5817164704846952e-02 -2.3802879096806544e-02 + 4.5797346036215603e-02 -2.3816602233652100e-02 + 4.5773450187182568e-02 -2.3833148552342399e-02 + 4.5744773248840236e-02 -2.3853005463906320e-02 + 4.5710358188020259e-02 -2.3876835651422044e-02 + 4.5669056226551853e-02 -2.3905434569031242e-02 + 4.5619488356985129e-02 -2.3939757089451702e-02 + 4.5559999111113608e-02 -2.3980949516584995e-02 + 4.5488601014868374e-02 -2.4030388046782664e-02 + 4.5402907845904741e-02 -2.4089724983526309e-02 + 4.5300054429176839e-02 -2.4160944273902536e-02 + 4.5176600247330452e-02 -2.4246428251985364e-02 + 4.5028413595109965e-02 -2.4349037854563597e-02 + 4.4850532348171490e-02 -2.4472209029412422e-02 + 4.4636996630311988e-02 -2.4620068602559411e-02 + 4.4380647718851605e-02 -2.4797573523117077e-02 + 4.4072886396761969e-02 -2.5010678188565387e-02 + 4.3703382602813944e-02 -2.5266535493330435e-02 + 4.3259726600353772e-02 -2.5573738371662581e-02 + 4.2727009930203126e-02 -2.5942609960225373e-02 + 4.2087322069739336e-02 -2.6385552129083788e-02 + 4.1319145922085666e-02 -2.6917464066011081e-02 + 4.0396631922847870e-02 -2.7556244910382954e-02 + 3.9288726571352371e-02 -2.8323397188239230e-02 + 3.7958126431391986e-02 -2.9244751098968763e-02 + 3.6360022927755434e-02 -3.0351333661650593e-02 + 4.6098856425382848e-02 -2.4122243692833271e-02 + 4.6094363995575496e-02 -2.4125524478423584e-02 + 4.6088972203050541e-02 -2.4129462061472189e-02 + 4.6082500827360061e-02 -2.4134188055465688e-02 + 4.6074733476281417e-02 -2.4139860489959173e-02 + 4.6065410316060706e-02 -2.4146669119408382e-02 + 4.6054219250741948e-02 -2.4154841865045778e-02 + 4.6040785540584363e-02 -2.4164652396327327e-02 + 4.6024659158856493e-02 -2.4176429364108749e-02 + 4.6005299677963747e-02 -2.4190567438428897e-02 + 4.5981957482643693e-02 -2.4207614057279600e-02 + 4.5953944973261399e-02 -2.4228071369227142e-02 + 4.5920327290548180e-02 -2.4252622094484328e-02 + 4.5879982272901659e-02 -2.4282085738723369e-02 + 4.5831562863726513e-02 -2.4317446046628201e-02 + 4.5773451951128308e-02 -2.4359883982076624e-02 + 4.5703708109642853e-02 -2.4410817352621773e-02 + 4.5620000404511710e-02 -2.4471948421312395e-02 + 4.5519530045097942e-02 -2.4545321122535557e-02 + 4.5398936229048163e-02 -2.4633389823496735e-02 + 4.5254182980426258e-02 -2.4739101965129025e-02 + 4.5080423144568373e-02 -2.4865997385835271e-02 + 4.4871834932346102e-02 -2.5018327691687114e-02 + 4.4621425484782706e-02 -2.5201199711805913e-02 + 4.4320794824009462e-02 -2.5420747882894276e-02 + 4.3959852230592032e-02 -2.5684341376792048e-02 + 4.3526475494806913e-02 -2.6000832946525852e-02 + 4.3006101578163376e-02 -2.6380857862779196e-02 + 4.2381234935133218e-02 -2.6837192982769459e-02 + 4.1630857008140246e-02 -2.7385187991239349e-02 + 4.0729717153098990e-02 -2.8043283231979455e-02 + 3.9647481361876104e-02 -2.8833631388873251e-02 + 3.8347710498511670e-02 -2.9782843672036291e-02 + 3.6786634177921836e-02 -3.0922885244076496e-02 + 4.6331807096189524e-02 -2.4502849563379479e-02 + 4.6327427026878316e-02 -2.4506229700180099e-02 + 4.6322170088841631e-02 -2.4510286523980757e-02 + 4.6315860569222746e-02 -2.4515155634028084e-02 + 4.6308287487896380e-02 -2.4520999845368759e-02 + 4.6299197509917185e-02 -2.4528014658759065e-02 + 4.6288286345102979e-02 -2.4536434897558426e-02 + 4.6275188626418204e-02 -2.4546542518581214e-02 + 4.6259465582803277e-02 -2.4558676125241045e-02 + 4.6240590303226151e-02 -2.4573242339161392e-02 + 4.6217831921223675e-02 -2.4590805176347701e-02 + 4.6190520034690222e-02 -2.4611881991733982e-02 + 4.6157743166222016e-02 -2.4637176180180808e-02 + 4.6118407220654668e-02 -2.4667532064330203e-02 + 4.6071198832785806e-02 -2.4703963179194530e-02 + 4.6014541336341301e-02 -2.4747686251617503e-02 + 4.5946541863054163e-02 -2.4800162024151817e-02 + 4.5864927777224139e-02 -2.4863144309053779e-02 + 4.5766970289122334e-02 -2.4938738936727663e-02 + 4.5649392653601011e-02 -2.5029474599181246e-02 + 4.5508259838716696e-02 -2.5138387994091838e-02 + 4.5338845922465038e-02 -2.5269126155764210e-02 + 4.5135474724846372e-02 -2.5426069440571089e-02 + 4.4891328285727734e-02 -2.5614479326464452e-02 + 4.4598216719741325e-02 -2.5840676017637176e-02 + 4.4246301687195254e-02 -2.6112251844650824e-02 + 4.3823764167690349e-02 -2.6438327646217213e-02 + 4.3316405360009087e-02 -2.6829860758025598e-02 + 4.2707167300938549e-02 -2.7300014955609363e-02 + 4.1975557129558590e-02 -2.7864604754203472e-02 + 4.1096955747386983e-02 -2.8542628921732364e-02 + 4.0041787832396349e-02 -2.9356910986039073e-02 + 3.8774525630352406e-02 -3.0334868017549563e-02 + 3.7252493500427829e-02 -3.1509433171647221e-02 + 4.6593530818322633e-02 -2.4894093232292518e-02 + 4.6589270467255764e-02 -2.4897576036537104e-02 + 4.6584157214495880e-02 -2.4901756081394142e-02 + 4.6578020149809045e-02 -2.4906773084673078e-02 + 4.6570654059763669e-02 -2.4912794806741901e-02 + 4.6561812533617811e-02 -2.4920022686447118e-02 + 4.6551199598234075e-02 -2.4928698679647272e-02 + 4.6538459872970811e-02 -2.4939113307200500e-02 + 4.6523166579472079e-02 -2.4951615457214412e-02 + 4.6504807208498027e-02 -2.4966624101952099e-02 + 4.6482670870017895e-02 -2.4984720388689641e-02 + 4.6456105485672729e-02 -2.5006437386397337e-02 + 4.6424224491022445e-02 -2.5032499854691061e-02 + 4.6385963695258881e-02 -2.5063777761405476e-02 + 4.6340045630729666e-02 -2.5101315426555935e-02 + 4.6284936725357474e-02 -2.5146366533479136e-02 + 4.6218795847808060e-02 -2.5200436193005715e-02 + 4.6139412479135763e-02 -2.5265331487292476e-02 + 4.6044132414238027e-02 -2.5343222208678101e-02 + 4.5929768469576776e-02 -2.5436713855173720e-02 + 4.5792493167628956e-02 -2.5548935360336020e-02 + 4.5627709757488956e-02 -2.5683644532735986e-02 + 4.5429897203456748e-02 -2.5845354776637280e-02 + 4.5192423897303859e-02 -2.6039487380801803e-02 + 4.4907323803677610e-02 -2.6272554517961295e-02 + 4.4565027489333921e-02 -2.6552379126402240e-02 + 4.4154038977247012e-02 -2.6888359078954784e-02 + 4.3660547555020864e-02 -2.7291784526967677e-02 + 4.3067961496170024e-02 -2.7776219079470393e-02 + 4.2356348061017998e-02 -2.8357957598098733e-02 + 4.1501761052589396e-02 -2.9056575914948160e-02 + 4.0475433516324037e-02 -2.9895590794433515e-02 + 3.9242808760478462e-02 -3.0903252066733961e-02 + 3.7762377576232312e-02 -3.2113493191271367e-02 + 4.6888195701436937e-02 -2.5296890302575276e-02 + 4.6884063146689504e-02 -2.5300479672840381e-02 + 4.6879103274505195e-02 -2.5304787617691837e-02 + 4.6873150301330109e-02 -2.5309958129948448e-02 + 4.6866005169434281e-02 -2.5316164103152784e-02 + 4.6857428859652842e-02 -2.5323613139725139e-02 + 4.6847134276973304e-02 -2.5332554598811039e-02 + 4.6834776701040817e-02 -2.5343287890556208e-02 + 4.6819942155418896e-02 -2.5356172578248119e-02 + 4.6802133504440811e-02 -2.5371640453804540e-02 + 4.6780661182386392e-02 -2.5390290446188776e-02 + 4.6754892671108550e-02 -2.5412671935206486e-02 + 4.6723968000132871e-02 -2.5439531856498113e-02 + 4.6686854900842199e-02 -2.5471766796818722e-02 + 4.6642314225289111e-02 -2.5510453030143151e-02 + 4.6588858403602905e-02 -2.5556882599637183e-02 + 4.6524701532093794e-02 -2.5612606669163072e-02 + 4.6447699400119183e-02 -2.5679487613536962e-02 + 4.6355277419863318e-02 -2.5759761615894407e-02 + 4.6244344012712997e-02 -2.5856113896558838e-02 + 4.6111186512658275e-02 -2.5971769127529905e-02 + 4.5951346056084488e-02 -2.6110600097688317e-02 + 4.5759467219925049e-02 -2.6277258311474368e-02 + 4.5529117322124675e-02 -2.6477330936864336e-02 + 4.5252569281871428e-02 -2.6717529404458838e-02 + 4.4920540717029937e-02 -2.7005916016756386e-02 + 4.4521880491651011e-02 -2.7352176200532236e-02 + 4.4043192168686858e-02 -2.7767945560251934e-02 + 4.3468381718163612e-02 -2.8267202720920301e-02 + 4.2778114316297605e-02 -2.8866741130291289e-02 + 4.1949162072167964e-02 -2.9586735596930910e-02 + 4.0953620944162737e-02 -3.0451422445402006e-02 + 3.9757970826111329e-02 -3.1489915887147689e-02 + 3.8321947647315779e-02 -3.2737187669167916e-02 + 4.7220207240971104e-02 -2.5712492117119953e-02 + 4.7216211994337148e-02 -2.5716192876085314e-02 + 4.7211416918641946e-02 -2.5720634509125876e-02 + 4.7205661738693915e-02 -2.5725965477592254e-02 + 4.7198754010672417e-02 -2.5732364040378486e-02 + 4.7190462656985260e-02 -2.5740044242480324e-02 + 4.7180510121698785e-02 -2.5749263181308539e-02 + 4.7168563138065951e-02 -2.5760329558648380e-02 + 4.7154221484450129e-02 -2.5773614096065187e-02 + 4.7137004542980247e-02 -2.5789561985246911e-02 + 4.7116245659428645e-02 -2.5808790741704276e-02 + 4.7091333331634275e-02 -2.5831866794119019e-02 + 4.7061436162518344e-02 -2.5859560257627250e-02 + 4.7025556181524847e-02 -2.5892795542942281e-02 + 4.6982495412643550e-02 -2.5932682323753939e-02 + 4.6930815711875302e-02 -2.5980552739239861e-02 + 4.6868790513955809e-02 -2.6038006090386801e-02 + 4.6794346851655635e-02 -2.6106962547045448e-02 + 4.6704995680286993e-02 -2.6189727687578698e-02 + 4.6597748141998352e-02 -2.6289070062729882e-02 + 4.6469014927571134e-02 -2.6408314415376458e-02 + 4.6314485323426947e-02 -2.6551453718553320e-02 + 4.6128981845592526e-02 -2.6723283826470240e-02 + 4.5906285544020570e-02 -2.6929565293443453e-02 + 4.5638926077573180e-02 -2.7177217825355045e-02 + 4.5317929480192198e-02 -2.7474553921821670e-02 + 4.4932515123087616e-02 -2.7831559576613880e-02 + 4.4469731678675579e-02 -2.8260231481471089e-02 + 4.3914019856580618e-02 -2.8774982059050117e-02 + 4.3246687251013480e-02 -2.9393125907218147e-02 + 4.2445277740098271e-02 -3.0135463918117653e-02 + 4.1482814420681510e-02 -3.1026984540647225e-02 + 4.0326890924359489e-02 -3.2097705485875948e-02 + 3.8938580992684976e-02 -3.3383683776787659e-02 + 4.7597766767597506e-02 -2.6139529529074664e-02 + 4.7593918556925775e-02 -2.6143348299894831e-02 + 4.7589299953073684e-02 -2.6147931570150881e-02 + 4.7583756579434949e-02 -2.6153432535440627e-02 + 4.7577103074608822e-02 -2.6160035139128651e-02 + 4.7569116865311414e-02 -2.6167960251697594e-02 + 4.7559530610435372e-02 -2.6177473169056217e-02 + 4.7548023308330981e-02 -2.6188892437104695e-02 + 4.7534209466606886e-02 -2.6202600599105782e-02 + 4.7517626155487123e-02 -2.6219057043306022e-02 + 4.7497631255386086e-02 -2.6238898976899089e-02 + 4.7473635769106674e-02 -2.6262710891046235e-02 + 4.7444838897209553e-02 -2.6291287458888968e-02 + 4.7410279397241815e-02 -2.6325582569114443e-02 + 4.7368803381929662e-02 -2.6366741281435489e-02 + 4.7319025634884847e-02 -2.6416138214926669e-02 + 4.7259283133152023e-02 -2.6475423669964339e-02 + 4.7187579200383148e-02 -2.6546579047788916e-02 + 4.7101516395443424e-02 -2.6631983448410730e-02 + 4.6998215858607501e-02 -2.6734493707522240e-02 + 4.6874220377031428e-02 -2.6857540589290428e-02 + 4.6725377883161168e-02 -2.7005244396846862e-02 + 4.6546701438480741e-02 -2.7182553917214386e-02 + 4.6332200967270247e-02 -2.7395413400384795e-02 + 4.6074681057306083e-02 -2.7650963211698857e-02 + 4.5765498008890688e-02 -2.7957780924155132e-02 + 4.5394267949703533e-02 -2.8326170970516661e-02 + 4.4948516196328413e-02 -2.8768512599484940e-02 + 4.4413256082648997e-02 -2.9299677824951138e-02 + 4.3770483134308778e-02 -2.9937533382175922e-02 + 4.2998567675870097e-02 -3.0703543473491104e-02 + 4.2071525627666917e-02 -3.1623493393150688e-02 + 4.0958143263902319e-02 -3.2728358073370933e-02 + 3.9620926918477593e-02 -3.4055344343244018e-02 + 4.8035232632645378e-02 -2.6571083110183823e-02 + 4.8031539992889963e-02 -2.6575031022657999e-02 + 4.8027108104505570e-02 -2.6579769288133995e-02 + 4.8021788831832099e-02 -2.6585456282890742e-02 + 4.8015404307058411e-02 -2.6592282170768443e-02 + 4.8007740954815865e-02 -2.6600475291658803e-02 + 4.7998542241742909e-02 -2.6610309913110135e-02 + 4.7987500143272264e-02 -2.6622115353419001e-02 + 4.7974244751253947e-02 -2.6636287092600280e-02 + 4.7958331850641897e-02 -2.6653300054277945e-02 + 4.7939145280796763e-02 -2.6673812994474175e-02 + 4.7916119855747202e-02 -2.6698430170526463e-02 + 4.7888487149801436e-02 -2.6727973129382621e-02 + 4.7855324780557595e-02 -2.6763428018000513e-02 + 4.7815525508625910e-02 -2.6805978619279407e-02 + 4.7767760117651367e-02 -2.6857046038642859e-02 + 4.7710432815322508e-02 -2.6918336385634289e-02 + 4.7641627644509514e-02 -2.6991898067777305e-02 + 4.7559044085168985e-02 -2.7080190640475687e-02 + 4.7459919660574806e-02 -2.7186167550809232e-02 + 4.7340936922086692e-02 -2.7313375583119717e-02 + 4.7198111656950932e-02 -2.7466074379361861e-02 + 4.7026658532836337e-02 -2.7649380082650159e-02 + 4.6820829633673428e-02 -2.7869437963247042e-02 + 4.6573720434850335e-02 -2.8133629856540797e-02 + 4.6277036673970533e-02 -2.8450823408462764e-02 + 4.5920814265741738e-02 -2.8831671523050922e-02 + 4.5493082838454796e-02 -2.9288972085467369e-02 + 4.4979461589278256e-02 -2.9838100045507694e-02 + 4.4362673907463283e-02 -3.0497526348504698e-02 + 4.3621964536637199e-02 -3.1289441064725219e-02 + 4.2732399850845551e-02 -3.2240501485254841e-02 + 4.1664027995929651e-02 -3.3382730040199725e-02 + 4.0380871055570873e-02 -3.4754591804539971e-02 + 4.8535585680329736e-02 -2.7012461307990294e-02 + 4.8532061317373226e-02 -2.7016549129199974e-02 + 4.8527831394011026e-02 -2.7021455312422945e-02 + 4.8522754525251288e-02 -2.7027343846686140e-02 + 4.8516660948834549e-02 -2.7034411634873749e-02 + 4.8509346822243067e-02 -2.7042895108991907e-02 + 4.8500567302525679e-02 -2.7053078256273670e-02 + 4.8490028402107067e-02 -2.7065302065566441e-02 + 4.8477377069887986e-02 -2.7079976032198454e-02 + 4.8462189334050568e-02 -2.7097591910476320e-02 + 4.8443877112919573e-02 -2.7118831801815381e-02 + 4.8421900976540498e-02 -2.7144321377563264e-02 + 4.8395527517140158e-02 -2.7174911299312689e-02 + 4.8363876385950022e-02 -2.7211622661724919e-02 + 4.8325890801600567e-02 -2.7255681199336051e-02 + 4.8280302121128590e-02 -2.7308558379616623e-02 + 4.8225587273983406e-02 -2.7372020774408333e-02 + 4.8159917614839481e-02 -2.7448189384074968e-02 + 4.8081097460332969e-02 -2.7539610927264046e-02 + 4.7986490222242710e-02 -2.7649343517354104e-02 + 4.7872929630915863e-02 -2.7781059631934720e-02 + 4.7736613037724272e-02 -2.7939169869001180e-02 + 4.7572973182013686e-02 -2.8128971680886274e-02 + 4.7376524085329191e-02 -2.8356828118035658e-02 + 4.7140675868263773e-02 -2.8630382618161424e-02 + 4.6857512245196797e-02 -2.8958817084757098e-02 + 4.6517523202787583e-02 -2.9353161946403850e-02 + 4.6109283869761097e-02 -2.9826668628246216e-02 + 4.5619068788980081e-02 -3.0395256947697444e-02 + 4.5030388659852372e-02 -3.1078052435667098e-02 + 4.4323434061159295e-02 -3.1898031548759843e-02 + 4.3474407614060628e-02 -3.2882796276744439e-02 + 4.2454722396536464e-02 -3.4065503881817318e-02 + 4.1230040037251593e-02 -3.5485982589588926e-02 + 4.9098545137414823e-02 -2.7475985296096701e-02 + 4.9095208711356551e-02 -2.7480221068746438e-02 + 4.9091204348996796e-02 -2.7485304822581547e-02 + 4.9086398204607883e-02 -2.7491406481849931e-02 + 4.9080629568614149e-02 -2.7498730076137776e-02 + 4.9073705468352116e-02 -2.7507520594558927e-02 + 4.9065394117207076e-02 -2.7518072302745170e-02 + 4.9055417204421685e-02 -2.7530738531131294e-02 + 4.9043440505401388e-02 -2.7545943595958060e-02 + 4.9029062656690423e-02 -2.7564197049675471e-02 + 4.9011726936089454e-02 -2.7586205681207808e-02 + 4.8990922678809376e-02 -2.7612617806913882e-02 + 4.8965955586073251e-02 -2.7644314876657909e-02 + 4.8935992253775658e-02 -2.7682354941650975e-02 + 4.8900032253471462e-02 -2.7728008099861211e-02 + 4.8856874592751287e-02 -2.7782799075884088e-02 + 4.8805077418820203e-02 -2.7848558379450949e-02 + 4.8742909599077969e-02 -2.7927483776783255e-02 + 4.8668292535097801e-02 -2.8022214160533840e-02 + 4.8578730234907851e-02 -2.8135918327028487e-02 + 4.8471225270464303e-02 -2.8272401672713148e-02 + 4.8342177769580018e-02 -2.8436234429254709e-02 + 4.8187264021158874e-02 -2.8632905780956713e-02 + 4.8001290586960094e-02 -2.8869009077571547e-02 + 4.7778018993391971e-02 -2.9152464397459468e-02 + 4.7509955091272420e-02 -2.9492785966855759e-02 + 4.7188095989526731e-02 -2.9901403441105243e-02 + 4.6801626048862045e-02 -3.0392047857165812e-02 + 4.6337551723170688e-02 -3.0981215222028489e-02 + 4.5780263005106764e-02 -3.1688723281201273e-02 + 4.5111006812261642e-02 -3.2538380083435563e-02 + 4.4307254762720426e-02 -3.3558786623538200e-02 + 4.3341944334198461e-02 -3.4784300231932443e-02 + 4.2182568251531140e-02 -3.6256190646240347e-02 + 4.9742327070635681e-02 -2.7955993608860148e-02 + 4.9739199293611654e-02 -2.7960390097606824e-02 + 4.9735445350698508e-02 -2.7965666742136863e-02 + 4.9730939766554627e-02 -2.7971999914091085e-02 + 4.9725531881840396e-02 -2.7979601384391317e-02 + 4.9719040791707463e-02 -2.7988725437726066e-02 + 4.9711249204754983e-02 -2.7999677504897388e-02 + 4.9701896214884612e-02 -2.8012824322604730e-02 + 4.9690668498684649e-02 -2.8028606306750904e-02 + 4.9677189792721753e-02 -2.8047552343511657e-02 + 4.9660938190281070e-02 -2.8070396039186242e-02 + 4.9641434961946500e-02 -2.8097810309009309e-02 + 4.9618029227989781e-02 -2.8130710047139511e-02 + 4.9589939702622120e-02 -2.8170193450196709e-02 + 4.9556228520899845e-02 -2.8217578806777409e-02 + 4.9515769796443600e-02 -2.8274448693482931e-02 + 4.9467211845162611e-02 -2.8342703074403328e-02 + 4.9408931793693205e-02 -2.8424623104529725e-02 + 4.9338981032193564e-02 -2.8522947803014041e-02 + 4.9255019659782136e-02 -2.8640966198354722e-02 + 4.9154237697532549e-02 -2.8782628073644349e-02 + 4.9033260397290744e-02 -2.8952677066884435e-02 + 4.8888034438441461e-02 -2.9156810636125199e-02 + 4.8713691163031703e-02 -2.9401872299801245e-02 + 4.8504382230791267e-02 -2.9696082644492010e-02 + 4.8253082151790964e-02 -3.0049316890568695e-02 + 4.7951351045593268e-02 -3.0473438364039915e-02 + 4.7589049647026441e-02 -3.0982699092687371e-02 + 4.7153996983074334e-02 -3.1594220984568100e-02 + 4.6631559244173323e-02 -3.2328573721445389e-02 + 4.6004156103211881e-02 -3.3210468690716109e-02 + 4.5250668028250458e-02 -3.4269592082579257e-02 + 4.4345724896860443e-02 -3.5541604833158900e-02 + 4.3258852330566318e-02 -3.7069342560074617e-02 + 5.0483698868948934e-02 -2.8452002998169152e-02 + 5.0480804565751700e-02 -2.8456576240647378e-02 + 5.0477330837082932e-02 -2.8462065024134224e-02 + 5.0473161573691527e-02 -2.8468652811005506e-02 + 5.0468157362182360e-02 -2.8476559886077921e-02 + 5.0462150801529063e-02 -2.8486050757185435e-02 + 5.0454940819989282e-02 -2.8497443134488262e-02 + 5.0446285986922260e-02 -2.8511118498717722e-02 + 5.0435896367119586e-02 -2.8527534971933201e-02 + 5.0423423783332963e-02 -2.8547242703429704e-02 + 5.0408385286830157e-02 -2.8571004792856475e-02 + 5.0390337882985511e-02 -2.8599521208936499e-02 + 5.0368679277295172e-02 -2.8633743627769482e-02 + 5.0342686503279006e-02 -2.8674814397054521e-02 + 5.0311491703191227e-02 -2.8724104805111846e-02 + 5.0274053032772985e-02 -2.8783261053509406e-02 + 5.0229119704809790e-02 -2.8854259491230338e-02 + 5.0175189985879089e-02 -2.8939472983414566e-02 + 5.0110460720688511e-02 -2.9041750667052432e-02 + 5.0032766670980479e-02 -2.9164513800783876e-02 + 4.9939507609575370e-02 -2.9311870962207925e-02 + 4.9827560697445449e-02 -2.9488756499664280e-02 + 4.9693175175375845e-02 -2.9701096928310675e-02 + 4.9531845807871074e-02 -2.9956010899088718e-02 + 4.9338160805853841e-02 -3.0262049493931603e-02 + 4.9105619099180646e-02 -3.0629484950541557e-02 + 4.8826410805092146e-02 -3.1070657540627929e-02 + 4.8491153506881365e-02 -3.1600392271716099e-02 + 4.8088575484038332e-02 -3.2236499410360497e-02 + 4.7605135272307059e-02 -3.3000375609128024e-02 + 4.7024564833527148e-02 -3.3917725736683918e-02 + 4.6327321109706762e-02 -3.5019429468412848e-02 + 4.5489927739237122e-02 -3.6342581430544946e-02 + 4.4484185112988558e-02 -3.7931739377299128e-02 + 4.5574914240870297e-02 -7.2700647786640435e-03 + 4.5570624064553096e-02 -7.2683976569350665e-03 + 4.5565475027171544e-02 -7.2663968164782466e-03 + 4.5559295028808677e-02 -7.2639953967732545e-03 + 4.5551877429261277e-02 -7.2611131221449509e-03 + 4.5542973424836958e-02 -7.2576538781851056e-03 + 4.5532285537611426e-02 -7.2535016859661110e-03 + 4.5519455899853151e-02 -7.2485175663814560e-03 + 4.5504054750835569e-02 -7.2425346307909422e-03 + 4.5485566004881038e-02 -7.2353524795829571e-03 + 4.5463273495265771e-02 -7.2266976820287709e-03 + 4.5436520713806827e-02 -7.2163113013203883e-03 + 4.5404414854431398e-02 -7.2038467559991659e-03 + 4.5365884237569917e-02 -7.1888880385131415e-03 + 4.5319642411020822e-02 -7.1709357860072487e-03 + 4.5264145023951853e-02 -7.1493905490882526e-03 + 4.5197538013629406e-02 -7.1235326927308051e-03 + 4.5117595348274288e-02 -7.0924982484399379e-03 + 4.5021644213150865e-02 -7.0552499005458458e-03 + 4.4906475100654250e-02 -7.0105421229982312e-03 + 4.4768233753356770e-02 -6.9568792867613638e-03 + 4.4602291295306414e-02 -6.8924653187281137e-03 + 4.4403088152477267e-02 -6.8151432117673494e-03 + 4.4163946482437426e-02 -6.7223223427674839e-03 + 4.3876844778565308e-02 -6.6108911497053668e-03 + 4.3532147046064666e-02 -6.4771122281257476e-03 + 4.3118277427097867e-02 -6.3164963217019476e-03 + 4.2621329325612425e-02 -6.1236509755957513e-03 + 4.2024595896647747e-02 -5.8920987791850621e-03 + 4.1308006151340865e-02 -5.6140591160129772e-03 + 4.0447447813880627e-02 -5.2801861371988860e-03 + 3.9413954348055537e-02 -4.8792542398666903e-03 + 3.8172729123796607e-02 -4.3977806141797440e-03 + 3.6681974346417186e-02 -3.8195723600118955e-03 + 4.6006846195556637e-02 -6.2596063036557447e-03 + 4.6002587914516446e-02 -6.2578306517117469e-03 + 4.5997477170157439e-02 -6.2556995876429083e-03 + 4.5991343149480293e-02 -6.2531419171871459e-03 + 4.5983980759160506e-02 -6.2500721660444705e-03 + 4.5975142306289768e-02 -6.2463882815541735e-03 + 4.5964533151547943e-02 -6.2419665670888150e-03 + 4.5951798088228815e-02 -6.2366590836404664e-03 + 4.5936510556016601e-02 -6.2302881952405196e-03 + 4.5918158317878169e-02 -6.2226406111562937e-03 + 4.5896030174475778e-02 -6.2134299748066724e-03 + 4.5869474668244051e-02 -6.2023766209193809e-03 + 4.5837605589852788e-02 -6.1891117555461506e-03 + 4.5799359182269732e-02 -6.1731927219028648e-03 + 4.5753458508774533e-02 -6.1540881865909114e-03 + 4.5698370649129537e-02 -6.1311603474223375e-03 + 4.5632255273742012e-02 -6.1036435623691432e-03 + 4.5552902852948093e-02 -6.0706186772137016e-03 + 4.5457660404558800e-02 -6.0309821848250067e-03 + 4.5343342260197331e-02 -5.9834091724724203e-03 + 4.5206122822155366e-02 -5.9263088051153545e-03 + 4.5041407674277077e-02 -5.8577708411462481e-03 + 4.4843678680883202e-02 -5.7755013762061935e-03 + 4.4606307833628227e-02 -5.6767456497937019e-03 + 4.4321333558321539e-02 -5.5581953184002941e-03 + 4.3979191935668856e-02 -5.4158770798267142e-03 + 4.3568393779508996e-02 -5.2450189128308011e-03 + 4.3075136702313381e-02 -5.0398894494634305e-03 + 4.2482839126818078e-02 -4.7936051064709764e-03 + 4.1771580605635024e-02 -4.4978985341543824e-03 + 4.0917429715710725e-02 -4.1428406690328587e-03 + 3.9891637098236732e-02 -3.7165071573064712e-03 + 3.8659666792358646e-02 -3.2045780948050224e-03 + 3.7180033693675951e-02 -2.5898578423643294e-03 + 4.6519493557422631e-02 -5.1676796112452312e-03 + 4.6515258276174982e-02 -5.1657793347667132e-03 + 4.6510175149567304e-02 -5.1634987337530469e-03 + 4.6504074295326658e-02 -5.1607616363347356e-03 + 4.6496751739588900e-02 -5.1574765971809898e-03 + 4.6487960313669446e-02 -5.1535347270720939e-03 + 4.6477407659651720e-02 -5.1488034759046911e-03 + 4.6464740489536513e-02 -5.1431246105835323e-03 + 4.6449534552413838e-02 -5.1363081470299230e-03 + 4.6431280390432650e-02 -5.1281259819973002e-03 + 4.6409270237469047e-02 -5.1182766202515495e-03 + 4.6382856353567196e-02 -5.1064568296936841e-03 + 4.6351157270223320e-02 -5.0922722884791938e-03 + 4.6313114925049914e-02 -5.0752497126183016e-03 + 4.6267459223220765e-02 -5.0548210244301117e-03 + 4.6212665465896967e-02 -5.0303043406074721e-03 + 4.6146903204832924e-02 -5.0008811382724616e-03 + 4.6067974788948522e-02 -4.9655688295473510e-03 + 4.5973241518702475e-02 -4.9231878185764799e-03 + 4.5859534902527359e-02 -4.8723219298523190e-03 + 4.5723050004281500e-02 -4.8112708722669595e-03 + 4.5559217265152031e-02 -4.7379931370841177e-03 + 4.5362548458818146e-02 -4.6500374064635253e-03 + 4.5126451567622239e-02 -4.5444601664286211e-03 + 4.4843008326665608e-02 -4.4177267571257062e-03 + 4.4502706929222167e-02 -4.2655925437458109e-03 + 4.4094120885220051e-02 -4.0829602277625554e-03 + 4.3603523218522691e-02 -3.8637085272767990e-03 + 4.3014423027741916e-02 -3.6004865051069142e-03 + 4.2307008850573848e-02 -3.2844666885694040e-03 + 4.1457480188278051e-02 -2.9050487714243275e-03 + 4.0437244865702618e-02 -2.4495040696018086e-03 + 3.9211955495053824e-02 -1.9025489643337903e-03 + 3.7740353011306890e-02 -1.2458332347318939e-03 + 4.7132453511235371e-02 -3.9959212705561091e-03 + 4.7128227248210516e-02 -3.9938759399898559e-03 + 4.7123154960086476e-02 -3.9914212858200952e-03 + 4.7117067135174322e-02 -3.9884753412041752e-03 + 4.7109760246754853e-02 -3.9849397082507461e-03 + 4.7100986764164063e-02 -3.9806975154312281e-03 + 4.7090455705401713e-02 -3.9756059203882093e-03 + 4.7077814535061234e-02 -3.9694947012520795e-03 + 4.7062639911606488e-02 -3.9621594914223133e-03 + 4.7044423475785475e-02 -3.9533549341115304e-03 + 4.7022458526577361e-02 -3.9427615019036466e-03 + 4.6996098917724001e-02 -3.9300488598001948e-03 + 4.6964465007718878e-02 -3.9147929439877771e-03 + 4.6926500931968450e-02 -3.8964847857130280e-03 + 4.6880939240258136e-02 -3.8745134943241055e-03 + 4.6826258417392602e-02 -3.8481458223600384e-03 + 4.6760631849278769e-02 -3.8165016264741780e-03 + 4.6681866504565281e-02 -3.7785243969068461e-03 + 4.6587329252447296e-02 -3.7329458627795020e-03 + 4.6473858317108908e-02 -3.6782434815876286e-03 + 4.6337656864705971e-02 -3.6125893804097586e-03 + 4.6174165114580806e-02 -3.5337890314508513e-03 + 4.5977906643756693e-02 -3.4392076005076433e-03 + 4.5742303683906714e-02 -3.3256814953830371e-03 + 4.5459455170737399e-02 -3.1894121504336681e-03 + 4.5119870055218253e-02 -3.0258384910553104e-03 + 4.4712146885191636e-02 -2.8294838150770829e-03 + 4.4222588864581344e-02 -2.5937719799173919e-03 + 4.3634741437247895e-02 -2.3108067672836792e-03 + 4.2928836860638905e-02 -1.9711070848416000e-03 + 4.2081127154657512e-02 -1.5632892124414709e-03 + 4.1063083129942800e-02 -1.0736855698632636e-03 + 3.9840432793402887e-02 -4.8588740335291054e-04 + 3.8372007127293835e-02 2.1980370856903471e-04 + 4.7852467747492716e-02 -2.7398563172461705e-03 + 4.7848236923174414e-02 -2.7376436392570098e-03 + 4.7843159177030282e-02 -2.7349881793008049e-03 + 4.7837064824198312e-02 -2.7318012832337792e-03 + 4.7829750132271850e-02 -2.7279765300577399e-03 + 4.7820966339727343e-02 -2.7233878147831353e-03 + 4.7810422968346505e-02 -2.7178804334795957e-03 + 4.7797767103051364e-02 -2.7112703258040990e-03 + 4.7782574952482414e-02 -2.7033365231403654e-03 + 4.7764337624459849e-02 -2.6938137509375792e-03 + 4.7742347197796971e-02 -2.6823612918036588e-03 + 4.7715957043691928e-02 -2.6686178496362345e-03 + 4.7684286518773017e-02 -2.6521250196509527e-03 + 4.7646278560961902e-02 -2.6323326300285999e-03 + 4.7600664289593586e-02 -2.6085803542486019e-03 + 4.7545920482166416e-02 -2.5800756335172537e-03 + 4.7480218488164694e-02 -2.5458671668303623e-03 + 4.7401362849314600e-02 -2.5048130774365518e-03 + 4.7306717545055096e-02 -2.4555426849559581e-03 + 4.7193117361524019e-02 -2.3964105976261862e-03 + 4.7056761377423310e-02 -2.3254415812203888e-03 + 4.6893084956153845e-02 -2.2402643526078236e-03 + 4.6696605908109111e-02 -2.1380320764876615e-03 + 4.6460739618129791e-02 -2.0153269004197227e-03 + 4.6177576891295410e-02 -1.8680453337935887e-03 + 4.5837617017304121e-02 -1.6912606397454510e-03 + 4.5429447051937064e-02 -1.4790576480550044e-03 + 4.4939356506944514e-02 -1.2243344831404102e-03 + 4.4350874477195525e-02 -9.1856460879569070e-04 + 4.3644213646014174e-02 -5.5151128515262295e-04 + 4.2795602519973532e-02 -1.1088497213046070e-04 + 4.1776483555035944e-02 4.1806765224154175e-04 + 4.0552550413386519e-02 1.0530566285965293e-03 + 3.9082592268633143e-02 1.8153398705475045e-03 + 4.8698357560091284e-02 -1.4021981637008620e-03 + 4.8694104545196362e-02 -1.3997910922185328e-03 + 4.8689000184458715e-02 -1.3969023699210857e-03 + 4.8682873913655965e-02 -1.3934355728091534e-03 + 4.8675520947329180e-02 -1.3892749574508914e-03 + 4.8666690183724805e-02 -1.3842836625036733e-03 + 4.8656090501022140e-02 -1.3782932215634122e-03 + 4.8643367134827836e-02 -1.3711034907828486e-03 + 4.8628094080129053e-02 -1.3624742050808440e-03 + 4.8609759794322679e-02 -1.3521169383494680e-03 + 4.8587652205834740e-02 -1.3396658898017222e-03 + 4.8561121481678113e-02 -1.3247241705869328e-03 + 4.8529282306847388e-02 -1.3067934514481294e-03 + 4.8491072017494530e-02 -1.2852756564711854e-03 + 4.8445215016606168e-02 -1.2594529822109735e-03 + 4.8390180029696674e-02 -1.2284639081059368e-03 + 4.8324128754614379e-02 -1.1912743944577642e-03 + 4.8244854165442809e-02 -1.1466432989237774e-03 + 4.8149706379557240e-02 -1.0930808519162838e-03 + 4.8035503573349084e-02 -1.0287987948061073e-03 + 4.7898424925833037e-02 -9.5165050835532838e-04 + 4.7733881961019103e-02 -8.5905912254702343e-04 + 4.7536363930868721e-02 -7.4793119921423568e-04 + 4.7299252008065971e-02 -6.1455309908353684e-04 + 4.7014596008177992e-02 -4.5446656963576970e-04 + 4.6672846102802597e-02 -2.6231940253751418e-04 + 4.6262530472577529e-02 -3.1686183646684185e-05 + 4.5769868032873640e-02 2.4514682995402387e-04 + 4.5178303187266108e-02 5.7743985338731861e-04 + 4.4467946960202238e-02 9.7630930166304163e-04 + 4.3614905749190816e-02 1.4550993535707463e-03 + 4.2590475220684008e-02 2.0298276271552224e-03 + 4.1360172417642491e-02 2.7197196668608788e-03 + 3.9882573782849463e-02 3.5478498621237058e-03 + 4.9681813605722616e-02 1.7944720797511307e-05 + 4.9677520069010599e-02 2.0576495771064044e-05 + 4.9672367094921191e-02 2.3734853888226602e-05 + 4.9666182505982037e-02 2.7525202213021333e-05 + 4.9658759582602005e-02 3.2074062825582273e-05 + 4.9649843726765792e-02 3.7530761800900460e-05 + 4.9639141982813016e-02 4.4079657158079082e-05 + 4.9626296209844149e-02 5.1939492259118123e-05 + 4.9610876355758268e-02 6.1372848506379831e-05 + 4.9592366026843172e-02 7.2694928149985531e-05 + 4.9570045987882123e-02 8.6300989259768812e-05 + 4.9543260344049052e-02 1.0262869551525000e-04 + 4.9511115295371208e-02 1.2222255909932755e-04 + 4.9472537999490113e-02 1.4573607029433333e-04 + 4.9426240650008640e-02 1.7395352259796937e-04 + 4.9370677328027468e-02 2.0781621451249066e-04 + 4.9303992167076913e-02 2.4845390527161726e-04 + 4.9223957076291805e-02 2.9722258072695240e-04 + 4.9127896911128441e-02 3.5574979526131756e-04 + 4.9012599554542936e-02 4.2598911133495676e-04 + 4.8874207859884000e-02 5.1028546072018344e-04 + 4.8708089792788720e-02 6.1145361714665114e-04 + 4.8508682374231032e-02 7.3287240629582584e-04 + 4.8269304144002469e-02 8.7859780169452506e-04 + 4.7981929805309180e-02 1.0534986807115843e-03 + 4.7636919440702884e-02 1.2634197653795809e-03 + 4.7222693159681438e-02 1.5153771709108810e-03 + 4.6725340205824993e-02 1.8177930606526616e-03 + 4.6128149348504621e-02 2.1807771946527059e-03 + 4.5411044754129409e-02 2.6164646982778147e-03 + 4.4549908384889723e-02 3.1394212181795065e-03 + 4.3515766213978194e-02 3.7671288357122904e-03 + 4.2273811036896043e-02 4.5205687504546611e-03 + 4.0782229227279448e-02 5.4249199295386113e-03 + 5.0823577485964028e-02 1.5141115731670876e-03 + 5.0819221212832069e-02 1.5170042399641815e-03 + 5.0813992966480870e-02 1.5204756618609782e-03 + 5.0807718066628829e-02 1.5246416779106636e-03 + 5.0800186792111200e-02 1.5296413274686104e-03 + 5.0791139661827744e-02 1.5356384463553025e-03 + 5.0780280432799314e-02 1.5428358229171994e-03 + 5.0767245737324267e-02 1.5514738048310001e-03 + 5.0751599255433585e-02 1.5618408964854775e-03 + 5.0732817076797339e-02 1.5742834052758781e-03 + 5.0710169195812602e-02 1.5892313189098672e-03 + 5.0682990159048841e-02 1.6071692235328783e-03 + 5.0650373063571105e-02 1.6286952899662310e-03 + 5.0611229346426298e-02 1.6545273941872551e-03 + 5.0564252340535409e-02 1.6855270864368777e-03 + 5.0507873499637763e-02 1.7227283640437463e-03 + 5.0440209811774224e-02 1.7673722123774382e-03 + 5.0359000621302330e-02 1.8209480708790693e-03 + 5.0261531718571423e-02 1.8852436136569395e-03 + 5.0144544124730767e-02 1.9624045126107603e-03 + 5.0004124479194258e-02 2.0550061832338429e-03 + 4.9835573314997265e-02 2.1661399147703264e-03 + 4.9633246761653101e-02 2.2995162623047349e-03 + 4.9390366318341379e-02 2.4595891529770597e-03 + 4.9098790267261876e-02 2.6517048431742296e-03 + 4.8748739005070832e-02 2.8822806861086292e-03 + 4.8328465020335457e-02 3.1590196522728320e-03 + 4.7823856380698478e-02 3.4911677240145877e-03 + 4.7217960359705047e-02 3.8898226960029096e-03 + 4.6490411158471710e-02 4.3683045990121679e-03 + 4.5616742481076562e-02 4.9425999811064094e-03 + 4.4567561900045384e-02 5.6318946930252614e-03 + 4.3307559361447590e-02 6.4592127218613916e-03 + 4.1794316652146085e-02 7.4521821060213374e-03 + 5.2129986551062130e-02 3.0893842890425600e-03 + 5.2125547895538311e-02 3.0925758537343603e-03 + 5.2120220801138796e-02 3.0964059485663799e-03 + 5.2113827298892690e-02 3.1010023658458309e-03 + 5.2106153722439763e-02 3.1065184881204446e-03 + 5.2096934463477088e-02 3.1131348077758940e-03 + 5.2085868722585041e-02 3.1210752094920661e-03 + 5.2072586270215791e-02 3.1306048003329986e-03 + 5.2056642556219224e-02 3.1420417945327013e-03 + 5.2037503798596473e-02 3.1557681496110490e-03 + 5.2014426085392231e-02 3.1722540792316067e-03 + 5.1986731265962122e-02 3.1920375813214719e-03 + 5.1953495253897058e-02 3.2157783335620138e-03 + 5.1913608868801996e-02 3.2442680162461102e-03 + 5.1865740706244404e-02 3.2784567390109487e-03 + 5.1808292540017981e-02 3.3194847625566126e-03 + 5.1739345748873816e-02 3.3687205768515582e-03 + 5.1656596954665047e-02 3.4278066109081351e-03 + 5.1557280692086822e-02 3.4987141039835024e-03 + 5.1438076489468729e-02 3.5838089748594371e-03 + 5.1294997212171130e-02 3.6859308919332534e-03 + 5.1123254884523274e-02 3.8084881876585541e-03 + 5.0917099447551156e-02 3.9555717856671890e-03 + 5.0669624995823198e-02 4.1320919409457701e-03 + 5.0372536942838102e-02 4.3439423463595972e-03 + 5.0015872248042929e-02 4.5981970638848679e-03 + 4.9587663257766194e-02 4.9033468210240017e-03 + 4.9073533811863142e-02 5.2695825084967396e-03 + 4.8456213990176633e-02 5.7091352665281647e-03 + 4.7714957143343284e-02 6.2366844017844912e-03 + 4.6824839591365595e-02 6.8698465945189998e-03 + 4.5755919469928574e-02 7.6297625108315507e-03 + 4.4472226519458188e-02 8.5418001239399213e-03 + 4.2930548962044214e-02 9.6363978887260560e-03 + 5.3618154610294851e-02 4.7378076386070944e-03 + 5.3613612787824366e-02 4.7413409139371587e-03 + 5.3608161903983514e-02 4.7455810590317088e-03 + 5.3601619869471401e-02 4.7506695331247127e-03 + 5.3593768075187162e-02 4.7567761187429208e-03 + 5.3584333469245231e-02 4.7641003861537655e-03 + 5.3573009354557936e-02 4.7728903169925218e-03 + 5.3559416910788922e-02 4.7834393319234848e-03 + 5.3543101282964314e-02 4.7960996207550011e-03 + 5.3523516327710144e-02 4.8112939110609432e-03 + 5.3499900964716421e-02 4.8295388372139314e-03 + 5.3471560980951925e-02 4.8514331166487068e-03 + 5.3437550793553244e-02 4.8777067750194192e-03 + 5.3396735428756129e-02 4.9092359069149438e-03 + 5.3347752533728643e-02 4.9470719141808672e-03 + 5.3288966748761088e-02 4.9924766010889243e-03 + 5.3218414898711479e-02 5.0469643000212727e-03 + 5.3133740148880275e-02 5.1123524368250628e-03 + 5.3032112896587824e-02 5.1908222271634941e-03 + 5.2910135718598629e-02 5.2849915335571040e-03 + 5.2763729153906092e-02 5.3980023177757630e-03 + 5.2587994453340649e-02 5.5336256094804526e-03 + 5.2377048648365863e-02 5.6963874925202163e-03 + 5.2123826359139681e-02 5.8917203075878888e-03 + 5.1819841640260281e-02 6.1261441024242913e-03 + 5.1454901816452112e-02 6.4074843598262987e-03 + 5.1016763641185021e-02 6.7451332284846899e-03 + 5.0490720167345446e-02 7.1503629125544421e-03 + 4.9859104383570198e-02 7.6367015886731338e-03 + 4.9100692876729829e-02 8.2203842659822664e-03 + 4.8189989436131835e-02 8.9208934544800448e-03 + 4.7096364515457650e-02 9.7616074403608661e-03 + 4.5783021659970724e-02 1.0770577488632058e-02 + 4.4205756209994666e-02 1.1981459538708446e-02 + 5.5298207112807009e-02 6.4577144292331809e-03 + 5.5293543864921121e-02 6.4616346773848287e-03 + 5.5287947282387589e-02 6.4663391890729272e-03 + 5.5281230425897693e-02 6.4719849021005584e-03 + 5.5273168867858963e-02 6.4787601729641717e-03 + 5.5263480937345157e-02 6.4868862094295734e-03 + 5.5251852879383757e-02 6.4966382616020238e-03 + 5.5237895765848255e-02 6.5083418202505029e-03 + 5.5221142616764980e-02 6.5223875594284664e-03 + 5.5201032743638426e-02 6.5392443878451445e-03 + 5.5176785109477842e-02 6.5594818602150440e-03 + 5.5147686417395862e-02 6.5837671789807928e-03 + 5.5112765804093640e-02 6.6129100615626157e-03 + 5.5070857962360949e-02 6.6478822293305484e-03 + 5.5020564142666879e-02 6.6898498321208422e-03 + 5.4960205314861975e-02 6.7402123655284640e-03 + 5.4887765906002577e-02 6.8006493827326153e-03 + 5.4800826213193446e-02 6.8731765618466056e-03 + 5.4696481203788366e-02 6.9602130034596144e-03 + 5.4571242953071801e-02 7.0646620064422905e-03 + 5.4420923416303169e-02 7.1900080203235461e-03 + 5.4240493563914888e-02 7.3404330090554026e-03 + 5.4023914112928291e-02 7.5209561057505425e-03 + 5.3763932126324535e-02 7.7376012090084600e-03 + 5.3451836603995974e-02 7.9975980934037239e-03 + 5.3077164803860051e-02 8.3096237140836138e-03 + 5.2627349370925919e-02 8.6840917063000234e-03 + 5.2087294352344389e-02 9.1334996665111134e-03 + 5.1438865780337517e-02 9.6728456966843623e-03 + 5.0660279630698489e-02 1.0320127959587925e-02 + 4.9725366528362423e-02 1.1096943705617028e-02 + 4.8602688453758175e-02 1.2029207479244996e-02 + 4.7254477757347702e-02 1.3148012115625026e-02 + 4.5635362818171425e-02 1.4490660838743920e-02 + 5.7190998568123402e-02 8.2354628340526835e-03 + 5.7186194676504161e-02 8.2398214230805962e-03 + 5.7180429334819600e-02 8.2450519449236391e-03 + 5.7173509985806933e-02 8.2513288716677940e-03 + 5.7165205462291480e-02 8.2588616013590400e-03 + 5.7155224237890843e-02 8.2678958879394034e-03 + 5.7143244279205779e-02 8.2787378459556298e-03 + 5.7128864954724856e-02 8.2917492995449003e-03 + 5.7111605245229839e-02 8.3073645236240168e-03 + 5.7090887620707784e-02 8.3261047488321083e-03 + 5.7065908218052644e-02 8.3485998256023208e-03 + 5.7035931423736225e-02 8.3755942562007135e-03 + 5.6999957115979674e-02 8.4079880535412599e-03 + 5.6956784880587016e-02 8.4468612912331764e-03 + 5.6904973844389431e-02 8.4935101378675881e-03 + 5.6842794434876033e-02 8.5494901061906603e-03 + 5.6768170436547249e-02 8.6166679623289610e-03 + 5.6678609386328051e-02 8.6972840288765951e-03 + 5.6571118953296640e-02 8.7940269637840629e-03 + 5.6442106472741289e-02 8.9101235120949696e-03 + 5.6287258233468210e-02 9.0494462258945418e-03 + 5.6101394431796639e-02 9.2166427453221900e-03 + 5.5878294883679611e-02 9.4172909477947542e-03 + 5.5610489598906972e-02 9.6580851291605541e-03 + 5.5289007136230146e-02 9.9470594037143201e-03 + 5.4903072233564755e-02 1.0293855739234914e-02 + 5.4439742494228477e-02 1.0710045509107147e-02 + 5.3883471851170525e-02 1.1209515203596254e-02 + 5.3215586059861791e-02 1.1808929044548222e-02 + 5.2413652508096348e-02 1.2528283763607821e-02 + 5.1450723085553325e-02 1.3391573814537639e-02 + 5.0294424606129207e-02 1.4427588895302275e-02 + 4.8905866169346071e-02 1.5670869988301653e-02 + 4.7238326675550196e-02 1.7162855347824572e-02 + 5.9296639302785538e-02 1.0076654047738122e-02 + 5.9291684086672708e-02 1.0081499470613700e-02 + 5.9285737172243107e-02 1.0087314194932013e-02 + 5.9278599959138693e-02 1.0094292167234377e-02 + 5.9270034030667260e-02 1.0102666155102902e-02 + 5.9259737257378375e-02 1.0112709198693464e-02 + 5.9247378704619880e-02 1.0124761673409878e-02 + 5.9232545154276554e-02 1.0139225758550193e-02 + 5.9214740489326144e-02 1.0156584156263193e-02 + 5.9193369069322703e-02 1.0177416211355705e-02 + 5.9167602770693509e-02 1.0202418873902275e-02 + 5.9136681727871912e-02 1.0232422393904983e-02 + 5.9099574359771111e-02 1.0268427079083153e-02 + 5.9055042505457851e-02 1.0311633354149308e-02 + 5.9001600001868798e-02 1.0363481805214292e-02 + 5.8937462936998364e-02 1.0425701240706074e-02 + 5.8860489899405816e-02 1.0500366373548784e-02 + 5.8768110206033113e-02 1.0589967051259917e-02 + 5.8657237681814960e-02 1.0697491345446506e-02 + 5.8524167074660273e-02 1.0826525273927244e-02 + 5.8364449600487305e-02 1.0981372482319783e-02 + 5.8172743407036293e-02 1.1167197874243581e-02 + 5.7942633897177347e-02 1.1390199973405398e-02 + 5.7666417834552695e-02 1.1657817750347016e-02 + 5.7334843932198835e-02 1.1978978785066369e-02 + 5.6936801154971350e-02 1.2364396998002285e-02 + 5.6458944199632377e-02 1.2826929811481584e-02 + 5.5885243492092486e-02 1.3382006556831519e-02 + 5.5196444490810459e-02 1.4048142274006626e-02 + 5.4369418027580121e-02 1.4847553845271467e-02 + 5.3376379754590496e-02 1.5806898744060077e-02 + 5.2183952376153461e-02 1.6958160684808782e-02 + 5.0752039062013116e-02 1.8339711269188062e-02 + 4.9032470055911208e-02 1.9997582522716613e-02 + 6.1636425060866772e-02 1.1961035095390558e-02 + 6.1631308997653997e-02 1.1966421504174398e-02 + 6.1625169087453413e-02 1.1972885413945235e-02 + 6.1617800308250592e-02 1.1980642412101851e-02 + 6.1608956540474220e-02 1.1989951235616947e-02 + 6.1598324366528887e-02 1.2001115274542994e-02 + 6.1585563413147353e-02 1.2014512954131321e-02 + 6.1570247089842725e-02 1.2030591299605925e-02 + 6.1551863240816976e-02 1.2049886829572639e-02 + 6.1529796987524386e-02 1.2073043470294916e-02 + 6.1503194759056204e-02 1.2100832855146845e-02 + 6.1471270635522803e-02 1.2134180427942448e-02 + 6.1432959620398180e-02 1.2174197956227312e-02 + 6.1386983460098112e-02 1.2222219613995826e-02 + 6.1331807888668710e-02 1.2279846482286408e-02 + 6.1265591281869355e-02 1.2348999957950458e-02 + 6.1186122988903684e-02 1.2431985851712556e-02 + 6.1090749259990744e-02 1.2531571316557674e-02 + 6.0976284267128311e-02 1.2651077173529739e-02 + 6.0838903209921635e-02 1.2794488715059039e-02 + 6.0674013891213824e-02 1.2966588680377785e-02 + 6.0476102418741552e-02 1.3173116834053613e-02 + 6.0238547814165960e-02 1.3420961458322686e-02 + 5.9953399260691480e-02 1.3718389126928755e-02 + 5.9611108458671389e-02 1.4075320389657921e-02 + 5.9200208041242375e-02 1.4503660509696139e-02 + 5.8706925178468886e-02 1.5017696204935684e-02 + 5.8114717304150569e-02 1.5634571511426908e-02 + 5.7403714266058600e-02 1.6374858477071430e-02 + 5.6550048040475150e-02 1.7263241494973030e-02 + 5.5525047367015454e-02 1.8329337794383942e-02 + 5.4294270118753360e-02 1.9608681053981267e-02 + 5.2816340756212082e-02 2.1143900442996074e-02 + 5.1041553606139670e-02 2.2986133838354354e-02 + 6.4208940817570184e-02 1.3892332881917347e-02 + 6.4203666075023244e-02 1.3898308041011640e-02 + 6.4197335776324221e-02 1.3905478452377974e-02 + 6.4189738568232554e-02 1.3914083254190119e-02 + 6.4180620737252475e-02 1.3924409444567385e-02 + 6.4169657565102456e-02 1.3936793455584585e-02 + 6.4156499516400733e-02 1.3951655108115753e-02 + 6.4140706817136850e-02 1.3969490230060427e-02 + 6.4121751500892221e-02 1.3990893904285411e-02 + 6.4098999728118902e-02 1.4016580335429275e-02 + 6.4071573184279362e-02 1.4047402296910124e-02 + 6.4038659929814168e-02 1.4084388943466275e-02 + 6.3999162024970593e-02 1.4128773334235194e-02 + 6.3951761692473477e-02 1.4182035189236282e-02 + 6.3894877249223159e-02 1.4245950240180546e-02 + 6.3826610185837018e-02 1.4322649457234533e-02 + 6.3744681610468534e-02 1.4414690128852128e-02 + 6.3646355912468824e-02 1.4525141166487184e-02 + 6.3528349068740539e-02 1.4657685480002998e-02 + 6.3386718494457914e-02 1.4816742837950717e-02 + 6.3216730715273228e-02 1.5007617307375470e-02 + 6.3012702386950739e-02 1.5236674183753740e-02 + 6.2767809288409901e-02 1.5511552297389829e-02 + 6.2473856829725588e-02 1.5841418752628688e-02 + 6.2121004319362239e-02 1.6237274555066575e-02 + 6.1697433667655385e-02 1.6712321257699149e-02 + 6.1188951326364018e-02 1.7282400761714608e-02 + 6.0578509999730065e-02 1.7966522808122717e-02 + 5.9845633948364001e-02 1.8787497565724370e-02 + 5.8965728446166425e-02 1.9772694157594119e-02 + 5.7909250044187455e-02 2.0954950076684339e-02 + 5.6640709605726362e-02 2.2373661369441716e-02 + 5.5117474427467839e-02 2.4076089386910422e-02 + 5.3288328928661616e-02 2.6118927042013788e-02 + 6.7021304105450527e-02 1.5861451846086297e-02 + 6.7015882632326135e-02 1.5868059256906826e-02 + 6.7009376290950912e-02 1.5875988369187338e-02 + 6.7001567878968687e-02 1.5885503610475141e-02 + 6.6992196668861595e-02 1.5896922326068742e-02 + 6.6980927191138823e-02 1.5910616434225835e-02 + 6.6967401705597035e-02 1.5927050200843878e-02 + 6.6951168257306376e-02 1.5946771856832190e-02 + 6.6931684275509051e-02 1.5970439368544413e-02 + 6.6908298410021869e-02 1.5998842401088988e-02 + 6.6880109848313218e-02 1.6032920554692871e-02 + 6.6846282234792012e-02 1.6073814606713081e-02 + 6.6805687187845048e-02 1.6122887847941882e-02 + 6.6756970410638244e-02 1.6181776271842630e-02 + 6.6698506411509789e-02 1.6252443131264512e-02 + 6.6628344131332978e-02 1.6337244412241343e-02 + 6.6544141646761160e-02 1.6439007408407886e-02 + 6.6443087747438054e-02 1.6561125017836860e-02 + 6.6321807741488534e-02 1.6707668906490877e-02 + 6.6176250308929110e-02 1.6883525310724123e-02 + 6.6001551580481710e-02 1.7094558003008631e-02 + 6.5791871849556413e-02 1.7347803846219895e-02 + 6.5540199399080637e-02 1.7651707440108053e-02 + 6.5238114813033932e-02 1.8016402655290420e-02 + 6.4875507807411081e-02 1.8454050396185570e-02 + 6.4440237007567291e-02 1.8979243784910428e-02 + 6.3917721167269861e-02 1.9609494172262848e-02 + 6.3290447999584346e-02 2.0365814033465723e-02 + 6.2537383997628745e-02 2.1273415975653538e-02 + 6.1633265271095437e-02 2.2362550879105259e-02 + 6.0547745402768208e-02 2.3669512733458554e-02 + 5.9244371502034404e-02 2.5237843174503876e-02 + 5.7679353811086659e-02 2.7119775268491807e-02 + 5.5800087173935461e-02 2.9377963981887231e-02 + 7.0084025265684358e-02 1.7849288875710193e-02 + 7.0078479030251509e-02 1.7856567870101394e-02 + 7.0071823016146298e-02 1.7865302877956742e-02 + 7.0063835055570511e-02 1.7875785187462842e-02 + 7.0054248468407285e-02 1.7888364375989535e-02 + 7.0042718160450795e-02 1.7903450050183924e-02 + 7.0028879838958086e-02 1.7921553680778815e-02 + 7.0012271203859430e-02 1.7943279153215013e-02 + 6.9992337286207684e-02 1.7969351218027878e-02 + 6.9968411876134215e-02 1.8000639680280962e-02 + 6.9939575433650938e-02 1.8038175921247984e-02 + 6.9904970442387124e-02 1.8083219643678174e-02 + 6.9863442654622243e-02 1.8137272440135594e-02 + 6.9813606747908138e-02 1.8202136259667108e-02 + 6.9753800018870202e-02 1.8279973492852205e-02 + 6.9682026780634815e-02 1.8373379077928503e-02 + 6.9595891592359072e-02 1.8485467032959859e-02 + 6.9492519071567102e-02 1.8619974299397664e-02 + 6.9368457585327087e-02 1.8781385358607725e-02 + 6.9219563571125575e-02 1.8975081774108407e-02 + 6.9040862581989965e-02 1.9207521638811714e-02 + 6.8826382363583349e-02 1.9486454899393157e-02 + 6.8568952324539939e-02 1.9821181715528002e-02 + 6.8259962624608386e-02 2.0222862434195254e-02 + 6.7889074740254463e-02 2.0704889460347046e-02 + 6.7443873722246972e-02 2.1283333340817980e-02 + 6.6909450384462416e-02 2.1977477816754184e-02 + 6.6267899284681769e-02 2.2810461515141652e-02 + 6.5497715500171069e-02 2.3810047438764220e-02 + 6.4573069769129340e-02 2.5009545588963990e-02 + 6.3462937450406237e-02 2.6448919051530885e-02 + 6.2130051803957156e-02 2.8176109868012458e-02 + 6.0529646125059511e-02 3.0248628215624310e-02 + 5.8607942032231949e-02 3.2735457106275810e-02 + 7.3392180809007321e-02 1.9854599767868780e-02 + 7.3386549596031761e-02 1.9862573209248460e-02 + 7.3379791660091301e-02 1.9872141543429679e-02 + 7.3371681464528216e-02 1.9883623830559100e-02 + 7.3361948294210999e-02 1.9897402972849892e-02 + 7.3350239584847265e-02 1.9913927516981025e-02 + 7.3336187375986295e-02 1.9933757756291443e-02 + 7.3319322338436188e-02 1.9957555111822952e-02 + 7.3299081087716461e-02 1.9986113373860800e-02 + 7.3274787337597069e-02 2.0020385191202191e-02 + 7.3245509238496903e-02 2.0061496105540751e-02 + 7.3210374356804706e-02 2.0110829388443104e-02 + 7.3168210839213710e-02 2.0170029589401388e-02 + 7.3117612253484551e-02 2.0241070197002380e-02 + 7.3056890587896967e-02 2.0326319436890110e-02 + 7.2984019818138082e-02 2.0428619231807933e-02 + 7.2896568143038604e-02 2.0551379956572181e-02 + 7.2791616608157542e-02 2.0698694145885085e-02 + 7.2665661375964655e-02 2.0875472944460665e-02 + 7.2514496346565024e-02 2.1087609843839041e-02 + 7.2333072170114657e-02 2.1342177156256501e-02 + 7.2115326891684817e-02 2.1647661760908900e-02 + 7.1853982510575010e-02 2.2014247956292327e-02 + 7.1540300582192656e-02 2.2454156808819858e-02 + 7.1163788604313730e-02 2.2982053247396498e-02 + 7.0711847261235278e-02 2.3615534384717245e-02 + 7.0169346592163867e-02 2.4375715209465833e-02 + 6.9518116734996763e-02 2.5287930986031791e-02 + 6.8736335994003042e-02 2.6382579514262150e-02 + 6.7797795491199950e-02 2.7696130968941059e-02 + 6.6671015473080242e-02 2.9272338506501551e-02 + 6.5318183306356151e-02 3.1163689382516749e-02 + 6.3693877116810543e-02 3.3433144206435630e-02 + 6.1743531652404003e-02 3.6156221468352463e-02 + 7.6947200601778037e-02 2.1862297487374682e-02 + 7.6941540668743799e-02 2.1870970986770908e-02 + 7.6934748328842020e-02 2.1881379373979007e-02 + 7.6926596932486074e-02 2.1893869701544433e-02 + 7.6916814437408235e-02 2.1908858460362314e-02 + 7.6905043914578336e-02 2.1926833394061648e-02 + 7.6890917757722971e-02 2.1948404041225420e-02 + 7.6873964290763097e-02 2.1974289805953614e-02 + 7.6853617335953778e-02 2.2005354052296866e-02 + 7.6829197281207753e-02 2.2042632911158933e-02 + 7.6799768713193994e-02 2.2087345870382080e-02 + 7.6764453384178949e-02 2.2141001544170535e-02 + 7.6722073493997012e-02 2.2205388524071168e-02 + 7.6671215494053299e-02 2.2282653137722264e-02 + 7.6610182861043222e-02 2.2375371001359667e-02 + 7.6536939395099257e-02 2.2486632883619961e-02 + 7.6449041137424220e-02 2.2620147742046015e-02 + 7.6343554616557174e-02 2.2780366365722671e-02 + 7.6216958671345703e-02 2.2972629741829561e-02 + 7.6065026542765465e-02 2.3203347085754441e-02 + 7.5882684259444569e-02 2.3480209458305975e-02 + 7.5663840539598681e-02 2.3812446071872270e-02 + 7.5401182467985037e-02 2.4211131799340532e-02 + 7.5085930048289132e-02 2.4689556089299455e-02 + 7.4707541336129474e-02 2.5263665513641335e-02 + 7.4253358183154580e-02 2.5952594594585314e-02 + 7.3708180602335471e-02 2.6779302455352642e-02 + 7.3053755337198364e-02 2.7771336303402439e-02 + 7.2268161296079311e-02 2.8961746903135566e-02 + 7.1325071002282775e-02 3.0390186154932042e-02 + 7.0192862990371946e-02 3.2104222839066672e-02 + 6.8833555001387714e-02 3.4160919707631111e-02 + 6.7201521695586797e-02 3.6628723674015082e-02 + 6.5241953155528901e-02 3.9589731186153207e-02 + 8.0738498283529164e-02 2.3871649681141284e-02 + 8.0732887577322554e-02 2.3880997953151819e-02 + 8.0726154378023510e-02 2.3892216043321254e-02 + 8.0718074045795576e-02 2.3905677980674011e-02 + 8.0708376959944664e-02 2.3921832624238085e-02 + 8.0696706184610542e-02 2.3941205392759273e-02 + 8.0682699983938830e-02 2.3964453353670461e-02 + 8.0665890814750729e-02 2.3992351776072951e-02 + 8.0645717484589680e-02 2.4025831053407387e-02 + 8.0621506394103482e-02 2.4066007741843976e-02 + 8.0592330294067122e-02 2.4114190554733739e-02 + 8.0557318057863397e-02 2.4172009972787123e-02 + 8.0515302065535532e-02 2.4241393331351446e-02 + 8.0464881007729402e-02 2.4324653435996879e-02 + 8.0404373079734762e-02 2.4424565656104846e-02 + 8.0331759788096355e-02 2.4544460435123483e-02 + 8.0244618481680130e-02 2.4688334300165593e-02 + 8.0140041340385812e-02 2.4860983067320319e-02 + 8.0014538095021459e-02 2.5068161678028389e-02 + 7.9863919204045217e-02 2.5316775984819628e-02 + 7.9683155550232337e-02 2.5615112864798562e-02 + 7.9466209926480985e-02 2.5973116307483224e-02 + 7.9205834624701918e-02 2.6402718643709022e-02 + 7.8893328292140075e-02 2.6918237900815711e-02 + 7.8518243838337248e-02 2.7536854447191672e-02 + 7.8068037511262386e-02 2.8279182694582516e-02 + 7.7527647259810581e-02 2.9169956744752312e-02 + 7.6878986087720147e-02 3.0238852597101129e-02 + 7.6100333204493234e-02 3.1521473995397287e-02 + 7.5165602290338834e-02 3.3060534332875591e-02 + 7.4043461994887858e-02 3.4907273428984822e-02 + 7.2696278737053935e-02 3.7123155660538212e-02 + 7.1078845761335732e-02 3.9781905155757510e-02 + 6.9136854982013968e-02 4.2971944887338916e-02 + 8.4758086830155496e-02 2.5872110296831390e-02 + 8.4752622104158737e-02 2.5882071774889263e-02 + 8.4746064155499526e-02 2.5894025680663391e-02 + 8.4738194227991961e-02 2.5908370552666954e-02 + 8.4728749771774414e-02 2.5925584656760189e-02 + 8.4717379288924713e-02 2.5946227477518707e-02 + 8.4703733721397681e-02 2.5970999385734203e-02 + 8.4687357693199114e-02 2.6000726389192153e-02 + 8.4667704641293487e-02 2.6036399756073081e-02 + 8.4644118554152992e-02 2.6079209078950782e-02 + 8.4615694466087757e-02 2.6130542491600295e-02 + 8.4581584785667061e-02 2.6192142533702167e-02 + 8.4540652061562763e-02 2.6266062504554100e-02 + 8.4491531211143722e-02 2.6354766349186320e-02 + 8.4432583936060873e-02 2.6461210779913813e-02 + 8.4361843997656713e-02 2.6588943817685617e-02 + 8.4276951515627446e-02 2.6742223034794677e-02 + 8.4175074083035276e-02 2.6926157435056552e-02 + 8.4052812045556188e-02 2.7146877693134286e-02 + 8.3906084757914667e-02 2.7411740414848396e-02 + 8.3729993986200846e-02 2.7729573207913916e-02 + 8.3518659852019422e-02 2.8110968703217054e-02 + 8.3265023782715650e-02 2.8568637283292730e-02 + 8.2960611812127771e-02 2.9117830210985574e-02 + 8.2595250229409389e-02 2.9776847168093923e-02 + 8.2156723949164956e-02 3.0567644986902565e-02 + 8.1630366023301537e-02 3.1516567673939733e-02 + 8.0998564360001343e-02 3.2655221795067746e-02 + 8.0240168883506213e-02 3.4021526037193439e-02 + 7.9329778956455446e-02 3.5660969444023749e-02 + 7.8236886782746221e-02 3.7628119626646153e-02 + 7.6924847557464621e-02 3.9988430413387871e-02 + 7.5349641140685805e-02 4.2820408219932500e-02 + 7.3458382743477393e-02 4.6218208269227304e-02 + 8.8998393437079826e-02 2.7844412803979757e-02 + 8.8993185610801204e-02 2.7854884042022569e-02 + 8.8986936018773832e-02 2.7867449623115811e-02 + 8.8979436226526404e-02 2.7882528454260962e-02 + 8.8970436081429030e-02 2.7900623238223711e-02 + 8.8959595788118018e-02 2.7922321510082688e-02 + 8.8946586739638234e-02 2.7948359825202818e-02 + 8.8930974928388737e-02 2.7979606335122753e-02 + 8.8912239463050963e-02 2.8017102867131882e-02 + 8.8889755172303908e-02 2.8062099668879625e-02 + 8.8862655049602904e-02 2.8116048858429110e-02 + 8.8830134271049216e-02 2.8180787727706047e-02 + 8.8791108433078372e-02 2.8258474141026113e-02 + 8.8744276135288513e-02 2.8351697502579043e-02 + 8.8688075532613431e-02 2.8463565049037243e-02 + 8.8620632177951172e-02 2.8597805393253850e-02 + 8.8539696406585711e-02 2.8758892765431199e-02 + 8.8442568159323234e-02 2.8952196086457604e-02 + 8.8326006719065181e-02 2.9184157831252833e-02 + 8.8186122324417276e-02 2.9462508628157025e-02 + 8.8018246010880305e-02 2.9796524724048368e-02 + 8.7816773292311912e-02 3.0197336862265445e-02 + 8.7574976406856686e-02 3.0678300817875481e-02 + 8.7284778782605682e-02 3.1255441867045874e-02 + 8.6936484090543928e-02 3.1947987899826558e-02 + 8.6518450701379646e-02 3.2779008795465359e-02 + 8.6016700493776660e-02 3.3776183160895812e-02 + 8.5414448709280291e-02 3.4972717697783651e-02 + 8.4691538837398425e-02 3.6408449445332280e-02 + 8.3823763244510949e-02 3.8131167107152919e-02 + 8.2782046323083378e-02 4.0198194812191453e-02 + 8.1531462182059686e-02 4.2678290227499457e-02 + 8.0030053139565724e-02 4.5653919245723498e-02 + 7.8227408259571141e-02 4.9223981908641717e-02 + 9.3443580773566445e-02 2.9778699649938459e-02 + 9.3438748451474485e-02 2.9789523758886691e-02 + 9.3432949539167559e-02 2.9802512747643388e-02 + 9.3425990666604078e-02 2.9818099615751412e-02 + 9.3417639769395891e-02 2.9836803971604917e-02 + 9.3407575466826723e-02 2.9859232316709901e-02 + 9.3395497890377044e-02 2.9886146582498437e-02 + 9.3381004228440909e-02 2.9918444047744686e-02 + 9.3363611053491516e-02 2.9957201478133300e-02 + 9.3342738184077512e-02 3.0003711031362457e-02 + 9.3317572740581112e-02 3.0059466401127111e-02 + 9.3287373711433502e-02 3.0126372583410443e-02 + 9.3251134163821969e-02 3.0206659624781196e-02 + 9.3207645685255303e-02 3.0303003529816408e-02 + 9.3155458048532994e-02 3.0418615429397278e-02 + 9.3092830792565237e-02 3.0557348572727960e-02 + 9.3017675096618790e-02 3.0723826702683255e-02 + 9.2927483997094551e-02 3.0923598084214632e-02 + 9.2819248602488580e-02 3.1163320307186382e-02 + 9.2689357488994248e-02 3.1450982003228489e-02 + 9.2533475888655403e-02 3.1796168840223515e-02 + 9.2346400596825404e-02 3.2210382618828248e-02 + 9.2121885697281941e-02 3.2707424050066436e-02 + 9.1852433210450543e-02 3.3303851889897373e-02 + 9.1529041567812025e-02 3.4019533616643116e-02 + 9.1140903370608026e-02 3.4878305841942847e-02 + 9.0675042146063825e-02 3.5908766238065937e-02 + 9.0115875710736607e-02 3.7145223061202159e-02 + 8.9444691215362832e-02 3.8628833492140302e-02 + 8.8639013885135468e-02 4.0408968165245085e-02 + 8.7671847780108017e-02 4.2544846627052386e-02 + 8.6510762436719568e-02 4.5107497306190729e-02 + 8.5116793839580998e-02 4.8182106213574008e-02 + 8.3443121563124764e-02 5.1870831428538877e-02 + 3.6563363950292876e-01 6.0807128797435439e-02 + 3.6015931947550750e-01 6.0662699928165864e-02 + 3.5418627038115658e-01 6.0501633079411477e-02 + 3.4769635538310084e-01 6.0301155880608789e-02 + 3.4067541471443424e-01 6.0084257155032933e-02 + 3.3311752239148479e-01 5.9820659736884690e-02 + 3.2502284904402784e-01 5.9532227054968336e-02 + 3.1640245101121778e-01 5.9189159347637937e-02 + 3.0727547025938123e-01 5.8812206503532000e-02 + 2.9767332355677728e-01 5.8381690549190055e-02 + 2.8763780527205507e-01 5.7896036390133077e-02 + 2.7722110378361314e-01 5.7361713640240453e-02 + 2.6648607277894243e-01 5.6775630031552282e-02 + 2.5550526722531403e-01 5.6123722315760460e-02 + 2.4435716295595256e-01 5.5416952868419855e-02 + 2.3312591794179932e-01 5.4656385509581185e-02 + 2.2189817009830773e-01 5.3845874276802888e-02 + 2.1076059149393694e-01 5.2989414578405697e-02 + 1.9979723313882050e-01 5.2091136426932055e-02 + 1.8908677149372893e-01 5.1158553864337729e-02 + 1.7870055239062826e-01 5.0199809329997097e-02 + 1.6870286431974307e-01 4.9203620716952085e-02 + 1.5915664221352654e-01 4.8086465253106794e-02 + 1.5013054458458000e-01 4.6690273951661240e-02 + 1.4167709113959487e-01 4.4973564679608419e-02 + 1.3380310435838944e-01 4.3075895117467039e-02 + 1.2649710890188481e-01 4.1123328717605628e-02 + 1.1975199846017322e-01 3.9162902155253559e-02 + 1.1355590438906998e-01 3.7222111600058699e-02 + 1.0788997328352093e-01 3.5324985141500051e-02 + 1.0274064564913195e-01 3.3461406838227958e-02 + 3.6563327132554269e-01 6.0819278905086094e-02 + 3.6015886590810720e-01 6.0675049831594663e-02 + 3.5418572269990534e-01 6.0514187473351910e-02 + 3.4769570423750507e-01 6.0313924872581012e-02 + 3.4067465068566727e-01 6.0097236867470212e-02 + 3.3311663546630144e-01 5.9833853136906846e-02 + 3.2502182957568060e-01 5.9545621967127614e-02 + 3.1640128913782822e-01 5.9202748751721636e-02 + 3.0727415697365501e-01 5.8825967429271327e-02 + 2.9767185047978123e-01 5.8395600184070404e-02 + 2.8763616510037632e-01 5.7910064688421414e-02 + 2.7721929098370773e-01 5.7375820384393705e-02 + 2.6648408375647425e-01 5.6789769467243900e-02 + 2.5550310027997419e-01 5.6137848790186240e-02 + 2.4435481908909670e-01 5.5431012246046407e-02 + 2.3312340082600749e-01 5.4670321162802793e-02 + 2.2189548616135646e-01 5.3859628184426370e-02 + 2.1075774978528489e-01 5.3002929645856678e-02 + 1.9979424503078139e-01 5.2104358799924221e-02 + 1.8908365035927213e-01 5.1171433753990060e-02 + 1.7869731317197632e-01 5.0212302662928941e-02 + 1.6869952217832268e-01 4.9215698519091848e-02 + 1.5915320834873423e-01 4.8098144040366733e-02 + 1.5012701878567597e-01 4.6701646503549896e-02 + 1.4167346338877207e-01 4.4984752489355469e-02 + 1.3379936877621937e-01 4.3086974126053924e-02 + 1.2649326663834540e-01 4.1134333796445224e-02 + 1.1974805207483839e-01 3.9173858053152565e-02 + 1.1355185664646213e-01 3.7233039529396994e-02 + 1.0788582704586330e-01 3.5335902611720357e-02 + 1.0273639996902151e-01 3.3472340185099370e-02 + 3.6563282950811499e-01 6.0833859217865438e-02 + 3.6015832162151373e-01 6.0689869899391624e-02 + 3.5418506547535056e-01 6.0529252929597988e-02 + 3.4769492285434689e-01 6.0329247846020437e-02 + 3.4067373384109628e-01 6.0112812704559648e-02 + 3.3311557114435780e-01 5.9849685397763835e-02 + 3.2502060620015238e-01 5.9561696040634535e-02 + 3.1639989487432774e-01 5.9219056213051374e-02 + 3.0727258101334215e-01 5.8842480713344802e-02 + 2.9767008276777290e-01 5.8412291915146838e-02 + 2.8763419687258257e-01 5.7926898810826799e-02 + 2.7721711559972301e-01 5.7392748636239332e-02 + 2.6648169690306261e-01 5.6806736942533576e-02 + 2.5550049991689738e-01 5.6154800704860008e-02 + 2.4435200641792523e-01 5.5447883636816186e-02 + 2.3312038025376167e-01 5.4687044075940605e-02 + 2.2189226540151782e-01 5.3876132994020075e-02 + 2.1075433969725574e-01 5.3019147838178238e-02 + 1.9979065926150122e-01 5.2120225749605481e-02 + 1.8907990495645530e-01 5.1186889714391351e-02 + 1.7869342606628236e-01 5.0227294746052337e-02 + 1.6869551156371004e-01 4.9230191956468328e-02 + 1.5914908766447919e-01 4.8112158651719042e-02 + 1.5012278777891772e-01 4.6715293625368290e-02 + 1.4166911003811519e-01 4.4998177914713555e-02 + 1.3379488602634396e-01 4.3100268984985007e-02 + 1.2648865586927469e-01 4.1147539935219787e-02 + 1.1974331635820598e-01 3.9187005170659213e-02 + 1.1354699929976361e-01 3.7246153080978506e-02 + 1.0788085150391923e-01 3.5349003609084648e-02 + 1.0273130509486415e-01 3.3485460231545972e-02 + 3.6563229932062974e-01 6.0851355855845668e-02 + 3.6015766846932851e-01 6.0707654243600473e-02 + 3.5418427679577141e-01 6.0547331739670085e-02 + 3.4769398518241834e-01 6.0347635676151853e-02 + 3.4067263361328942e-01 6.0131503969770794e-02 + 3.3311429394130915e-01 5.9868684369546316e-02 + 3.2501913813019007e-01 5.9580985184889738e-02 + 3.1639822173604015e-01 5.9238625419125640e-02 + 3.0727068983596345e-01 5.8862296901963707e-02 + 2.9766796148532815e-01 5.8432322234466469e-02 + 2.8763183496795935e-01 5.7947099992908591e-02 + 2.7721450510444740e-01 5.7413062765668599e-02 + 2.6647883264119310e-01 5.6827098130924014e-02 + 2.5549737944008133e-01 5.6175143210346334e-02 + 2.4434863116805994e-01 5.5468129502500574e-02 + 2.3311675551945932e-01 5.4707111756499671e-02 + 2.2188840043901153e-01 5.3895938937685649e-02 + 2.1075024753788510e-01 5.3038609828014845e-02 + 1.9978635628174149e-01 5.2139266234996519e-02 + 1.8907541041365597e-01 5.1205436999272609e-02 + 1.7868876147756757e-01 5.0245285365109055e-02 + 1.6869069876184825e-01 4.9247584187995297e-02 + 1.5914414277683656e-01 4.8128976280274585e-02 + 1.5011771050200723e-01 4.6731670256434640e-02 + 1.4166388594619980e-01 4.5014288501640298e-02 + 1.3378950665310804e-01 4.3116222884974548e-02 + 1.2648312287085128e-01 4.1163387364487311e-02 + 1.1973763342061369e-01 3.9202781768607253e-02 + 1.1354117040414499e-01 3.7261889394571139e-02 + 1.0787488077218944e-01 3.5364724852840347e-02 + 1.0272519116276593e-01 3.3501204329994039e-02 + 3.6563166308632555e-01 6.0872352196938095e-02 + 3.6015688467496615e-01 6.0728995832349142e-02 + 3.5418333036588645e-01 6.0569026687034011e-02 + 3.4769285995882843e-01 6.0369701446688837e-02 + 3.4067131331944289e-01 6.0153933860490671e-02 + 3.3311276127372824e-01 5.9891483505565418e-02 + 3.2501737641866835e-01 5.9604132523733637e-02 + 3.1639621393855821e-01 5.9262108827026566e-02 + 3.0726842038743607e-01 5.8886076682249044e-02 + 2.9766541590636530e-01 5.8456358963347541e-02 + 2.8762900063785823e-01 5.7971341747375504e-02 + 2.7721137246090161e-01 5.7437440045454480e-02 + 2.6647539547299331e-01 5.6851531868304050e-02 + 2.5549363480915460e-01 5.6199554513696626e-02 + 2.4434458080479107e-01 5.5492424822048747e-02 + 2.3311240577025258e-01 5.4731193236733588e-02 + 2.2188376241141200e-01 5.3919706315610959e-02 + 2.1074533686976601e-01 5.3061964442683691e-02 + 1.9978119262507357e-01 5.2162115025290980e-02 + 1.8907001687748454e-01 5.1227693929935543e-02 + 1.7868316388259639e-01 5.0266874277988677e-02 + 1.6868492330771359e-01 4.9268455017703328e-02 + 1.5913820881644877e-01 4.8149157569682202e-02 + 1.5011161767129130e-01 4.6751322334337417e-02 + 1.4165761693423856e-01 4.5033621314580163e-02 + 1.3378305130030568e-01 4.3135367663245688e-02 + 1.2647648316469526e-01 4.1182404368608080e-02 + 1.1973081378449540e-01 3.9221713766848347e-02 + 1.1353417561563303e-01 3.7280773044017050e-02 + 1.0786771577769871e-01 3.5383590411704781e-02 + 1.0271785432545563e-01 3.3520097308475272e-02 + 3.6563090052014474e-01 6.0897548050995454e-02 + 3.6015594407681756e-01 6.0754605617134416e-02 + 3.5418219355770658e-01 6.0595060101448439e-02 + 3.4769150745993005e-01 6.0396179412649062e-02 + 3.4066972550495533e-01 6.0180848297534173e-02 + 3.3311091728495901e-01 5.9918840526462930e-02 + 3.2501525615720556e-01 5.9631906839821558e-02 + 3.1639379686151720e-01 5.9290285840673335e-02 + 3.0726568772772050e-01 5.8914608721373274e-02 + 2.9766235020510168e-01 5.8485198685268344e-02 + 2.8762558667394938e-01 5.8000426812995443e-02 + 2.7720759869248313e-01 5.7466687026376917e-02 + 2.6647125439053088e-01 5.6880845859538454e-02 + 2.5548912284345709e-01 5.6228840826449300e-02 + 2.4433970000254837e-01 5.5521571183220431e-02 + 2.3310716373211190e-01 5.4760082212368388e-02 + 2.2187817246672167e-01 5.3948217588654777e-02 + 2.1073941779925057e-01 5.3089979624886222e-02 + 1.9977496804119782e-01 5.2189522454342586e-02 + 1.8906351455490933e-01 5.1254390380226833e-02 + 1.7867641486250377e-01 5.0292768381653502e-02 + 1.6867795909690428e-01 4.9293486722845781e-02 + 1.5913105271486253e-01 4.8173361158944786e-02 + 1.5010426932542600e-01 4.6774890237593056e-02 + 1.4165005565954858e-01 4.5056805505026720e-02 + 1.3377526499734951e-01 4.3158325654870794e-02 + 1.2646847431242864e-01 4.1205208511601574e-02 + 1.1972258778527423e-01 3.9244415420297871e-02 + 1.1352573829550271e-01 3.7303416233328161e-02 + 1.0785907316313456e-01 3.5406211482388962e-02 + 1.0270900453954453e-01 3.3542750907329832e-02 + 3.6562998542724007e-01 6.0927783839986205e-02 + 3.6015481534232846e-01 6.0785338124034638e-02 + 3.5418082936758027e-01 6.0626300963683377e-02 + 3.4768988443701210e-01 6.0427953735604931e-02 + 3.4066782009893209e-01 6.0213146382593952e-02 + 3.3310870446517199e-01 5.9951669707337146e-02 + 3.2501271180507740e-01 5.9665236767588621e-02 + 3.1639089632532191e-01 5.9324098995949953e-02 + 3.0726240848659297e-01 5.8948847894370549e-02 + 2.9765867130812795e-01 5.8519807061870197e-02 + 2.8762148985560532e-01 5.8035329583127293e-02 + 2.7720307010243617e-01 5.7501784072570672e-02 + 2.6646628501721636e-01 5.6916023292352236e-02 + 2.5548370840392937e-01 5.6263985016528295e-02 + 2.4433384295293342e-01 5.5556547400101408e-02 + 2.3310087319342654e-01 5.4794749532781850e-02 + 2.2187146443444108e-01 5.3982431630394977e-02 + 2.1073231481058952e-01 5.3123598320759594e-02 + 1.9976749843143532e-01 5.2222411808913939e-02 + 1.8905571165406324e-01 5.1286426522712314e-02 + 1.7866831592032936e-01 5.0323841671116781e-02 + 1.6866960192197739e-01 4.9323525098458443e-02 + 1.5912246526716767e-01 4.8202405762452841e-02 + 1.5009545118086154e-01 4.6803171989537859e-02 + 1.4164098199629882e-01 4.5084626778127135e-02 + 1.3376592129595682e-01 4.3185875469218843e-02 + 1.2645886354782884e-01 4.1232573689522586e-02 + 1.1971271644043086e-01 3.9271657594524528e-02 + 1.1351561336191468e-01 3.7330588235889015e-02 + 1.0784870187274137e-01 3.5433356929445360e-02 + 1.0269838464017433e-01 3.3569935376448257e-02 + 3.6562888729688431e-01 6.0964067873015892e-02 + 3.6015346083738170e-01 6.0822218219939828e-02 + 3.5417919231071743e-01 6.0663791085630692e-02 + 3.4768793677517468e-01 6.0466084008588425e-02 + 3.4066553357121354e-01 6.0251905165500663e-02 + 3.3310604903418822e-01 5.9991065798348814e-02 + 3.2500965852814906e-01 5.9705233744277504e-02 + 3.1638741561976247e-01 5.9364675831722252e-02 + 3.0725847332697337e-01 5.8989935933190740e-02 + 2.9765425655298067e-01 5.8561338122430570e-02 + 2.8761657358600851e-01 5.8077213888843460e-02 + 2.7719763569780059e-01 5.7543901477565385e-02 + 2.6646032166367128e-01 5.6958237124646871e-02 + 2.5547721096182785e-01 5.6306158916740401e-02 + 2.4432681436991227e-01 5.5598519687663384e-02 + 2.3309332441499159e-01 5.4836351096490432e-02 + 2.2186341465550644e-01 5.4023489208852048e-02 + 2.1072379107630174e-01 5.3163941431556526e-02 + 1.9975853474460384e-01 5.2261879656613310e-02 + 1.8904634801128078e-01 5.1324870462391974e-02 + 1.7865859702188916e-01 5.0361130134477378e-02 + 1.6865957313856267e-01 4.9359571614260904e-02 + 1.5911216015117485e-01 4.8237259704876592e-02 + 1.5008486922308018e-01 4.6837110469731144e-02 + 1.4163009341029426e-01 4.5118012650234907e-02 + 1.3375470865824060e-01 4.3218935562029742e-02 + 1.2644733042847323e-01 4.1265412192809867e-02 + 1.1970087061921794e-01 3.9304348470216313e-02 + 1.1350346322896866e-01 3.7363194884662040e-02 + 1.0783625610668807e-01 3.5465931692726806e-02 + 1.0268564053868469e-01 3.3602556949517748e-02 + 3.6562756951386916e-01 6.1007610252943323e-02 + 3.6015183539830092e-01 6.0866475877070059e-02 + 3.5417722780210703e-01 6.0708780773360616e-02 + 3.4768559953253581e-01 6.0511841874813385e-02 + 3.4066278968076075e-01 6.0298417236964337e-02 + 3.3310286245033011e-01 6.0038342629467202e-02 + 3.2500599451887457e-01 5.9753231622916250e-02 + 3.1638323868519830e-01 5.9413369521392902e-02 + 3.0725375103599512e-01 5.9039243040196095e-02 + 2.9764895873531139e-01 5.8611176823305286e-02 + 2.8761067393845041e-01 5.8127476445129389e-02 + 2.7719111427538357e-01 5.7594443707401410e-02 + 2.6645316548966802e-01 5.7008895014867278e-02 + 2.5546941386885536e-01 5.6356768830255533e-02 + 2.4431837989525837e-01 5.5648887602217201e-02 + 2.3308426569364973e-01 5.4886274073766117e-02 + 2.2185375472195054e-01 5.4072759331553782e-02 + 2.1071356238540975e-01 5.3212354118187671e-02 + 1.9974777810040786e-01 5.2309241951456677e-02 + 1.8903511141048074e-01 5.1371003991445771e-02 + 1.7864693410560864e-01 5.0405877017035770e-02 + 1.6864753835233062e-01 4.9402828087586829e-02 + 1.5909979375822222e-01 4.8279085023466464e-02 + 1.5007217061226208e-01 4.6877837176204182e-02 + 1.4161702683728225e-01 4.5158076179390438e-02 + 1.3374125321470365e-01 4.3258608115066238e-02 + 1.2643349039872107e-01 4.1304818801793805e-02 + 1.1968665533941976e-01 3.9343577892920360e-02 + 1.1348888276762163e-01 3.7402323205256306e-02 + 1.0782132087859363e-01 3.5505021723835718e-02 + 1.0267034730130944e-01 3.3641703128495237e-02 + 3.6562598813727870e-01 6.1059863286089922e-02 + 3.6014988482511229e-01 6.0919587245166440e-02 + 3.5417487033512157e-01 6.0762770576943126e-02 + 3.4768279477337027e-01 6.0566753488423317e-02 + 3.4065949693185066e-01 6.0354233887032489e-02 + 3.3309903845579480e-01 6.0095076976536412e-02 + 3.2500159759936437e-01 5.9810831204994440e-02 + 3.1637822623982509e-01 5.9471804048064549e-02 + 3.0724808414652127e-01 5.9098413630145626e-02 + 2.9764260119663577e-01 5.8670985279697149e-02 + 2.8760359418624687e-01 5.8187793472768590e-02 + 2.7718328837528289e-01 5.7655096278196538e-02 + 2.6644457786952219e-01 5.7069686303599099e-02 + 2.5546005712770814e-01 5.6417502464157110e-02 + 2.4430825827832545e-01 5.5709330746488206e-02 + 2.3307339496350460e-01 5.4946183195866638e-02 + 2.2184216252072353e-01 5.4131884925404022e-02 + 2.1070128765976723e-01 5.3270450682461702e-02 + 1.9973486981640054e-01 5.2366077937578616e-02 + 1.8902162716510784e-01 5.1426365350711524e-02 + 1.7863293826924584e-01 5.0459574294280905e-02 + 1.6863309626063303e-01 4.9454736771387946e-02 + 1.5908495372765535e-01 4.8329276227221399e-02 + 1.5005693190921182e-01 4.6926709964125721e-02 + 1.4160134656783974e-01 4.5206153086965468e-02 + 1.3372510628856041e-01 4.3306215793093600e-02 + 1.2641688195749221e-01 4.1352107294765898e-02 + 1.1966959658695732e-01 3.9390653715342810e-02 + 1.1347138578675460e-01 3.7449277662666508e-02 + 1.0780339816771900e-01 3.5551930195580873e-02 + 1.0265199496986462e-01 3.3688678943747163e-02 + 3.6562408889835518e-01 6.1122680017504649e-02 + 3.6014754013652328e-01 6.0983432392774262e-02 + 3.5417203473427572e-01 6.0827667888077031e-02 + 3.4767941954636716e-01 6.0632754655884455e-02 + 3.4065553300293172e-01 6.0421318275942167e-02 + 3.3309443367424957e-01 6.0163259310377505e-02 + 3.2499630171190153e-01 5.9880047923679992e-02 + 3.1637218789153498e-01 5.9542018237762541e-02 + 3.0724125641727568e-01 5.9169505960468723e-02 + 2.9763494043899513e-01 5.8742837275104862e-02 + 2.8759506234487819e-01 5.8260249337863002e-02 + 2.7717385658123261e-01 5.7727947742478136e-02 + 2.6643422732130384e-01 5.7142696598205589e-02 + 2.5544877886337403e-01 5.6490435470102796e-02 + 2.4429605734951468e-01 5.5781906667071723e-02 + 2.3306029027996197e-01 5.5018109519167524e-02 + 2.2182818728333295e-01 5.4202862105029254e-02 + 2.1068648866754489e-01 5.3340184120301823e-02 + 1.9971930591989931e-01 5.2434289921188572e-02 + 1.8900536759668449e-01 5.1492799298291952e-02 + 1.7861606040926378e-01 5.0524003252080028e-02 + 1.6861567866228472e-01 4.9517011826623207e-02 + 1.5906705452896849e-01 4.8389483324463370e-02 + 1.5003855039355435e-01 4.6985328643948762e-02 + 1.4158243144419402e-01 4.5263810974787884e-02 + 1.3370562765875185e-01 4.3363305326166092e-02 + 1.2639684621882841e-01 4.1408808918855226e-02 + 1.1964901741789040e-01 3.9447095612585865e-02 + 1.1345027792159618e-01 3.7505569742059007e-02 + 1.0778177683688869e-01 3.5608163234023472e-02 + 1.0262985573544035e-01 3.3744989225567679e-02 + 3.6562180985228537e-01 6.1198060046180558e-02 + 3.6014472654226121e-01 6.1060046513972566e-02 + 3.5416863203589527e-01 6.0905544597893879e-02 + 3.4767536928646581e-01 6.0711955984899632e-02 + 3.4065077628974511e-01 6.0501819461563695e-02 + 3.3308890792610807e-01 6.0245078020001827e-02 + 3.2498994662406261e-01 5.9963107884608721e-02 + 3.1636494183724156e-01 5.9626275152487793e-02 + 3.0723306309165055e-01 5.9254816631920289e-02 + 2.9762574746430243e-01 5.8829059532101255e-02 + 2.8758482405417385e-01 5.8347196225483344e-02 + 2.7716253833113880e-01 5.7815369335777689e-02 + 2.6642180654952352e-01 5.7230308774478544e-02 + 2.5543524481514657e-01 5.6577954886535053e-02 + 2.4428141608657258e-01 5.5868997567870338e-02 + 2.3304456449382852e-01 5.5104420890472745e-02 + 2.2181141681505595e-01 5.4288034491868621e-02 + 2.1066872967590686e-01 5.3423864005665900e-02 + 1.9970062902584221e-01 5.2516144051240367e-02 + 1.8898585587918135e-01 5.1572519775849937e-02 + 1.7859580672518705e-01 5.0601317733858522e-02 + 1.6859477727585037e-01 4.9591741618307754e-02 + 1.5904557520648482e-01 4.8461731560237822e-02 + 1.5001649227579048e-01 4.7055670772138555e-02 + 1.4155973298298605e-01 4.5333000145106279e-02 + 1.3368225297726224e-01 4.3431812462869125e-02 + 1.2637280299476275e-01 4.1476850557120241e-02 + 1.1962432206629225e-01 3.9514825571372175e-02 + 1.1342494812453471e-01 3.7573119912351918e-02 + 1.0775583087176133e-01 3.5675642548490295e-02 + 1.0260328827773817e-01 3.3812561225623483e-02 + 3.6561907505542740e-01 6.1288516010158389e-02 + 3.6014135027517347e-01 6.1151983378969987e-02 + 3.5416454883049164e-01 6.0998996558204510e-02 + 3.4767050899263835e-01 6.0806997476163346e-02 + 3.4064506823621693e-01 6.0598420767661150e-02 + 3.3308227701357118e-01 6.0343260340714508e-02 + 3.2498232048571463e-01 6.0062779691573087e-02 + 3.1635624651986560e-01 5.9727383287649857e-02 + 3.0722323102816040e-01 5.9357189257958805e-02 + 2.9761471580049981e-01 5.8932526042681829e-02 + 2.8757253798871851e-01 5.8451532274077067e-02 + 2.7714895629114150e-01 5.7920275012051547e-02 + 2.6640690145955448e-01 5.7335443130881458e-02 + 2.5541900376886484e-01 5.6682977911847843e-02 + 2.4426384635771181e-01 5.5973506355385894e-02 + 2.3302569331190681e-01 5.5207994224332431e-02 + 2.2179129198928235e-01 5.4390241026879983e-02 + 2.1064741859691855e-01 5.3524279522705123e-02 + 1.9967821643897690e-01 5.2614368647071565e-02 + 1.8896244147963168e-01 5.1668183975398574e-02 + 1.7857150194165747e-01 5.0694094726844455e-02 + 1.6856969522611920e-01 4.9681416973179342e-02 + 1.5901979961087515e-01 4.8548429038831400e-02 + 1.4999002210451268e-01 4.7140080911944424e-02 + 1.4153249437963469e-01 4.5416026724652010e-02 + 1.3365420289098381e-01 4.3514020590896742e-02 + 1.2634395064020940e-01 4.1558500076038674e-02 + 1.1959468714282075e-01 3.9596101064310600e-02 + 1.1339455185198523e-01 3.7654179649002861e-02 + 1.0772469518421864e-01 3.5756617248537709e-02 + 1.0257140678711035e-01 3.3893647138967253e-02 + 3.6561579338328459e-01 6.1397063065612656e-02 + 3.6013729882109652e-01 6.1262307501237956e-02 + 3.5415964903100655e-01 6.1111138779097018e-02 + 3.4766467666603107e-01 6.0921047116828206e-02 + 3.4063821857519749e-01 6.0714342167201903e-02 + 3.3307431989739655e-01 6.0461078937285855e-02 + 3.2497316907246282e-01 6.0182385649613937e-02 + 3.1634581206394974e-01 5.9848712816054465e-02 + 3.0721143244757354e-01 5.9480036150581679e-02 + 2.9760147766862943e-01 5.9056685570745046e-02 + 2.8755779454252522e-01 5.8576735220739806e-02 + 2.7713265764205558e-01 5.8046161484341496e-02 + 2.6638901511596297e-01 5.7461603991484367e-02 + 2.5539951424248508e-01 5.6809005147265168e-02 + 2.4424276237628945e-01 5.6098916478177330e-02 + 2.3300304755066609e-01 5.5332281776266264e-02 + 2.2176714181902119e-01 5.4512888395137835e-02 + 2.1062184488656630e-01 5.3644777646013858e-02 + 1.9965132088327148e-01 5.2732237643533388e-02 + 1.8893434371337828e-01 5.1782980477281623e-02 + 1.7854233568004613e-01 5.0805426564161600e-02 + 1.6853959621140469e-01 4.9789026830311105e-02 + 1.5898886830870573e-01 4.8652465431260353e-02 + 1.4995825728071824e-01 4.7241372483973962e-02 + 1.4149980740866033e-01 4.5515658008795708e-02 + 1.3362054211384311e-01 4.3612669716984222e-02 + 1.2630932711642895e-01 4.1656478855354284e-02 + 1.1955912451352871e-01 3.9693630997254543e-02 + 1.1335807558279884e-01 3.7751450659825755e-02 + 1.0768733159796094e-01 3.5853786201606369e-02 + 1.0253314821987435e-01 3.3990949534555170e-02 + 3.6561185549768316e-01 6.1527319386485146e-02 + 3.6013243717163151e-01 6.1394696281588779e-02 + 3.5415376933928672e-01 6.1245709254961866e-02 + 3.4765767791154528e-01 6.1057906471418719e-02 + 3.4062999898685287e-01 6.0853447605339124e-02 + 3.3306477132774659e-01 6.0602460982315420e-02 + 3.2496218730866294e-01 6.0325912496803392e-02 + 3.1633329060905885e-01 5.9994307913810274e-02 + 3.0719727400077895e-01 5.9627452049625003e-02 + 2.9758559171588145e-01 5.9205676594899601e-02 + 2.8754010216631504e-01 5.8726978308357047e-02 + 2.7711309897422648e-01 5.8197224762963629e-02 + 2.6636755116519817e-01 5.7612996496033020e-02 + 2.5537612642154794e-01 5.6960237261499458e-02 + 2.4421746115776274e-01 5.6249408017862379e-02 + 2.3297587214419507e-01 5.5481426192969259e-02 + 2.2173816106951788e-01 5.4660064555363923e-02 + 2.1059115583684543e-01 5.3789374678686656e-02 + 1.9961904556751303e-01 5.2873679693264598e-02 + 1.8890062569418412e-01 5.1920735505977665e-02 + 1.7850733541664615e-01 5.0939023971296848e-02 + 1.6850347659594134e-01 4.9918157840466097e-02 + 1.5895174990168637e-01 4.8777308264895694e-02 + 1.4992013860353895e-01 4.7362921513133913e-02 + 1.4146058211356563e-01 4.5635214670099185e-02 + 1.3358014821307049e-01 4.3731047765297390e-02 + 1.2626777788406776e-01 4.1774052464755518e-02 + 1.1951644832167116e-01 3.9810665969112265e-02 + 1.1331430299303206e-01 3.7868174904239743e-02 + 1.0764249420021209e-01 3.5970387956744759e-02 + 1.0248723682021803e-01 3.4107711401254903e-02 + 3.6560713020902863e-01 6.1683626762139454e-02 + 3.6012660332965668e-01 6.1553562578801291e-02 + 3.5414671380661655e-01 6.1407193554110506e-02 + 3.4764927946017438e-01 6.1222137389023587e-02 + 3.4062013548790704e-01 6.1020373784053401e-02 + 3.3305331300075153e-01 6.0772119046886793e-02 + 3.2494900909484281e-01 6.0498144278415156e-02 + 3.1631826470842084e-01 6.0169021547337116e-02 + 3.0718028364916733e-01 5.9804350593367257e-02 + 2.9756652829331742e-01 5.9384465234799663e-02 + 2.8751887096888468e-01 5.8907269368589255e-02 + 2.7708962815771027e-01 5.8378499995185962e-02 + 2.6634179393787011e-01 5.7794666741557421e-02 + 2.5534806047713382e-01 5.7141714980986080e-02 + 2.4418709906211139e-01 5.6429996991326448e-02 + 2.3294326094820997e-01 5.5660398564114651e-02 + 2.2170338338675954e-01 5.4836674966836134e-02 + 2.1055432811897287e-01 5.3962890088684226e-02 + 1.9958031425628980e-01 5.3043409079515193e-02 + 1.8886016306576980e-01 5.2086040427366198e-02 + 1.7846533402379494e-01 5.1099339712288576e-02 + 1.6846013191104175e-01 5.0073113875200352e-02 + 1.5890720659982988e-01 4.8927118460468946e-02 + 1.4987439491393226e-01 4.7508779114679087e-02 + 1.4141351042313841e-01 4.5778681398019057e-02 + 1.3353167414070991e-01 4.3873100124058581e-02 + 1.2621791736277810e-01 4.1915139464062119e-02 + 1.1946523540189660e-01 3.9951106571854078e-02 + 1.1326177435240609e-01 3.8008242603851009e-02 + 1.0758868775051687e-01 3.6110308640601801e-02 + 1.0243214153265033e-01 3.4247824191062648e-02 + 3.6560146011291345e-01 6.1871195312072302e-02 + 3.6011960291691314e-01 6.1744201791725573e-02 + 3.5413824730764809e-01 6.1600974322224999e-02 + 3.4763920139638649e-01 6.1419214047532464e-02 + 3.4060829929964292e-01 6.1220684699662638e-02 + 3.3303956294640130e-01 6.0975708164412182e-02 + 3.2493319509865742e-01 6.0704821790852820e-02 + 3.1630023340564817e-01 6.0378677212027568e-02 + 3.0715989491798029e-01 6.0016628076269125e-02 + 2.9754365178526931e-01 5.9599010755519530e-02 + 2.8749339303529403e-01 5.9123617713197518e-02 + 2.7706146258188996e-01 5.8596029263959792e-02 + 2.6631088456672192e-01 5.8012669943302342e-02 + 2.5531438054074707e-01 5.7359487068467274e-02 + 2.4415066363776242e-01 5.6646702502064272e-02 + 2.3290412649586595e-01 5.5875164073356139e-02 + 2.2166164904240893e-01 5.5048606049744882e-02 + 2.1051013362501289e-01 5.4171107100210100e-02 + 1.9953383534372340e-01 5.3247082798848801e-02 + 1.8881160646773790e-01 5.2284404731946593e-02 + 1.7841493080567591e-01 5.1291716950545393e-02 + 1.6840811664261079e-01 5.0259059423005840e-02 + 1.5885375289482193e-01 4.9106888962221276e-02 + 1.4981950065225830e-01 4.7683806462188713e-02 + 1.4135702247527163e-01 4.5950839650771354e-02 + 1.3347350325544832e-01 4.4043561085557563e-02 + 1.2615808266537415e-01 4.2084441947078180e-02 + 1.1940377775851942e-01 4.0119633333708084e-02 + 1.1319873778186036e-01 3.8176321838569713e-02 + 1.0752411775237121e-01 3.6278211415087434e-02 + 1.0236602487785657e-01 3.4415957452509360e-02 + 3.6559465635748789e-01 6.2096277139914946e-02 + 3.6011120270589764e-01 6.1972968353572355e-02 + 3.5412808771064458e-01 6.1833510682454573e-02 + 3.4762710783212114e-01 6.1655705401747682e-02 + 3.4059409588922729e-01 6.1461057081458943e-02 + 3.3302306279260357e-01 6.1220014300629365e-02 + 3.2491421810343613e-01 6.0952833906763822e-02 + 3.1627859552398946e-01 6.0630263009676631e-02 + 3.0713542799699695e-01 6.0271359949339694e-02 + 2.9751619940044882e-01 5.9856464162393749e-02 + 2.8746281880233537e-01 5.9383234393024509e-02 + 2.7702766303562421e-01 5.8857062934379201e-02 + 2.6627379231911269e-01 5.8274272213644451e-02 + 2.5527396346441261e-01 5.7620811882294731e-02 + 2.4410693982295029e-01 5.6906747306562977e-02 + 2.3285716369312429e-01 5.6132880762831412e-02 + 2.2161156621439798e-01 5.5302921320091583e-02 + 2.1045709846301583e-01 5.4420965384707989e-02 + 1.9947805872645011e-01 5.3491489041186703e-02 + 1.8875333647726245e-01 5.2522439594650805e-02 + 1.7835444472371234e-01 5.1522567262155129e-02 + 1.6834569595681012e-01 5.0482191644228340e-02 + 1.5878960594685157e-01 4.9322611071815473e-02 + 1.4975362490511834e-01 4.7893836727276082e-02 + 1.4128923418231926e-01 4.6157426935600494e-02 + 1.3340369532400218e-01 4.4248111551403013e-02 + 1.2608627805396527e-01 4.2287602170925656e-02 + 1.1933002551468355e-01 4.0321862626909122e-02 + 1.1312309073610564e-01 3.8378014036836959e-02 + 1.0744663051204564e-01 3.6479691801673618e-02 + 1.0228668157624227e-01 3.4617714365637646e-02 + 3.6558649236825230e-01 6.2366374713143102e-02 + 3.6010112286142593e-01 6.2247487518831690e-02 + 3.5411589648472452e-01 6.2112553508349322e-02 + 3.4761259571698511e-01 6.1939494113346413e-02 + 3.4057705181987524e-01 6.1749502909805035e-02 + 3.3300326248187234e-01 6.1513180507872113e-02 + 3.2489144542313314e-01 6.1250447153962433e-02 + 3.1625262961013334e-01 6.0932164529929202e-02 + 3.0710606705613280e-01 6.0577036606971849e-02 + 2.9748325571404960e-01 6.0165406500004778e-02 + 2.8742612870086126e-01 5.9694772491639014e-02 + 2.7698710235359353e-01 5.9170301251427304e-02 + 2.6622928018454090e-01 5.8588192678655560e-02 + 2.5522546131957025e-01 5.7934399227676181e-02 + 2.4405446937256606e-01 5.7218798472064236e-02 + 2.3280080623562199e-01 5.6442138027385631e-02 + 2.2155146450425797e-01 5.5608096726970833e-02 + 2.1039345373053100e-01 5.4720792264490503e-02 + 1.9941112402816849e-01 5.3784773338649706e-02 + 1.8868340951500112e-01 5.2808078118776650e-02 + 1.7828185824004431e-01 5.1799584222011391e-02 + 1.6827078774269333e-01 5.0749946806839016e-02 + 1.5871262601965813e-01 4.9581474019518637e-02 + 1.4967457023068159e-01 4.8145869376206449e-02 + 1.4120788427727426e-01 4.6405327912282086e-02 + 1.3331992168977180e-01 4.4493568245391919e-02 + 1.2600010825250935e-01 4.2531390477012064e-02 + 1.1924151841464529e-01 4.0564533722429581e-02 + 1.1303230974570080e-01 3.8620040528726571e-02 + 1.0735364117128147e-01 3.6721464034172827e-02 + 1.0219146485651404e-01 3.4859818346760101e-02 + 3.6557669632446843e-01 6.2690490911343488e-02 + 3.6008902763576967e-01 6.2576909500009492e-02 + 3.5410126743157733e-01 6.2447403742176277e-02 + 3.4759518141256923e-01 6.2280039255988115e-02 + 3.4055659897124491e-01 6.2095636425169534e-02 + 3.3297950192945652e-01 6.1864978296212611e-02 + 3.2486411779813518e-01 6.1607581195228731e-02 + 3.1622146986106309e-01 6.1294444290225000e-02 + 3.0707083301693056e-01 6.0943846311879060e-02 + 2.9744372210925119e-01 6.0536134789955995e-02 + 2.8738209911516699e-01 6.0068615455293184e-02 + 2.7693842777769356e-01 5.9546184232246446e-02 + 2.6617586356315764e-01 5.8964893989688960e-02 + 2.5516725637634846e-01 5.8310700547970384e-02 + 2.4399150214802312e-01 5.7593256133955606e-02 + 2.3273317428484522e-01 5.6813242773699826e-02 + 2.2147933913160481e-01 5.5974303021770401e-02 + 2.1031707641328246e-01 5.5080580119466024e-02 + 1.9933079843716212e-01 5.4136709905472237e-02 + 1.8859949289724057e-01 5.3150839588216842e-02 + 1.7819474989308462e-01 5.2131999666401599e-02 + 1.6818089302390354e-01 5.1071247966852848e-02 + 1.5862024496056853e-01 4.9892104405316232e-02 + 1.4957969920485253e-01 4.8448303280679270e-02 + 1.4111025872285779e-01 4.6702803672388722e-02 + 1.3321938742647627e-01 4.4788110722662380e-02 + 1.2589669837163150e-01 4.2823930748528451e-02 + 1.1913530357526189e-01 4.0855733206461228e-02 + 1.1292336605413686e-01 3.8910466359339653e-02 + 1.0724204729165936e-01 3.7011584630640422e-02 + 1.0207719797116740e-01 3.5150336921986984e-02 + 3.6556494213957225e-01 6.3079429073894744e-02 + 3.6007451420951198e-01 6.2972214418913097e-02 + 3.5408371316920706e-01 6.2849222362828527e-02 + 3.4757428458467865e-01 6.2688691545929473e-02 + 3.4053205560495159e-01 6.2510994521851007e-02 + 3.3295098901172021e-01 6.2287133259146150e-02 + 3.2483132406497423e-01 6.2036139381401054e-02 + 3.1618407722982916e-01 6.1729177039231649e-02 + 3.0702855086814840e-01 6.1384014677748969e-02 + 2.9739628009356012e-01 6.0981005125867668e-02 + 2.8732926151699933e-01 6.0517223055342129e-02 + 2.7688001577075860e-01 5.9997239500638955e-02 + 2.6611176066833392e-01 5.9416930898521514e-02 + 2.5509740705180356e-01 5.8762257112590532e-02 + 2.4391593763507768e-01 5.8042599959648555e-02 + 2.3265201164514468e-01 5.7258562763777845e-02 + 2.2139278392887893e-01 5.6413744550170120e-02 + 2.1022541842175907e-01 5.5512319222188952e-02 + 1.9923440206600154e-01 5.4559027190081856e-02 + 1.8849878684973098e-01 5.3562146512572656e-02 + 1.7809021333564273e-01 5.2530891148159890e-02 + 1.6807301239708483e-01 5.1456802123979781e-02 + 1.5850938031741635e-01 5.0264853466366347e-02 + 1.4946584621465864e-01 4.8811216387790055e-02 + 1.4099309993734646e-01 4.7059766808246042e-02 + 1.3309873785522811e-01 4.5141553712780356e-02 + 1.2577259774838101e-01 4.3174970890194661e-02 + 1.1900783671490184e-01 4.1205164209299761e-02 + 1.1279262430786431e-01 3.9258968792544660e-02 + 1.0710812507961190e-01 3.7359720606360669e-02 + 1.0194006793587942e-01 3.5498950300237191e-02 + 3.6555083865024501e-01 6.3546153042580045e-02 + 3.6005709931133806e-01 6.3446578232060347e-02 + 3.5406264891954187e-01 6.3331402328707043e-02 + 3.4754920887843138e-01 6.3179071596977096e-02 + 3.4050260364410284e-01 6.3009421195360307e-02 + 3.3291677314986079e-01 6.2793715796749777e-02 + 3.2479197075456823e-01 6.2550405384068919e-02 + 3.1613920474175350e-01 6.2250852086114937e-02 + 3.0697781043027705e-01 6.1912212009843724e-02 + 2.9733934725968802e-01 6.1514844344713979e-02 + 2.8726585340389182e-01 6.1055546496163515e-02 + 2.7680991776510705e-01 6.0538499637118548e-02 + 2.6603483297683089e-01 5.9959368492272347e-02 + 2.5501358300979465e-01 5.9304117782481569e-02 + 2.4382525472159622e-01 5.8581804841324470e-02 + 2.3255461032780295e-01 5.7792938558307597e-02 + 2.2128891088205938e-01 5.6941065730996013e-02 + 2.1011542137655731e-01 5.6030397063935866e-02 + 1.9911871831944253e-01 5.5065798458913441e-02 + 1.8837793085556026e-01 5.4055704999353485e-02 + 1.7796476010685042e-01 5.3009550798585915e-02 + 1.6794354567913189e-01 5.1919456721563652e-02 + 1.5837633219569594e-01 5.0712141708878292e-02 + 1.4932921152232428e-01 4.9246701232441112e-02 + 1.4085249777373252e-01 4.7488111403090574e-02 + 1.3295394626895990e-01 4.5565673836192679e-02 + 1.2562366445470541e-01 4.3596207305834855e-02 + 1.1885486352593835e-01 4.1624469379902086e-02 + 1.1263572087894518e-01 3.9677159413073551e-02 + 1.0694740474791682e-01 3.7777471224146035e-02 + 1.0177549790657769e-01 3.5917273553799582e-02 + 3.6553391666180557e-01 6.4106219192126446e-02 + 3.6003620317570073e-01 6.4015811817128565e-02 + 3.5403737306433442e-01 6.3910014881656707e-02 + 3.4751911873482833e-01 6.3767523795462452e-02 + 3.4046726141082817e-01 6.3607528844442943e-02 + 3.3287571360713719e-01 6.3401609943510448e-02 + 3.2474474560154321e-01 6.3167519110247788e-02 + 3.1608535586056691e-01 6.2876856046037585e-02 + 3.0691691925322029e-01 6.2546042058208531e-02 + 2.9727102441278791e-01 6.2155443971541033e-02 + 2.8718975939206787e-01 6.1701526478145752e-02 + 2.7672579502149874e-01 6.1188002926407137e-02 + 2.6594251372315647e-01 6.0610283995579550e-02 + 2.5491298722769418e-01 5.9954340243052684e-02 + 2.4371642737087440e-01 5.9228839635494523e-02 + 2.3243771996062190e-01 5.8434177751948389e-02 + 2.2116425350450472e-01 5.7573838727741279e-02 + 2.0998341426877742e-01 5.6652077438656710e-02 + 1.9897988624650756e-01 5.5673910384251492e-02 + 1.8823289117597963e-01 5.4647961084004819e-02 + 1.7781420285509988e-01 5.3583927841303239e-02 + 1.6778817137376670e-01 5.2474627323150148e-02 + 1.5821665937023444e-01 5.1248872340394783e-02 + 1.4916523401946596e-01 4.9769267423293670e-02 + 1.4068375856608012e-01 4.8002108886009712e-02 + 1.3278017906801109e-01 4.6074601527662955e-02 + 1.2544492656839629e-01 4.4101674132160443e-02 + 1.1867127717782276e-01 4.2127618312275995e-02 + 1.1244741770396464e-01 4.0178970502501861e-02 + 1.0675452079807311e-01 3.8278753945839059e-02 + 1.0157799387677785e-01 3.6419243083365409e-02 + 3.6551361342788180e-01 6.4778294838376382e-02 + 3.6001113031305310e-01 6.4698887843832154e-02 + 3.5400704382729331e-01 6.4604345073639990e-02 + 3.4748301157989564e-01 6.4473660906756422e-02 + 3.4042485091399732e-01 6.4325251784076304e-02 + 3.3282644144187468e-01 6.4131075906373194e-02 + 3.2468807374405123e-01 6.3908047737786480e-02 + 3.1602073450832363e-01 6.3628052064912691e-02 + 3.0684384606615372e-01 6.3306628444443763e-02 + 2.9718903208709163e-01 6.2924152867310554e-02 + 2.8709844048365868e-01 6.2476690778765942e-02 + 2.7662484040562579e-01 6.1967394151011490e-02 + 2.6583172202846289e-01 6.1391368821695380e-02 + 2.5479226240263630e-01 6.0734592363672846e-02 + 2.4358582334569576e-01 6.0005265521581919e-02 + 2.3229743898481731e-01 5.9203647917897249e-02 + 2.2101465078110236e-01 5.8333148509064077e-02 + 2.0982499053793438e-01 5.7398075190349847e-02 + 1.9881327123860321e-01 5.6403625190008945e-02 + 1.8805882574104091e-01 5.5358648160325659e-02 + 1.7763351506146416e-01 5.4273159438694638e-02 + 1.6760170187783910e-01 5.3140810649523612e-02 + 1.5802503045654631e-01 5.1892927209721065e-02 + 1.4896843836058801e-01 5.0396324442999671e-02 + 1.4048124780542373e-01 4.8618882870684242e-02 + 1.3257163373539441e-01 4.6685291151745252e-02 + 1.2523041550428321e-01 4.4708210121267217e-02 + 1.1845094712070647e-01 4.2731372254618857e-02 + 1.1222142668500176e-01 4.0781118483791887e-02 + 1.0652303214727106e-01 3.8880267362664173e-02 + 1.0134096049789251e-01 3.7021580159759530e-02 + 3.6548925406243504e-01 6.5584780287835542e-02 + 3.5998104646342394e-01 6.5518572972621314e-02 + 3.5397065131458250e-01 6.5437534345960557e-02 + 3.4743968446511547e-01 6.5321017542572676e-02 + 3.4037395859942265e-01 6.5186510392152147e-02 + 3.3276731384596508e-01 6.5006425032108406e-02 + 3.2462006514886010e-01 6.4796670869437537e-02 + 3.1594318506364266e-01 6.4529474790460450e-02 + 3.0675615288016622e-01 6.4219318263880470e-02 + 2.9709063431674188e-01 6.3846588285258563e-02 + 2.8698884912454775e-01 6.3406871216891147e-02 + 2.7650368444497198e-01 6.2902645398331458e-02 + 2.6569875976721102e-01 6.2328650876352754e-02 + 2.5464737853670355e-01 6.1670873658627556e-02 + 2.4342908256069018e-01 6.0936953849903830e-02 + 2.3212908396169984e-01 6.0126987947576566e-02 + 2.2083510775710199e-01 5.9244294716272558e-02 + 2.0963486040698506e-01 5.8293245694785285e-02 + 1.9861330969441643e-01 5.7279255002258146e-02 + 1.8784992183196125e-01 5.6211443663802048e-02 + 1.7741666250779764e-01 5.5100207466410762e-02 + 1.6737790951572226e-01 5.3940199976054398e-02 + 1.5779504509043205e-01 5.2665761681886650e-02 + 1.4873225128509140e-01 5.1148760749619257e-02 + 1.4023820110162014e-01 4.9358978696090926e-02 + 1.3232134414765917e-01 4.7418084868495552e-02 + 1.2497296574256186e-01 4.5436018620210954e-02 + 1.1818651337107609e-01 4.3455841474238088e-02 + 1.1195019868378198e-01 4.1503659761971068e-02 + 1.0624520598710467e-01 3.9602046412880919e-02 + 1.0105647976280961e-01 3.7744346869935434e-02 + 3.6546002928498544e-01 6.6552555242267886e-02 + 3.5994495098159174e-01 6.6502186429133303e-02 + 3.5392698399415551e-01 6.6437351550220569e-02 + 3.4738769405571790e-01 6.6337834236790613e-02 + 3.4031288825710876e-01 6.6220007989031021e-02 + 3.3269635934540492e-01 6.6056829659166733e-02 + 3.2453845150127664e-01 6.5863002595723030e-02 + 3.1585012032475479e-01 6.5611164200723687e-02 + 3.0665091346053647e-01 6.5314526255761368e-02 + 2.9697254709311682e-01 6.4953488969564419e-02 + 2.8685732719000695e-01 6.4523063823678228e-02 + 2.7635828249435346e-01 6.4024920825850984e-02 + 2.6553918768556073e-01 6.3453361100755501e-02 + 2.5447349789910528e-01 6.2794380801406646e-02 + 2.4324097094627475e-01 6.2054947302797814e-02 + 2.3192703256117544e-01 6.1234961385210375e-02 + 2.2061962804608104e-01 6.0337633615617635e-02 + 2.0940667346617772e-01 5.9367411934183691e-02 + 1.9837332238077598e-01 5.8329970752845163e-02 + 1.8759920104349628e-01 5.7234756763381946e-02 + 1.7715640076305428e-01 5.6092622304917489e-02 + 1.6710931748688185e-01 5.4899423262881573e-02 + 1.5751901903243329e-01 5.3593118133662201e-02 + 1.4844878087595814e-01 5.2051638335292680e-02 + 1.3994649699414080e-01 5.0247046502611997e-02 + 1.3202094658997415e-01 4.8297388889863062e-02 + 1.2466397413076774e-01 4.6309339154066785e-02 + 1.1786913927118364e-01 4.4325153693360930e-02 + 1.1162466992020717e-01 4.2370657321867233e-02 + 1.0591175800856407e-01 4.0468128223537181e-02 + 1.0071504501212594e-01 3.8611612823785876e-02 + 3.6542496878630953e-01 6.7713874408447339e-02 + 3.5990164375797756e-01 6.7682510205408164e-02 + 3.5387458851490372e-01 6.7637118072056523e-02 + 3.4732530864480404e-01 6.7557998219996293e-02 + 3.4023960452196811e-01 6.7460186960225474e-02 + 3.3261121203446470e-01 6.7317294789211751e-02 + 3.2444051044736161e-01 6.7142577799625736e-02 + 3.1573843501868942e-01 6.6909166007028426e-02 + 3.0652461542567350e-01 6.6628747594599122e-02 + 2.9683082842306002e-01 6.6281738637869111e-02 + 2.8669948345220592e-01 6.5862460788544297e-02 + 2.7618377919497911e-01 6.5371614095255381e-02 + 2.6534767657887165e-01 6.4802973014934651e-02 + 2.5426481278990876e-01 6.4142545909035675e-02 + 2.4301520486753711e-01 6.3396492931275361e-02 + 2.3168453490421703e-01 6.2564480048898516e-02 + 2.2036101256854437e-01 6.1649588038605721e-02 + 2.0913280547607327e-01 6.0656356563947328e-02 + 1.9808529014098719e-01 5.9590772422184336e-02 + 1.8729828488807040e-01 5.8462673133010942e-02 + 1.7684403179097097e-01 5.7283458916125553e-02 + 1.6678694860198659e-01 5.6050428425393886e-02 + 1.5718772586748572e-01 5.4705881651912605e-02 + 1.4810855122161001e-01 5.3135025688874279e-02 + 1.3959638385506370e-01 5.1312660402643789e-02 + 1.3166039848429276e-01 4.9352484452554211e-02 + 1.2429311053917749e-01 4.7357252777220631e-02 + 1.1748821427537505e-01 4.5368255650618340e-02 + 1.1123395710985812e-01 4.3410980071185636e-02 + 1.0551154011768886e-01 4.1507350533784279e-02 + 1.0030524117432536e-01 3.9652254604071388e-02 + 3.6538290936681778e-01 6.9107442126863816e-02 + 3.5984968560538255e-01 6.9098881181581362e-02 + 3.5381172155184965e-01 6.9076817840183935e-02 + 3.4725045061138421e-01 6.9022172189306716e-02 + 3.4015166509229428e-01 6.8948375920711999e-02 + 3.3250903265008958e-01 6.8829823885159264e-02 + 3.2432297465184690e-01 6.8678035488528341e-02 + 3.1560440195153028e-01 6.8466731874891301e-02 + 3.0637304267513743e-01 6.8205772946725904e-02 + 2.9666074627708511e-01 6.7875593835523759e-02 + 2.8651004638741223e-01 6.7469688435799924e-02 + 2.7597434563815743e-01 6.6987592901298854e-02 + 2.6511782848229615e-01 6.6422449743356538e-02 + 2.5401435059869637e-01 6.5760282022161221e-02 + 2.4274424013330220e-01 6.5006281304164304e-02 + 2.3139348684325753e-01 6.4159831848954282e-02 + 2.2005061767141657e-01 6.3223858752408893e-02 + 2.0880410212782838e-01 6.2203011806042159e-02 + 1.9773958430559410e-01 6.1103652718345593e-02 + 1.8693711304587707e-01 5.9936088042558185e-02 + 1.7646911136866172e-01 5.8712375480937752e-02 + 1.6640002322128514e-01 5.7431544988034607e-02 + 1.5679008646699064e-01 5.6041106184892456e-02 + 1.4770018340091504e-01 5.4434996648069486e-02 + 1.3917615153425245e-01 5.2591300763644579e-02 + 1.3122764019819985e-01 5.0618500244055009e-02 + 1.2384796995575680e-01 4.8614647734101041e-02 + 1.1703099658022034e-01 4.6619874195850487e-02 + 1.1076499089470900e-01 4.4659261255886248e-02 + 1.0503116494092161e-01 4.2754308990012493e-02 + 9.9813360283060801e-02 4.0900914276797082e-02 + 3.6533245684059812e-01 7.0779701787813565e-02 + 3.5978735083645297e-01 7.0798501509599987e-02 + 3.5373629210763102e-01 7.0804429150072679e-02 + 3.4716062742871900e-01 7.0779148615031304e-02 + 3.4004613942022960e-01 7.0734166064425952e-02 + 3.3238641385593548e-01 7.0644817547040537e-02 + 3.2418192262648843e-01 7.0520538473435534e-02 + 3.1544354731008428e-01 7.0335759330851663e-02 + 3.0619113418488603e-01 7.0098146138178552e-02 + 2.9645661996673706e-01 6.9788156916565910e-02 + 2.8628268734043411e-01 6.9398292307283782e-02 + 2.7572298371150261e-01 6.8926691870146328e-02 + 2.6484196180303943e-01 6.8365739861569352e-02 + 2.5371373953046639e-01 6.7701477049965320e-02 + 2.4241901841396263e-01 6.6937932809267409e-02 + 2.3104415745678691e-01 6.6074153447331752e-02 + 2.1967806437980714e-01 6.5112877339615655e-02 + 2.0840957101458729e-01 6.4058886517104133e-02 + 1.9732464259531388e-01 6.2918992652144595e-02 + 1.8650360462637408e-01 6.1704065195147088e-02 + 1.7601909730340518e-01 6.0426950864951666e-02 + 1.6593559604903271e-01 5.9088757146035786e-02 + 1.5631279556656480e-01 5.7643244980710058e-02 + 1.4721001184639196e-01 5.5994828056924448e-02 + 1.3867173647529107e-01 5.4125531957254100e-02 + 1.3070818832032302e-01 5.2137578297226136e-02 + 1.2331365407252864e-01 5.0123377209910017e-02 + 1.1648218332103404e-01 4.8121668535993006e-02 + 1.1020207497172546e-01 4.6157047466080417e-02 + 1.0445455421674175e-01 4.4250504784223030e-02 + 9.9222939060712875e-02 4.2399148465150895e-02 + 3.6527194050996314e-01 7.2786382946510741e-02 + 3.5971257051457128e-01 7.2838010857509516e-02 + 3.5364579239670185e-01 7.2877522599988254e-02 + 3.4705284895825361e-01 7.2887474618461554e-02 + 3.3991951118228558e-01 7.2877062450444799e-02 + 3.3223926658086950e-01 7.2822751543781553e-02 + 3.2401264767445176e-01 7.2731476555195490e-02 + 3.1525050092330670e-01 7.2578519168003910e-02 + 3.0597281440739588e-01 7.2368912816571554e-02 + 2.9621162958695729e-01 7.2083143021835369e-02 + 2.8600980805244097e-01 7.1712518599852615e-02 + 2.7542129098468510e-01 7.1253503312213695e-02 + 2.6451085308631522e-01 7.0697571623249189e-02 + 2.5335292702009882e-01 7.0030785651027827e-02 + 2.4202866242044391e-01 6.9255780298732361e-02 + 2.3062486145441369e-01 6.8371196471552834e-02 + 2.1923088884487366e-01 6.7379548618788976e-02 + 2.0793601127665032e-01 6.6285777581955058e-02 + 1.9682657941841786e-01 6.5097235090044364e-02 + 1.8598325083152187e-01 6.3825466152411345e-02 + 1.7547892637854973e-01 6.2484264360833930e-02 + 1.6537811931028598e-01 6.1077230191877260e-02 + 1.5573987262288413e-01 5.9565625837535670e-02 + 1.4662162288647446e-01 5.7866435648442391e-02 + 1.3806624670822437e-01 5.5966414317644701e-02 + 1.3008464639555672e-01 5.3960271686263696e-02 + 1.2267226794771725e-01 5.1933647217747361e-02 + 1.1582339352505625e-01 4.9923611482591619e-02 + 1.0952635572637509e-01 4.7954175963040635e-02 + 1.0376239551091843e-01 4.6045720308683050e-02 + 9.8514202632007081e-02 4.4196805696238052e-02 + 3.6519935879467930e-01 7.5194357618471486e-02 + 3.5962286457069637e-01 7.5285372818008511e-02 + 3.5353721507529251e-01 7.5365178282822853e-02 + 3.4692352832043211e-01 7.5417401441654860e-02 + 3.3976756130721375e-01 7.5448465106489865e-02 + 3.3206268362883634e-01 7.5436189949157850e-02 + 3.2380950056370972e-01 7.5384509779195849e-02 + 3.1501881644871116e-01 7.5269727692748589e-02 + 3.0571078955295544e-01 7.5093718129892212e-02 + 2.9591758707336407e-01 7.4836999657335909e-02 + 2.8568228534298140e-01 7.4489451012894392e-02 + 2.7505917813915098e-01 7.4045525162901527e-02 + 2.6411342661758092e-01 7.3495604983676799e-02 + 2.5291984122710343e-01 7.2825778355181114e-02 + 2.4156010943015624e-01 7.2037007044073689e-02 + 2.3012156528602673e-01 7.1127445671379602e-02 + 2.1869412201586114e-01 7.0099340172398314e-02 + 2.0736756822261046e-01 6.8957822136889807e-02 + 1.9622871718729482e-01 6.7710891505002507e-02 + 1.8535862502485084e-01 6.6370904074107714e-02 + 1.7483050547678228e-01 6.4952789759403287e-02 + 1.6470891726872303e-01 6.3463140565183179e-02 + 1.5505212146778000e-01 6.1872219704000038e-02 + 1.4591529954590249e-01 6.0112095364011957e-02 + 1.3733939031994929e-01 5.8175196705739896e-02 + 1.2933611622147187e-01 5.6147219928333526e-02 + 1.2190231435453289e-01 5.4105680182640295e-02 + 1.1503254595370380e-01 5.2085645022579438e-02 + 1.0871518404046489e-01 5.0110425500859479e-02 + 1.0293148847554801e-01 4.8199667928699091e-02 + 9.7663395140220446e-02 4.6353677163011725e-02 + 3.6511231433835356e-01 7.8083867517854344e-02 + 3.5951526063839356e-01 7.8222138226010429e-02 + 3.5340695414926859e-01 7.8350285983034951e-02 + 3.4676836310342674e-01 7.8453223310233966e-02 + 3.3958522770000410e-01 7.8534045778475489e-02 + 3.3185077602256913e-01 7.8572200250874358e-02 + 3.2356570066238022e-01 7.8568019600387701e-02 + 3.1474075543373414e-01 7.8499032587117268e-02 + 3.0539630287058145e-01 7.8363323009142435e-02 + 2.9556466111450153e-01 7.8141449153363851e-02 + 2.8528916426783563e-01 7.7821573822348000e-02 + 2.7462452931598114e-01 7.7395737258754593e-02 + 2.6363638126699240e-01 7.6853012663981701e-02 + 2.5239998403740688e-01 7.6179519034567988e-02 + 2.4099767061024219e-01 7.5374210697674485e-02 + 2.2951741344881507e-01 7.4434659016333268e-02 + 2.1804978410561296e-01 7.3362787989524489e-02 + 2.0668519761651521e-01 7.2163958354766800e-02 + 1.9551102252402563e-01 7.0846948109662605e-02 + 1.8460879332588581e-01 6.9425086163358199e-02 + 1.7405209932759766e-01 6.7914666127592740e-02 + 1.6390555393773129e-01 6.6325869750713265e-02 + 1.5422648007673026e-01 6.4639760788857359e-02 + 1.4506735338987020e-01 6.2806506672885107e-02 + 1.3646678760834283e-01 6.0825345262529043e-02 + 1.2843748930707613e-01 5.8771157078481122e-02 + 1.2097796482255778e-01 5.6711708793411121e-02 + 1.1408311026241603e-01 5.4679664493938122e-02 + 1.0774134714306632e-01 5.2697494747062701e-02 + 1.0193395798025473e-01 5.0783965889777669e-02 + 9.6641974051628374e-02 4.8941474965218362e-02 + 3.6500793660756703e-01 8.1551196331574261e-02 + 3.5938619705089925e-01 8.1746160659164957e-02 + 3.5325068637590507e-01 8.1932304854724691e-02 + 3.4658219303618848e-01 8.2096083426186794e-02 + 3.3936643703537112e-01 8.2236599295079260e-02 + 3.3159647663602865e-01 8.2335250644916508e-02 + 3.2327310920955454e-01 8.2388049336606289e-02 + 3.1440702797871278e-01 8.2373994882686569e-02 + 3.0501884064801488e-01 8.2286622523056907e-02 + 2.9514104657735879e-01 8.2106538301246701e-02 + 2.8481728930088029e-01 8.1819846120914974e-02 + 2.7410279378229291e-01 8.1415691281847558e-02 + 2.6306374180360809e-01 8.0881575701653219e-02 + 2.5177594161562511e-01 8.0203656002744594e-02 + 2.4032250100220798e-01 7.9378478043302905e-02 + 2.2879215869674724e-01 7.8402913676939190e-02 + 2.1727627643452999e-01 7.7278500976221076e-02 + 2.0586602115283864e-01 7.6010876009650299e-02 + 1.9464942788340153e-01 7.4609750732137797e-02 + 1.8370860534765515e-01 7.3089622022835948e-02 + 1.7311759367918922e-01 7.1468420082276315e-02 + 1.6294107206362612e-01 6.9760634225900786e-02 + 1.5323523788039695e-01 6.7960287898706895e-02 + 1.4404932019241809e-01 6.6039265695124513e-02 + 1.3541914299940619e-01 6.4004974976569345e-02 + 1.2735859384065731e-01 6.1919318427249709e-02 + 1.1986818199845736e-01 5.9838365530918244e-02 + 1.1294320540534694e-01 5.7791896428573276e-02 + 1.0657214375482396e-01 5.5801373146370584e-02 + 1.0073630671087912e-01 5.3884506097176314e-02 + 9.5415640089018691e-02 5.2046202622278735e-02 + 3.6488278963899512e-01 8.5711875907804824e-02 + 3.5923140696308720e-01 8.5974854413393587e-02 + 3.5306322936001483e-01 8.6230574317980313e-02 + 3.4635882948844887e-01 8.6467340339368093e-02 + 3.3910390307192734e-01 8.6679464274261847e-02 + 3.3129130457440537e-01 8.6850685737857508e-02 + 3.2292195711042637e-01 8.6971831532032001e-02 + 3.1400648124225466e-01 8.7023666010011685e-02 + 3.0456577895234738e-01 8.6994266438317397e-02 + 2.9463256718044722e-01 8.6864296298209354e-02 + 2.8425086092927887e-01 8.6617389127425781e-02 + 2.7347649491483056e-01 8.6239216750982450e-02 + 2.6237631925777510e-01 8.5715396003521960e-02 + 2.5102679564929181e-01 8.5032129060863326e-02 + 2.3951196187827420e-01 8.4183072261609496e-02 + 2.2792147645836475e-01 8.3164258610565978e-02 + 2.1634764960024519e-01 8.1976763626955496e-02 + 2.0488255077429993e-01 8.0626554273646595e-02 + 1.9361501504179038e-01 7.9124463659966809e-02 + 1.8262784041909635e-01 7.7486390560466939e-02 + 1.7199560824296123e-01 7.5732229297649875e-02 + 1.6178307684909235e-01 7.3881638090867369e-02 + 1.5204509329558588e-01 7.1944190658172147e-02 + 1.4282699131824692e-01 6.9917829480786509e-02 + 1.3416124776105912e-01 6.7819764004227012e-02 + 1.2606316731042227e-01 6.5696324881570858e-02 + 1.1853566259564748e-01 6.3589546351732390e-02 + 1.1157451370613694e-01 6.1525748122849042e-02 + 1.0516827012534365e-01 5.9525182030786689e-02 + 9.9298274042213031e-02 5.7604291442295272e-02 + 9.3943168806574537e-02 5.5770995599928562e-02 +-2.7075699320875515e-02 -1.0884787268268814e-01 +-2.8095626054097062e-02 -1.0914485269614789e-01 +-2.9181649916326453e-02 -1.0944426943734814e-01 +-3.0333438931910654e-02 -1.0975337197703700e-01 +-3.1549253061618834e-02 -1.1008464646144699e-01 +-3.2830951260286630e-02 -1.1043630208709747e-01 +-3.4179839649187166e-02 -1.1080709644234646e-01 +-3.5598928966453822e-02 -1.1118784542442853e-01 +-3.7088466759815454e-02 -1.1157757128411989e-01 +-3.8647420266930230e-02 -1.1197830715389535e-01 +-4.0274927291254640e-02 -1.1238967467240556e-01 +-4.1974461582403991e-02 -1.1279057878856856e-01 +-4.3741414082185431e-02 -1.1318971644090658e-01 +-4.5575159514134739e-02 -1.1357623182842552e-01 +-4.7470865868062824e-02 -1.1395497765872997e-01 +-4.9424254831575719e-02 -1.1432592268003298e-01 +-5.1431815808237781e-02 -1.1468152119634077e-01 +-5.3489942659636656e-02 -1.1500904376047240e-01 +-5.5594265157906275e-02 -1.1529433887074708e-01 +-5.7739094958705099e-02 -1.1552030562432324e-01 +-5.9917119403930699e-02 -1.1566996719115087e-01 +-6.2118396990012384e-02 -1.1574256171216715e-01 +-6.4333121297647650e-02 -1.1575719033955126e-01 +-6.6551538434933930e-02 -1.1568982565604956e-01 +-6.8760945619045555e-02 -1.1551416541652998e-01 +-7.0941175878472873e-02 -1.1517906332902640e-01 +-7.3065153385953888e-02 -1.1465450689972952e-01 +-7.5120914803605568e-02 -1.1398068843359022e-01 +-7.7072478634648500e-02 -1.1312494805354431e-01 +-7.8890097661373240e-02 -1.1208621439015197e-01 +-8.0549880093559872e-02 -1.1088478016866306e-01 +-2.7072315071679835e-02 -1.0885928789605252e-01 +-2.8092391371063428e-02 -1.0915626560591855e-01 +-2.9178517278825550e-02 -1.0945578520659274e-01 +-3.0330296770792350e-02 -1.0976499161042035e-01 +-3.1546083706706633e-02 -1.1009623803339462e-01 +-3.2827772144721087e-02 -1.1044787817181419e-01 +-3.4176709934857816e-02 -1.1081861993472217e-01 +-3.5595870743324563e-02 -1.1119938715637959e-01 +-3.7085464661731765e-02 -1.1158914688805543e-01 +-3.8644465785412842e-02 -1.1198989764004919e-01 +-4.0272115597363906e-02 -1.1240118345545305e-01 +-4.1971782529120726e-02 -1.1280218219739190e-01 +-4.3738884034900623e-02 -1.1320130499675793e-01 +-4.5572766866032656e-02 -1.1358788739948465e-01 +-4.7468588475434031e-02 -1.1396666617376219e-01 +-4.9422110340722684e-02 -1.1433760885392658e-01 +-5.1429854110215487e-02 -1.1469318965692989e-01 +-5.3488225668055903e-02 -1.1502069733993750e-01 +-5.5592864257355983e-02 -1.1530597060042791e-01 +-5.7738084816415298e-02 -1.1553191575013565e-01 +-5.9916527450529757e-02 -1.1568161289922456e-01 +-6.2118164559823823e-02 -1.1575430753935058e-01 +-6.4333259628444911e-02 -1.1576883786701278e-01 +-6.6552170854752776e-02 -1.1570134455422987e-01 +-6.8762254232770076e-02 -1.1552540347205471e-01 +-7.0943364703627734e-02 -1.1519001202072601e-01 +-7.3068270250037468e-02 -1.1466536943161407e-01 +-7.5124878136880263e-02 -1.1399106070094912e-01 +-7.7077432094744089e-02 -1.1313479176117944e-01 +-7.8896064048255971e-02 -1.1209546424731438e-01 +-8.0556761547246850e-02 -1.1089302040652804e-01 +-2.7068214124151412e-02 -1.0887283735919681e-01 +-2.8088509268224014e-02 -1.0916996221528669e-01 +-2.9174757009238706e-02 -1.0946960409489460e-01 +-3.0326525996399394e-02 -1.0977893389333593e-01 +-3.1542280635431706e-02 -1.1011014804040391e-01 +-3.2823957698921616e-02 -1.1046176917224594e-01 +-3.4172954461348243e-02 -1.1083244871299773e-01 +-3.5592200758948714e-02 -1.1121323735500342e-01 +-3.7081862079567450e-02 -1.1160303747121424e-01 +-3.8640921068242809e-02 -1.1200380556205668e-01 +-4.0268741510210364e-02 -1.1241499519859494e-01 +-4.1968567760214376e-02 -1.1281610558505865e-01 +-4.3735847909270147e-02 -1.1321521178792288e-01 +-4.5569895548472988e-02 -1.1360187388199662e-01 +-4.7465855705593016e-02 -1.1398069219289007e-01 +-4.9419537238772793e-02 -1.1435163219206318e-01 +-5.1427500422952521e-02 -1.1470719185326546e-01 +-5.3486165675290638e-02 -1.1503468163990438e-01 +-5.5591183587644963e-02 -1.1531992873978898e-01 +-5.7736872794160857e-02 -1.1554584827620749e-01 +-5.9915816783719177e-02 -1.1569558814871074e-01 +-6.2117885701003094e-02 -1.1576840156276276e-01 +-6.4333426300027474e-02 -1.1578281482808310e-01 +-6.6552930786673584e-02 -1.1571516660742007e-01 +-6.8763825764807371e-02 -1.1553888936315670e-01 +-7.0945991610005449e-02 -1.1520315184252874e-01 +-7.3072010210554317e-02 -1.1467840276939360e-01 +-7.5129635172830403e-02 -1.1400350763222858e-01 +-7.7083376687115027e-02 -1.1314660439733953e-01 +-7.8903223754708804e-02 -1.1210656239437029e-01 +-8.0565020826782907e-02 -1.1090290883669911e-01 +-2.7063236839938297e-02 -1.0888888878752982e-01 +-2.8083849499995022e-02 -1.0918639780062633e-01 +-2.9170243113557714e-02 -1.0948618671049815e-01 +-3.0322000800133156e-02 -1.0979566282416987e-01 +-3.1537717172474423e-02 -1.1012684020274054e-01 +-3.2819381067205958e-02 -1.1047843795229829e-01 +-3.4168448157518454e-02 -1.1084904407954753e-01 +-3.5587796613003000e-02 -1.1122985776852604e-01 +-3.7077538894040696e-02 -1.1161970596506089e-01 +-3.8636668346798790e-02 -1.1202049413616823e-01 +-4.0264692533670127e-02 -1.1243157099294795e-01 +-4.1964710172154494e-02 -1.1283281266271271e-01 +-4.3732204459862145e-02 -1.1323190067721806e-01 +-4.5566449768458889e-02 -1.1361865737447258e-01 +-4.7462576527330151e-02 -1.1399752313050758e-01 +-4.9416449928819828e-02 -1.1436846009610414e-01 +-5.1424676502580126e-02 -1.1472399455080329e-01 +-5.3483694255638613e-02 -1.1505146280717353e-01 +-5.5589167373885674e-02 -1.1533667860028986e-01 +-5.7735418579943805e-02 -1.1556256784561826e-01 +-5.9914963524308258e-02 -1.1571235901503001e-01 +-6.2117551154799888e-02 -1.1578531300989170e-01 +-6.4333627275503055e-02 -1.1579958706920400e-01 +-6.6553844183645391e-02 -1.1573175218092140e-01 +-6.8765713316921717e-02 -1.1555507275739083e-01 +-7.0949144355609561e-02 -1.1521892160570679e-01 +-7.3076497777606678e-02 -1.1469404035879086e-01 +-7.5135345094509393e-02 -1.1401844424138886e-01 +-7.7090510833827230e-02 -1.1316077981761410e-01 +-7.8911815475138050e-02 -1.1211987777589220e-01 +-8.0574934151641880e-02 -1.1091477513935563e-01 +-2.7057185273691005e-02 -1.0890786155413018e-01 +-2.8078255054339644e-02 -1.0920611677990269e-01 +-2.9164824197452376e-02 -1.0950608574816717e-01 +-3.0316570169807142e-02 -1.0981573498807723e-01 +-3.1532241336964840e-02 -1.1014687098604546e-01 +-3.2813890110892266e-02 -1.1049843990541659e-01 +-3.4163040973497032e-02 -1.1086895969589659e-01 +-3.5582511406431989e-02 -1.1124980252035270e-01 +-3.7072350956237003e-02 -1.1163970785793814e-01 +-3.8631566413130522e-02 -1.1204051911671010e-01 +-4.0259833669353234e-02 -1.1245146434625757e-01 +-4.1960081256718948e-02 -1.1285285977565085e-01 +-4.3727832179360410e-02 -1.1325192838490671e-01 +-4.5562314549897058e-02 -1.1363879716216285e-01 +-4.7458641722178674e-02 -1.1401771984638392e-01 +-4.9412745749299027e-02 -1.1438865343448608e-01 +-5.1421288524140712e-02 -1.1474415787533367e-01 +-5.3480729374603506e-02 -1.1507160021963082e-01 +-5.5586748763392327e-02 -1.1535677856990129e-01 +-5.7733673826410092e-02 -1.1558263210011109e-01 +-5.9913938961415968e-02 -1.1573248485602698e-01 +-6.2117149823592607e-02 -1.1580560478276783e-01 +-6.4333869839075131e-02 -1.1581971358240156e-01 +-6.6554942386204755e-02 -1.1575165360274876e-01 +-6.8767980833470799e-02 -1.1557449330100386e-01 +-7.0952928314085423e-02 -1.1523784812201480e-01 +-7.3081882324103842e-02 -1.1471280204289701e-01 +-7.5142199106778815e-02 -1.1403636857276503e-01 +-7.7099072729126375e-02 -1.1317779067091426e-01 +-7.8922125664206574e-02 -1.1213585283009014e-01 +-8.0586833258252014e-02 -1.1092901493378067e-01 +-2.7049813182927131e-02 -1.0893022994095641e-01 +-2.8071536225823594e-02 -1.0922976893069197e-01 +-2.9158318292105218e-02 -1.0952996434298579e-01 +-3.0310052827890951e-02 -1.0983981799430240e-01 +-3.1525670794085012e-02 -1.1017090814204177e-01 +-3.2807302387344896e-02 -1.1052244144663738e-01 +-3.4156552900285658e-02 -1.1089286009174223e-01 +-3.5576168834936188e-02 -1.1127373659573886e-01 +-3.7066125281640487e-02 -1.1166370969242707e-01 +-3.8625445976222798e-02 -1.1206454726650407e-01 +-4.0254002917876723e-02 -1.1247533973894096e-01 +-4.1954526826203251e-02 -1.1287691439407022e-01 +-4.3722585241059521e-02 -1.1327596309035116e-01 +-4.5557351887836037e-02 -1.1366296434190498e-01 +-4.7453920255583017e-02 -1.1404195531891735e-01 +-4.9408301584184730e-02 -1.1441288522927816e-01 +-5.1417223994833672e-02 -1.1476835398772058e-01 +-5.3477172700913587e-02 -1.1509576513343564e-01 +-5.5583847643322699e-02 -1.1538089873514509e-01 +-5.7731580555061737e-02 -1.1560671030979523e-01 +-5.9912708564170462e-02 -1.1575663699417207e-01 +-6.2116668409643833e-02 -1.1582995212497853e-01 +-6.4334162915770446e-02 -1.1584386512003728e-01 +-6.6556263285477327e-02 -1.1577553351204625e-01 +-6.8770705363903145e-02 -1.1559779863530335e-01 +-7.0957470027451688e-02 -1.1526056389574263e-01 +-7.3088343047004511e-02 -1.1473531122898120e-01 +-7.5150426915684160e-02 -1.1405787831398395e-01 +-7.7109348332911151e-02 -1.1319820416193084e-01 +-7.8934498104501996e-02 -1.1215501807013864e-01 +-8.0601116613650048e-02 -1.1094610295753451e-01 +-2.7040813277579925e-02 -1.0895652535747516e-01 +-2.8063463087349420e-02 -1.0925812773624544e-01 +-2.9150506590128404e-02 -1.0955861800956411e-01 +-3.0302231145787187e-02 -1.0986871257356452e-01 +-3.1517786802328689e-02 -1.1019975294922080e-01 +-3.2799399138217798e-02 -1.1055124220174448e-01 +-3.4148768000250879e-02 -1.1092154288820052e-01 +-3.5568557299896678e-02 -1.1130245803163932e-01 +-3.7058654285346077e-02 -1.1169251125690009e-01 +-3.8618104105964494e-02 -1.1209337851154116e-01 +-4.0247005882804630e-02 -1.1250399491458644e-01 +-4.1947861885461894e-02 -1.1290577729330370e-01 +-4.3716288627326190e-02 -1.1330480676319388e-01 +-4.5551396129396904e-02 -1.1369196416924718e-01 +-4.7448254925234350e-02 -1.1407103704645677e-01 +-4.9402969806101024e-02 -1.1444196307847677e-01 +-5.1412348063196806e-02 -1.1479738949458373e-01 +-5.3472906395091460e-02 -1.1512476306036185e-01 +-5.5580368035339910e-02 -1.1540984323156017e-01 +-5.7729069246013336e-02 -1.1563560574059159e-01 +-5.9911230788075524e-02 -1.1578562114280903e-01 +-6.2116090985398886e-02 -1.1585916499661203e-01 +-6.4334517479054470e-02 -1.1587284652336537e-01 +-6.6557852755849953e-02 -1.1580418686092007e-01 +-6.8773979815930433e-02 -1.1562576602519732e-01 +-7.0962921483229635e-02 -1.1528782838522894e-01 +-7.3096094920061361e-02 -1.1476231544987550e-01 +-7.5160304532546032e-02 -1.1408369073053458e-01 +-7.7121680981506485e-02 -1.1322270096361506e-01 +-7.8949345397263115e-02 -1.1217800953874910e-01 +-8.0618262912964242e-02 -1.1096660887084607e-01 +-2.7029800946635967e-02 -1.0898733726038858e-01 +-2.8053755765242539e-02 -1.0929211064044056e-01 +-2.9141125833477187e-02 -1.0959300078437410e-01 +-3.0292843823337461e-02 -1.0990337905772922e-01 +-3.1508326956856778e-02 -1.1023436688579437e-01 +-3.2789918093589790e-02 -1.1058580163170376e-01 +-3.4139427253195645e-02 -1.1095596548102979e-01 +-3.5559422839683379e-02 -1.1133692455263640e-01 +-3.7049688867541404e-02 -1.1172707220587202e-01 +-3.8609297585950858e-02 -1.1212797251534488e-01 +-4.0238609301057562e-02 -1.1253838765484393e-01 +-4.1939864481238022e-02 -1.1294040916303837e-01 +-4.3708732281037506e-02 -1.1333942197109935e-01 +-4.5544248427163800e-02 -1.1372676286949936e-01 +-4.7441457144195592e-02 -1.1410593391979823e-01 +-4.9396573421525161e-02 -1.1447685605842779e-01 +-5.1406499108455891e-02 -1.1483223234213527e-01 +-5.3467789276730640e-02 -1.1515956062221115e-01 +-5.5576194988935852e-02 -1.1544457706922276e-01 +-5.7726056551523540e-02 -1.1567028251246390e-01 +-5.9909455633420046e-02 -1.1582040432864528e-01 +-6.2115398482549995e-02 -1.1589421489142858e-01 +-6.4334947073564783e-02 -1.1590762350252569e-01 +-6.6559766426610739e-02 -1.1583856729506142e-01 +-6.8777916313866483e-02 -1.1565932832745829e-01 +-7.0969465267414086e-02 -1.1532055355652097e-01 +-7.3105395838670734e-02 -1.1479471098838431e-01 +-7.5172163677127979e-02 -1.1411466658385272e-01 +-7.7136482946632237e-02 -1.1325209790703089e-01 +-7.8967162769278496e-02 -1.1220558969679398e-01 +-8.0638847333280125e-02 -1.1099121620306571e-01 +-2.7016293499628183e-02 -1.0902331264775041e-01 +-2.8042071644905082e-02 -1.0933280066980525e-01 +-2.9129859004656890e-02 -1.0963425621500406e-01 +-3.0281577075362949e-02 -1.0994496910216059e-01 +-3.1496976491216827e-02 -1.1027590361134029e-01 +-3.2778544860839282e-02 -1.1062727098272049e-01 +-3.4128219985194941e-02 -1.1099727707902507e-01 +-3.5548460646782763e-02 -1.1137828554459248e-01 +-3.7038930123248416e-02 -1.1176854399225936e-01 +-3.8598734962395652e-02 -1.1216948055777200e-01 +-4.0228533287664667e-02 -1.1257966793941918e-01 +-4.1930268324781944e-02 -1.1298196253323155e-01 +-4.3699664083456664e-02 -1.1338096405925217e-01 +-4.5535670077617448e-02 -1.1376851980681800e-01 +-4.7433300688309185e-02 -1.1414780845627377e-01 +-4.9388900265695188e-02 -1.1451872700093534e-01 +-5.1399483474549493e-02 -1.1487404408956889e-01 +-5.3461652255321228e-02 -1.1520131777753774e-01 +-5.5571190880071120e-02 -1.1548625833236063e-01 +-5.7722442561342548e-02 -1.1571189785276811e-01 +-5.9907322903154252e-02 -1.1586214721020503e-01 +-6.2114568088628336e-02 -1.1593626697437083e-01 +-6.4335468490580583e-02 -1.1594935474927455e-01 +-6.6562071882357091e-02 -1.1587981878307066e-01 +-6.8782650301982287e-02 -1.1569960517118735e-01 +-7.0977320778978989e-02 -1.1535983459565194e-01 +-7.3116555199803368e-02 -1.1483357236625287e-01 +-7.5186403112455044e-02 -1.1415183882503986e-01 +-7.7154249344376064e-02 -1.1328737519602622e-01 +-7.8988544669345309e-02 -1.1223867241588723e-01 +-8.0663561110757523e-02 -1.1102074505533940e-01 +-2.6999683714223111e-02 -1.0906515424419230e-01 +-2.8027988229766550e-02 -1.0938146846410844e-01 +-2.9116323832185400e-02 -1.0968375378679857e-01 +-3.0268054005068205e-02 -1.0999486366827883e-01 +-3.1483357850678503e-02 -1.1032574730153298e-01 +-3.2764902621627449e-02 -1.1067703162953847e-01 +-3.4114773602639939e-02 -1.1104685717062443e-01 +-3.5535304889280354e-02 -1.1142792043998373e-01 +-3.7026019406853079e-02 -1.1181830817006314e-01 +-3.8586067034502160e-02 -1.1221928378279826e-01 +-4.0216442045776443e-02 -1.1262921656750476e-01 +-4.1918753942655124e-02 -1.1303182009016426e-01 +-4.3688781422138445e-02 -1.1343081977508357e-01 +-4.5525374521177261e-02 -1.1381862608178926e-01 +-4.7423514202385830e-02 -1.1419805546401113e-01 +-4.9379696064598015e-02 -1.1456897121820106e-01 +-5.1391069188912938e-02 -1.1492421863844643e-01 +-5.3454292889135571e-02 -1.1525142649724585e-01 +-5.5565191007750044e-02 -1.1553627683134567e-01 +-5.7718107532572914e-02 -1.1576184083146288e-01 +-5.9904760099289647e-02 -1.1591224287234102e-01 +-6.2113572535483580e-02 -1.1598671859319340e-01 +-6.4336102646212187e-02 -1.1599943043535464e-01 +-6.6564851408731474e-02 -1.1592931353643038e-01 +-6.8788345572134160e-02 -1.1574794040223448e-01 +-7.0986751733105910e-02 -1.1540698681813530e-01 +-7.3129944213949999e-02 -1.1488018766144806e-01 +-7.5203502313290677e-02 -1.1419644700902915e-01 +-7.7175574881953091e-02 -1.1332970904201424e-01 +-7.9014204731412171e-02 -1.1227835287687939e-01 +-8.0693235130159635e-02 -1.1105617928747780e-01 +-2.6979206179547129e-02 -1.0911361782140766e-01 +-2.8010979812876435e-02 -1.0943959330059379e-01 +-2.9100058388039890e-02 -1.0974313117373134e-01 +-3.0251821763419322e-02 -1.1005471844920796e-01 +-3.1467018193953540e-02 -1.1038555858093264e-01 +-3.2748539806723057e-02 -1.1073674109590906e-01 +-3.4098641299892367e-02 -1.1110636170548509e-01 +-3.5519516503100791e-02 -1.1148748480032590e-01 +-3.7010526430734263e-02 -1.1187802233611990e-01 +-3.8570875478740350e-02 -1.1227903909814702e-01 +-4.0201932744182357e-02 -1.1268869152575424e-01 +-4.1904938062942654e-02 -1.1309164067494565e-01 +-4.3675721065842117e-02 -1.1349065362254308e-01 +-4.5513017735330646e-02 -1.1387875084377687e-01 +-4.7411772222991873e-02 -1.1425834841621077e-01 +-4.9368656149146942e-02 -1.1462926296034648e-01 +-5.1380978479501717e-02 -1.1498442870826613e-01 +-5.3445468917521527e-02 -1.1531155718089689e-01 +-5.5557998361468443e-02 -1.1559630050510077e-01 +-5.7712907982183932e-02 -1.1582177888655205e-01 +-5.9901679884931627e-02 -1.1597236339088261e-01 +-6.2112379268541511e-02 -1.1604724542697251e-01 +-6.4336875730732088e-02 -1.1605951835256140e-01 +-6.6568205435374325e-02 -1.1598869747182571e-01 +-6.8795200435972106e-02 -1.1580594705392057e-01 +-7.0998075234002339e-02 -1.1546359001675215e-01 +-7.3146008312719613e-02 -1.1493610081436972e-01 +-7.5224037953575920e-02 -1.1424997855834322e-01 +-7.7201174035651118e-02 -1.1338051078133611e-01 +-7.9044999806399743e-02 -1.1232594333356950e-01 +-8.0728868354228753e-02 -1.1109869904952678e-01 +-2.6953894572514805e-02 -1.0916950945372202e-01 +-2.7990385371439167e-02 -1.0950888137121349e-01 +-2.9080502660066329e-02 -1.0981434224361136e-01 +-3.0232335970031818e-02 -1.1012651806717821e-01 +-3.1447414405139207e-02 -1.1045732953143093e-01 +-3.2728915351616948e-02 -1.1080838829353808e-01 +-3.4079287346672031e-02 -1.1117777853212782e-01 +-3.5500568557779735e-02 -1.1155896564385644e-01 +-3.6991935019685514e-02 -1.1194967523471758e-01 +-3.8552659238746685e-02 -1.1235073427358268e-01 +-4.0184522212257837e-02 -1.1276008363562791e-01 +-4.1888360884898293e-02 -1.1316341453004319e-01 +-4.3660047005577400e-02 -1.1356246348223373e-01 +-4.5498186700640500e-02 -1.1395089686365165e-01 +-4.7397684426362954e-02 -1.1433069507080150e-01 +-4.9355415568461659e-02 -1.1470161114803265e-01 +-5.1368878872823251e-02 -1.1505668160651551e-01 +-5.3434890584332435e-02 -1.1538371436548707e-01 +-5.5549377413544751e-02 -1.1566833113421381e-01 +-5.7706672020449191e-02 -1.1589371370974895e-01 +-5.9897977028897161e-02 -1.1604451571570154e-01 +-6.2110949485031888e-02 -1.1611985678888777e-01 +-6.4337820722272843e-02 -1.1613161919163845e-01 +-6.6572256874082081e-02 -1.1605994471790912e-01 +-6.8803455322026461e-02 -1.1587556136418364e-01 +-7.1011672765962833e-02 -1.1553154172833782e-01 +-7.3165282101598783e-02 -1.1500316232622636e-01 +-7.5248703798209901e-02 -1.1431421821847691e-01 +-7.7231905383200919e-02 -1.1344147374067466e-01 +-7.9081958922188375e-02 -1.1238301589338197e-01 +-8.0771662093084798e-02 -1.1114971967011571e-01 +-2.6922527619137080e-02 -1.0923368377596938e-01 +-2.7965364171410153e-02 -1.0959127966460015e-01 +-2.9056974322390176e-02 -1.0989970992271669e-01 +-3.0208941680974877e-02 -1.1021264043378889e-01 +-3.1423895108095970e-02 -1.1054344952497097e-01 +-3.2705381055357620e-02 -1.1089435982819736e-01 +-3.4056069484651480e-02 -1.1126349393454812e-01 +-3.5477828727567051e-02 -1.1164474787095943e-01 +-3.6969626073757464e-02 -1.1203565285844394e-01 +-3.8530818234138058e-02 -1.1243675410516754e-01 +-4.0163631039322037e-02 -1.1284578330228351e-01 +-4.1868470810686426e-02 -1.1324952968643563e-01 +-4.3641235854698361e-02 -1.1364864733448049e-01 +-4.5480385556644756e-02 -1.1403746722036594e-01 +-4.7380782756099880e-02 -1.1441750417709412e-01 +-4.9339537302692166e-02 -1.1478842622713330e-01 +-5.1354372621406505e-02 -1.1514338615051864e-01 +-5.3422211547618718e-02 -1.1547030359077741e-01 +-5.5539046766132638e-02 -1.1575477124310142e-01 +-5.7699193782943498e-02 -1.1598004837959411e-01 +-5.9893524739253447e-02 -1.1613110872404925e-01 +-6.2109237037860122e-02 -1.1620696190640299e-01 +-6.4338979391011394e-02 -1.1621813274118570e-01 +-6.6577156610862526e-02 -1.1614542297178851e-01 +-6.8813402146574998e-02 -1.1595910766296580e-01 +-7.1028003538800427e-02 -1.1561312117655843e-01 +-7.3188407418627574e-02 -1.1508359005193226e-01 +-7.5278334706326736e-02 -1.1439130730073044e-01 +-7.7268800974750196e-02 -1.1351462934664927e-01 +-7.9126318228930098e-02 -1.1245145369819527e-01 +-8.0823061317218600e-02 -1.1121093809096906e-01 +-2.6883561123989947e-02 -1.0930704438683900e-01 +-2.7934834541918068e-02 -1.0968898471139824e-01 +-2.9028635834757909e-02 -1.1000198176808082e-01 +-3.0180849852980893e-02 -1.1031593250271725e-01 +-3.1395679042585500e-02 -1.1064678392225169e-01 +-3.2677160463959840e-02 -1.1099751958206013e-01 +-3.4028217874856173e-02 -1.1136637247407019e-01 +-3.5450538319274631e-02 -1.1174769401104843e-01 +-3.6942857212643662e-02 -1.1213881775179028e-01 +-3.8504633849946054e-02 -1.1253995989994006e-01 +-4.0138564590484836e-02 -1.1294866053351164e-01 +-4.1844606135662037e-02 -1.1335285178170623e-01 +-4.3618659318478289e-02 -1.1375208328292687e-01 +-4.5459018993332011e-02 -1.1414134532915443e-01 +-4.7360506021131732e-02 -1.1452166547988063e-01 +-4.9320498227128168e-02 -1.1489260036016155e-01 +-5.1336984172642000e-02 -1.1524743296555785e-01 +-5.3407018140570382e-02 -1.1557421166266989e-01 +-5.5526670457404025e-02 -1.1585850445170569e-01 +-5.7690226794486085e-02 -1.1608366800630772e-01 +-5.9888170285962807e-02 -1.1623503365511706e-01 +-6.2107187214866667e-02 -1.1631144937514944e-01 +-6.4340404966717238e-02 -1.1632193712737096e-01 +-6.6583090489333863e-02 -1.1624797187926610e-01 +-6.8825395899426170e-02 -1.1605937632084001e-01 +-7.1047620738328904e-02 -1.1571106597271091e-01 +-7.3216155202262212e-02 -1.1518004215964432e-01 +-7.5313935596684367e-02 -1.1448381460481918e-01 +-7.7313101827514871e-02 -1.1360241424895459e-01 +-7.9179563230767441e-02 -1.1253351216904713e-01 +-8.0884804466777233e-02 -1.1128438824066815e-01 +-2.6835043150543227e-02 -1.0939054740552531e-01 +-2.7897390301975730e-02 -1.0980444750087888e-01 +-2.8994448298849385e-02 -1.1012438455776626e-01 +-3.0147107643394008e-02 -1.1043979802591027e-01 +-3.1361828969385504e-02 -1.1077076795837393e-01 +-3.2643323572052553e-02 -1.1112130419737183e-01 +-3.3994809930564272e-02 -1.1148985276988251e-01 +-3.5417787218849299e-02 -1.1187123994875980e-01 +-3.6910738482435132e-02 -1.1226260418567938e-01 +-3.8473245555794233e-02 -1.1266378499805466e-01 +-4.0108490364789050e-02 -1.1307216081070937e-01 +-4.1815973097800517e-02 -1.1347682007356565e-01 +-4.3591563151073640e-02 -1.1387622551067418e-01 +-4.5433372339105341e-02 -1.1426599098127592e-01 +-4.7336181478690530e-02 -1.1464664567527520e-01 +-4.9297672417487358e-02 -1.1501760360830515e-01 +-5.1316145349747246e-02 -1.1537229083041915e-01 +-5.3388816719638452e-02 -1.1569890300916943e-01 +-5.5511847700576378e-02 -1.1598299199968416e-01 +-5.7679476073778518e-02 -1.1620803660175824e-01 +-5.9881729814635999e-02 -1.1635976056590050e-01 +-6.2104735427795890e-02 -1.1643678243166558e-01 +-6.4342165703892631e-02 -1.1644648361980034e-01 +-6.6590288220951657e-02 -1.1637099705584350e-01 +-6.8839868996918394e-02 -1.1617971737847783e-01 +-7.1071191382032911e-02 -1.1582866403156061e-01 +-7.3249452060694276e-02 -1.1529570478160947e-01 +-7.5356716404728186e-02 -1.1459482126030618e-01 +-7.7366300875227084e-02 -1.1370775053952796e-01 +-7.9243479916670120e-02 -1.1263189231491845e-01 +-8.0958983508509247e-02 -1.1137250698504035e-01 +-2.6774509193757318e-02 -1.0948520903937774e-01 +-2.7851188640256028e-02 -1.0994037895564311e-01 +-2.8953105034320130e-02 -1.1027067302963410e-01 +-3.0106559740749474e-02 -1.1058829648900093e-01 +-3.1321219936518235e-02 -1.1091951827987424e-01 +-3.2602756467388548e-02 -1.1126983754460068e-01 +-3.3954740243076237e-02 -1.1163806236519187e-01 +-3.5378484021223129e-02 -1.1201950980698919e-01 +-3.6872203394608775e-02 -1.1241113243691006e-01 +-3.8435622875255440e-02 -1.1281234959834943e-01 +-4.0072411009845682e-02 -1.1322041990251094e-01 +-4.1781619574921276e-02 -1.1362556296807531e-01 +-4.3559041907262487e-02 -1.1402521933106304e-01 +-4.5402587711122995e-02 -1.1441555559653213e-01 +-4.7307002832999247e-02 -1.1479660351077887e-01 +-4.9270311322421809e-02 -1.1516759928504118e-01 +-5.1291177873567129e-02 -1.1552212226818608e-01 +-5.3367018805465051e-02 -1.1584853537132173e-01 +-5.5494100796525954e-02 -1.1613238872341224e-01 +-5.7666588763344573e-02 -1.1635731341882735e-01 +-5.9873982267362992e-02 -1.1650945395713670e-01 +-6.2101805891018436e-02 -1.1658711323369436e-01 +-6.4344349663244968e-02 -1.1659591001923184e-01 +-6.6599034782939534e-02 -1.1651858290192259e-01 +-6.8857349100426554e-02 -1.1632415298305991e-01 +-7.1099520678416878e-02 -1.1596986360037621e-01 +-7.3289412678477661e-02 -1.1543439743187675e-01 +-7.5408134283720882e-02 -1.1472802214246650e-01 +-7.7430195013235822e-02 -1.1383414151932891e-01 +-7.9320216783997990e-02 -1.1274982850128870e-01 +-8.1048116367924208e-02 -1.1147821258932399e-01 +-2.6698853805854190e-02 -1.0959211828524984e-01 +-2.7793803197880912e-02 -1.1009976345090548e-01 +-2.8902934692142425e-02 -1.1044516846048916e-01 +-3.0057795815343111e-02 -1.1076624982206579e-01 +-3.1272500106654944e-02 -1.1109796431964293e-01 +-3.2554124801170654e-02 -1.1144806771276078e-01 +-3.3906684654227304e-02 -1.1181595542578698e-01 +-3.5331320502237522e-02 -1.1219745377562657e-01 +-3.6825974436965274e-02 -1.1258934610014310e-01 +-3.8390531779882137e-02 -1.1299059879484401e-01 +-4.0029132168584551e-02 -1.1339840135250492e-01 +-4.1740403593807922e-02 -1.1380403701516485e-01 +-4.3520008671681903e-02 -1.1420403915057302e-01 +-4.5365635485054463e-02 -1.1459502051747926e-01 +-4.7272003984948095e-02 -1.1497652786924158e-01 +-4.9237520253063119e-02 -1.1534758229590769e-01 +-5.1261272808817121e-02 -1.1570192221998067e-01 +-5.3340923688286711e-02 -1.1602809873186844e-01 +-5.5472860923206142e-02 -1.1631168243210978e-01 +-5.7651143054561392e-02 -1.1653649263103777e-01 +-5.9864662365755120e-02 -1.1668911133057322e-01 +-6.2098310444767733e-02 -1.1676741998387523e-01 +-6.4347071142194776e-02 -1.1677517625044570e-01 +-6.6609685014199990e-02 -1.1669562800864676e-01 +-6.8878481281899717e-02 -1.1649751233698243e-01 +-7.1133582052994720e-02 -1.1613940482910493e-01 +-7.3337379510036924e-02 -1.1560069991244155e-01 +-7.5469944590752056e-02 -1.1488784701202191e-01 +-7.7506948261032466e-02 -1.1398578589706615e-01 +-7.9412360222775771e-02 -1.1289119353198836e-01 +-8.1155234334986004e-02 -1.1160499801335333e-01 +-2.6604174150946909e-02 -1.0971245696464450e-01 +-2.7722037089660399e-02 -1.1028588900551162e-01 +-2.8841760481201316e-02 -1.1065278705483451e-01 +-2.9999075523183778e-02 -1.1097934989112690e-01 +-3.1214041060709418e-02 -1.1131200042926816e-01 +-3.2495829578811093e-02 -1.1166193037451304e-01 +-3.3849057337847217e-02 -1.1202947770764075e-01 +-3.5274729470131855e-02 -1.1241101341072621e-01 +-3.6770522035510726e-02 -1.1280317720787215e-01 +-3.8336494431092882e-02 -1.1320446847434266e-01 +-3.9977224148572674e-02 -1.1361206119635600e-01 +-4.1690955674754789e-02 -1.1401819402606654e-01 +-4.3473158812934343e-02 -1.1441865397447643e-01 +-4.5321280220562248e-02 -1.1481036292338796e-01 +-4.7230027765555245e-02 -1.1519240346111852e-01 +-4.9198230560326704e-02 -1.1556354504419293e-01 +-5.1225466469903058e-02 -1.1591768440437684e-01 +-5.3309698134318718e-02 -1.1624358218117808e-01 +-5.5447451465429495e-02 -1.1652686142755658e-01 +-5.7632635178725376e-02 -1.1675157095627797e-01 +-5.9853452685019834e-02 -1.1690472917901279e-01 +-6.2094147802924493e-02 -1.1698367150013875e-01 +-6.4350479338587091e-02 -1.1699022654920861e-01 +-6.6622682296512206e-02 -1.1690800771053889e-01 +-6.8904055661079933e-02 -1.1670559352696368e-01 +-7.1174554350621144e-02 -1.1634297696293192e-01 +-7.3394971611038640e-02 -1.1580010516073679e-01 +-7.5544262593129005e-02 -1.1507960514202209e-01 +-7.7599168536808025e-02 -1.1416771383141504e-01 +-7.9523026295121452e-02 -1.1306062440292823e-01 +-8.1283987651162307e-02 -1.1175704187021056e-01 +-2.6485578854490866e-02 -1.0984753102138770e-01 +-2.7631692992088792e-02 -1.1050239999436115e-01 +-2.8766700091781495e-02 -1.1089906729370398e-01 +-2.9928216768956458e-02 -1.1123425676608430e-01 +-3.1143871864062759e-02 -1.1156865654055817e-01 +-3.2425953032108108e-02 -1.1191854219279998e-01 +-3.3779959486723528e-02 -1.1228576396181159e-01 +-3.5206834880328192e-02 -1.1266731980892575e-01 +-3.6704015756215513e-02 -1.1305974493401251e-01 +-3.8271741043347039e-02 -1.1346108458797415e-01 +-3.9914976162323972e-02 -1.1386854553121106e-01 +-4.1631633882520697e-02 -1.1427518173474775e-01 +-4.3416926666942336e-02 -1.1467622609465281e-01 +-4.5268040050929138e-02 -1.1506875483889639e-01 +-4.7179688781276152e-02 -1.1545140968945153e-01 +-4.9151166786493936e-02 -1.1582267640836717e-01 +-5.1182612269190818e-02 -1.1617660089420342e-01 +-5.3272352783587260e-02 -1.1650217437715428e-01 +-5.5417068512844218e-02 -1.1678511584943629e-01 +-5.7610464276131382e-02 -1.1700974868906679e-01 +-5.9839974976061180e-02 -1.1716350181608022e-01 +-6.2089203700740142e-02 -1.1724302472900833e-01 +-6.4354770035611034e-02 -1.1724818362258117e-01 +-6.6638582413009947e-02 -1.1716276922485140e-01 +-6.8935041958586282e-02 -1.1695535734191247e-01 +-7.1223868179591809e-02 -1.1658740607800237e-01 +-7.3464144956252489e-02 -1.1603920326623211e-01 +-7.5633638382192614e-02 -1.1530965796068672e-01 +-7.7710001124563111e-02 -1.1438594887865687e-01 +-7.9655972616909834e-02 -1.1326367263573292e-01 +-8.1438773278738261e-02 -1.1193934056907008e-01 +-2.6336952422782250e-02 -1.0999881812868810e-01 +-2.7517301093910426e-02 -1.1075337183095409e-01 +-2.8673892190017831e-02 -1.1119021705005457e-01 +-2.9842425389936922e-02 -1.1153867951218194e-01 +-3.1059586023208449e-02 -1.1187627938112424e-01 +-3.2342190766137355e-02 -1.1222642643103932e-01 +-3.3697117771059402e-02 -1.1259337353040566e-01 +-3.5125392867446550e-02 -1.1297493112933459e-01 +-3.6624266312306329e-02 -1.1336759479072341e-01 +-3.8194152502020455e-02 -1.1376900234581126e-01 +-3.9840341582737984e-02 -1.1417642790794202e-01 +-4.1560470278748027e-02 -1.1458358428772208e-01 +-4.3349433917254786e-02 -1.1498534981625949e-01 +-4.5204138410816622e-02 -1.1537880180507362e-01 +-4.7119329399433536e-02 -1.1576215937743482e-01 +-4.9094807995671397e-02 -1.1613360042914751e-01 +-5.1131347925359331e-02 -1.1648730157058300e-01 +-5.3227714772106659e-02 -1.1681250440130324e-01 +-5.5380758135512603e-02 -1.1709507961819328e-01 +-5.7583915058971979e-02 -1.1731967062066925e-01 +-5.9823781098769672e-02 -1.1747405956656100e-01 +-6.2083352715787354e-02 -1.1755406173401313e-01 +-6.4360201362376690e-02 -1.1755758144231486e-01 +-6.6658083913452820e-02 -1.1746836582739514e-01 +-6.8972632841323975e-02 -1.1725515903194544e-01 +-7.1283263947111528e-02 -1.1688087937026151e-01 +-7.3547267206922423e-02 -1.1632590264426877e-01 +-7.5741148271054909e-02 -1.1558562521182773e-01 +-7.7843242641326027e-02 -1.1464770074243105e-01 +-7.9815734819850201e-02 -1.1350698367758873e-01 +-8.1624889866552183e-02 -1.1215786606358702e-01 +-2.6150663104947441e-02 -1.1016803515688936e-01 +-2.7371809070592727e-02 -1.1104340123223881e-01 +-2.8558141876708815e-02 -1.1153320711125406e-01 +-2.9738037402491445e-02 -1.1190144385222124e-01 +-3.0958201308002996e-02 -1.1224470915682891e-01 +-3.2241762849092671e-02 -1.1259576857974067e-01 +-3.3597809829437199e-02 -1.1296256979264677e-01 +-3.5027721948188879e-02 -1.1334411714130048e-01 +-3.6528656695373661e-02 -1.1373698643537737e-01 +-3.8101192226143402e-02 -1.1413849319018887e-01 +-3.9750872318813170e-02 -1.1454599511191725e-01 +-4.1475107265991781e-02 -1.1495370991969624e-01 +-4.3268428320458706e-02 -1.1535633847743371e-01 +-4.5127446855694649e-02 -1.1575082914917237e-01 +-4.7046967819494481e-02 -1.1613498537772182e-01 +-4.9027342417046919e-02 -1.1650666273115047e-01 +-5.1070057362191799e-02 -1.1686014149982396e-01 +-5.3174396029987393e-02 -1.1718493116826122e-01 +-5.5337390069750532e-02 -1.1746712099333712e-01 +-5.7552138398293311e-02 -1.1769171454551004e-01 +-5.9804344246625618e-02 -1.1784675420552955e-01 +-6.2076462960089250e-02 -1.1792707391002540e-01 +-6.4367115035435726e-02 -1.1792864495976280e-01 +-6.6682066609669730e-02 -1.1783493764503095e-01 +-6.9018298512515133e-02 -1.1761502494831050e-01 +-7.1354864860906683e-02 -1.1723321340173652e-01 +-7.3647210645915021e-02 -1.1666969505315229e-01 +-7.5870507060061015e-02 -1.1591663135222632e-01 +-7.8003480231429639e-02 -1.1496159479552336e-01 +-8.0007792954289614e-02 -1.1379851051096730e-01 +-8.1848726167748048e-02 -1.1241975472073604e-01 +-2.5917203254725314e-02 -1.1035722384204417e-01 +-2.7186237866533767e-02 -1.1137770623520403e-01 +-2.8412489398453620e-02 -1.1193592761420140e-01 +-2.9610143923768352e-02 -1.1233257634120494e-01 +-3.0835938850062725e-02 -1.1268543475989869e-01 +-3.2121288846942847e-02 -1.1303869095316360e-01 +-3.3478771821607745e-02 -1.1340564695938209e-01 +-3.4910619863709400e-02 -1.1378719952458489e-01 +-3.6414060471315866e-02 -1.1418023939571513e-01 +-3.7989825567123520e-02 -1.1458188912654654e-01 +-3.9643640115429320e-02 -1.1498959161297384e-01 +-4.1372722055615679e-02 -1.1539793470340179e-01 +-4.3171211334898894e-02 -1.1580156951776394e-01 +-4.5035417641028933e-02 -1.1619722551910960e-01 +-4.6960237125859131e-02 -1.1658228466800731e-01 +-4.8946614480912955e-02 -1.1695427440917650e-01 +-5.0996826507711354e-02 -1.1730754598650146e-01 +-5.3110756602707088e-02 -1.1763189112374299e-01 +-5.5285627566631787e-02 -1.1791369116376176e-01 +-5.7514130334396882e-02 -1.1813833655767222e-01 +-5.9781051615312830e-02 -1.1829400118793244e-01 +-6.2068405412754074e-02 -1.1837440267439078e-01 +-6.4375964942906802e-02 -1.1837362698581515e-01 +-6.6711640241160136e-02 -1.1827464793080518e-01 +-6.9073855755455577e-02 -1.1804698226559883e-01 +-7.1441269050560807e-02 -1.1765617537712414e-01 +-7.3767467952201710e-02 -1.1708197180839298e-01 +-7.6026207038831242e-02 -1.1631360036067417e-01 +-7.8196261895988065e-02 -1.1533794572036098e-01 +-8.0238774213573505e-02 -1.1414776746636893e-01 +-8.2117990563208274e-02 -1.1273353399652065e-01 +-2.5624757513118462e-02 -1.1056884585660148e-01 +-2.6949300176630518e-02 -1.1176223792182081e-01 +-2.8227719445547236e-02 -1.1240739888533877e-01 +-2.9452081079293830e-02 -1.1284345863573596e-01 +-3.0687873884365030e-02 -1.1321172755510960e-01 +-3.1976596949314304e-02 -1.1356952332439985e-01 +-3.3336077362610107e-02 -1.1393730077536177e-01 +-3.4770262799075420e-02 -1.1431895639781112e-01 +-3.6276744867013738e-02 -1.1471214710086489e-01 +-3.7856424698081197e-02 -1.1511399619584770e-01 +-3.9515142440654079e-02 -1.1552203460746832e-01 +-4.1249937183261011e-02 -1.1593111356770053e-01 +-4.3054553139395685e-02 -1.1633589889178046e-01 +-4.4925004720243834e-02 -1.1673285550776798e-01 +-4.6856314221221211e-02 -1.1711893145383667e-01 +-4.8850063298353091e-02 -1.1749132519279405e-01 +-5.0909392031375719e-02 -1.1784442515051527e-01 +-5.3034862243528810e-02 -1.1816831577234153e-01 +-5.5223893439693965e-02 -1.1844974187730914e-01 +-5.7468710597454807e-02 -1.1867448423782100e-01 +-5.9753200348811340e-02 -1.1883069016543474e-01 +-6.2059070372828151e-02 -1.1891084784769852e-01 +-6.4387355532890711e-02 -1.1890721461165145e-01 +-6.6748206014795669e-02 -1.1880208522370531e-01 +-6.9141555591218110e-02 -1.1856545171174586e-01 +-7.1545665983780815e-02 -1.1816386829602381e-01 +-7.3912296739638644e-02 -1.1757639940324997e-01 +-7.6213691427659644e-02 -1.1678960873068725e-01 +-7.8428305421427855e-02 -1.1578908431554087e-01 +-8.0516699601276775e-02 -1.1456613150442203e-01 +-8.2441990747640262e-02 -1.1310939464512257e-01 +-2.5258702149899011e-02 -1.1080587406133849e-01 +-2.6646967756322738e-02 -1.1220381315219181e-01 +-2.7991832557708325e-02 -1.1295800932142135e-01 +-2.9254795140309212e-02 -1.1344709735762323e-01 +-3.0507408172681254e-02 -1.1383879866922259e-01 +-3.1802414211857498e-02 -1.1420504421102141e-01 +-3.3164963608073861e-02 -1.1457502504886811e-01 +-3.4602078429998850e-02 -1.1495709502016474e-01 +-3.6112255261614518e-02 -1.1535047020090415e-01 +-3.7696656371694316e-02 -1.1575259129322320e-01 +-3.9361190739557447e-02 -1.1616111313453129e-01 +-4.1102714718625907e-02 -1.1657107302924291e-01 +-4.2914593450243919e-02 -1.1697715787013377e-01 +-4.4792571932788537e-02 -1.1737555570712369e-01 +-4.6731837614631233e-02 -1.1776277322854607e-01 +-4.8734651610122970e-02 -1.1813568022358677e-01 +-5.0805081862678951e-02 -1.1848867239346750e-01 +-5.2944435511156351e-02 -1.1881213261424978e-01 +-5.5150332894829623e-02 -1.1909322499744644e-01 +-5.7414502569832673e-02 -1.1931809123403539e-01 +-5.9719999538971572e-02 -1.1947467757049859e-01 +-6.2048394318141291e-02 -1.1955415759722750e-01 +-6.4402093288055573e-02 -1.1954701955084375e-01 +-6.6793534840557917e-02 -1.1943474380738354e-01 +-6.9224194854599977e-02 -1.1918771566214593e-01 +-7.1671983541609391e-02 -1.1877319239824821e-01 +-7.4086900492335545e-02 -1.1816936423680441e-01 +-7.6439572000800343e-02 -1.1736030798424191e-01 +-7.8707755407196447e-02 -1.1632974851083679e-01 +-8.0851283781371755e-02 -1.1506720019919382e-01 +-8.2831973898109978e-02 -1.1355951695129748e-01 +-2.4801040782109363e-02 -1.1107186947310425e-01 +-2.6261966113682068e-02 -1.1271027648790079e-01 +-2.7689486340413610e-02 -1.1359976148053171e-01 +-2.9006124514742979e-02 -1.1415850305017652e-01 +-3.0285541001133807e-02 -1.1458407097396012e-01 +-3.1591862555321294e-02 -1.1496470170379668e-01 +-3.2959553208913417e-02 -1.1533949822526739e-01 +-3.4400573129177457e-02 -1.1572278234736338e-01 +-3.5915274566052584e-02 -1.1611651842743860e-01 +-3.7505348965824782e-02 -1.1651901819836309e-01 +-3.9176779120499244e-02 -1.1692818664025334e-01 +-4.0926231777301106e-02 -1.1733920387280490e-01 +-4.2746726432595035e-02 -1.1774674783108045e-01 +-4.4633787387270960e-02 -1.1814673119349466e-01 +-4.6582813203217964e-02 -1.1853522688797553e-01 +-4.8596784190073419e-02 -1.1890877779004479e-01 +-5.0680746198086407e-02 -1.1926176400520745e-01 +-5.2836799866093014e-02 -1.1958486540376959e-01 +-5.5062774624110820e-02 -1.1986568929908578e-01 +-5.7349917762999039e-02 -1.2009066969414091e-01 +-5.9680582256991591e-02 -1.2024737779172184e-01 +-6.2036401326569957e-02 -1.2032561725680566e-01 +-6.4421255746445166e-02 -1.2031416840960284e-01 +-6.6849867856949491e-02 -1.2019359769268731e-01 +-6.9325258342080587e-02 -1.1993447718138601e-01 +-7.1825073545334184e-02 -1.1950439650199322e-01 +-7.4297655802872634e-02 -1.1888049880070553e-01 +-7.6711902648281358e-02 -1.1804442945216907e-01 +-7.9044500459864303e-02 -1.1697755180607373e-01 +-8.1254299523739790e-02 -1.1566721840964166e-01 +-8.3301538833713024e-02 -1.1409846016361602e-01 +-2.4229770892593663e-02 -1.1137104409674266e-01 +-2.5773172269374887e-02 -1.1329069275787401e-01 +-2.7301389570040285e-02 -1.1434653135967997e-01 +-2.8690046389709095e-02 -1.1499512523878125e-01 +-3.0009974230043014e-02 -1.1546763658776829e-01 +-3.1335691264184513e-02 -1.1587090501662309e-01 +-3.2712381771155291e-02 -1.1625493272055390e-01 +-3.4159067112916865e-02 -1.1664119640362491e-01 +-3.5679441451499712e-02 -1.1703582013168638e-01 +-3.7276333128695653e-02 -1.1743889733540985e-01 +-3.8955931551423809e-02 -1.1784890112737846e-01 +-4.0714735427844644e-02 -1.1826117537349499e-01 +-4.2545467953381010e-02 -1.1867035289306725e-01 +-4.4443503308423435e-02 -1.1907207219869620e-01 +-4.6404507408277097e-02 -1.1946199594269195e-01 +-4.8432214626599898e-02 -1.1983634892892009e-01 +-5.0532677871442021e-02 -1.2018948025578124e-01 +-5.2708817101888898e-02 -1.2051235248282439e-01 +-5.4958692949867542e-02 -1.2079299316928711e-01 +-5.7273149294248940e-02 -1.2101802048642317e-01 +-5.9634032957716146e-02 -1.2117447296749068e-01 +-6.2023264211276338e-02 -1.2125075817874166e-01 +-6.4446284297662221e-02 -1.2123401037326732e-01 +-6.6920047337419519e-02 -1.2110378717627765e-01 +-6.9449099876537107e-02 -1.2083052934182753e-01 +-7.2010945402771045e-02 -1.2038173405502763e-01 +-7.4552398570337033e-02 -1.1973330562224557e-01 +-7.7040522483694543e-02 -1.1886438555155925e-01 +-7.9450565539322074e-02 -1.1775354453706550e-01 +-8.1740021038984673e-02 -1.1638558884524650e-01 +-8.3867133342057434e-02 -1.1474362570897897e-01 +-2.3518153223110225e-02 -1.1170832407114598e-01 +-2.5154887792129235e-02 -1.1395556803696019e-01 +-2.6803615921545936e-02 -1.1521435650936546e-01 +-2.8285900829605769e-02 -1.1597730608102508e-01 +-2.9664136687594191e-02 -1.1651287325705317e-01 +-3.1021243056601158e-02 -1.1694953103898578e-01 +-3.2413618049658664e-02 -1.1734944389248209e-01 +-3.3869241644465926e-02 -1.1774204491206856e-01 +-3.5397085437564486e-02 -1.1813884992322499e-01 +-3.7002243418184810e-02 -1.1854295415230955e-01 +-3.8691524283991287e-02 -1.1895404332770873e-01 +-4.0461376037252424e-02 -1.1936779490996653e-01 +-4.2304303787088715e-02 -1.1977879621781995e-01 +-4.4215620715331291e-02 -1.2018241439476676e-01 +-4.6191327164131414e-02 -1.2057393424250579e-01 +-4.8235939491262689e-02 -1.2094928390727085e-01 +-5.0356521870111304e-02 -1.2130277151587739e-01 +-5.2556820219280834e-02 -1.2162560573769521e-01 +-5.4835175527840563e-02 -1.2190615655693077e-01 +-5.7182180427446452e-02 -1.2213108520220362e-01 +-5.9579436884656931e-02 -1.2228676598397943e-01 +-6.2009391953874865e-02 -1.2236021110732849e-01 +-6.4479109584666155e-02 -1.2233696231099017e-01 +-6.7007689076087854e-02 -1.2219544160590513e-01 +-6.9601173035616956e-02 -1.2190555773360709e-01 +-7.2237060183395707e-02 -1.2143424138200024e-01 +-7.4860784602716696e-02 -1.2075589979516653e-01 +-7.7437483971112553e-02 -1.1984698414277843e-01 +-7.9940597307691985e-02 -1.1868288545032264e-01 +-8.2325764049421032e-02 -1.1724548467628552e-01 +-8.4548652903583182e-02 -1.1551580786911056e-01 +-2.2633831871739656e-02 -1.1208943880120699e-01 +-2.4375955042955567e-02 -1.1471709890721045e-01 +-2.6166794698832430e-02 -1.1622177015077099e-01 +-2.7767561891311243e-02 -1.1712875417250232e-01 +-2.9226191722717582e-02 -1.1774714396264788e-01 +-3.0631252314719064e-02 -1.1823069555419087e-01 +-3.2049919651979737e-02 -1.1865562058430858e-01 +-3.3520350577999292e-02 -1.1906006575448734e-01 +-3.5058780054823387e-02 -1.1946174632608085e-01 +-3.6674244784334974e-02 -1.1986794176221459e-01 +-3.8375074174284762e-02 -1.2028054786148679e-01 +-4.0158018289374375e-02 -1.2069603822736816e-01 +-4.2015518496514095e-02 -1.2110907159619783e-01 +-4.3942938169904119e-02 -1.2151477246618833e-01 +-4.5936686109918988e-02 -1.2190808592641067e-01 +-4.8002079619111036e-02 -1.2228467488842357e-01 +-5.0147176034158983e-02 -1.2263879663131114e-01 +-5.2376546771587637e-02 -1.2296183806899162e-01 +-5.4688903257701510e-02 -1.2324238163269205e-01 +-5.7074815725149136e-02 -1.2346696902170971e-01 +-5.9515959205769416e-02 -1.2362120648821491e-01 +-6.1995552436430720e-02 -1.2369073087388081e-01 +-6.4522321817015407e-02 -1.2365951644993951e-01 +-6.7117410492374907e-02 -1.2350466641593195e-01 +-6.9788325940723622e-02 -1.2319510208957447e-01 +-7.2512701083092462e-02 -1.2269666135683346e-01 +-7.5234742329292600e-02 -1.2198189495391185e-01 +-7.7917583826774717e-02 -1.2102427670763696e-01 +-8.0532462718471504e-02 -1.1979564318463848e-01 +-8.3032544458379251e-02 -1.1827458446436691e-01 +-8.5370162074030601e-02 -1.1643985042333968e-01 +-2.1537739651818624e-02 -1.1252106526792785e-01 +-2.3398679745016943e-02 -1.1558945804096188e-01 +-2.5355127135583837e-02 -1.1739020007265018e-01 +-2.7102500703155279e-02 -1.1847706109134458e-01 +-2.8668018364019617e-02 -1.1920254330265005e-01 +-3.0142598066164629e-02 -1.1974970876198766e-01 +-3.1603013737296876e-02 -1.2021143758320978e-01 +-3.3097980534734742e-02 -1.2063570415680161e-01 +-3.4652538256708984e-02 -1.2104699217258273e-01 +-3.6281584683381371e-02 -1.2145758204046822e-01 +-3.7996460714174035e-02 -1.2187264190721897e-01 +-3.9795024309177834e-02 -1.2229027219602706e-01 +-4.1670005596793860e-02 -1.2270558490065939e-01 +-4.3616983863247173e-02 -1.2311358523239078e-01 +-4.5632856136572024e-02 -1.2350893615827586e-01 +-4.7723750350290292e-02 -1.2388706792283924e-01 +-4.9898689041217817e-02 -1.2424216609679434e-01 +-5.2163081630717145e-02 -1.2456569453456891e-01 +-5.4516151557330653e-02 -1.2484627900009528e-01 +-5.6948743465392006e-02 -1.2507017031714637e-01 +-5.9442962964032474e-02 -1.2522212427113572e-01 +-6.1983043223271063e-02 -1.2528642207803695e-01 +-6.4579402248169465e-02 -1.2524544359577630e-01 +-6.7255132011247734e-02 -1.2507472609307851e-01 +-7.0019179582225519e-02 -1.2474170629596770e-01 +-7.2849440720673994e-02 -1.2421054431968429e-01 +-7.5689037142109672e-02 -1.2345146122487834e-01 +-7.8499017273438138e-02 -1.2243456698586330e-01 +-8.1247983208566507e-02 -1.2112775010601654e-01 +-8.3885881618848704e-02 -1.1950595143115511e-01 +-8.6360766169883765e-02 -1.1754543254329862e-01 + 1.8079494935976024e-02 4.3576065657578659e-03 + 1.7309441116609717e-02 3.5523743667375154e-03 + 1.6463547613957259e-02 2.6464424237706528e-03 + 1.5533495990590021e-02 1.6320105598050206e-03 + 1.4510343017318659e-02 5.0123703795766964e-04 + 1.3380437268730443e-02 -7.4989476428072050e-04 + 1.2127754666811052e-02 -2.1233057192201945e-03 + 1.0732386438434795e-02 -3.6167974314448028e-03 + 9.1863919479749298e-03 -5.2382459574115787e-03 + 7.4787878132145658e-03 -6.9914307967425442e-03 + 5.6031018791073963e-03 -8.8825786175744815e-03 + 3.5555011826821185e-03 -1.0918103645083352e-02 + 1.3350129642869012e-03 -1.3104129438006807e-02 +-1.0547182878619813e-03 -1.5447542529640233e-02 +-3.6038500482304730e-03 -1.7956834625789619e-02 +-6.2960847986076093e-03 -2.0641487112908568e-02 +-9.1100145531721726e-03 -2.3509724929295112e-02 +-1.2015490852007158e-02 -2.6571035769191884e-02 +-1.4953339210023207e-02 -2.9853261066176816e-02 +-1.7886538027368577e-02 -3.3353457177351060e-02 +-2.0767021968992497e-02 -3.7070016153026533e-02 +-2.3588384064339107e-02 -4.0962623261090472e-02 +-2.6351114112471923e-02 -4.4984694914189230e-02 +-2.9027033357095482e-02 -4.9108522441526803e-02 +-3.1542978600881656e-02 -5.3331632232611254e-02 +-3.3883052872879758e-02 -5.7612860128896971e-02 +-3.6015231392691444e-02 -6.1921006430522105e-02 +-3.7900443609625002e-02 -6.6227890566806100e-02 +-3.9514719386867916e-02 -7.0499176395101601e-02 +-4.0859015282450055e-02 -7.4693394571268709e-02 +-4.1924334837408067e-02 -7.8776277661858768e-02 +-4.2710979297017115e-02 -8.2714902067426113e-02 +-4.3171298719276857e-02 -8.6484767134539370e-02 +-4.3262006703586486e-02 -9.0056970131445993e-02 +-4.3023803197672260e-02 -9.3392210522665553e-02 +-4.2380337307671732e-02 -9.6436524613678756e-02 +-4.1438937579615941e-02 -9.9160683095674412e-02 +-4.0224322899194691e-02 -1.0152280025470849e-01 +-3.8808057090529736e-02 -1.0351192106123602e-01 +-3.7189045921865713e-02 -1.0504907956106523e-01 +-3.5508041773596739e-02 -1.0620535638099590e-01 +-3.3848698531557135e-02 -1.0703482158990509e-01 +-3.2279185630741537e-02 -1.0764670643733155e-01 +-3.0805439689753442e-02 -1.0802075801194189e-01 +-2.9458918774846219e-02 -1.0830188915467040e-01 +-2.8228529016045445e-02 -1.0842930756661322e-01 +-2.7116253352284212e-02 -1.0849236209424269e-01 + 1.8088173385085088e-02 4.3492900820179268e-03 + 1.7318247186561931e-02 3.5440530142936415e-03 + 1.6472420563317818e-02 2.6382328321884895e-03 + 1.5542414625447920e-02 1.6238874220818632e-03 + 1.4519251749518928e-02 4.9318384747567667e-04 + 1.3389288003462809e-02 -7.5792761480236194e-04 + 1.2136487402123652e-02 -2.1313672233013894e-03 + 1.0741042354413113e-02 -3.6249671993169269e-03 + 9.1949589736724964e-03 -5.2465018325331784e-03 + 7.4872838629187677e-03 -6.9997813340056062e-03 + 5.6115439134524136e-03 -8.8910109721714002e-03 + 3.5639076504540095e-03 -1.0926601210221709e-02 + 1.3434099327073498e-03 -1.3112675562305314e-02 +-1.0462953317891543e-03 -1.5456115575734947e-02 +-3.5953601971732987e-03 -1.7965403680993305e-02 +-6.2874894963160120e-03 -2.0650012671457316e-02 +-9.1012635017460528e-03 -2.3518169281904356e-02 +-1.2006457493411496e-02 -2.6579362027097587e-02 +-1.4944027506770138e-02 -2.9861326315801101e-02 +-1.7876903891105581e-02 -3.3361222685929247e-02 +-2.0757168496742060e-02 -3.7077402488546574e-02 +-2.3578377825187475e-02 -4.0969684433751652e-02 +-2.6340921107844476e-02 -4.4991501043376535e-02 +-2.9016524753671318e-02 -4.9115058874939402e-02 +-3.1532241807652815e-02 -5.3337762005676095e-02 +-3.3872054453722968e-02 -5.7618584589968373e-02 +-3.6003935418501408e-02 -6.1926270424118093e-02 +-3.7888863061337208e-02 -6.6232609830885775e-02 +-3.9502913165530541e-02 -7.0503296385718700e-02 +-4.0846970829179506e-02 -7.4696893240893208e-02 +-4.1912080809430263e-02 -7.8779097557639371e-02 +-4.2698387991752761e-02 -8.2716925231154509e-02 +-4.3158369059020318e-02 -8.6485718469887590e-02 +-4.3249039566804759e-02 -9.0056672406548674e-02 +-4.3010536405052806e-02 -9.3390343649131291e-02 +-4.2367556734855608e-02 -9.6432980416648509e-02 +-4.1426566048888010e-02 -9.9155396446346244e-02 +-4.0212816613693421e-02 -1.0151579557511810e-01 +-3.8797479850739239e-02 -1.0350273666366604e-01 +-3.7180475193925144e-02 -1.0503850248543568e-01 +-3.5501223024683691e-02 -1.0619379923336460e-01 +-3.3843458173153949e-02 -1.0702301218912930e-01 +-3.2275141902077621e-02 -1.0763408906640254e-01 +-3.0802642193347968e-02 -1.0800865735427154e-01 +-2.9456913104211703e-02 -1.0828901169478861e-01 +-2.8227534542821665e-02 -1.0841688919748871e-01 +-2.7115523989830529e-02 -1.0848047383449190e-01 + 1.8098548492152065e-02 4.3394650112166576e-03 + 1.7328813870971422e-02 3.5340685950196026e-03 + 1.6483067940356776e-02 2.6283810761888026e-03 + 1.5553116574506774e-02 1.6141395082225262e-03 + 1.4529941910723442e-02 4.8351963360390103e-04 + 1.3399908522398510e-02 -7.6756738540704659e-04 + 1.2146966931162288e-02 -2.1410415258423156e-03 + 1.0751429394398805e-02 -3.6347708010814328e-03 + 9.2052394939656744e-03 -5.2564089290533522e-03 + 7.4974791982328716e-03 -7.0098019184255253e-03 + 5.6216744291786207e-03 -8.9011297247207199e-03 + 3.5739955081359200e-03 -1.0936798219588543e-02 + 1.3534864160070405e-03 -1.3122930828218242e-02 +-1.0361876542849325e-03 -1.5466403121817187e-02 +-3.5851722603853354e-03 -1.7975686419102518e-02 +-6.2771749888026491e-03 -2.0660243229510340e-02 +-9.0907618903820226e-03 -2.3528302408802305e-02 +-1.1995617468320183e-02 -2.6589353162630700e-02 +-1.4932853328920014e-02 -2.9871004540491679e-02 +-1.7865343158126198e-02 -3.3370541115950662e-02 +-2.0745344461181137e-02 -3.7086266237609841e-02 +-2.3566370235320561e-02 -4.0978158021595511e-02 +-2.6328689179442241e-02 -4.4999668384586571e-02 +-2.9003914613503160e-02 -4.9122902292363407e-02 +-3.1519357538107660e-02 -5.3345117759984427e-02 +-3.3858856219998686e-02 -5.7625453841903637e-02 +-3.5990380223695946e-02 -6.1932587047120069e-02 +-3.7874966480760650e-02 -6.6238272844752491e-02 +-3.9488745581197512e-02 -7.0508240350018445e-02 +-4.0832517463591837e-02 -7.4701091526161126e-02 +-4.1897375463148520e-02 -7.8782481156064468e-02 +-4.2683278176322920e-02 -8.2719352310079208e-02 +-4.3142854091198966e-02 -8.6486859590691370e-02 +-4.3233477508189892e-02 -9.0056314133093729e-02 +-4.2994618445046005e-02 -9.3388103048066676e-02 +-4.2352218803218954e-02 -9.6428726854024371e-02 +-4.1411721114823073e-02 -9.9149052243314384e-02 +-4.0199007733132786e-02 -1.0150738711891932e-01 +-3.8784791199307549e-02 -1.0349171843089455e-01 +-3.7170188061320865e-02 -1.0502581054899929e-01 +-3.5493039203524396e-02 -1.0617993395890753e-01 +-3.3837166981720478e-02 -1.0700883602364712e-01 +-3.2270289644196003e-02 -1.0761895781033579e-01 +-3.0799281888139719e-02 -1.0799412542670626e-01 +-2.9454507877636659e-02 -1.0827356980369102e-01 +-2.8226334187173147e-02 -1.0840198813710283e-01 +-2.7114572246136847e-02 -1.0846633825884840e-01 + 1.8110944338110783e-02 4.3278914015095586e-03 + 1.7341492539628699e-02 3.5220909416160853e-03 + 1.6495844551681644e-02 2.6165586320139760e-03 + 1.5565958322236543e-02 1.6024417942828719e-03 + 1.4542769645825874e-02 4.7192202458431917e-04 + 1.3412652627772218e-02 -7.7913561547385247e-04 + 1.2159542714902246e-02 -2.1526513999233863e-03 + 1.0763893760106859e-02 -3.6465349561307352e-03 + 9.2175762461915584e-03 -5.2682975099267310e-03 + 7.5097137097542522e-03 -7.0218265334585856e-03 + 5.6338311554696117e-03 -8.9132721228558833e-03 + 3.5861010760963315e-03 -1.0949034531663125e-02 + 1.3655783705161285e-03 -1.3135237027442804e-02 +-1.0240582538606439e-03 -1.5478748019714113e-02 +-3.5729465697812292e-03 -1.7988025520249324e-02 +-6.2647973707177377e-03 -2.0672519737597126e-02 +-9.0781594548981614e-03 -2.3540462021495751e-02 +-1.1982609444242006e-02 -2.6601341988660675e-02 +-1.4919444124099367e-02 -2.9882618300967476e-02 +-1.7851470609012300e-02 -3.3381722973620895e-02 +-2.0731155806894424e-02 -3.7096902946500143e-02 +-2.3551960979199600e-02 -4.0988326586533258e-02 +-2.6314010402438654e-02 -4.5009469173726439e-02 +-2.8988782707892364e-02 -4.9132313959097354e-02 +-3.1503896245972898e-02 -5.3353944702271221e-02 +-3.3843018151535884e-02 -5.7633696798395091e-02 +-3.5974113952720911e-02 -6.1940166751302837e-02 +-3.7858290694675258e-02 -6.6245068313040778e-02 +-3.9471744309922549e-02 -7.0514173071532668e-02 +-4.0815173391655607e-02 -7.4706129297925028e-02 +-4.1879728311566861e-02 -7.8786541075106478e-02 +-4.2665146041238534e-02 -8.2722263773454235e-02 +-4.3124237017262423e-02 -8.6488228239237200e-02 +-4.3214800908890509e-02 -9.0055882763726697e-02 +-4.2975520017385541e-02 -9.3385413814162169e-02 +-4.2333811519027681e-02 -9.6423621824285946e-02 +-4.1393908469621966e-02 -9.9141438860853678e-02 +-4.0182435194444845e-02 -1.0149729292354859e-01 +-3.8769570564836327e-02 -1.0347850088444535e-01 +-3.7157840292783871e-02 -1.0501058106735540e-01 +-3.5483216690369739e-02 -1.0616330030336270e-01 +-3.3829613608122741e-02 -1.0699181776980755e-01 +-3.2264467191910125e-02 -1.0760081378270366e-01 +-3.0795244818134795e-02 -1.0797667146818872e-01 +-2.9451623749096552e-02 -1.0825505510867911e-01 +-2.8224882903572401e-02 -1.0838411009446415e-01 +-2.7113322695139171e-02 -1.0844955783782827e-01 + 1.8125744385331093e-02 4.3143043750433598e-03 + 1.7356704208232071e-02 3.5077261879337437e-03 + 1.6511176118253517e-02 2.6023712688781849e-03 + 1.5581367573681870e-02 1.5884042191760168e-03 + 1.4558162265987978e-02 4.5800410250078361e-04 + 1.3427944817642460e-02 -7.9301822150172282e-04 + 1.2174634147096863e-02 -2.1665842630797039e-03 + 1.0778850885399611e-02 -3.6606517105894684e-03 + 9.2323805313612468e-03 -5.2825638978078139e-03 + 7.5243952808465037e-03 -7.0362559481231277e-03 + 5.6484193818801976e-03 -8.9278428495494673e-03 + 3.6006279575578580e-03 -1.0963717963210474e-02 + 1.3800889671477707e-03 -1.3150004293725225e-02 +-1.0095027035779709e-03 -1.5493561670624606e-02 +-3.5582755009531692e-03 -1.8002832176151201e-02 +-6.2499439268435611e-03 -2.0687251314626533e-02 +-9.0630358128815317e-03 -2.3555053353888376e-02 +-1.1966999821079042e-02 -2.6615727810366197e-02 +-1.4903352805414397e-02 -2.9896554654157761e-02 +-1.7834824023647281e-02 -3.3395140832991367e-02 +-2.0714129692432085e-02 -3.7109667298173402e-02 +-2.3534669658427640e-02 -4.1000529237121414e-02 +-2.6296395206767093e-02 -4.5021230090994992e-02 +-2.8970624795317135e-02 -4.9143607336944173e-02 +-3.1485342453887802e-02 -5.3364537084192393e-02 +-3.3824012199144000e-02 -5.7643588136528458e-02 +-3.5954594374011287e-02 -6.1949262046326205e-02 +-3.7838279908948086e-02 -6.6253222661444497e-02 +-3.9451342540978596e-02 -7.0521292285064860e-02 +-4.0794360454013134e-02 -7.4712174378134988e-02 +-4.1858550673683374e-02 -7.8791412401557820e-02 +-4.2643386969190747e-02 -8.2725756047613230e-02 +-4.3101897786247165e-02 -8.6489869609667661e-02 +-4.3192385963720777e-02 -9.0055363051452786e-02 +-4.2952606350313345e-02 -9.3382185987110872e-02 +-4.2311720278271375e-02 -9.6417494707196724e-02 +-4.1372535091129890e-02 -9.9132302286278021e-02 +-4.0162545513683125e-02 -1.0148517413306966e-01 +-3.8751313968825016e-02 -1.0346264598204555e-01 +-3.7143018422926131e-02 -1.0499230697611013e-01 +-3.5471426859658241e-02 -1.0614334650836026e-01 +-3.3820543935845986e-02 -1.0697138629525606e-01 +-3.2257480527049909e-02 -1.0757905980643533e-01 +-3.0790393665592879e-02 -1.0795570485519738e-01 +-2.9448165651925439e-02 -1.0823285933332313e-01 +-2.8223124402982257e-02 -1.0836266408845013e-01 +-2.7111672969234595e-02 -1.0842967483634665e-01 + 1.8143401765824265e-02 4.2984167579332910e-03 + 1.7374953032641409e-02 3.4905058326867985e-03 + 1.6529573422668264e-02 2.5853459587773511e-03 + 1.5599857466256081e-02 1.5715586620626302e-03 + 1.4576632453606384e-02 4.4130146342018705e-04 + 1.3446294398895180e-02 -8.0967840358637567e-04 + 1.2192744555394467e-02 -2.1833051431356656e-03 + 1.0796799280439418e-02 -3.6775914977496657e-03 + 9.2501459335945137e-03 -5.2996836893601058e-03 + 7.5420133927151262e-03 -7.0535710695648537e-03 + 5.6659254768501111e-03 -8.9453275044845196e-03 + 3.6180605030982802e-03 -1.0981337874957822e-02 + 1.3975020446132340e-03 -1.3167724764394130e-02 +-9.9203565513351129e-04 -1.5511337725631033e-02 +-3.5406698722323373e-03 -1.8020599781312773e-02 +-6.2321193573956317e-03 -2.0704928872082362e-02 +-9.0448864117304850e-03 -2.3572562657766485e-02 +-1.1948268277010758e-02 -2.6632989693799774e-02 +-1.4884042834624221e-02 -2.9913278044452003e-02 +-1.7814848799248179e-02 -3.3411241735454178e-02 +-2.0693698743912917e-02 -3.7124984951160810e-02 +-2.3513919766274018e-02 -4.1015172952687938e-02 +-2.6275256022828593e-02 -4.5035343148079589e-02 +-2.8948835832253609e-02 -4.9157158499406058e-02 +-3.1463077558072997e-02 -5.3377248012532567e-02 +-3.3801204668208067e-02 -5.7655457440655318e-02 +-3.5931170802395267e-02 -6.1960175897364529e-02 +-3.7814267190538216e-02 -6.6263007572057761e-02 +-3.9426860070445019e-02 -7.0529835264463020e-02 +-4.0769384848957625e-02 -7.4719428119775319e-02 +-4.1833135994399966e-02 -7.8797257160429957e-02 +-4.2617275354576309e-02 -8.2729944648125137e-02 +-4.3075092485627887e-02 -8.6491837794257759e-02 +-4.3165483739629369e-02 -9.0054736428161863e-02 +-4.2925116262014631e-02 -9.3378311506171735e-02 +-4.2285207263782772e-02 -9.6410140618118548e-02 +-4.1346889553014528e-02 -9.9121337606944943e-02 +-4.0138674232468995e-02 -1.0147062342020811e-01 +-3.8729417623281734e-02 -1.0344362881347766e-01 +-3.7125225756215907e-02 -1.0497038004393378e-01 +-3.5457274943909052e-02 -1.0611941121389698e-01 +-3.3809652322929713e-02 -1.0694685525297214e-01 +-3.2249096773454639e-02 -1.0755298125978340e-01 +-3.0784562855624687e-02 -1.0793051456039283e-01 +-2.9444019641087605e-02 -1.0820625497971803e-01 +-2.8220987582739571e-02 -1.0833694477796672e-01 +-2.7109484233513736e-02 -1.0840616555927945e-01 + 1.8164451392258647e-02 4.2799241641943778e-03 + 1.7396842249772670e-02 3.4698748342804147e-03 + 1.6551649254867764e-02 2.5649152497632531e-03 + 1.5622043610272153e-02 1.5513433094355939e-03 + 1.4598795296211858e-02 4.2125667714543430e-04 + 1.3468312413294322e-02 -8.2967214707854601e-04 + 1.2214478007538936e-02 -2.2033722516004461e-03 + 1.0818337144796132e-02 -3.6979188099199693e-03 + 9.2714647862695496e-03 -5.3202276127853783e-03 + 7.5631554534970283e-03 -7.0743489642678299e-03 + 5.6869331129437263e-03 -8.9663087781329549e-03 + 3.6389799722212576e-03 -1.1002481471823982e-02 + 1.4183982578856228e-03 -1.3188988970503525e-02 +-9.7107463843096667e-04 -1.5532668522128470e-02 +-3.5195426183155794e-03 -1.8041920358230067e-02 +-6.2107292419170592e-03 -2.0726141458469044e-02 +-9.0231056551324761e-03 -2.3593573392490338e-02 +-1.1925790421387156e-02 -2.6653702375499244e-02 +-1.4860870318259273e-02 -2.9933345770005736e-02 +-1.7790879499330333e-02 -3.3430562063386397e-02 +-2.0669182163786382e-02 -3.7143366751287842e-02 +-2.3489019453436129e-02 -4.1032746178330748e-02 +-2.6249887645306835e-02 -4.5052278752253483e-02 +-2.8922689831034885e-02 -4.9173418620201866e-02 +-3.1436359190067445e-02 -5.3392501220886540e-02 +-3.3773835073631200e-02 -5.7669700172101407e-02 +-3.5903062405334356e-02 -6.1973271796009047e-02 +-3.7785452247061299e-02 -6.6274749022201873e-02 +-3.9397480609305278e-02 -7.0540086726370840e-02 +-4.0739413997741440e-02 -7.4728132097948735e-02 +-4.1802636210908038e-02 -7.8804269666765764e-02 +-4.2585940378745996e-02 -8.2734967913176916e-02 +-4.3042928624577606e-02 -8.6494197498957384e-02 +-4.3133195008452432e-02 -9.0053980224078636e-02 +-4.2892137091899672e-02 -9.3373660537968139e-02 +-4.2253386695344640e-02 -9.6401313495438248e-02 +-4.1316118412839817e-02 -9.9108178774645853e-02 +-4.0110023636688592e-02 -1.0145315101992422e-01 +-3.8703158349415158e-02 -1.0342082051256911e-01 +-3.7103865519258844e-02 -1.0494407078057530e-01 +-3.5440286605038208e-02 -1.0609070180676748e-01 +-3.3796571012928205e-02 -1.0691739973977489e-01 +-3.2239036359100533e-02 -1.0752172321929238e-01 +-3.0777552601643766e-02 -1.0790024437352638e-01 +-2.9439049035684742e-02 -1.0817437239202880e-01 +-2.8218381465291466e-02 -1.0830611237107647e-01 +-2.7106568538422110e-02 -1.0837843495958262e-01 + 1.8189524377789767e-02 4.2585131962339026e-03 + 1.7423092943432257e-02 3.4451792577952314e-03 + 1.6578138687248591e-02 2.5403986931703485e-03 + 1.5648664517722025e-02 1.5270838890288517e-03 + 1.4625388708372102e-02 3.9720062088381989e-04 + 1.3494731934728717e-02 -8.5366684476322887e-04 + 1.2240559483761916e-02 -2.2274556911273946e-03 + 1.0844182303138269e-02 -3.7223110051629637e-03 + 9.2970479345145015e-03 -5.3448805575729303e-03 + 7.5885263971307371e-03 -7.0992820808166556e-03 + 5.7121427410227093e-03 -8.9914858577536637e-03 + 3.6640839321788305e-03 -1.1027853359283787e-02 + 1.4434744623528166e-03 -1.3214505500931079e-02 +-9.4592061486864889e-04 -1.5558264802195711e-02 +-3.4941891929284549e-03 -1.8067504260699589e-02 +-6.1850601879187509e-03 -2.0751595867153874e-02 +-8.9969666383632862e-03 -2.3618785646391714e-02 +-1.1898816977150449e-02 -2.6678555336588111e-02 +-1.4833062517850916e-02 -2.9957426535759262e-02 +-1.7762117723761819e-02 -3.3453745380766384e-02 +-2.0639763068202605e-02 -3.7165425792031456e-02 +-2.3459138441437967e-02 -4.1053835148103117e-02 +-2.6219443655718849e-02 -4.5072601382216311e-02 +-2.8891315696156394e-02 -4.9192928945274536e-02 +-3.1404296445529049e-02 -5.3410805195753565e-02 +-3.3740990760192602e-02 -5.7686790826693805e-02 +-3.5869332168596647e-02 -6.1988985836834334e-02 +-3.7750874766043593e-02 -6.6288838125217825e-02 +-3.9362224548506804e-02 -7.0552388312890957e-02 +-4.0703448778671353e-02 -7.4738576133143511e-02 +-4.1766033368280490e-02 -7.8812682931926503e-02 +-4.2548336929928578e-02 -8.2740991447272066e-02 +-4.3004335491365384e-02 -8.6497026071445118e-02 +-4.3094439997134665e-02 -9.0053066682036928e-02 +-4.2852574694807688e-02 -9.3368077045228190e-02 +-4.2215195096369479e-02 -9.6390717780665242e-02 +-4.1279197895636097e-02 -9.9092386289768741e-02 +-4.0075636006195937e-02 -1.0143216787376312e-01 +-3.8671670211834958e-02 -1.0339346784946919e-01 +-3.7078220578254162e-02 -1.0491250440883994e-01 +-3.5419891722014790e-02 -1.0605626851952352e-01 +-3.3780857317608937e-02 -1.0688202824077545e-01 +-3.2226963554776202e-02 -1.0748426315906140e-01 +-3.0769121653686161e-02 -1.0786386305246981e-01 +-2.9433089641312960e-02 -1.0813617258494553e-01 +-2.8215187914040440e-02 -1.0826917026209527e-01 +-2.7102672179346702e-02 -1.0834581174096350e-01 + 1.8219365475549799e-02 4.2338734111229473e-03 + 1.7454566077358572e-02 3.4156544250608994e-03 + 1.6609923293622684e-02 2.5109809315169147e-03 + 1.5680606086851782e-02 1.4979711481023332e-03 + 1.4657297912265981e-02 3.6833005477796455e-04 + 1.3526432408814001e-02 -8.8246367276899947e-04 + 1.2271859088720801e-02 -2.2563599311395464e-03 + 1.0875196129997256e-02 -3.7515808775918807e-03 + 9.3277484560877408e-03 -5.3744644106086693e-03 + 7.6189722078488509e-03 -7.1292013135905701e-03 + 5.7423949656087454e-03 -9.0216977085533535e-03 + 3.6942095439183574e-03 -1.1058299005544638e-02 + 1.4735669847210392e-03 -1.3245124592350594e-02 +-9.1573463079280099e-04 -1.5588979365704097e-02 +-3.4637640421004839e-03 -1.8098203808322510e-02 +-6.1542559961216105e-03 -2.0782140156669938e-02 +-8.9655968078659037e-03 -2.3649039432428683e-02 +-1.1866448795782743e-02 -2.6708375667127766e-02 +-1.4799692055771559e-02 -2.9986322708595636e-02 +-1.7727605566432214e-02 -3.3481563830546998e-02 +-2.0604461300917008e-02 -3.7191897896881376e-02 +-2.3423280311019146e-02 -4.1079143485090445e-02 +-2.6182908108834110e-02 -4.5096988397063227e-02 +-2.8853668236235454e-02 -4.9216338740322982e-02 +-3.1365820151930970e-02 -5.3432770126719355e-02 +-3.3701576436809232e-02 -5.7707298716991873e-02 +-3.5828855653485044e-02 -6.2007841196817085e-02 +-3.7709382425385768e-02 -6.6305744131711239e-02 +-3.9319916269541927e-02 -7.0567149967232456e-02 +-4.0660290201769617e-02 -7.4751107908511943e-02 +-4.1722105523721263e-02 -7.8822776326689908e-02 +-4.2503210692006223e-02 -8.2748213402515480e-02 +-4.2958028603539984e-02 -8.6500415890870916e-02 +-4.3047922025863515e-02 -9.0051961705460648e-02 +-4.2805117531772227e-02 -9.3361373430028941e-02 +-4.2169355575432568e-02 -9.6377998398836220e-02 +-4.1234899932577958e-02 -9.9073432368512751e-02 +-4.0034361509287290e-02 -1.0140696528166414e-01 +-3.8633916646454915e-02 -1.0336066886668215e-01 +-3.7047429019283783e-02 -1.0487463216116555e-01 +-3.5395404788829438e-02 -1.0601497344512660e-01 +-3.3761978086402841e-02 -1.0683954894491805e-01 +-3.2212475023668738e-02 -1.0743937829262039e-01 +-3.0758978456200563e-02 -1.0782012845657785e-01 +-2.9425943715364156e-02 -1.0809041516527482e-01 +-2.8211251036194446e-02 -1.0822494084631686e-01 +-2.7097454011091839e-02 -1.0830754393659232e-01 + 1.8254854556873312e-02 4.2057136255263059e-03 + 1.7492288352074472e-02 3.3804151085902279e-03 + 1.6648060009840211e-02 2.4756861607882277e-03 + 1.5718930937448545e-02 1.4630338416682903e-03 + 1.4695584775990447e-02 3.3368067827985529e-04 + 1.3564468836486151e-02 -9.1702448327697942e-04 + 1.2309421110477526e-02 -2.2910508136291170e-03 + 1.0912412261987418e-02 -3.7867037475263323e-03 + 9.3645901321485984e-03 -5.4099654587429378e-03 + 7.6555081584381603e-03 -7.1651036745566388e-03 + 5.7786986039522221e-03 -9.0579510036917429e-03 + 3.7303615163820237e-03 -1.1094832888054946e-02 + 1.5096795606241039e-03 -1.3281866427896978e-02 +-8.7950978766659774e-04 -1.5625835442339892e-02 +-3.4272523583429287e-03 -1.8135041633900676e-02 +-6.1172890404194141e-03 -2.0818791862001692e-02 +-8.9279487209233104e-03 -2.3685342627988198e-02 +-1.1827606869529984e-02 -2.6744155469120484e-02 +-1.4759645953318183e-02 -3.0020997009404349e-02 +-1.7686193785322341e-02 -3.3514943797300550e-02 +-2.0562100823112484e-02 -3.7223666210445254e-02 +-2.3380249236708204e-02 -4.1109515738668369e-02 +-2.6139061529064353e-02 -4.5126252604761989e-02 +-2.8808493389419015e-02 -4.9244426801040936e-02 +-3.1319647179613955e-02 -5.3459128244030894e-02 +-3.3654277604809303e-02 -5.7731906899436074e-02 +-3.5780283502214551e-02 -6.2030465493295453e-02 +-3.7659592510831209e-02 -6.6326030019256341e-02 +-3.9269144907360075e-02 -7.0584863579641471e-02 +-4.0608499407397441e-02 -7.4766144497148412e-02 +-4.1669385784506172e-02 -7.8834884742535818e-02 +-4.2449056231137546e-02 -8.2756870743387057e-02 +-4.2902467071447299e-02 -8.6504477169544902e-02 +-4.2992083799533461e-02 -9.0050623258596751e-02 +-4.2748193701899008e-02 -9.3353324047770039e-02 +-4.2114334922425146e-02 -9.6362728684426413e-02 +-4.1181751422558685e-02 -9.9050683060724440e-02 +-3.9984819693716825e-02 -1.0137669033370431e-01 +-3.8588657218036830e-02 -1.0332134379679041e-01 +-3.7010454750559980e-02 -1.0482919703869251e-01 +-3.5366001174495197e-02 -1.0596545346378103e-01 +-3.3739290865909641e-02 -1.0678852937030507e-01 +-3.2195085918330979e-02 -1.0738560641417901e-01 +-3.0746770351053436e-02 -1.0776754461487033e-01 +-2.9417372135608952e-02 -1.0803562067590233e-01 +-2.8206361684337784e-02 -1.0817204035675287e-01 +-2.7090457454939633e-02 -1.0826279469300694e-01 + 1.8297033542168873e-02 4.1737830125743525e-03 + 1.7537482665808461e-02 3.3384500193408902e-03 + 1.6693815412093853e-02 2.4333489601446896e-03 + 1.5764913537141746e-02 1.4211063829184694e-03 + 1.4741522965853156e-02 2.9209475145275057e-04 + 1.3610106764837203e-02 -9.5850413630903025e-04 + 1.2354498892453058e-02 -2.3326880066049673e-03 + 1.0957071059649054e-02 -3.8288499823278081e-03 + 9.4088016223605273e-03 -5.4525672715766502e-03 + 7.6993527081880972e-03 -7.2081854925176037e-03 + 5.8222643697728961e-03 -9.1014536292761718e-03 + 3.7737456671312689e-03 -1.1138672257534401e-02 + 1.5530168794945650e-03 -1.3325955081660410e-02 +-8.3603758585752642e-04 -1.5670060720340662e-02 +-3.3834361658702894e-03 -1.8179244680838310e-02 +-6.0729258961225068e-03 -2.0862771830594280e-02 +-8.8827649141195245e-03 -2.3728904480265971e-02 +-1.1780996336227445e-02 -2.6787084693240499e-02 +-1.4711588465885782e-02 -3.0062604523039427e-02 +-1.7636503633198450e-02 -3.3554996681856013e-02 +-2.0511270599115193e-02 -3.7261790725870665e-02 +-2.3328610052430799e-02 -4.1145965653724387e-02 +-2.6086440068084273e-02 -4.5161369339752212e-02 +-2.8754286506753417e-02 -4.9278127229457021e-02 +-3.1264237602343085e-02 -5.3490758219027712e-02 +-3.3597516653187311e-02 -5.7761434872148763e-02 +-3.5721996439799238e-02 -6.2057611588983742e-02 +-3.7599845863152577e-02 -6.6350371184129120e-02 +-3.9208217252702064e-02 -7.0606119354679156e-02 +-4.0546349646831362e-02 -7.4784186173304054e-02 +-4.1606113088083756e-02 -7.8849409533504930e-02 +-4.2384066671903170e-02 -8.2767246662347624e-02 +-4.2835802456598744e-02 -8.6509341217112429e-02 +-4.2925054872243344e-02 -9.0048999310871389e-02 +-4.2679919527062862e-02 -9.3343657335751964e-02 +-4.2048292087693652e-02 -9.6344395819883924e-02 +-4.1117985351493684e-02 -9.9023376657285181e-02 +-3.9925353337454658e-02 -1.0134031625284018e-01 +-3.8534407967029109e-02 -1.0327420034591904e-01 +-3.6966052122567893e-02 -1.0477469303629997e-01 +-3.5330688312598460e-02 -1.0590607587347663e-01 +-3.3712021013798180e-02 -1.0672724808068695e-01 +-3.2174212927784385e-02 -1.0732119879615236e-01 +-3.0732070362797518e-02 -1.0770431063128849e-01 +-2.9407083887986313e-02 -1.0797002679906191e-01 +-2.8200234805038814e-02 -1.0810885398865770e-01 +-2.7081074686684855e-02 -1.0821063764207624e-01 + 1.8347140637601640e-02 4.1378973459556797e-03 + 1.7591604399313863e-02 3.2886235478882162e-03 + 1.6748706262429931e-02 2.3825820569666313e-03 + 1.5820082221624645e-02 1.3707902217832057e-03 + 1.4796640050601766e-02 2.4218218127014215e-04 + 1.3664864236332838e-02 -1.0082893827543279e-03 + 1.2408596674330169e-02 -2.3826640086216200e-03 + 1.1010660972479788e-02 -3.8794240453940481e-03 + 9.4618574869154669e-03 -5.5036901577667427e-03 + 7.7519681981369284e-03 -7.2598822432333888e-03 + 5.8745453124198540e-03 -9.1536548749124695e-03 + 3.8258092174802568e-03 -1.1191277637937227e-02 + 1.6050248650321475e-03 -1.3378859232024951e-02 +-7.8386750803547474e-04 -1.5723128156523884e-02 +-3.3308535933911014e-03 -1.8232284971972684e-02 +-6.0196860540623828e-03 -2.0915544798100556e-02 +-8.8285356854529689e-03 -2.3781175778623390e-02 +-1.1725063267192543e-02 -2.6838590478291881e-02 +-1.4653916472553900e-02 -3.0112531077293187e-02 +-1.7576881091770177e-02 -3.3603055804403620e-02 +-2.0450277684716252e-02 -3.7307543740772137e-02 +-2.3266640307724570e-02 -4.1189710127026165e-02 +-2.6023286444342365e-02 -4.5203508949981361e-02 +-2.8689242306469971e-02 -4.9318560316834285e-02 +-3.1197743271647455e-02 -5.3528714435245282e-02 +-3.3529400147073694e-02 -5.7796865789598043e-02 +-3.5652051270271171e-02 -6.2090182522936806e-02 +-3.7528151621413035e-02 -6.6379577847115512e-02 +-3.9135101216937758e-02 -7.0631625438991874e-02 +-4.0471768630197996e-02 -7.4805832955220919e-02 +-4.1530173048248853e-02 -7.8866831570523016e-02 +-4.2306073270640697e-02 -8.2779679333375156e-02 +-4.2755817416482510e-02 -8.6515164212005544e-02 +-4.2844588518990229e-02 -9.0047025180017712e-02 +-4.2598038018257851e-02 -9.3332046231979104e-02 +-4.1969016337882088e-02 -9.6322383256350036e-02 +-4.1041482120593491e-02 -9.8990597571570846e-02 +-3.9853973212788808e-02 -1.0129660661554379e-01 +-3.8469394081767333e-02 -1.0321769223882586e-01 +-3.6912723372014879e-02 -1.0470931669002907e-01 +-3.5288270658114761e-02 -1.0583488527221539e-01 +-3.3679233856432469e-02 -1.0665363711515757e-01 +-3.2149153496575419e-02 -1.0724406331710644e-01 +-3.0714360959133401e-02 -1.0762826037401108e-01 +-2.9394721401812336e-02 -1.0789153817315925e-01 +-2.8192476564795094e-02 -1.0803351286142916e-01 +-2.7068501190535058e-02 -1.0815005086773734e-01 + 1.8406654139283982e-02 4.0979707586785560e-03 + 1.7656385539005545e-02 3.2296881648647647e-03 + 1.6814547263227151e-02 2.3217426337891925e-03 + 1.5886269382081035e-02 1.3104080220915082e-03 + 1.4862767913161729e-02 1.8227375885541914e-04 + 1.3730562078898032e-02 -1.0680456432664296e-03 + 1.2473519783345091e-02 -2.4426510324532910e-03 + 1.1074968196494790e-02 -3.9401113974406972e-03 + 9.5255274302027335e-03 -5.5650385089337211e-03 + 7.8151097104292074e-03 -7.3219163332971455e-03 + 5.9372853711003992e-03 -9.2162936405818033e-03 + 3.8882891794911915e-03 -1.1254401401859635e-02 + 1.6674390511925146e-03 -1.3442340989162921e-02 +-7.2125847720144005e-04 -1.5786804912125467e-02 +-3.2677499585193398e-03 -1.8295928491795697e-02 +-5.9557923173827491e-03 -2.0978868040657538e-02 +-8.7634483530799785e-03 -2.3843897009712144e-02 +-1.1657942784623856e-02 -2.6900384271314751e-02 +-1.4584705929025436e-02 -3.0172439247792206e-02 +-1.7505342000476480e-02 -3.3660720653924739e-02 +-2.0377090967543310e-02 -3.7362452436516945e-02 +-2.3192272702815677e-02 -4.1242209999848498e-02 +-2.5947491003536032e-02 -4.5254075771367440e-02 +-2.8611194833190322e-02 -4.9367069538391185e-02 +-3.1117946083299926e-02 -5.3574262096347532e-02 +-3.3447655537799499e-02 -5.7839379088719063e-02 +-3.5568116062247558e-02 -6.2129261378842678e-02 +-3.7442120922206293e-02 -6.6414621906389470e-02 +-3.9047357965881373e-02 -7.0662231455088445e-02 +-4.0382269296530778e-02 -7.4831804410763494e-02 +-4.1439026850034727e-02 -7.8887726794889743e-02 +-4.2212472852374533e-02 -8.2794572213605477e-02 +-4.2659852073377427e-02 -8.6522131509954692e-02 +-4.2747985911990222e-02 -9.0044620079415438e-02 +-4.2499845200116397e-02 -9.3318096473325979e-02 +-4.1873853066387981e-02 -9.6295949463439001e-02 +-4.0949699091276298e-02 -9.8951244675219457e-02 +-3.9768292085687135e-02 -1.0124407223721715e-01 +-3.8391493347344242e-02 -1.0314996968547226e-01 +-3.6848667475230863e-02 -1.0463090964384004e-01 +-3.5237306957330079e-02 -1.0574953995367681e-01 +-3.3639800751489486e-02 -1.0656521358701709e-01 +-3.2119060192401676e-02 -1.0715169553209113e-01 +-3.0693013934990600e-02 -1.0753679211590567e-01 +-2.9379839290996055e-02 -1.0779767023387470e-01 +-2.8182537262139762e-02 -1.0794387419384011e-01 +-2.7051678498930930e-02 -1.0807990817738973e-01 + 1.8477348326939820e-02 4.0540535964908005e-03 + 1.7733889965029254e-02 3.1603106818920246e-03 + 1.6893507153721541e-02 2.2489004453659133e-03 + 1.5965671256660287e-02 1.2379499402103615e-03 + 1.4942103077270834e-02 1.1036499999335761e-04 + 1.3809384188433986e-02 -1.1397733060943356e-03 + 1.2551434823623871e-02 -2.5146573659783861e-03 + 1.1152136293281534e-02 -4.0129348505076002e-03 + 9.6019354167284736e-03 -5.6386576057577253e-03 + 7.8908837351935428e-03 -7.3963544235915229e-03 + 6.0125776793241706e-03 -9.2914562544923768e-03 + 3.9632704667955541e-03 -1.1330146024877733e-02 + 1.7423426889015695e-03 -1.3518514445626269e-02 +-6.4612054666563054e-04 -1.5863211025149516e-02 +-3.1920190058189139e-03 -1.8372293788473892e-02 +-5.8791111907838820e-03 -2.1054849701286578e-02 +-8.6853262573381440e-03 -2.3919156065446159e-02 +-1.1577396754406845e-02 -2.6974518253595717e-02 +-1.4501647597430153e-02 -3.0244323487707489e-02 +-1.7419506275135263e-02 -3.3729909942719044e-02 +-2.0289273702107587e-02 -3.7428350013405547e-02 +-2.3103025966424363e-02 -4.1305219070421159e-02 +-2.5856520906149701e-02 -4.5314754882468514e-02 +-2.8517545416936102e-02 -4.9425265862893718e-02 +-3.1022183866217412e-02 -5.3628919324637536e-02 +-3.3349555165589913e-02 -5.7890389594831504e-02 +-3.5467392357418616e-02 -6.2176147059261666e-02 +-3.7338887344506293e-02 -6.6456669112270106e-02 +-3.8942060448861629e-02 -7.0698956709634331e-02 +-4.0274866661084964e-02 -7.4862963355911985e-02 +-4.1329625761019340e-02 -7.8912784716948819e-02 +-4.2100140663729614e-02 -8.2812406120031740e-02 +-4.2544715610614986e-02 -8.6530462489409363e-02 +-4.2632005114222486e-02 -9.0041682608221124e-02 +-4.2382101833306908e-02 -9.3301332240373042e-02 +-4.1759614870743464e-02 -9.6264202194660697e-02 +-4.0839585938339369e-02 -9.8903992813716785e-02 +-3.9665446024041692e-02 -1.0118091931380020e-01 +-3.8298168454931468e-02 -1.0306882014073152e-01 +-3.6771718739469411e-02 -1.0453689075560613e-01 +-3.5176058015801356e-02 -1.0564723576496163e-01 +-3.3592357615682578e-02 -1.0645899872161983e-01 +-3.2082908858705045e-02 -1.0704109490542156e-01 +-3.0667265127309780e-02 -1.0742678779909633e-01 +-2.9361872514661796e-02 -1.0768548860060484e-01 +-2.8169645122949838e-02 -1.0783750499569010e-01 +-2.7029222536870335e-02 -1.0799896630585903e-01 + 1.8561364007482345e-02 4.0063773407155150e-03 + 1.7826585130649174e-02 3.0791143254020720e-03 + 1.6988174791617714e-02 2.1618133296781926e-03 + 1.6060918898079115e-02 1.1510120252029013e-03 + 1.5037278841465504e-02 2.4048825312691693e-05 + 1.3903949781038996e-02 -1.2258754989187834e-03 + 1.2644941829297004e-02 -2.6010951353898021e-03 + 1.1244737777003999e-02 -4.1003223094833391e-03 + 9.6936306432449295e-03 -5.7270017805138400e-03 + 7.9818186211977910e-03 -7.4856761946342229e-03 + 6.1029345888707143e-03 -9.3816458116908787e-03 + 4.0532556957074565e-03 -1.1421033939117699e-02 + 1.8322365538270412e-03 -1.3609915876462656e-02 +-5.5594484189435095e-04 -1.5954889743341666e-02 +-3.1011322991447111e-03 -1.8463922215460182e-02 +-5.7870812190287712e-03 -2.1146018697493225e-02 +-8.5915554209925662e-03 -2.4009457374305057e-02 +-1.1480738940648398e-02 -2.7063452895404884e-02 +-1.4401969910978306e-02 -3.0330576165653288e-02 +-1.7316519049544437e-02 -3.3812925216478287e-02 +-2.0183902614235610e-02 -3.7507437105736660e-02 +-2.2995921846928224e-02 -4.1380842988855249e-02 +-2.5747335044273109e-02 -4.5387568187251440e-02 +-2.8405176219579643e-02 -4.9495080816100732e-02 +-3.0907261410662100e-02 -5.3694507625479559e-02 +-3.3231824995610768e-02 -5.7951594382899430e-02 +-3.5346521799265784e-02 -6.2232397119004190e-02 +-3.7215011445040629e-02 -6.6507117605169697e-02 +-3.8815695590355054e-02 -7.0743023991809650e-02 +-4.0145977909760773e-02 -7.4900344189956128e-02 +-4.1198308331693127e-02 -7.8942830369414380e-02 +-4.1965325696073121e-02 -8.2833753322252734e-02 +-4.2406580069361065e-02 -8.6540415882100652e-02 +-4.2492751960086193e-02 -9.0038084831637777e-02 +-4.2240927522660059e-02 -9.3281178455826036e-02 +-4.1622475089322694e-02 -9.6226067244529645e-02 +-4.0707482914830617e-02 -9.8847245903612518e-02 +-3.9542000817737295e-02 -1.0110498720853899e-01 +-3.8186385781923370e-02 -1.0297159737744442e-01 +-3.6679273150430895e-02 -1.0442417605230012e-01 +-3.5102422711449040e-02 -1.0552461506236366e-01 +-3.3535254063155419e-02 -1.0633142236542764e-01 +-3.2039458715929912e-02 -1.0690866305010137e-01 +-3.0636181814725646e-02 -1.0729452256393034e-01 +-2.9340087657757769e-02 -1.0755154707178911e-01 +-2.8152715323287187e-02 -1.0771166720035238e-01 +-2.6999334611484176e-02 -1.0790584686991370e-01 + 1.8661296178486480e-02 3.9554079595234253e-03 + 1.7937437636398282e-02 2.9847362180035314e-03 + 1.7101638124349026e-02 2.0579182730314305e-03 + 1.6175162003060829e-02 1.0467283917622930e-03 + 1.5151451420845818e-02 -7.9564771586090457e-05 + 1.4017399968793660e-02 -1.3292396741360554e-03 + 1.2757160723150991e-02 -2.7048617910311805e-03 + 1.1355860076902815e-02 -4.2051882418974390e-03 + 9.8036727530624763e-03 -5.8330162103744192e-03 + 8.0909491878544369e-03 -7.5928568331995148e-03 + 6.2113717821899658e-03 -9.4898653213892625e-03 + 4.1612490438456308e-03 -1.1530091281602260e-02 + 1.9401228292430562e-03 -1.3719587891192847e-02 +-4.4771936751606377e-04 -1.6064891819554030e-02 +-2.9920543541743761e-03 -1.8573862105654437e-02 +-5.6766268052564376e-03 -2.1255408488556789e-02 +-8.4789963544409704e-03 -2.4117804680471994e-02 +-1.1364745067623718e-02 -2.7170137814465659e-02 +-1.4282346409714748e-02 -3.0434066633702874e-02 +-1.7192956145251202e-02 -3.3912527119026203e-02 +-2.0057470906223233e-02 -3.7602355543333625e-02 +-2.2867385418336671e-02 -4.1471610033935305e-02 +-2.5616281810712623e-02 -4.5474941681206041e-02 +-2.8270346457219191e-02 -4.9578830023847296e-02 +-3.0769343651783534e-02 -5.3773212353263489e-02 +-3.3090535011708479e-02 -5.8025028916560473e-02 +-3.5201474054597788e-02 -6.2299879034867445e-02 +-3.7066366191194987e-02 -6.6567644059048803e-02 +-3.8664046862659202e-02 -7.0795900049461125e-02 +-3.9991302316735776e-02 -7.4945186742027728e-02 +-4.1040676760691876e-02 -7.8978850289843833e-02 +-4.1803524928201358e-02 -8.2859293894931713e-02 +-4.2240852664880695e-02 -8.6552295448586614e-02 +-4.2325549392346694e-02 -9.0033664472391112e-02 +-4.2071673509442908e-02 -9.3256938823601046e-02 +-4.1457840504046058e-02 -9.6180250383838484e-02 +-4.0548998572151891e-02 -9.8779079616149887e-02 +-3.9393841014887791e-02 -1.0101367406660235e-01 +-3.8052517655765658e-02 -1.0285513649045883e-01 +-3.6568200104372298e-02 -1.0428908456703784e-01 +-3.5013859486696858e-02 -1.0537765815887119e-01 +-3.3466490707738390e-02 -1.0617821063524829e-01 +-3.1987201888483072e-02 -1.0675008089118397e-01 +-3.0598619009135904e-02 -1.0713556681356549e-01 +-2.9313507864541448e-02 -1.0739182880247310e-01 +-2.8130228101074638e-02 -1.0756329853659391e-01 +-2.6959691787447247e-02 -1.0779901218339397e-01 + 1.8780301476873887e-02 3.9019090862240078e-03 + 1.8070042097399510e-02 2.8758970834630144e-03 + 1.7237581661942399e-02 1.9343478691949503e-03 + 1.6312167497015355e-02 9.2170193307224461e-04 + 1.5288402595094192e-02 -2.0394361137183125e-04 + 1.4153501448497922e-02 -1.4533357581297088e-03 + 1.2891834872110883e-02 -2.8294381173596308e-03 + 1.1489208760493247e-02 -4.3310317076077571e-03 + 9.9357341631971848e-03 -5.9602350875281413e-03 + 8.2219183591564615e-03 -7.7214659732340509e-03 + 6.3415093310410673e-03 -9.6197174022353716e-03 + 4.2908570220337753e-03 -1.1660948283508409e-02 + 2.0696059273356622e-03 -1.3851180287877062e-02 +-3.1782779935149745e-04 -1.6196876516020271e-02 +-2.8611405922382661e-03 -1.8705769617597019e-02 +-5.5440545193214310e-03 -2.1386657413259520e-02 +-8.3438779795413556e-03 -2.4247800112490860e-02 +-1.1225544701502612e-02 -2.7298108534708539e-02 +-1.4138784677925070e-02 -3.0558235843188127e-02 +-1.7044710751576451e-02 -3.4032026829789459e-02 +-1.9905771962498028e-02 -3.7716276940975249e-02 +-2.2713125335811806e-02 -4.1580556171948592e-02 +-2.5458976267799013e-02 -4.5579786121478748e-02 +-2.8108567780321468e-02 -4.9679289303355710e-02 +-3.0603827427043036e-02 -5.3867655118423841e-02 +-3.2920967570773466e-02 -5.8113134276766232e-02 +-3.5027412268684853e-02 -6.2380831549361915e-02 +-3.6887999450738194e-02 -6.6640258904527627e-02 +-3.8482053291640207e-02 -7.0859344026303006e-02 +-3.9805676841069490e-02 -7.4998976647492624e-02 +-4.0851448182284943e-02 -7.9022023163006508e-02 +-4.1609332197910125e-02 -8.2889834556202732e-02 +-4.2042022146764814e-02 -8.6566455718840599e-02 +-4.2124781248903106e-02 -9.0028214557183947e-02 +-4.1868769585692779e-02 -9.3227768388744095e-02 +-4.1260199347655527e-02 -9.6125190752331946e-02 +-4.0358862885102598e-02 -9.8697171186045637e-02 +-3.9216038704299003e-02 -1.0090384822458526e-01 +-3.7892224386533155e-02 -1.0271565202179743e-01 +-3.6434736615620751e-02 -1.0412722768669837e-01 +-3.4907289980154500e-02 -1.0520155458722415e-01 +-3.3383641319460235e-02 -1.0599425383034458e-01 +-3.1924298760869343e-02 -1.0656016283759105e-01 +-3.0553157738931306e-02 -1.0694468554008309e-01 +-2.9280798191107470e-02 -1.0720169544795113e-01 +-2.8100069623645214e-02 -1.0738897971620921e-01 +-2.6907313081246144e-02 -1.0767673398338395e-01 + 1.8922229309681262e-02 3.8470159151628978e-03 + 1.8228792796073506e-02 2.7514784088964305e-03 + 1.7400412941851118e-02 1.7879806960293229e-03 + 1.6476435512660779e-02 7.7194336635130973e-04 + 1.5452661608433052e-02 -3.5324303776874938e-04 + 1.4316770567220654e-02 -1.6023339632067735e-03 + 1.3053455069897678e-02 -2.9790061493032878e-03 + 1.1649231461013125e-02 -4.4820543653401263e-03 + 1.0094222961211737e-02 -6.1128994827300363e-03 + 8.3790992645466182e-03 -7.8757863677771500e-03 + 6.4976931457367375e-03 -9.7755238042270733e-03 + 4.4464096040703043e-03 -1.1817959578979185e-02 + 2.2250137056583508e-03 -1.4009070891679012e-02 +-1.6192777982994028e-04 -1.6355232596098456e-02 +-2.7040145791876195e-03 -1.8864029517430998e-02 +-5.3849282738859016e-03 -2.1544128823521202e-02 +-8.1816700264025176e-03 -2.4403762670075966e-02 +-1.1058491216203370e-02 -2.7451602242635646e-02 +-1.3966493111922487e-02 -3.0707209490913687e-02 +-1.6866857572366480e-02 -3.4175395695596328e-02 +-1.9723759913673061e-02 -3.7853009088030694e-02 +-2.2527989999957015e-02 -4.1711327274695127e-02 +-2.5270152579806762e-02 -4.5705593761126949e-02 +-2.7914454551662422e-02 -4.9799785789460281e-02 +-3.0405187502523180e-02 -5.3980980430139880e-02 +-3.2717459278144977e-02 -5.8218837633205567e-02 +-3.4818531532517481e-02 -6.2477938037730496e-02 +-3.6673968910233334e-02 -6.6727372380753991e-02 +-3.8263640142967285e-02 -7.0935465371945838e-02 +-3.9582902374021636e-02 -7.5063493428444941e-02 +-4.0624275776299575e-02 -7.9073755801403592e-02 +-4.1376256503371581e-02 -8.2926330167741744e-02 +-4.1803473765247449e-02 -8.6583307303174595e-02 +-4.1883705813917968e-02 -9.0021469606843416e-02 +-4.1625539529848828e-02 -9.3192638978508213e-02 +-4.1022940055577557e-02 -9.6059003399034282e-02 +-4.0130751177588367e-02 -9.8598713372836586e-02 +-3.9002698647524640e-02 -1.0077174313233682e-01 +-3.7700311519779248e-02 -1.0254861602213099e-01 +-3.6274360307078063e-02 -1.0393337902939444e-01 +-3.4778980847008603e-02 -1.0499055174795907e-01 +-3.3283755239423646e-02 -1.0577345107392784e-01 +-3.1848493701075453e-02 -1.0633268938098671e-01 +-3.0498012931142734e-02 -1.0671574267999293e-01 +-2.9240094648498301e-02 -1.0697584574291914e-01 +-2.8059329381745175e-02 -1.0718487727894330e-01 +-2.6838397152225673e-02 -1.0753705313874365e-01 + 1.9091783468256161e-02 3.7923200306124714e-03 + 1.8419104287269211e-02 2.6106036613100358e-03 + 1.7595435471333458e-02 1.6155276067094237e-03 + 1.6673337803705654e-02 5.9283477863546707e-04 + 1.5649649268295578e-02 -5.3242740725474038e-04 + 1.4512621503251574e-02 -1.7812453605199430e-03 + 1.3247407920449400e-02 -3.1585910536479503e-03 + 1.1841266604526340e-02 -4.6633025734763786e-03 + 1.0284430534608546e-02 -6.2960989291696657e-03 + 8.5677419557320961e-03 -8.0609562232900091e-03 + 6.6851409730663133e-03 -9.9624686813131538e-03 + 4.6331058777786208e-03 -1.2006348349660001e-02 + 2.4115432553454990e-03 -1.4198510291525891e-02 + 2.5195494947573308e-05 -1.6545223209505525e-02 +-2.5154202562093016e-03 -1.9053899784793833e-02 +-5.1939189738468214e-03 -2.1733054835749509e-02 +-7.9869295073531493e-03 -2.4590869831513415e-02 +-1.0858005320542203e-02 -2.7635696230561564e-02 +-1.3759721122326251e-02 -3.0885933229826305e-02 +-1.6653489936245193e-02 -3.4347396680102303e-02 +-1.9505382436163708e-02 -3.8017123695644722e-02 +-2.2305794780023345e-02 -4.1868301935747962e-02 +-2.5043486756174339e-02 -4.5856554334733041e-02 +-2.7681543852337898e-02 -4.9944307087400802e-02 +-3.0166791692010302e-02 -5.4116959278729837e-02 +-3.2473211051636745e-02 -5.8345648509643411e-02 +-3.4567864918651721e-02 -6.2594414216491145e-02 +-3.6417143840208513e-02 -6.6831873481689286e-02 +-3.8001515556610743e-02 -7.1026792986273790e-02 +-3.9315534533301021e-02 -7.5140867609420126e-02 +-4.0351533564394380e-02 -7.9135725156505188e-02 +-4.1096503405116593e-02 -8.2969907963932804e-02 +-4.1517266276449076e-02 -8.6603320958078350e-02 +-4.1594233590304730e-02 -9.0013087073946202e-02 +-4.1333978253578263e-02 -9.3150295290471419e-02 +-4.0738135316680898e-02 -9.5979407804733796e-02 +-3.9857073866645165e-02 -9.8480309117319920e-02 +-3.8746775507948208e-02 -1.0061283315773556e-01 +-3.7470556895806063e-02 -1.0234861267181608e-01 +-3.6081636294002718e-02 -1.0370132100505659e-01 +-3.4624399144860665e-02 -1.0473777918673362e-01 +-3.3163233533883653e-02 -1.0550852798622927e-01 +-3.1757002108945429e-02 -1.0606022648446843e-01 +-3.0430889674543622e-02 -1.0644162045765680e-01 +-2.9188758539943353e-02 -1.0670827600618406e-01 +-2.8004048615611666e-02 -1.0694665578569509e-01 +-2.6748125224948321e-02 -1.0737772650682721e-01 + 1.9294725157573026e-02 3.7399657102810111e-03 + 1.8647680110193052e-02 2.4527245048915195e-03 + 1.7829092382262809e-02 1.4136443623512128e-03 + 1.6909289756054297e-02 3.7913852052075199e-04 + 1.5885847679490250e-02 -7.4739351885398468e-04 + 1.4747542692775464e-02 -1.9960872605235690e-03 + 1.3480153349046948e-02 -3.3742317298647686e-03 + 1.2071721782532031e-02 -4.8808385186873892e-03 + 1.0512708942319768e-02 -6.5159416256222518e-03 + 8.7941497444840692e-03 -8.2831399246294131e-03 + 6.9101179668370595e-03 -1.0186770308639960e-02 + 4.8571892512958171e-03 -1.2232378974930505e-02 + 2.6354363165138070e-03 -1.4425795133296173e-02 + 2.4980550490590417e-04 -1.6773159320536624e-02 +-2.2890439392780140e-03 -1.9281684661635327e-02 +-4.9646233065082116e-03 -2.1959708216414252e-02 +-7.7531159613921244e-03 -2.4815326651136668e-02 +-1.0617386679896102e-02 -2.7856473411049281e-02 +-1.3511567501666127e-02 -3.1100334130514988e-02 +-1.6397524444896845e-02 -3.4553741969686400e-02 +-1.9243380217970611e-02 -3.8214109749993147e-02 +-2.2039114486189747e-02 -4.2056738982009928e-02 +-2.4771383778428243e-02 -4.6037694114914679e-02 +-2.7402078935409125e-02 -5.0117632055432147e-02 +-2.9880678834842377e-02 -5.4280112838455345e-02 +-3.2180059978101812e-02 -5.8497773851328809e-02 +-3.4267050526717489e-02 -6.2734112944070830e-02 +-3.6108966962087610e-02 -6.6957224228772816e-02 +-3.7686926188324102e-02 -7.1136357630294356e-02 +-3.8994631592387842e-02 -7.5233648336578141e-02 +-4.0024057504202064e-02 -7.9209927021395884e-02 +-4.0760711786136827e-02 -8.3021894367637239e-02 +-4.1173863123993487e-02 -8.6627029124686589e-02 +-4.1246662574667539e-02 -9.0002622142994093e-02 +-4.0984482561970161e-02 -9.3099198549240356e-02 +-4.0396284808829834e-02 -9.5883637987427051e-02 +-3.9528727023327562e-02 -9.8337843077771339e-02 +-3.8439857516184159e-02 -1.0042168711081970e-01 +-3.7195501304546595e-02 -1.0210916625248764e-01 +-3.5850031283334791e-02 -1.0342366319764032e-01 +-3.4438035779346406e-02 -1.0443504789527808e-01 +-3.3017669422690993e-02 -1.0519082596161194e-01 +-3.1646352570816480e-02 -1.0573395171534603e-01 +-3.0348754481092310e-02 -1.0611416122931246e-01 +-2.9123039540166082e-02 -1.0639222157901049e-01 +-2.7928916434033873e-02 -1.0666936362995133e-01 +-2.6630419451855892e-02 -1.0719615563651634e-01 + 1.9538131270026717e-02 3.6927608166976707e-03 + 1.8922821230384936e-02 2.2777172401546733e-03 + 1.8109305621570558e-02 1.1790501067635245e-03 + 1.7191979266880722e-02 1.2506869837984933e-04 + 1.6169001151225184e-02 -1.0050749727280471e-03 + 1.5029305875801136e-02 -2.2540717622671715e-03 + 1.3759436789794063e-02 -3.6331852711414558e-03 + 1.2348287481471475e-02 -5.1419462426594139e-03 + 1.0786684039691507e-02 -6.7797592280243709e-03 + 9.0658912019871800e-03 -8.5497328525014002e-03 + 7.1801479053352733e-03 -1.0455886859678288e-02 + 5.1261583141041815e-03 -1.2503563754508071e-02 + 2.9041904479251046e-03 -1.4698475508443207e-02 + 5.1942666227736264e-04 -1.7046607202204318e-02 +-2.0172997133089143e-03 -1.9554941616903011e-02 +-4.6893452019702879e-03 -2.2231607715042394e-02 +-7.4723690481736018e-03 -2.5084567505857129e-02 +-1.0328587039495742e-02 -2.8121220092757439e-02 +-1.3213750616814474e-02 -3.1357513368563301e-02 +-1.6090466616063559e-02 -3.4801281914040548e-02 +-1.8929046357768757e-02 -3.8450557532662195e-02 +-2.1719034144240860e-02 -4.2282954536870650e-02 +-2.4444722016441277e-02 -4.6255042624138938e-02 +-2.7066748495799490e-02 -5.0325487554871921e-02 +-2.9537292102462229e-02 -5.4475860027082448e-02 +-3.1828205289756967e-02 -5.8680255424462716e-02 +-3.3906051622662935e-02 -6.2901649372065507e-02 +-3.5739168248327700e-02 -6.7107572112547545e-02 +-3.7309363419593546e-02 -7.1267789911303184e-02 +-3.8609450553781038e-02 -7.5344883056587278e-02 +-3.9630833954539944e-02 -7.9298731966816235e-02 +-4.0357636456879863e-02 -8.3083843874011576e-02 +-4.0761808517113689e-02 -8.6655022994436406e-02 +-4.0829362572047077e-02 -8.9989493065691262e-02 +-4.0565526204054674e-02 -9.3037453419782951e-02 +-3.9986008516391273e-02 -9.5768328106046796e-02 +-3.9134799232208306e-02 -9.8166326134616427e-02 +-3.8071908715643157e-02 -1.0019179553914190e-01 +-3.6866195855720513e-02 -1.0182253994203289e-01 +-3.5571685707914608e-02 -1.0309162711228656e-01 +-3.4213189859007336e-02 -1.0407262581962436e-01 +-3.2841638670352148e-02 -1.0481007072958184e-01 +-3.1512153902016900e-02 -1.0534352143434458e-01 +-3.0247475322383359e-02 -1.0572412615203894e-01 +-2.9037636931821698e-02 -1.0602004908367825e-01 +-2.7826913951588084e-02 -1.0634730833438157e-01 +-2.6477643084686264e-02 -1.0698929374498847e-01 + 1.9830719590867171e-02 3.6543100198542866e-03 + 1.9254764550442279e-02 2.0859946354221423e-03 + 1.8445922504568960e-02 9.0863121968697892e-04 + 1.7530692940787278e-02 -1.7557662454337124e-04 + 1.6508360956763023e-02 -1.3134937372890996e-03 + 1.5367212523865132e-02 -2.5638067774319375e-03 + 1.4094542358311373e-02 -3.9441695016791687e-03 + 1.2680192871981544e-02 -5.4553794028606240e-03 + 1.1115511531682574e-02 -7.0963534766690182e-03 + 9.3920551194296223e-03 -8.8696072093772723e-03 + 7.5042674080136639e-03 -1.0778762961468872e-02 + 5.4490207525479386e-03 -1.2828910335074467e-02 + 3.2268133962414774e-03 -1.5025603013587572e-02 + 8.4310016853437206e-04 -1.7374636543693065e-02 +-1.6910704301780588e-03 -1.9882728685558859e-02 +-4.3588321128477034e-03 -2.2557763067737661e-02 +-7.1352406935460489e-03 -2.5407496574544448e-02 +-9.9819369329341122e-03 -2.8438662126007302e-02 +-1.2856332754400273e-02 -3.1665976081500478e-02 +-1.5722129611849028e-02 -3.5098231453288296e-02 +-1.8551937537441839e-02 -3.8734379313502543e-02 +-2.1334849788194610e-02 -4.2554534360588078e-02 +-2.4052546420654526e-02 -4.6515832509469959e-02 +-2.6664372504448579e-02 -5.0574736377668815e-02 +-2.9125158508826524e-02 -5.4710693316905777e-02 +-3.1405879261634233e-02 -5.8899133660360876e-02 +-3.3472820306618335e-02 -6.3102550289684298e-02 +-3.5295420737734118e-02 -6.7287883997891665e-02 +-3.6856209806479141e-02 -7.1425436395443409e-02 +-3.8147080486421792e-02 -7.5478210787749897e-02 +-3.9158624646874911e-02 -7.9404948790966129e-02 +-3.9873764893087048e-02 -8.3157568827122288e-02 +-4.0267337600985886e-02 -8.6687942216016931e-02 +-4.0328397452287994e-02 -8.9972932683938495e-02 +-4.0063268972576373e-02 -9.2962712009025963e-02 +-3.9493680863309823e-02 -9.5629365375855868e-02 +-3.8662231051038616e-02 -9.7959709138847301e-02 +-3.7630959004790146e-02 -9.9915366966835478e-02 +-3.6471898408999337e-02 -1.0147950412992490e-01 +-3.5237131625867196e-02 -1.0269479317101933e-01 +-3.3941703069006485e-02 -1.0363899470830294e-01 +-3.2628416412806956e-02 -1.0435415085506944e-01 +-3.1348732333995877e-02 -1.0487702049801753e-01 +-3.0121277839396741e-02 -1.0526113844943413e-01 +-2.8925157177598373e-02 -1.0558308009100449e-01 +-2.7688908825468428e-02 -1.0597393980687572e-01 +-2.6280228013501338e-02 -1.0675353452454273e-01 + 2.0183243556936525e-02 3.6291823544872346e-03 + 1.9656051837785824e-02 1.8786338515185430e-03 + 1.8851254575869367e-02 5.9952606972051795e-04 + 1.7936791993602898e-02 -5.2925649092191366e-04 + 1.6915004376398392e-02 -1.6817222637290291e-03 + 1.5772384759735292e-02 -2.9354816202277925e-03 + 1.4496593815999459e-02 -4.3176430364721347e-03 + 1.3078511470584796e-02 -5.8316581785926329e-03 + 1.1510184441344619e-02 -7.4762933512597021e-03 + 9.7835572482771315e-03 -9.2534072850155615e-03 + 7.8933320609760847e-03 -1.1166125085100370e-02 + 5.8365993114747371e-03 -1.3219217735680565e-02 + 3.6141297390852138e-03 -1.5418027275461705e-02 + 1.2316927459201932e-03 -1.7768116906921195e-02 +-1.2993947715237556e-03 -2.0275899759126359e-02 +-3.9619565970374186e-03 -2.2948966925226133e-02 +-6.7303722821312256e-03 -2.5794774232507336e-02 +-9.5658165244818048e-03 -2.8819246556252395e-02 +-1.2427389262609674e-02 -3.2035905542657610e-02 +-1.5280296470105998e-02 -3.5454441281782920e-02 +-1.8099527054952706e-02 -3.9075073805355000e-02 +-2.0873709403173034e-02 -4.2880588176909533e-02 +-2.3581700242485796e-02 -4.6828739198415084e-02 +-2.6181523440710567e-02 -5.0873602571354912e-02 +-2.8630503513254326e-02 -5.4992387996944295e-02 +-3.0898951979806123e-02 -5.9161642698708800e-02 +-3.2952893125180002e-02 -6.3343432155048049e-02 +-3.4762926274510157e-02 -6.7504105259697855e-02 +-3.6312313038092126e-02 -7.1614496563764923e-02 +-3.7592000002093458e-02 -7.5637970293737519e-02 +-3.8591514790942458e-02 -7.9531895255865792e-02 +-3.9292853756097382e-02 -8.3245167813786033e-02 +-3.9673908197666141e-02 -8.6726452993612715e-02 +-3.9727070405923777e-02 -8.9951919322999202e-02 +-3.9461089185442576e-02 -9.2872045928597755e-02 +-3.8902994696538511e-02 -9.5461699951154527e-02 +-3.8095423612041393e-02 -9.7710662381099225e-02 +-3.7102728320056420e-02 -9.9583088001344633e-02 +-3.5999709704963988e-02 -1.0106907466194549e-01 +-3.4834940857301482e-02 -1.0222081255941329e-01 +-3.3613624387588616e-02 -1.0312060623173459e-01 +-3.2369576791882772e-02 -1.0380897779479052e-01 +-3.1148549371964953e-02 -1.0432101357875957e-01 +-2.9961975830886330e-02 -1.0471355493008153e-01 +-2.8775474229651647e-02 -1.0507136371580027e-01 +-2.7503196770711797e-02 -1.0554174863776081e-01 +-2.6026220256422580e-02 -1.0648459727188224e-01 + 2.0608947064396914e-02 3.6231260321886306e-03 + 2.0141945675336070e-02 1.6575185203966426e-03 + 1.9340670348383986e-02 2.4920612612132402e-04 + 1.8424375456887479e-02 -9.4255654570934533e-04 + 1.7402289059595587e-02 -2.1197455226223279e-03 + 1.6258117895597116e-02 -3.3809866488350923e-03 + 1.4978910650741306e-02 -4.7661087592686903e-03 + 1.3556525598414141e-02 -6.2834213899361181e-03 + 1.1983901914089611e-02 -7.9322728384150273e-03 + 1.0253509438486796e-02 -9.7139044616891181e-03 + 8.3603852575858222e-03 -1.1630835472375207e-02 + 6.3019007506036106e-03 -1.3687430373561340e-02 + 4.0791509052860849e-03 -1.5888750167761423e-02 + 1.6982696466203860e-03 -1.8240071630753616e-02 +-8.2908869684679160e-04 -2.0747456649199674e-02 +-3.4853316602414400e-03 -2.3418142136913948e-02 +-6.2441052779094470e-03 -2.6259157827136149e-02 +-9.0662593545062162e-03 -2.9275477075098560e-02 +-1.1912610979929825e-02 -3.2479490304522074e-02 +-1.4750314185741301e-02 -3.5881722217446219e-02 +-1.7556787664055433e-02 -3.9484042676761942e-02 +-2.0320182267136128e-02 -4.3272053809109236e-02 +-2.3016382870575069e-02 -4.7204168271241381e-02 +-2.5602069549132894e-02 -5.1231941518912028e-02 +-2.8036787128751201e-02 -5.5330251087174875e-02 +-3.0290456650784971e-02 -5.9476442085089100e-02 +-3.2328904568949351e-02 -6.3632212994082865e-02 +-3.4123916351473653e-02 -6.7763348356851411e-02 +-3.5659471610579765e-02 -7.1841183301560363e-02 +-3.6925543051649426e-02 -7.5829323902853726e-02 +-3.7910367612555590e-02 -7.9683474934471588e-02 +-3.8595367833308136e-02 -8.3349048604366135e-02 +-3.8961639261210060e-02 -8.6771208228398275e-02 +-3.9005372266648394e-02 -8.9925076265135795e-02 +-3.8739028952394311e-02 -9.2761773001939454e-02 +-3.8194444819445464e-02 -9.5259100068104757e-02 +-3.7415790460716566e-02 -9.7410316726636414e-02 +-3.6470170415983542e-02 -9.9183844334712820e-02 +-3.5434135723370577e-02 -1.0057822472478399e-01 +-3.4351284420129337e-02 -1.0165510657467498e-01 +-3.3216764957118186e-02 -1.0250169492260446e-01 +-3.2054387097772467e-02 -1.0315853922141864e-01 +-3.0901280878066890e-02 -1.0366064559423917e-01 +-2.9757968679756452e-02 -1.0406823068291104e-01 +-2.8574999786870583e-02 -1.0447345469955276e-01 +-2.7254971045009301e-02 -1.0504217191680737e-01 +-2.5700742047852256e-02 -1.0617743127499478e-01 + 2.1124063855884029e-02 3.6433405910401653e-03 + 2.0730917860494975e-02 1.4254977909190546e-03 + 1.9933211401908180e-02 -1.4442752078018558e-04 + 1.9011113501593811e-02 -1.4221214655811159e-03 + 1.7986530624797995e-02 -2.6382732757524712e-03 + 1.6840340141758076e-02 -3.9139080811599171e-03 + 1.5557430132889396e-02 -5.3043987922191411e-03 + 1.4130159475013513e-02 -6.8258322682334949e-03 + 1.2552510760747291e-02 -8.4795398747127652e-03 + 1.0817663849064071e-02 -1.0266424413359045e-02 + 8.9211028683473196e-03 -1.2188316365043535e-02 + 6.8605611545575528e-03 -1.4249061304451475e-02 + 4.6375222278343363e-03 -1.6453348628220538e-02 + 2.2585460184988775e-03 -1.8806099817580822e-02 +-2.6428700096570781e-04 -2.1312968100160694e-02 +-2.9128458347766218e-03 -2.3980754175978954e-02 +-5.6600110737737132e-03 -2.6815906784291792e-02 +-8.4664756436031753e-03 -2.9822312875211168e-02 +-1.1294825693614929e-02 -3.3011314792876077e-02 +-1.4114605384295405e-02 -3.6394232571735373e-02 +-1.6905689592676246e-02 -3.9974968713841652e-02 +-1.9655742611706817e-02 -4.3742060224072524e-02 +-2.2337618671248519e-02 -4.7654599992438595e-02 +-2.4906624245436895e-02 -5.1661563364359939e-02 +-2.7324144881950459e-02 -5.5735417386228128e-02 +-2.9560019227324374e-02 -5.9853891356692696e-02 +-3.1580001331821879e-02 -6.3978363983406325e-02 +-3.3357049753017377e-02 -6.8074115359945342e-02 +-3.4875812547246539e-02 -7.2112909217463120e-02 +-3.6125253858140131e-02 -7.6058396584823579e-02 +-3.7092164191419648e-02 -7.9864257248428078e-02 +-3.7757800807635224e-02 -8.3471938721032438e-02 +-3.8106637183737080e-02 -8.6822779809005893e-02 +-3.8139307820206594e-02 -8.9890522750450855e-02 +-3.7873141896228188e-02 -9.2627218838853068e-02 +-3.7344725061889891e-02 -9.5013841428492368e-02 +-3.6601239044474841e-02 -9.7047960440970013e-02 +-3.5712925150236705e-02 -9.8704407113138756e-02 +-3.4756555602490129e-02 -9.9991586706917587e-02 +-3.3769376786952653e-02 -1.0098063004734938e-01 +-3.2736052999623969e-02 -1.0176429603767900e-01 +-3.1668823272282487e-02 -1.0238522388351999e-01 +-3.0592453202853309e-02 -1.0287966121265901e-01 +-2.9493044093835706e-02 -1.0331023456674608e-01 +-2.8305854205273494e-02 -1.0377625515884106e-01 +-2.6925684461629164e-02 -1.0446550001058871e-01 +-2.5285370900965588e-02 -1.0582616169313777e-01 + 2.1748354352729114e-02 3.6988127561770139e-03 + 2.1445232584760190e-02 1.1865743488925844e-03 + 2.0652241641760695e-02 -5.8292502296815926e-04 + 1.9719173676945905e-02 -1.9746326738648095e-03 + 1.8687968512520747e-02 -3.2486039864520651e-03 + 1.7538276801593086e-02 -4.5493836187382652e-03 + 1.6251223478921023e-02 -5.9498626792305210e-03 + 1.4818492274612342e-02 -7.4770133743271043e-03 + 1.3235032512547810e-02 -9.1364035723841743e-03 + 1.1494947101154415e-02 -1.0929360865106078e-02 + 9.5943296230203649e-03 -1.2857058882661926e-02 + 7.5313839470804254e-03 -1.4922698113746578e-02 + 5.3080639179702181e-03 -1.7130478950210172e-02 + 2.9314340464784774e-03 -1.9484878719424874e-02 + 4.1411241839414508e-04 -2.1991067373477217e-02 +-2.2251008832193282e-03 -2.4655300087459715e-02 +-4.9583228158449994e-03 -2.7483263638174608e-02 +-7.7462791352683200e-03 -3.0477642123459447e-02 +-1.0553420932334702e-02 -3.3648825912357599e-02 +-1.3352080003805307e-02 -3.7008939759445657e-02 +-1.6124596065286240e-02 -4.0564266527136170e-02 +-1.8858150532388207e-02 -4.4306360078776350e-02 +-2.1522618362860239e-02 -4.8195002050263204e-02 +-2.4071882969702467e-02 -5.2176619669807772e-02 +-2.6468713257780566e-02 -5.6221201730522440e-02 +-2.8683172313190036e-02 -6.0306374657130464e-02 +-3.0681136336903472e-02 -6.4393206962037250e-02 +-3.2436684172297607e-02 -6.8446558898315427e-02 +-3.3935036670451953e-02 -7.2438500026066333e-02 +-3.5164107261379134e-02 -7.6332427841151254e-02 +-3.6109201777622738e-02 -8.0079554583463081e-02 +-3.6751853712870194e-02 -8.3616872208611012e-02 +-3.7080183721739164e-02 -8.6881546661526143e-02 +-3.7100072243528494e-02 -8.9845649871736114e-02 +-3.6834733408104371e-02 -9.2462385625736790e-02 +-3.6326040646991527e-02 -9.4716323183689055e-02 +-3.5625556381240937e-02 -9.6610684780499848e-02 +-3.4806675763936444e-02 -9.8129108082712607e-02 +-3.3944568322178487e-02 -9.9291215403683616e-02 +-3.3068744841749570e-02 -1.0017791195220832e-01 +-3.2152474066610134e-02 -1.0088872396363129e-01 +-3.1193932086809879e-02 -1.0147030463223587e-01 +-3.0201638521489185e-02 -1.0196028291120197e-01 +-2.9145033885910204e-02 -1.0242265886528221e-01 +-2.7944899341200466e-02 -1.0296495017231813e-01 +-2.6492259256360159e-02 -1.0380079573576680e-01 +-2.4757423201088931e-02 -1.0542408879390559e-01 + 2.2505695562813680e-02 3.8007215449979981e-03 + 2.2311644140025757e-02 9.4614081657339759e-04 + 2.1526170729294022e-02 -1.0671431741258977e-03 + 2.0576172665358241e-02 -2.6067895298075754e-03 + 1.9531982085770821e-02 -3.9626078707777034e-03 + 1.8375455311475331e-02 -5.3039117300960779e-03 + 1.7083185157411591e-02 -6.7223767640741333e-03 + 1.5644371128781941e-02 -8.2584394162381666e-03 + 1.4054290052071665e-02 -9.9248108205216828e-03 + 1.2308101329762051e-02 -1.1724789813300485e-02 + 1.0402726282994965e-02 -1.3659233836409176e-02 + 8.3369906876185340e-03 -1.5730607679680247e-02 + 6.1134269496688660e-03 -1.7942477719304423e-02 + 3.7397074050535377e-03 -2.0298760640088492e-02 + 1.2291227420825059e-03 -2.2804041599528112e-02 +-1.3987311515624966e-03 -2.5463887228411881e-02 +-4.1152484486749134e-03 -2.8283024333703416e-02 +-6.8813977635552460e-03 -3.1262843393622071e-02 +-9.6636462299051640e-03 -3.4412890296147143e-02 +-1.2437425108124015e-02 -3.7746168988335861e-02 +-1.5187535067741861e-02 -4.1271617930046217e-02 +-1.7900709028446142e-02 -4.4983844125680371e-02 +-2.0544010393702024e-02 -4.8843323049538673e-02 +-2.3069825461572987e-02 -5.2794064531312253e-02 +-2.5441814920723657e-02 -5.6803518433824217e-02 +-2.7630528140320312e-02 -6.0848683647378679e-02 +-2.9602216454192205e-02 -6.4890264072062068e-02 +-3.1331993045803967e-02 -6.8892785142395455e-02 +-3.2805501007886394e-02 -7.2828433992356126e-02 +-3.4009564038801496e-02 -7.6659930344987956e-02 +-3.4928116983814553e-02 -8.0335484611581187e-02 +-3.5543441759845230e-02 -8.3787133753022630e-02 +-3.5847747409625492e-02 -8.6947509873661635e-02 +-3.5853053360247251e-02 -8.9786780828122886e-02 +-3.5589485802502485e-02 -9.2259493960569039e-02 +-3.5105342680126841e-02 -9.4354607447172556e-02 +-3.4457670687119461e-02 -9.6082985207274471e-02 +-3.3722415665848222e-02 -9.7439586056677505e-02 +-3.2971191913008562e-02 -9.8456689886977186e-02 +-3.2224111931983768e-02 -9.9225852337774229e-02 +-3.1441121290852365e-02 -9.9854661228202968e-02 +-3.0603301142559210e-02 -1.0039430659590705e-01 +-2.9700345440936821e-02 -1.0088314302303526e-01 +-2.8684303291763538e-02 -1.0138664162746183e-01 +-2.7462574799191976e-02 -1.0202305945359806e-01 +-2.5926093321528391e-02 -1.0303585614528485e-01 +-2.4089104220768865e-02 -1.0496373955536718e-01 + 2.3424767773674880e-02 3.9629223843462560e-03 + 2.3362232943030158e-02 7.1128775377359802e-04 + 2.2589296013762993e-02 -1.5970655561120030e-03 + 2.1616166125763763e-02 -3.3252704302104662e-03 + 2.0550423254966737e-02 -4.7928006581530631e-03 + 1.9381120744198413e-02 -6.1952752841567503e-03 + 1.8081057952415835e-02 -7.6441916176719958e-03 + 1.6635182280171919e-02 -9.1951674796604335e-03 + 1.5037652396331763e-02 -1.0870938502705509e-02 + 1.3284450749033859e-02 -1.2679187947654455e-02 + 1.1373550077274678e-02 -1.4621423667110263e-02 + 9.3046093433073636e-03 -1.6699459455501393e-02 + 7.0808899772301648e-03 -1.8916077234907278e-02 + 4.7108095104326066e-03 -2.1274480378324041e-02 + 2.2084866092353050e-03 -2.3778527904880803e-02 +-4.0557882095584847e-04 -2.6432917242772233e-02 +-3.1021402327596525e-03 -2.9241213044457884e-02 +-5.8426430706117350e-03 -3.2203451248310123e-02 +-8.5957680765823951e-03 -3.5328458464544674e-02 +-1.1340245519721839e-02 -3.8630253638219592e-02 +-1.4063321696864618e-02 -4.2120605270494646e-02 +-1.6751370479286137e-02 -4.5797151794260187e-02 +-1.9368915025542003e-02 -4.9621080367799546e-02 +-2.1866757196552830e-02 -5.3534202785826310e-02 +-2.4208974106220867e-02 -5.7501380820255570e-02 +-2.6366778348309507e-02 -6.1498468373329722e-02 +-2.8307070759983094e-02 -6.5485664807894750e-02 +-3.0005891066323696e-02 -6.9427199953125296e-02 +-3.1449100425239448e-02 -7.3295102160685133e-02 +-3.2622420519778761e-02 -7.7050842819943469e-02 +-3.3508692604437756e-02 -8.0638995730169208e-02 +-3.4091489496592235e-02 -8.3986127821136208e-02 +-3.4367766829073339e-02 -8.7019983642966953e-02 +-3.4356649050175582e-02 -8.9708656981743545e-02 +-3.4096469265888656e-02 -9.2008364801756906e-02 +-3.3643484742412397e-02 -9.3913886383788281e-02 +-3.3060802393934462e-02 -9.5446405253269709e-02 +-3.2425654858809744e-02 -9.6614949885219820e-02 +-3.1803809108452777e-02 -9.7466417183645765e-02 +-3.1203165165622552e-02 -9.8103883008952494e-02 +-3.0567663521093549e-02 -9.8642541488937696e-02 +-2.9859749594970134e-02 -9.9137424984337266e-02 +-2.9049627699780735e-02 -9.9627529515283642e-02 +-2.8071988983078309e-02 -1.0018169570347660e-01 +-2.6821453060125913e-02 -1.0093263339130785e-01 +-2.5191804908638742e-02 -1.0215726028879295e-01 +-2.3246458785448440e-02 -1.0443696589557915e-01 + 2.4539900805119204e-02 4.2025280974939960e-03 + 2.4635408218043605e-02 4.9120572216309840e-04 + 2.3882815825214655e-02 -2.1715727096563212e-03 + 2.2880735248480034e-02 -4.1366579408051050e-03 + 2.1782987557553948e-02 -5.7524488805720019e-03 + 2.0591946401731828e-02 -7.2426454908198932e-03 + 1.9278974162390574e-02 -8.7398041054456473e-03 + 1.7823936523041008e-02 -1.0315827274894223e-02 + 1.6217942487043127e-02 -1.2005670478146171e-02 + 1.4456815047342881e-02 -1.3824220180240007e-02 + 1.2539593943384329e-02 -1.5775489462982750e-02 + 1.0467030164220027e-02 -1.7861190189254375e-02 + 8.2433296094150121e-03 -2.0083256365439683e-02 + 5.8778378818531993e-03 -2.2443991416423746e-02 + 3.3856701949441246e-03 -2.4946333621684875e-02 + 7.8830633894514475e-04 -2.7593893054387350e-02 +-1.8844909793864118e-03 -3.0388879056659310e-02 +-4.5949056874622961e-03 -3.3329945554829078e-02 +-7.3140448648690666e-03 -3.6425352954140872e-02 +-1.0024021419218839e-02 -3.9690303688149756e-02 +-1.2714499484757533e-02 -4.3139457292495950e-02 +-1.5371658400601501e-02 -4.6773393989752339e-02 +-1.7957828271711582e-02 -5.0554056293307718e-02 +-2.0422157844855824e-02 -5.4421339363372560e-02 +-2.2728726936159082e-02 -5.8337495260744276e-02 +-2.4849478868270242e-02 -6.2276767128537358e-02 +-2.6752195756011232e-02 -6.6198613398739781e-02 +-2.8413721616095573e-02 -7.0066893759886284e-02 +-2.9819900051671625e-02 -7.3853076168632015e-02 +-3.0955396871585786e-02 -7.7516652785035958e-02 +-3.1802396376829689e-02 -8.0997815318582536e-02 +-3.2346451933310413e-02 -8.4217113542878030e-02 +-3.2590151534166965e-02 -8.7097073097883171e-02 +-3.2560914380511882e-02 -8.9603673893777602e-02 +-3.2307057940614593e-02 -9.1695627540986049e-02 +-3.1894315797132478e-02 -9.3375944262021449e-02 +-3.1391690488836610e-02 -9.4679702719019890e-02 +-3.0875680810026399e-02 -9.5633823806919593e-02 +-3.0401893124477598e-02 -9.6301738565381878e-02 +-2.9961594696677599e-02 -9.6795277508226321e-02 +-2.9483230692803047e-02 -9.7235427405374733e-02 +-2.8911307804914112e-02 -9.7680554235110337e-02 +-2.8197207053370799e-02 -9.8172266771835756e-02 +-2.7257773761286807e-02 -9.8786401754320657e-02 +-2.5974402164331074e-02 -9.9674655292473907e-02 +-2.4245642342717217e-02 -1.0115055302461054e-01 +-2.2188040694160444e-02 -1.0383509496500994e-01 +-8.3218261499371893e-02 -1.0792142418209764e-01 +-8.4188066651068302e-02 -1.0608194115679435e-01 +-8.4895120265118279e-02 -1.0404076300304842e-01 +-8.5263434754297540e-02 -1.0182824797619307e-01 +-8.5356514176440468e-02 -9.9506349662212806e-02 +-8.5132440506982793e-02 -9.7112166787161544e-02 +-8.4594524410818689e-02 -9.4686000905417428e-02 +-8.3802458745467337e-02 -9.2245886854660633e-02 +-8.2807504239255703e-02 -8.9796644800874820e-02 +-8.1639449988372678e-02 -8.7339650185545167e-02 +-8.0279889601029719e-02 -8.4897969070116527e-02 +-7.8774894180383331e-02 -8.2458875533095416e-02 +-7.7148662263353526e-02 -8.0016290123938849e-02 +-7.5410286184263958e-02 -7.7571994105059078e-02 +-7.3552939197822936e-02 -7.5139517853942947e-02 +-7.1585400045660955e-02 -7.2721918431569929e-02 +-6.9525554800432987e-02 -7.0313807061055750e-02 +-6.7388809025357072e-02 -6.7910472727561746e-02 +-6.5187984980224503e-02 -6.5508929939099181e-02 +-6.2932356287974681e-02 -6.3109240238502867e-02 +-6.0612772078547053e-02 -6.0729307863509663e-02 +-5.8238491942664540e-02 -5.8370419898706026e-02 +-5.5823027212227552e-02 -5.6028842913133793e-02 +-5.3374805817166616e-02 -5.3705695712221717e-02 +-5.0897054652233813e-02 -5.1407897165685126e-02 +-4.8406123465974740e-02 -4.9128098123968025e-02 +-4.5910354015242211e-02 -4.6867065623265751e-02 +-4.3414045075672078e-02 -4.4629875403591403e-02 +-4.0915720639141513e-02 -4.2428107334448899e-02 +-3.8423833773869258e-02 -4.0262000131868536e-02 +-3.5943328163689392e-02 -3.8135119322824526e-02 +-3.3481206458242117e-02 -3.6048481147865595e-02 +-3.1046235522795004e-02 -3.4000358136757738e-02 +-2.8642957666200772e-02 -3.1993350241441836e-02 +-2.6270944770223337e-02 -3.0035576121795384e-02 +-2.3939082669576017e-02 -2.8123351621775417e-02 +-2.1651880043610842e-02 -2.6257501568901963e-02 +-1.9410592771184520e-02 -2.4442205942266652e-02 +-1.7217396371539163e-02 -2.2679921240754786e-02 +-1.5076805319016210e-02 -2.0969466095070669e-02 +-1.2990387473444670e-02 -1.9312615962294631e-02 +-1.0958784967495036e-02 -1.7711716884548753e-02 +-8.9862814963808709e-03 -1.6163814110179420e-02 +-7.0740476241868706e-03 -1.4669213379353159e-02 +-5.2224728520873778e-03 -1.3228638968902450e-02 +-3.4327393112244028e-03 -1.1841221250724719e-02 +-1.7058575628982953e-03 -1.0505739031488007e-02 +-4.1837318180244778e-05 -9.2217470021583384e-03 + 1.5599264210935469e-03 -7.9891237867996349e-03 + 3.1010144570078921e-03 -6.8086061456110033e-03 + 4.5815437479666543e-03 -5.6786397339145455e-03 + 6.0019432119341933e-03 -4.5977057403651222e-03 + 7.3628726057115125e-03 -3.5642736370947339e-03 + 8.6653580989634275e-03 -2.5770206480600134e-03 + 9.9103712016282743e-03 -1.6343180989633111e-03 + 1.1098931622037102e-02 -7.3439593022127717e-04 + 1.2232529765029431e-02 1.2405761258317750e-04 + 1.3312549222945705e-02 9.4262294099923790e-04 + 1.4340431308817415e-02 1.7229121838395719e-03 + 1.5318165163358025e-02 2.4658906059855349e-03 + 1.6247876373157832e-02 3.1723842219650174e-03 + 1.7131357454361233e-02 3.8436769739607912e-03 + 1.7970107249042598e-02 4.4814510974008799e-03 +-8.3227022198404554e-02 -1.0792707365296615e-01 +-8.4197811198710532e-02 -1.0608616857848308e-01 +-8.4905276522339201e-02 -1.0404334775243489e-01 +-8.5274231094605579e-02 -1.0182935861422192e-01 +-8.5367289881379663e-02 -9.9506062675867882e-02 +-8.5143162651338603e-02 -9.7110483155016497e-02 +-8.4605244549468828e-02 -9.4683079806765991e-02 +-8.3813097355307259e-02 -9.2242005044804148e-02 +-8.2817986536316168e-02 -8.9792028675412444e-02 +-8.1649578796206074e-02 -8.7334429476009057e-02 +-8.0289874133203432e-02 -8.4892112878427933e-02 +-7.8784719292631047e-02 -8.2452576291308602e-02 +-7.7158305241173009e-02 -8.0009653351586496e-02 +-7.5419685766308961e-02 -7.7565066121711573e-02 +-7.3562130582788959e-02 -7.5132271422010316e-02 +-7.1594434118199199e-02 -7.2714380430443329e-02 +-6.9534460549265972e-02 -7.0306040481172949e-02 +-6.7397609433089090e-02 -6.7902528993287928e-02 +-6.5196691388311398e-02 -6.5500849306161985e-02 +-6.2940899933416158e-02 -6.3101062647958978e-02 +-6.0621188246282723e-02 -6.0720972011223978e-02 +-5.8246814517313360e-02 -5.8361939514396347e-02 +-5.5831262518786291e-02 -5.6020256498737764e-02 +-5.3382940489244829e-02 -5.3697024135413142e-02 +-5.0905142657925825e-02 -5.1399118143858002e-02 +-4.8414169815374303e-02 -4.9119261634367743e-02 +-4.5918352118562850e-02 -4.6858189304476001e-02 +-4.3421963372864969e-02 -4.4620965636515131e-02 +-4.0923580821413716e-02 -4.2419126967617231e-02 +-3.8431632999007211e-02 -4.0252966285739475e-02 +-3.5951076964011244e-02 -3.8126029341019572e-02 +-3.3488924768649737e-02 -3.6039339557025082e-02 +-3.1053921777634979e-02 -3.3991187265076064e-02 +-2.8650587424040818e-02 -3.1984160272147483e-02 +-2.6278549225807097e-02 -3.0026332824648356e-02 +-2.3946664395977826e-02 -2.8114081962710848e-02 +-2.1659427727171384e-02 -2.6248216136229661e-02 +-1.9418103831482587e-02 -2.4432895370861355e-02 +-1.7224883659365420e-02 -2.2670577174748532e-02 +-1.5084263900234053e-02 -2.0960102862856017e-02 +-1.2997809847792658e-02 -1.9303233031092368e-02 +-1.0966190630757825e-02 -1.7702299329124382e-02 +-8.9936688930831246e-03 -1.6154381407007683e-02 +-7.0814137149665651e-03 -1.4659767389443750e-02 +-5.2298228797275585e-03 -1.3219174807344216e-02 +-3.4400790221392422e-03 -1.1831741832294702e-02 +-1.7131871004754905e-03 -1.0496250764626125e-02 +-4.9154218314465265e-05 -9.2122516905065472e-03 + 1.5526315336655335e-03 -7.9796225565824542e-03 + 3.0937359550434183e-03 -6.7990870644142800e-03 + 4.5742781603081437e-03 -5.6691062415325155e-03 + 5.9946872170217498e-03 -4.5881606644452419e-03 + 7.3556248044865605e-03 -3.5547202963547553e-03 + 8.6581147230621169e-03 -2.5674594382864577e-03 + 9.9031274987141614e-03 -1.6247512612506071e-03 + 1.1091687029196461e-02 -7.2482854409734038e-04 + 1.2225280974451419e-02 1.3362571519722483e-04 + 1.3305292726410851e-02 9.5218959159801470e-04 + 1.4333170401623980e-02 1.7324721627761362e-03 + 1.5310904724788769e-02 2.4754450406282999e-03 + 1.6240616475659699e-02 3.1819383938349829e-03 + 1.7124093735578452e-02 3.8532331563187320e-03 + 1.7962944813174696e-02 4.4909644632718992e-03 +-8.3237537092373387e-02 -1.0793385410539033e-01 +-8.4209502999215854e-02 -1.0609124097940814e-01 +-8.4917466235851474e-02 -1.0404645069230718e-01 +-8.5287184461834267e-02 -1.0183069206899900e-01 +-8.5380221400698328e-02 -9.9505718267761792e-02 +-8.5156030140098815e-02 -9.7108463568159262e-02 +-8.4618108829631389e-02 -9.4679575786141890e-02 +-8.3825863636094275e-02 -9.2237347868713945e-02 +-8.2830564644681706e-02 -8.9786489819171283e-02 +-8.1661734356857640e-02 -8.7328164448786924e-02 +-8.0301855615631357e-02 -8.4885086222522263e-02 +-7.8796509394466016e-02 -8.2445017604095200e-02 +-7.7169876619167369e-02 -8.0001689378229046e-02 +-7.5430965433413405e-02 -7.7556752410593760e-02 +-7.3573160466751886e-02 -7.5123575787748892e-02 +-7.1605275135043056e-02 -7.2705335051827719e-02 +-6.9545147545086561e-02 -7.0296720766199430e-02 +-6.7408169971601276e-02 -6.7892996652138368e-02 +-6.5207138842597392e-02 -6.5491152680298759e-02 +-6.2951152436873575e-02 -6.3091249316972145e-02 +-6.0631287773044058e-02 -6.0710969031279455e-02 +-5.8256801634693572e-02 -5.8351763182559170e-02 +-5.5841144844755726e-02 -5.6009952869375358e-02 +-5.3392702283420135e-02 -5.3686618165259076e-02 +-5.0914848284650219e-02 -5.1388583487906099e-02 +-4.8423825413111757e-02 -4.9108657906471398e-02 +-4.5927949734265366e-02 -4.6847537742402315e-02 +-4.3431465405747820e-02 -4.4610273786242327e-02 +-4.0933013031962215e-02 -4.2408350585425227e-02 +-3.8440992107739776e-02 -4.0242125659783586e-02 +-3.5960375597115977e-02 -3.8115121377937773e-02 +-3.3498186736356871e-02 -3.6028369727641153e-02 +-3.1063145193439251e-02 -3.3980182255783552e-02 +-2.8659743251030826e-02 -3.1973132181400167e-02 +-2.6287674583417398e-02 -3.0015240969156608e-02 +-2.3955762423585176e-02 -2.8102958412522607e-02 +-2.1668484937196732e-02 -2.6237073579947166e-02 +-1.9427117157124009e-02 -2.4421722650902956e-02 +-1.7233868384539268e-02 -2.2659364354316244e-02 +-1.5093214165293325e-02 -2.0948866981830447e-02 +-1.3006716784481910e-02 -1.9291973447711306e-02 +-1.0975077420135759e-02 -1.7690998349708404e-02 +-9.0025337547714225e-03 -1.6143062171731094e-02 +-7.0902530498814214e-03 -1.4648432177812788e-02 +-5.2386429425635818e-03 -1.3207817827341267e-02 +-3.4488866763128568e-03 -1.1820366562850938e-02 +-1.7219825320636379e-03 -1.0484864854066026e-02 +-5.7934444714534937e-05 -9.2008573233795521e-03 + 1.5438776353179536e-03 -7.9682210113396872e-03 + 3.0850017307643032e-03 -6.7876641870302330e-03 + 4.5655594332999240e-03 -5.6576660678046573e-03 + 5.9859800134533913e-03 -4.5767065946758292e-03 + 7.3469274161849134e-03 -3.5432562896594868e-03 + 8.6494226365531092e-03 -2.5559860017938911e-03 + 9.8944350506738298e-03 -1.6132710935736266e-03 + 1.1082993490813983e-02 -7.1334767896590219e-04 + 1.2216582395634995e-02 1.4510742126301905e-04 + 1.3296584959992544e-02 9.6366952714045228e-04 + 1.4324457359177083e-02 1.7439441466702763e-03 + 1.5302192199481897e-02 2.4869104118990333e-03 + 1.6231904553141677e-02 3.1934034234695928e-03 + 1.7115378431487985e-02 3.8647000863849972e-03 + 1.7954496083253037e-02 4.5023245673436046e-03 +-8.3250157884904974e-02 -1.0794199218644743e-01 +-8.4223530822442133e-02 -1.0609732715358976e-01 +-8.4932097016534314e-02 -1.0405017599249655e-01 +-8.5302725321569378e-02 -1.0183229320345621e-01 +-8.5395740178001694e-02 -9.9505304953280735e-02 +-8.5171472437936047e-02 -9.7106041172677127e-02 +-8.4633546133049700e-02 -9.4675372824153115e-02 +-8.3841183097890085e-02 -9.2231760689525696e-02 +-8.2845657453221547e-02 -8.9779843902586656e-02 +-8.1676322444084029e-02 -8.7320646171345023e-02 +-8.0316233461589989e-02 -8.4876655343189472e-02 +-7.8810657469108217e-02 -8.2435947760112385e-02 +-7.7183761993896413e-02 -7.9992132830932192e-02 +-7.5444501275288428e-02 -7.7546775770962709e-02 +-7.3586396646507998e-02 -7.5113141147348142e-02 +-7.1618284542527305e-02 -7.2694480917440810e-02 +-6.9557972080066172e-02 -7.0285537368539930e-02 +-6.7420842687685875e-02 -6.7881558044382326e-02 +-6.5219675451592199e-02 -6.5479516920139938e-02 +-6.2963455625033943e-02 -6.3079473002280048e-02 +-6.0643407385269729e-02 -6.0698965516255976e-02 +-5.8268786215733261e-02 -5.8339551770135126e-02 +-5.5853003576796879e-02 -5.5997588611705583e-02 +-5.3404416705098753e-02 -5.3674130890245496e-02 +-5.0926495065801228e-02 -5.1375942144490101e-02 +-4.8435412099130576e-02 -4.9095933519097967e-02 +-4.5939466718244740e-02 -4.6834755896990633e-02 +-4.3442867953750276e-02 -4.4597443380478552e-02 +-4.0944331673422742e-02 -4.2395419009261436e-02 +-3.8452223093707001e-02 -4.0229116893767125e-02 +-3.5971534061055938e-02 -3.8102031844088065e-02 +-3.3509301090713511e-02 -3.6015206046596457e-02 +-3.1074213164049486e-02 -3.3966976296991393e-02 +-2.8670730411289102e-02 -3.1959898290533639e-02 +-2.6298625028469014e-02 -3.0001930886892052e-02 +-2.3966679993700453e-02 -2.8089610210606672e-02 +-2.1679353574607214e-02 -2.6223702459347454e-02 +-1.9437933223893523e-02 -2.4408315337927974e-02 +-1.7244650025826085e-02 -2.2645909053643946e-02 +-1.5103954437346948e-02 -2.0935383921163009e-02 +-1.3017405233342865e-02 -1.9278461853765069e-02 +-1.0985741558530349e-02 -1.7677437298477726e-02 +-9.0131715684389074e-03 -1.6129479102003227e-02 +-7.1008602889662152e-03 -1.4634829890007160e-02 +-5.2492270605026675e-03 -1.3194189471214828e-02 +-3.4594558628217825e-03 -1.1806716286253790e-02 +-1.7325370303753894e-03 -1.0471201775492552e-02 +-6.8470639857674901e-05 -9.1871840921736048e-03 + 1.5333729098495382e-03 -7.9545390588896085e-03 + 3.0745206299819593e-03 -6.7739567623194448e-03 + 4.5550969296022101e-03 -5.6439378840620778e-03 + 5.9755313549649759e-03 -4.5629617413733290e-03 + 7.3364905116719489e-03 -3.5294994850566253e-03 + 8.6389920821036120e-03 -2.5422179000020983e-03 + 9.8840041059444200e-03 -1.5994949458801408e-03 + 1.1072561206050607e-02 -6.9957063871708177e-04 + 1.2206144058290860e-02 1.5888544387267193e-04 + 1.3286135682151805e-02 9.7744538575665119e-04 + 1.4314001773962075e-02 1.7577105405232574e-03 + 1.5291737170486762e-02 2.5006689282915276e-03 + 1.6221450196213294e-02 3.2071614866850139e-03 + 1.7104923646926347e-02 3.8784589839552246e-03 + 1.7944562211240103e-02 4.5158788617529902e-03 +-8.3265306973572623e-02 -1.0795176005161300e-01 +-8.4240360926315649e-02 -1.0610462957913398e-01 +-8.4949658366568051e-02 -1.0405464888068969e-01 +-8.5321369851370940e-02 -1.0183421598210717e-01 +-8.5414364058464684e-02 -9.9504808958398222e-02 +-8.5190005071694330e-02 -9.7103135890589318e-02 +-8.4652071143678870e-02 -9.4670331941824670e-02 +-8.3859566340989650e-02 -9.2225058133319646e-02 +-8.2863767516825740e-02 -8.9771869825067491e-02 +-8.1693830163571957e-02 -8.7311623899988366e-02 +-8.0333486980292690e-02 -8.4866539871195246e-02 +-7.8827635089793235e-02 -8.2425064784212410e-02 +-7.7200424046380167e-02 -7.9980665291836159e-02 +-7.5460744630659229e-02 -7.7534803539003175e-02 +-7.3602280520331659e-02 -7.5100619752113781e-02 +-7.1633896101429714e-02 -7.2681456415359599e-02 +-6.9573361723468868e-02 -7.0272117666141817e-02 +-6.7436050045797308e-02 -6.7867832005637702e-02 +-6.5234718903069186e-02 -6.5465554280313490e-02 +-6.2978219713218847e-02 -6.3065340971907580e-02 +-6.0657951178674438e-02 -6.0684561384537615e-02 +-5.8283167770999962e-02 -5.8324898341513658e-02 +-5.5867233972238944e-02 -5.5982751642335300e-02 +-5.3418474395156165e-02 -5.3659146003484891e-02 +-5.0940471245962481e-02 -5.1360772880799779e-02 +-4.8449316076965503e-02 -4.9080664378763794e-02 +-4.5953286877942819e-02 -4.6819417723578574e-02 +-4.3456551165814226e-02 -4.4582046628829149e-02 +-4.0957914027980789e-02 -4.2379901234775828e-02 +-3.8465700356720270e-02 -4.0213506353777802e-02 +-3.5984924367024551e-02 -3.8086324435310202e-02 +-3.3522638305923252e-02 -3.5999409793004436e-02 +-3.1087494546146451e-02 -3.3951129220878076e-02 +-2.8683915242920272e-02 -3.1944017362530150e-02 +-2.6311765585869281e-02 -2.9985958993615929e-02 +-2.3979780987825008e-02 -2.8073592452251710e-02 +-2.1692395918658149e-02 -2.6207657038938521e-02 +-1.9450912612180817e-02 -2.4392226492529222e-02 +-1.7257587954271243e-02 -2.2629762812322523e-02 +-1.5116842698783458e-02 -2.0919204243320486e-02 +-1.3030231549677531e-02 -1.9262247807780443e-02 +-1.0998538512552971e-02 -1.7661164213454563e-02 +-9.0259369159002862e-03 -1.6113179436869522e-02 +-7.1135890290239543e-03 -1.4618507096622137e-02 +-5.2619280628475457e-03 -1.3177835472327615e-02 +-3.4721388889467409e-03 -1.1790336021259085e-02 +-1.7452023997262432e-03 -1.0454806101611246e-02 +-8.1113965273579025e-05 -9.1707762273116368e-03 + 1.5207671722583039e-03 -7.9381205765438646e-03 + 3.0619432634173931e-03 -6.7575078920646282e-03 + 4.5425418802259830e-03 -5.6274640991520386e-03 + 5.9629929440413731e-03 -4.5464679610091145e-03 + 7.3239661708731875e-03 -3.5129913248706378e-03 + 8.6264753444249692e-03 -2.5256962097466064e-03 + 9.8714869612884192e-03 -1.5829636447099223e-03 + 1.1060042408977930e-02 -6.8303818841452277e-04 + 1.2193617993062513e-02 1.7541903532817681e-04 + 1.3273596608364070e-02 9.9397632526060571e-04 + 1.4301455165202748e-02 1.7742302318728025e-03 + 1.5279191137828541e-02 2.5171792486055641e-03 + 1.6208904951518714e-02 3.2236711812098488e-03 + 1.7092386227361134e-02 3.8949664637041438e-03 + 1.7932926432651174e-02 4.5320364369273161e-03 +-8.3283491724969919e-02 -1.0796348453208564e-01 +-8.4260552460350011e-02 -1.0611339113193984e-01 +-8.4970738196020204e-02 -1.0406001994573300e-01 +-8.5343736937886827e-02 -1.0183652534676747e-01 +-8.5436714611276471e-02 -9.9504213770001793e-02 +-8.5212246913371939e-02 -9.7099651838019246e-02 +-8.4674301521033793e-02 -9.4664286713122964e-02 +-8.3881626068077447e-02 -9.2217018024865011e-02 +-8.2885497746005621e-02 -8.9762302401904373e-02 +-8.1714842290537840e-02 -8.7300796711171677e-02 +-8.0354191363639679e-02 -8.4854403564217140e-02 +-7.8848008134642419e-02 -8.2412006419355366e-02 +-7.7220417944815697e-02 -7.9966904701856620e-02 +-7.5480237149932711e-02 -7.7520436486999925e-02 +-7.3621341826410350e-02 -7.5085594326147184e-02 +-7.1652630361626654e-02 -7.2665827671606176e-02 +-6.9591829585406065e-02 -7.0256014562949554e-02 +-6.7454299015026281e-02 -6.7851361177906619e-02 +-6.5252770362719870e-02 -6.5448799500392646e-02 +-6.2995936992428142e-02 -6.3048381891239749e-02 +-6.0675404101979594e-02 -6.0667276548631896e-02 +-5.8300425721307565e-02 -5.8307314608814401e-02 +-5.5884310330958746e-02 -5.5964947479469493e-02 +-5.3435344171476953e-02 -5.3641163918373251e-02 +-5.0957242725247161e-02 -5.1342570261697071e-02 +-4.8466000784629357e-02 -4.9062341590513543e-02 +-4.5969870754590442e-02 -4.6801011973268018e-02 +-4.3472971239453519e-02 -4.4563570149829937e-02 +-4.0974212833149434e-02 -4.2361280070659389e-02 +-3.8481873187124239e-02 -4.0194773677041773e-02 +-3.6000992947749576e-02 -3.8067475591089660e-02 +-3.3538642949682500e-02 -3.5980454522939756e-02 +-3.1103431945534010e-02 -3.3932112835298969e-02 +-2.8699737381362323e-02 -3.1924959881106101e-02 +-2.6327534289010867e-02 -2.9966793013808269e-02 +-2.3995502052373240e-02 -2.8054371262818737e-02 +-2.1708046701989243e-02 -2.6188402426527386e-02 +-1.9466488032081015e-02 -2.4372919778861447e-02 +-1.7273113410199090e-02 -2.2610387492456693e-02 +-1.5132308520877559e-02 -2.0899788622678609e-02 +-1.3045623381976137e-02 -1.9242790764102902e-02 +-1.1013894841447033e-02 -1.7641636761941019e-02 +-9.0412552921348040e-03 -1.6093619866138477e-02 +-7.1288635931082535e-03 -1.4598919676566461e-02 +-5.2771693527698922e-03 -1.3158210714260132e-02 +-3.4873585239566713e-03 -1.1770679798852926e-02 +-1.7604008014171829e-03 -1.0435131322827324e-02 +-9.6285801818101448e-05 -9.1510868062314524e-03 + 1.5056401924968528e-03 -7.9184182002658785e-03 + 3.0468503574911493e-03 -6.7377693025924236e-03 + 4.5274757565738179e-03 -5.6076956087625371e-03 + 5.9479468201918172e-03 -4.5266754867185266e-03 + 7.3089368823744325e-03 -3.4931815411337304e-03 + 8.6114551560316846e-03 -2.5058702275253682e-03 + 9.8564663704436492e-03 -1.5631261913588619e-03 + 1.1045019773262145e-02 -6.6319924666117288e-04 + 1.2178586629515750e-02 1.9525929343299823e-04 + 1.3258549804261737e-02 1.0138133243261665e-03 + 1.4286399367263562e-02 1.7940538879831801e-03 + 1.5264135902994407e-02 2.5369917752505887e-03 + 1.6193850784886034e-02 3.2434827849948614e-03 + 1.7077358498737354e-02 3.9147689994788147e-03 + 1.7919357735569973e-02 4.5512779993542194e-03 +-8.3305321652986764e-02 -1.0797755815591610e-01 +-8.4284775922925020e-02 -1.0612390313792516e-01 +-8.4996042687408346e-02 -1.0406647033665981e-01 +-8.5370568523843074e-02 -1.0183929948980863e-01 +-8.5463537930508468e-02 -9.9503499603753529e-02 +-8.5238940948543146e-02 -9.7095474254655229e-02 +-8.4700978515201711e-02 -9.4657037923749451e-02 +-8.3908097495780168e-02 -9.2207374145683238e-02 +-8.2911571419700805e-02 -8.9750823606759428e-02 +-8.1740060902504921e-02 -8.7287803458432747e-02 +-8.0379036875144208e-02 -8.4839843214903038e-02 +-7.8872455643591563e-02 -8.2396338120227605e-02 +-7.7244409822569859e-02 -7.9950392651178454e-02 +-7.5503628875595238e-02 -7.7503195498345126e-02 +-7.3644216336803112e-02 -7.5067564170815490e-02 +-7.1675112035848684e-02 -7.2647074123415992e-02 +-6.9613991436683051e-02 -7.0236691616008998e-02 +-6.7476197974045943e-02 -6.7831596788058973e-02 +-6.5274431145952896e-02 -6.5428694315646921e-02 +-6.3017198257503876e-02 -6.3028030079981048e-02 +-6.0696348142351871e-02 -6.0646534917797472e-02 +-5.8321135383076206e-02 -5.8286214675848907e-02 +-5.5904801800727780e-02 -5.5943582770896338e-02 +-5.3455588684330597e-02 -5.3619585106121324e-02 +-5.0977368593721123e-02 -5.1320727827488880e-02 +-4.8486022338267418e-02 -4.9040354505351012e-02 +-4.5989770958613695e-02 -4.6778925153911292e-02 +-4.3492675637879209e-02 -4.4541397839108147e-02 +-4.0993771372783372e-02 -4.2338934906376788e-02 +-3.8501280748648135e-02 -4.0172294425557385e-02 +-3.6020275549646798e-02 -3.8044857045489482e-02 +-3.3557848501149658e-02 -3.5957708533925541e-02 +-3.1122556458152605e-02 -3.3909293322079370e-02 +-2.8718724430692150e-02 -3.1902090382398759e-02 +-2.6346456783230970e-02 -2.9943794252100635e-02 +-2.4014367147032655e-02 -2.8031306008635584e-02 +-2.1726827600091352e-02 -2.6165296738156686e-02 +-1.9485178754181331e-02 -2.4349751581744131e-02 +-1.7291743874992698e-02 -2.2587137349241476e-02 +-1.5150867378907940e-02 -2.0876489867454759e-02 +-1.3064093938842768e-02 -1.9219442045844460e-02 +-1.1032322415494540e-02 -1.7618204174685504e-02 +-9.0596372862726711e-03 -1.6070148421986608e-02 +-7.1471931782676182e-03 -1.4575414676721249e-02 +-5.2954590250384858e-03 -1.3134661062587781e-02 +-3.5056220915530394e-03 -1.1747092468335663e-02 +-1.7786388228563405e-03 -1.0411521631800183e-02 +-1.1449178821062524e-04 -9.1274595227346135e-03 + 1.4874876840020119e-03 -7.8947750700602108e-03 + 3.0287387750357712e-03 -6.7140830711059927e-03 + 4.5093963158885902e-03 -5.5839734946263701e-03 + 5.9298914262907237e-03 -4.5029246062739175e-03 + 7.2909016219717760e-03 -3.4694098141468547e-03 + 8.5934307830977438e-03 -2.4820791156536879e-03 + 9.8384416341808032e-03 -1.5393214001752792e-03 + 1.1026992497292200e-02 -6.3939251721648635e-04 + 1.2160548873708375e-02 2.1906752827615436e-04 + 1.3240493758658030e-02 1.0376175424783409e-03 + 1.4268332597189664e-02 1.8178423129019674e-03 + 1.5246069632567066e-02 2.5607670063286835e-03 + 1.6175786334670244e-02 3.2672565315218045e-03 + 1.7059358365315285e-02 3.9385199081461517e-03 + 1.7903617133554869e-02 4.5741674352440002e-03 +-8.3331529093460671e-02 -1.0799445239651621e-01 +-8.4313835281738012e-02 -1.0613651503418997e-01 +-8.5026420187721233e-02 -1.0407421805032482e-01 +-8.5402753963639347e-02 -1.0184263261477196e-01 +-8.5495729613104657e-02 -9.9502642778072678e-02 +-8.5270979237738187e-02 -9.7090465857258668e-02 +-8.4732991714976350e-02 -9.4648347223349971e-02 +-8.3939862844265009e-02 -9.2195807594728771e-02 +-8.2942856181223309e-02 -8.9737052088659244e-02 +-8.1770328974276274e-02 -8.7272210723079141e-02 +-8.0408851884346669e-02 -8.4822375372631750e-02 +-7.8901792444274046e-02 -8.2377538667550404e-02 +-7.7273198944926458e-02 -7.9930579135882543e-02 +-7.5531699946058184e-02 -7.7482505574400493e-02 +-7.3671667100956517e-02 -7.5045928493926495e-02 +-7.1702090856010536e-02 -7.2624571217891468e-02 +-6.9640586258006731e-02 -7.0213505198116047e-02 +-6.7502476998785962e-02 -6.7807880389910813e-02 +-6.5300422715058412e-02 -6.5404568875155708e-02 +-6.3042712525978220e-02 -6.3003606612144852e-02 +-6.0721481753713114e-02 -6.0621645202533110e-02 +-5.8345987153284269e-02 -5.8260895537417347e-02 +-5.5929391343533273e-02 -5.5917945530795377e-02 +-5.3479883210900532e-02 -5.3593690098509963e-02 +-5.1001519774575191e-02 -5.1294517914399859e-02 +-4.8510048063635375e-02 -4.9013970380910897e-02 +-4.6013650567973373e-02 -4.6752421083633110e-02 +-4.3516321352912606e-02 -4.4514790306418077e-02 +-4.1017241586730979e-02 -4.2312121035202661e-02 +-3.8524570059722499e-02 -4.0145319270362495e-02 +-3.6043415106918789e-02 -3.8017714889431717e-02 +-3.3580895132519883e-02 -3.5930413825351427e-02 +-3.1145505356387347e-02 -3.3881910117183923e-02 +-2.8741509573808881e-02 -3.1874646248577450e-02 +-2.6369163850746495e-02 -2.9916196323265309e-02 +-2.4037005001148616e-02 -2.8003627952109155e-02 +-2.1749364618771208e-02 -2.6137569694426672e-02 +-1.9507607929185766e-02 -2.4321949546339067e-02 +-1.7314100316853102e-02 -2.2559237517377519e-02 +-1.5173137829223670e-02 -2.0848531345954577e-02 +-1.3086259113128716e-02 -1.9191423210734210e-02 +-1.1054435478490863e-02 -1.7590085570067086e-02 +-9.0816955991657941e-03 -1.6041982749567911e-02 +-7.1691888345785174e-03 -1.4547208542361216e-02 +-5.3174068091009366e-03 -1.3106401563199806e-02 +-3.5275383814623393e-03 -1.1718787865911766e-02 +-1.8005243600069968e-03 -1.0383190066226389e-02 +-1.3633866588203179e-04 -9.0991068099595274e-03 + 1.4657044882188856e-03 -7.8664029218381230e-03 + 3.0070047382584702e-03 -6.6856596972859460e-03 + 4.4877008548033304e-03 -5.5555070648866320e-03 + 5.9082248864122909e-03 -4.4744236759469277e-03 + 7.2692591457031754e-03 -3.4408837633772742e-03 + 8.5718013268853421e-03 -2.4535298781693600e-03 + 9.8168119074577374e-03 -1.5107558664075396e-03 + 1.1005359604788663e-02 -6.1082444728015903e-04 + 1.2138903399695722e-02 2.4763730155392971e-04 + 1.3218826672003083e-02 1.0661823510590008e-03 + 1.4246652737285639e-02 1.8463884757256746e-03 + 1.5224390142109780e-02 2.5892975573987022e-03 + 1.6154110619681826e-02 3.2957844698835335e-03 + 1.7037819341923607e-02 3.9669991826651345e-03 + 1.7885467260073149e-02 4.6013653905913332e-03 +-8.3362994090042025e-02 -1.0801473359739849e-01 +-8.4348694490475259e-02 -1.0615164596542942e-01 +-8.5062889940803146e-02 -1.0408352554006652e-01 +-8.5441359176103696e-02 -1.0184663829429448e-01 +-8.5534364752108155e-02 -9.9501614984650197e-02 +-8.5309432923297221e-02 -9.7084462518811407e-02 +-8.4771408761626352e-02 -9.4637929594117487e-02 +-8.3977980717762732e-02 -9.2181936493150970e-02 +-8.2980392810327722e-02 -8.9720530628656397e-02 +-8.1806658739509347e-02 -8.7253498359575132e-02 +-8.0444630519863378e-02 -8.4801420454086646e-02 +-7.8936996300853143e-02 -8.2354982937120610e-02 +-7.7307744299686912e-02 -7.9906804277500521e-02 +-7.5565386649769375e-02 -7.7457676637906703e-02 +-7.3704609953393480e-02 -7.5019966410366887e-02 +-7.1734466611528422e-02 -7.2597569666101397e-02 +-6.9672500906048554e-02 -7.0185683106458965e-02 +-6.7534012208991662e-02 -6.7779421965596207e-02 +-6.5331610664085799e-02 -6.5375619450477332e-02 +-6.3073330706730005e-02 -6.2974296624914369e-02 +-6.0751643179233546e-02 -6.0591777881852278e-02 +-5.8375809532822003e-02 -5.8230513686337936e-02 +-5.5958898494679742e-02 -5.5887181428628453e-02 +-5.3509038219184242e-02 -5.3562615489494515e-02 +-5.1030501398238136e-02 -5.1263067448698338e-02 +-4.8538878731825878e-02 -4.8982309979176498e-02 +-4.6042305200465559e-02 -4.6720616355719453e-02 +-4.3544696824219589e-02 -4.4482860193362353e-02 +-4.1045405802626236e-02 -4.2279944843888848e-02 +-3.8552517573782287e-02 -4.0112949012788869e-02 +-3.6071183194897154e-02 -3.7985144446532150e-02 +-3.3608551046078843e-02 -3.5897660856869802e-02 +-3.1173043308525786e-02 -3.3849050567633140e-02 +-2.8768852709993433e-02 -3.1841712254242253e-02 +-2.6396412442100121e-02 -2.9883079632704108e-02 +-2.4064170058724719e-02 -2.7970414640497376e-02 +-2.1776408958163126e-02 -2.6104296934191227e-02 +-1.9534523373624029e-02 -2.4288586823762177e-02 +-1.7340927884719318e-02 -2.2525758197679470e-02 +-1.5199862121195087e-02 -2.0814981098161257e-02 +-1.3112858034765295e-02 -1.9157800087262190e-02 +-1.1080971123425945e-02 -1.7556343946981509e-02 +-9.1081654634610348e-03 -1.6008184033350460e-02 +-7.1955838410362695e-03 -1.4513360993326955e-02 +-5.3437444023838286e-03 -1.3072490281352822e-02 +-3.5538379431582319e-03 -1.1684822618926772e-02 +-1.8267868750844538e-03 -1.0349192280789571e-02 +-1.6255449075557805e-04 -9.0650835876470888e-03 + 1.4395643956548511e-03 -7.8323557954186399e-03 + 2.9809236949649887e-03 -6.6515517895487965e-03 + 4.4616661122226292e-03 -5.5213475039185417e-03 + 5.8822249384700475e-03 -4.4402227388390721e-03 + 7.2432879394776608e-03 -3.4066525372537567e-03 + 8.5458456835780482e-03 -2.4192709335606327e-03 + 9.7908561666854559e-03 -1.4764775290838944e-03 + 1.0979399904240022e-02 -5.7654277836380297e-04 + 1.2112928599183276e-02 2.8192087205311197e-04 + 1.3192826403713550e-02 1.1004597682438199e-03 + 1.4220637276590677e-02 1.8806439452543023e-03 + 1.5198374856428722e-02 2.6235345822752409e-03 + 1.6128103910933830e-02 3.3300165559550969e-03 + 1.7012081536155632e-02 4.0011365333739871e-03 + 1.7864686028535796e-02 4.6336455232764097e-03 +-8.3400774347371948e-02 -1.0803908210504223e-01 +-8.4390509291471336e-02 -1.0616979871391685e-01 +-8.5106676631743330e-02 -1.0409470893105385e-01 +-8.5487661545816981e-02 -1.0185145356310996e-01 +-8.5580733949502760e-02 -9.9500382450353989e-02 +-8.5355588309359021e-02 -9.7077268160883051e-02 +-8.4817511029957757e-02 -9.4625444433427838e-02 +-8.4023721351844716e-02 -9.2165303732395218e-02 +-8.3025429722685520e-02 -8.9700711141725217e-02 +-8.1850265784400314e-02 -8.7231042164028896e-02 +-8.0487565872904038e-02 -8.4776283735231259e-02 +-7.8979240488838254e-02 -8.2327921267868767e-02 +-7.7349196494470654e-02 -7.9878276403853379e-02 +-7.5605812703617589e-02 -7.7427880492613579e-02 +-7.3744144144445023e-02 -7.4988812951466435e-02 +-7.1773319209956152e-02 -7.2565170568401671e-02 +-6.9710799723356073e-02 -7.0152298913404548e-02 +-6.7571854986116120e-02 -6.7745273663111782e-02 +-6.5369033485954256e-02 -6.5340881695125891e-02 +-6.3110074011199932e-02 -6.2939122075680018e-02 +-6.0787838450646579e-02 -6.0555937565826834e-02 +-5.8411596759380617e-02 -5.8194057054212052e-02 +-5.5994306673732425e-02 -5.5850265341791785e-02 +-5.3544026459223917e-02 -5.3525325134134057e-02 +-5.1065279655846695e-02 -5.1225328913021832e-02 +-4.8573475238983643e-02 -4.8944318291461890e-02 +-4.6076689492780661e-02 -4.6682450897147579e-02 +-4.3578748245950552e-02 -4.4444542545517732e-02 +-4.1079202815781521e-02 -4.2241334042738048e-02 +-3.8586055080146724e-02 -4.0074104610240219e-02 +-3.6104505780089495e-02 -3.7946060127097073e-02 +-3.3641738078575310e-02 -3.5858358264404797e-02 +-3.1206087837783118e-02 -3.3809619522371229e-02 +-2.8801665828072868e-02 -3.1802190014742340e-02 +-2.6429110915558954e-02 -2.9843340759041086e-02 +-2.4096767609606884e-02 -2.7930559176818436e-02 +-2.1808862049326725e-02 -2.6064369188449229e-02 +-1.9566822516182948e-02 -2.4248551164072124e-02 +-1.7373120740075503e-02 -2.2485583684410063e-02 +-1.5231930930171226e-02 -2.0774720769021832e-02 +-1.3144777739403908e-02 -1.9117451615509505e-02 +-1.1112813863994103e-02 -1.7515854981276311e-02 +-9.1399291476093707e-03 -1.5967625709721378e-02 +-7.2272581586617871e-03 -1.4472743674059206e-02 +-5.3753498727954581e-03 -1.3031796909612231e-02 +-3.5853974387976407e-03 -1.1644064713520644e-02 +-1.8583017037197545e-03 -1.0308395074738894e-02 +-1.9401288395165083e-04 -9.0242557578297401e-03 + 1.4081959294861830e-03 -7.7914984800814477e-03 + 2.9496261552075416e-03 -6.6106224887433141e-03 + 4.4304241504356705e-03 -5.4803562538761723e-03 + 5.8510248514674424e-03 -4.3991818684284102e-03 + 7.2121221557160230e-03 -3.3655751221096006e-03 + 8.5146984933056596e-03 -2.3781604037427751e-03 + 9.7597091679468197e-03 -1.4353439486485921e-03 + 1.0948247937549860e-02 -5.3540480943179499e-04 + 1.2081758519188340e-02 3.2306092803390359e-04 + 1.3161626410515900e-02 1.1415921797369301e-03 + 1.4189419244588672e-02 1.9217506112190674e-03 + 1.5167156815146908e-02 2.6646194620760398e-03 + 1.6096905617126664e-02 3.3710916951813449e-03 + 1.6981385187038581e-02 4.0420380705323928e-03 + 1.7841085084982687e-02 4.6719143915391328e-03 +-8.3446141278159844e-02 -1.0806831524444466e-01 +-8.4440665386012539e-02 -1.0619157644846411e-01 +-8.5159251897153551e-02 -1.0410814918711034e-01 +-8.5543191721186657e-02 -1.0185724391747648e-01 +-8.5636386552366328e-02 -9.9498904993549769e-02 +-8.5410990252754435e-02 -9.7068648734829871e-02 +-8.4872836483314062e-02 -9.4610485018531337e-02 +-8.4078608896377249e-02 -9.2145362415773702e-02 +-8.3079464341992565e-02 -8.9676936754694972e-02 +-8.1902610035740966e-02 -8.7204093101855368e-02 +-8.0539089871664249e-02 -8.4746132621143361e-02 +-7.9029932880445658e-02 -8.2295454768563869e-02 +-7.7398936019549419e-02 -7.9844045770323044e-02 +-7.5654326804496949e-02 -7.7392123169979121e-02 +-7.3791589127367635e-02 -7.4951430287334933e-02 +-7.1819944772969144e-02 -7.2526295595373172e-02 +-6.9756760085127531e-02 -7.0112241215517457e-02 +-6.7617267036326201e-02 -6.7704298304027785e-02 +-6.5413937073701245e-02 -6.5299198567989616e-02 +-6.3154168057030793e-02 -6.2896909032350942e-02 +-6.0831275003885549e-02 -6.0512929832629965e-02 +-5.8454541971664262e-02 -5.8150311355351390e-02 +-5.6036795959761222e-02 -5.5805967227857328e-02 +-5.3586015491448216e-02 -5.3480575586777296e-02 +-5.1107014029455132e-02 -5.1180045522870983e-02 +-4.8614990617949341e-02 -4.8898729419519914e-02 +-4.6117948865884668e-02 -4.6636652639388432e-02 +-4.3619611139760782e-02 -4.4398559248261922e-02 +-4.1119759186926820e-02 -4.2195001943307393e-02 +-3.8626300790355145e-02 -4.0027491208247758e-02 +-3.6144494128280101e-02 -3.7899159255955578e-02 +-3.3681562425700841e-02 -3.5811196529477514e-02 +-3.1245739866500293e-02 -3.3762302843908513e-02 +-2.8841043463020237e-02 -3.1754761315991371e-02 +-2.6468349327814385e-02 -2.9795655721212056e-02 +-2.4135883942832861e-02 -2.7882733349948438e-02 +-2.1847805597232525e-02 -2.6016455285970110e-02 +-1.9605582336822563e-02 -2.4200507824864912e-02 +-1.7411751853885164e-02 -2.2437375202409099e-02 +-1.5270413036745940e-02 -2.0726408328294713e-02 +-1.3183082777435741e-02 -1.9069032452656051e-02 +-1.1151025122520924e-02 -1.7467269587020804e-02 +-9.1780453603019715e-03 -1.5918955925882487e-02 +-7.2652677772964596e-03 -1.4424002532999632e-02 +-5.4132769449663611e-03 -1.2982965099192523e-02 +-3.6232688675285280e-03 -1.1595155779527593e-02 +-1.8961192206032762e-03 -1.0259438627733592e-02 +-2.3176213015546312e-04 -8.9752623982713581e-03 + 1.3705532846731315e-03 -7.7424686455790492e-03 + 2.9120686919131555e-03 -6.5615075755447658e-03 + 4.3929334094773252e-03 -5.4311670749639853e-03 + 5.8135845228411255e-03 -4.3499331834094572e-03 + 7.1747227342499748e-03 -3.3162823149304457e-03 + 8.4773212750281716e-03 -2.3288280637136856e-03 + 9.7223325939397049e-03 -1.3859842433733838e-03 + 1.0910865115775950e-02 -4.8603931489591236e-04 + 1.2044353986951625e-02 3.7242866335161431e-04 + 1.3124186874606291e-02 1.1909504007382406e-03 + 1.4151958339440199e-02 1.9710787490204956e-03 + 1.5129696012629187e-02 2.7139217892989372e-03 + 1.6059489364196034e-02 3.4203745110641818e-03 + 1.6944869080724723e-02 4.0910172540817996e-03 + 1.7814533732945708e-02 4.7172363293684575e-03 +-8.3500623369047886e-02 -1.0810341488470215e-01 +-8.4500824293215315e-02 -1.0621770288943576e-01 +-8.5222384166542139e-02 -1.0412430564890728e-01 +-8.5609783704697559e-02 -1.0186420943705100e-01 +-8.5703182550545404e-02 -9.9497134995257877e-02 +-8.5477494353042832e-02 -9.7058325155100156e-02 +-8.4939231155786360e-02 -9.4592566092298741e-02 +-8.4144472136614440e-02 -9.2121458590607316e-02 +-8.3144292722408836e-02 -8.9648420410266036e-02 +-8.1965445035066822e-02 -8.7171752432207233e-02 +-8.0600921178628895e-02 -8.4709969474298222e-02 +-7.9090762841531229e-02 -8.2256505777956818e-02 +-7.7458619147137586e-02 -7.9802973061384105e-02 +-7.5712547714459844e-02 -7.7349211743374932e-02 +-7.3848528744619474e-02 -7.4906573210391209e-02 +-7.1875898982994957e-02 -7.2479651245109869e-02 +-6.9811915076399958e-02 -7.0064176773817682e-02 +-6.7671762467483701e-02 -6.7655131625434239e-02 +-6.5467816100381146e-02 -6.5249181855937310e-02 +-6.3207083805172787e-02 -6.2846248401261406e-02 +-6.0883402040680573e-02 -6.0461321435571598e-02 +-5.8506077015274216e-02 -5.8097819721598554e-02 +-5.6087782425796734e-02 -5.5752811183412673e-02 +-5.3636406745156323e-02 -5.3426874626611172e-02 +-5.1157095977700233e-02 -5.1125709461332436e-02 +-4.8664808446431972e-02 -4.8844024448314032e-02 +-4.6167457631099945e-02 -4.6581695123914441e-02 +-4.3668648247518038e-02 -4.4343376335217156e-02 +-4.1168426803281262e-02 -4.2139404594047428e-02 +-3.8674596650736040e-02 -3.9971554980167627e-02 +-3.6192481905175169e-02 -3.7842878671694516e-02 +-3.3729351510233797e-02 -3.5754604394139938e-02 +-3.1293320364292471e-02 -3.3705523625013382e-02 +-2.8888299255273555e-02 -3.1697844099962499e-02 +-2.6515435786933543e-02 -2.9738435907129879e-02 +-2.4182822525943705e-02 -2.7825343398966113e-02 +-2.1894537631538660e-02 -2.5958957756401727e-02 +-1.9652095298752486e-02 -2.4142855059173886e-02 +-1.7458108762198891e-02 -2.2379526316335892e-02 +-1.5316590941396185e-02 -2.0668433333775132e-02 +-1.3229050752632593e-02 -1.9010928096896515e-02 +-1.1196878618781178e-02 -1.7408968997149627e-02 +-9.2237845360767304e-03 -1.5860552493732617e-02 +-7.3108799351301974e-03 -1.4365512676897271e-02 +-5.4587901481281493e-03 -1.2924367259068370e-02 +-3.6687146353387885e-03 -1.1536465836523473e-02 +-1.9414998345436861e-03 -1.0200691184754912e-02 +-2.7706009178954930e-04 -8.9164703917717913e-03 + 1.3253814542014397e-03 -7.6836313949297059e-03 + 2.8669991364015115e-03 -6.5025699987906506e-03 + 4.3479439677088670e-03 -5.3721405216752716e-03 + 5.7686557909595549e-03 -4.2908352684521561e-03 + 7.1298427412160173e-03 -3.2571310939912804e-03 + 8.4324677836821529e-03 -2.2696296852326367e-03 + 9.6774804243239670e-03 -1.3267534167219497e-03 + 1.0866005077723642e-02 -4.2680085145904061e-04 + 1.1999467958333166e-02 4.3166946380618793e-04 + 1.3079260059811611e-02 1.2501793483878680e-03 + 1.4107006301145780e-02 2.0302726920167435e-03 + 1.5084745331457178e-02 2.7730848440005976e-03 + 1.6014636096187779e-02 3.4794986446222069e-03 + 1.6901576881061271e-02 4.1496311606218578e-03 + 1.7784988994783885e-02 4.7708650686285707e-03 +-8.3566058322745107e-02 -1.0814556047413461e-01 +-8.4572978518721698e-02 -1.0624904662541915e-01 +-8.5298198441279324e-02 -1.0414373244829048e-01 +-8.5689634936400805e-02 -1.0187259230002349e-01 +-8.5783354856317176e-02 -9.9495016332195818e-02 +-8.5557329732622853e-02 -9.7045965041143642e-02 +-8.5018911017129897e-02 -9.4571109275871826e-02 +-8.4223505335017892e-02 -9.2092810808618725e-02 +-8.3222069086971731e-02 -8.9614219350489618e-02 +-8.2040877167912529e-02 -8.7132941948292436e-02 +-8.0675122741212038e-02 -8.4666599143838631e-02 +-7.9163757502513518e-02 -8.2209782547601723e-02 +-7.7530232994405909e-02 -7.9753691645117017e-02 +-7.5782418393274056e-02 -7.7297714508795010e-02 +-7.3916864308315969e-02 -7.4852747738666875e-02 +-7.1943049146326918e-02 -7.2423686008682334e-02 +-6.9878104734527657e-02 -7.0006506340183614e-02 +-6.7737158281715906e-02 -6.7596137016854463e-02 +-6.5532463649078554e-02 -6.5189166019583203e-02 +-6.3270586699465059e-02 -6.2785448777920000e-02 +-6.0945958993180296e-02 -6.0399392553211438e-02 +-5.8567920222707404e-02 -5.8034834292047331e-02 +-5.6148965349782476e-02 -5.5689026331494924e-02 +-5.3696882420169789e-02 -5.3362431494010126e-02 +-5.1217195373453511e-02 -5.1060511789118357e-02 +-4.8724588928180733e-02 -4.8778380916558596e-02 +-4.6226864703214895e-02 -4.6515746628510102e-02 +-4.3727495007359896e-02 -4.4277152742790413e-02 +-4.1226827958993503e-02 -4.2072689342540950e-02 +-3.8732553128482713e-02 -3.9904431338596252e-02 +-3.6250069711527992e-02 -3.7775342653728776e-02 +-3.3786698223467804e-02 -3.5686696575720663e-02 +-3.1350414319313860e-02 -3.3637389652551059e-02 +-2.8945009834958169e-02 -3.1629539638455072e-02 +-2.6571940082874307e-02 -2.9669775198253069e-02 +-2.4239147414746434e-02 -2.7756476940048298e-02 +-2.1950615766783362e-02 -2.5889959549786717e-02 +-1.9707912471474503e-02 -2.4073670697311214e-02 +-1.7513736472068449e-02 -2.2310109426648673e-02 +-1.5372003603772982e-02 -2.0598863246867671e-02 +-1.3284214976925024e-02 -1.8941201034415177e-02 +-1.1251902841498768e-02 -1.7339010866952227e-02 +-9.2786711791186891e-03 -1.5790468841087694e-02 +-7.3656153865582878e-03 -1.4295324196518255e-02 +-5.5134069993439862e-03 -1.2854050318488594e-02 +-3.7232496400321623e-03 -1.1466038995346681e-02 +-1.9959559772214693e-03 -1.0130194682963081e-02 +-3.3141610249706136e-04 -8.8459199775925198e-03 + 1.2711743798522841e-03 -7.6130247231598483e-03 + 2.8129148065762330e-03 -6.4318453060429126e-03 + 4.2939558487166659e-03 -5.3013093184719673e-03 + 5.7147408030152370e-03 -4.2199184840427291e-03 + 7.0759857689013279e-03 -3.1861498685284702e-03 + 8.3786424314713191e-03 -2.1985922549725653e-03 + 9.6236573723460384e-03 -1.2556775546974403e-03 + 1.0812172114889579e-02 -3.5571493295266101e-04 + 1.1945603935800291e-02 5.0275772500039007e-04 + 1.3025348742673170e-02 1.3212528460174813e-03 + 1.4053065411545527e-02 2.1013056223741604e-03 + 1.5030810426182846e-02 2.8440799277823529e-03 + 1.5960907149235842e-02 3.5504174222603336e-03 + 1.6850474890475548e-02 4.2197239457518153e-03 + 1.7752532550005921e-02 4.8342842137427912e-03 +-8.3644655712006952e-02 -1.0819616857559504e-01 +-8.4659518026896294e-02 -1.0628665049061392e-01 +-8.5389247894212914e-02 -1.0416709840748439e-01 +-8.5785378457131994e-02 -1.0188268603488096e-01 +-8.5879584020715702e-02 -9.9492483365335324e-02 +-8.5653174553598582e-02 -9.7031173121674558e-02 +-8.5114536336575827e-02 -9.4545425982342349e-02 +-8.4318341215919065e-02 -9.2058485989421762e-02 +-8.3315377296173540e-02 -8.9573204728859754e-02 +-8.2131436841365119e-02 -8.7086368425795854e-02 +-8.0764170964144330e-02 -8.4614590175072973e-02 +-7.9251349280852465e-02 -8.2153737042781338e-02 +-7.7616161585752380e-02 -7.9694562356003820e-02 +-7.5866270995661012e-02 -7.7235913217826496e-02 +-7.3998878375462401e-02 -7.4788161473313922e-02 +-7.2023636736147742e-02 -7.2356539045023552e-02 +-6.9957537581984530e-02 -6.9937311731626747e-02 +-6.7815634964702554e-02 -6.7525351270523185e-02 +-6.5610030744779807e-02 -6.5117152829789499e-02 +-6.3346795650039145e-02 -6.2712479845519462e-02 +-6.1021033723044016e-02 -6.0325079490414595e-02 +-5.8642133768849546e-02 -5.7959258157228404e-02 +-5.6222383885971658e-02 -5.5612487910553218e-02 +-5.3769461806766498e-02 -5.3285097186973621e-02 +-5.1289316250332916e-02 -5.0982282372516695e-02 +-4.8796324178937131e-02 -4.8699612213751832e-02 +-4.6298148439518884e-02 -4.6436609118340133e-02 +-4.3798114127710411e-02 -4.4197678796987432e-02 +-4.1296909462630177e-02 -4.1992633106766986e-02 +-3.8802102972539020e-02 -3.9823882794477072e-02 +-3.6319178542839746e-02 -3.7694300447637850e-02 +-3.3855514013796065e-02 -3.5605211044978081e-02 +-3.1418923501044020e-02 -3.3555630366873319e-02 +-2.9013067495201498e-02 -3.1547569133646265e-02 +-2.6639746053632393e-02 -2.9587386528229811e-02 +-2.4306735339194627e-02 -2.7673839292340352e-02 +-2.2017909113500461e-02 -2.5807160096590655e-02 +-1.9774895282992290e-02 -2.3990648042235066e-02 +-1.7580488949491397e-02 -2.2226811568878117e-02 +-1.5438497733839904e-02 -2.0515379011122731e-02 +-1.3350415665148632e-02 -1.8857526116924296e-02 +-1.1317932023563685e-02 -1.7255064604260826e-02 +-9.3445346791306647e-03 -1.5706369162186814e-02 +-7.4312991301152403e-03 -1.4211097159610515e-02 +-5.5789486306448317e-03 -1.2769670645206132e-02 +-3.7886917752132008e-03 -1.1381528307206654e-02 +-2.0613024819051999e-03 -1.0045599508534888e-02 +-3.9664123681814158e-04 -8.7612594068999291e-03 + 1.2061247340118401e-03 -7.5282940650149731e-03 + 2.7480123711787359e-03 -6.3469761566102689e-03 + 4.2291689799403304e-03 -5.2163128166031721e-03 + 5.6500420458013905e-03 -4.1348193441336466e-03 + 7.0113560051313249e-03 -3.1009727865292740e-03 + 8.3140503842049993e-03 -2.1133482441961834e-03 + 9.5590689961129877e-03 -1.1703880691575493e-03 + 1.0747571274735083e-02 -2.7041225162519755e-04 + 1.1880966070365175e-02 5.8806262477727731e-04 + 1.2960656338336660e-02 1.4065393848229620e-03 + 1.3988338841706589e-02 2.1865452722087254e-03 + 1.4966103304168593e-02 2.9292710576803915e-03 + 1.5896621002099657e-02 3.6354628615094891e-03 + 1.6790484648141025e-02 4.3034807820841545e-03 + 1.7717415520209903e-02 4.9092588400652453e-03 +-8.3739072210633467e-02 -1.0825694010771428e-01 +-8.4763310463756611e-02 -1.0633176712424268e-01 +-8.5498599492254412e-02 -1.0419521115133250e-01 +-8.5900169713397811e-02 -1.0189484694506885e-01 +-8.5995087844422807e-02 -9.9489460147733438e-02 +-8.5768246839321799e-02 -9.7013480168452654e-02 +-8.5229301103467339e-02 -9.4514697470994183e-02 +-8.4432138526807282e-02 -9.2017370991622258e-02 +-8.3427316691981293e-02 -8.9524025482172032e-02 +-8.2240163986895529e-02 -8.7030481230550627e-02 +-8.0871038879791801e-02 -8.4552228482274561e-02 +-7.9356456913600978e-02 -8.2086514555847742e-02 +-7.7719265124927259e-02 -7.9623619348858310e-02 +-7.5966904917095249e-02 -7.7161745796551509e-02 +-7.4097311382146577e-02 -7.4710664076810068e-02 +-7.2120352540565313e-02 -7.2275978694000334e-02 +-7.0052864524057859e-02 -6.9854292437176016e-02 +-6.7909809187923983e-02 -6.7440419574557084e-02 +-6.5703097773181951e-02 -6.5030744956676670e-02 +-6.3438253828726351e-02 -6.2624904437886014e-02 +-6.1111132413692489e-02 -6.0235905919060688e-02 +-5.8731192528704193e-02 -5.7868575738740158e-02 +-5.6310485103869504e-02 -5.5520646613560709e-02 +-5.3856568915336162e-02 -5.3192292845808703e-02 +-5.1375863730939053e-02 -5.0888417840412266e-02 +-4.8882404555200536e-02 -4.8605094901971665e-02 +-4.6383682429436447e-02 -4.6341644985753980e-02 +-4.3882861075104272e-02 -4.4102302380548145e-02 +-4.1381007584404994e-02 -4.1896568290590394e-02 +-3.8885565749310562e-02 -3.9727224398260222e-02 +-3.6402113963376156e-02 -3.7597051314375941e-02 +-3.3938092593404093e-02 -3.5507433785934857e-02 +-3.1501129777986858e-02 -3.3457521217425158e-02 +-2.9094743412317214e-02 -3.1449197638788708e-02 +-2.6721114438572398e-02 -2.9488525760039304e-02 +-2.4387838202670264e-02 -2.7574677086142852e-02 +-2.2098660571173864e-02 -2.5707798577286695e-02 +-1.9855277625239497e-02 -2.3891018942399159e-02 +-1.7660590907724014e-02 -2.2126857374694327e-02 +-1.5518289350169145e-02 -2.0415197745983129e-02 +-1.3429861376015319e-02 -1.8757113021286791e-02 +-1.1397167325971614e-02 -1.7154333769856485e-02 +-9.4235702967614653e-03 -1.5605450610875605e-02 +-7.5101212887995622e-03 -1.4110023608034178e-02 +-5.6576005499262300e-03 -1.2668415953378462e-02 +-3.8672225371242162e-03 -1.1280117591449288e-02 +-2.1397170293648085e-03 -9.9440862121491155e-03 +-4.7490863244036648e-04 -8.6596665206328093e-03 + 1.1280636601190947e-03 -7.4266137505143151e-03 + 2.6701276757711409e-03 -6.2451337294538696e-03 + 4.1514231302747506e-03 -5.1143183486064133e-03 + 5.5724023669022115e-03 -4.0327017783595848e-03 + 6.9337983018602023e-03 -2.9987609161732935e-03 + 8.2365376634404696e-03 -2.0110567444810976e-03 + 9.4815618143346339e-03 -1.0680427979840685e-03 + 1.0670048475312667e-02 -1.6804976023535438e-04 + 1.1803399286883698e-02 6.9042703810706034e-04 + 1.2883027076200045e-02 1.5088810300044936e-03 + 1.3910671475784958e-02 2.2888326348669079e-03 + 1.4888490329071250e-02 3.0314915986614753e-03 + 1.5819839758514420e-02 3.7374144875025120e-03 + 1.6720532749019953e-02 4.4034975682972280e-03 + 1.7680112406133198e-02 4.9979004301048732e-03 +-8.3852501875455218e-02 -1.0832991671194378e-01 +-8.4887798120050192e-02 -1.0638590208591484e-01 +-8.5629936234937601e-02 -1.0422904630425157e-01 +-8.6037791148882756e-02 -1.0190950826463668e-01 +-8.6133728831284173e-02 -9.9485860120605132e-02 +-8.5906413661489989e-02 -9.6992330355301720e-02 +-8.5367040590057092e-02 -9.4477951649077921e-02 +-8.4568687117808683e-02 -9.1968139226688728e-02 +-8.3561605291393254e-02 -8.9465065473584307e-02 +-8.2370710718663323e-02 -8.6963421888776565e-02 +-8.0999296185922082e-02 -8.4477462037704537e-02 +-7.9482582722661788e-02 -8.2005893582895645e-02 +-7.7842975140371501e-02 -7.9538505295708550e-02 +-7.6087680509488123e-02 -7.7072737690080190e-02 +-7.4215453743348980e-02 -7.4617675918622992e-02 +-7.2236426977979940e-02 -7.2179328830122610e-02 +-7.0167267607203279e-02 -6.9754689709986203e-02 +-6.8022821042404730e-02 -6.7338517634913081e-02 +-6.5814760179919940e-02 -6.4927066305476136e-02 +-6.3548013636170048e-02 -6.2519797016353226e-02 +-6.1219263508895359e-02 -6.0128900363923828e-02 +-5.8838066753658429e-02 -5.7759769300093439e-02 +-5.6416205692092748e-02 -5.5410443841383425e-02 +-5.3961113683613109e-02 -5.3080923868834687e-02 +-5.1479724386481546e-02 -5.0775795183085795e-02 +-4.8985698230339103e-02 -4.8491681564213740e-02 +-4.6486314426971764e-02 -4.6227689135301904e-02 +-4.3984562650294066e-02 -4.3987840319826089e-02 +-4.1481926021375577e-02 -4.1781293862095184e-02 +-3.8985725319334967e-02 -3.9611234284490378e-02 +-3.6501643140865937e-02 -3.7480354617895541e-02 +-3.4037186389356815e-02 -3.5390108538476080e-02 +-3.1599771111949865e-02 -3.3339792892217432e-02 +-2.9192763514901049e-02 -3.1331142774784992e-02 +-2.6818758321112687e-02 -2.9369900340010056e-02 +-2.4485158079812042e-02 -2.7455686612391249e-02 +-2.2195561579564406e-02 -2.5588561848522273e-02 +-1.9951740379411380e-02 -2.3771461479248135e-02 +-1.7756711960586976e-02 -2.2006916621158990e-02 +-1.5614037666296293e-02 -2.0294979981436336e-02 +-1.3525202745644564e-02 -1.8636613217302866e-02 +-1.1492250279819514e-02 -1.7033462955769942e-02 +-9.5184123593984229e-03 -1.5484349949771247e-02 +-7.6047101763627748e-03 -1.3988733966976278e-02 +-5.7519855645887770e-03 -1.2546911599720753e-02 +-3.9614597557002520e-03 -1.1158427639652154e-02 +-2.2338126719596701e-03 -9.8222715755633024e-03 +-5.6882587932635328e-04 -8.5377546321053922e-03 + 1.0343884662311982e-03 -7.3045927548671188e-03 + 2.5766635192930147e-03 -6.1229234024471968e-03 + 4.0581258156329710e-03 -4.9919268609985561e-03 + 5.4792329763211087e-03 -3.9101626584879838e-03 + 6.8407262375292637e-03 -2.8761076824988432e-03 + 8.1435192505714474e-03 -1.8883088462495678e-03 + 9.3885514198906693e-03 -9.4523133738472740e-04 + 1.0577018632504013e-02 -4.5215994591092942e-05 + 1.1710317440965673e-02 8.1326221850585656e-04 + 1.2789874293205362e-02 1.6316880825388131e-03 + 1.3817479986848713e-02 2.4115760873107198e-03 + 1.4795437397226139e-02 3.1541344346230084e-03 + 1.5728373908260790e-02 3.8595808360207579e-03 + 1.6639618331382843e-02 4.5228740098078347e-03 + 1.7641385743474389e-02 5.1027472414302590e-03 +-8.3988784476517281e-02 -1.0841754793825083e-01 +-8.5037115240368208e-02 -1.0645086618633176e-01 +-8.5787679098430797e-02 -1.0426978281871505e-01 +-8.6202778420926357e-02 -1.0192719776278700e-01 +-8.6300143038128913e-02 -9.9481586714982473e-02 +-8.6072322327182829e-02 -9.6967067002845977e-02 +-8.5532360777093960e-02 -9.4434036197350871e-02 +-8.4732534108127158e-02 -9.1909211570305405e-02 +-8.3722703951224095e-02 -8.9394392797993133e-02 +-8.2527464512167872e-02 -8.6882964272569418e-02 +-8.1153229606883134e-02 -8.4387834862177560e-02 +-7.9633929401751527e-02 -8.1909214130639854e-02 +-7.7991408720280861e-02 -7.9436393880946310e-02 +-7.6232631616179047e-02 -7.6965919630601329e-02 +-7.4357256552076187e-02 -7.4506102560525256e-02 +-7.2375738669563455e-02 -7.2063380668984170e-02 +-7.0304566639194030e-02 -6.9635195706614611e-02 +-6.8158438707570199e-02 -6.7216258400070145e-02 +-6.5948731336946856e-02 -6.4802666453761884e-02 +-6.3679738667124036e-02 -6.2393645876756283e-02 +-6.1349038521092879e-02 -6.0000497181067466e-02 +-5.8966321357836173e-02 -5.7629218822713560e-02 +-5.6543070097892785e-02 -5.5278210071692681e-02 +-5.4086589481031094e-02 -5.2947276946612068e-02 +-5.1604362733001570e-02 -5.0640668129617129e-02 +-4.9109646666962853e-02 -4.8355596305595924e-02 +-4.6609461060768860e-02 -4.6090943485362232e-02 +-4.4106611257006635e-02 -4.3850472046355234e-02 +-4.1603029498701788e-02 -4.1642968610298280e-02 +-3.9105922854630437e-02 -3.9472046349641327e-02 +-3.6621087317797264e-02 -3.7340321972391288e-02 +-3.4156098293139883e-02 -3.5249328523559262e-02 +-3.1718132782721710e-02 -3.3198522397224511e-02 +-2.9310399522218297e-02 -3.1189465225149642e-02 +-2.6935933684981237e-02 -2.9227559674092830e-02 +-2.4601937222214289e-02 -2.7312903864916891e-02 +-2.2311841821589646e-02 -2.5445473964722826e-02 +-2.0067500837952848e-02 -2.3627989198152479e-02 +-1.7872055620728335e-02 -2.1862993276592323e-02 +-1.5728933782014658e-02 -2.0150718342684122e-02 +-1.3639620965652278e-02 -1.8492008359408667e-02 +-1.1606350947378732e-02 -1.6888426030409517e-02 +-9.6322221191087638e-03 -1.5339031553052666e-02 +-7.7182199878611298e-03 -1.3843184758777447e-02 +-5.8652513003942903e-03 -1.2401108150889682e-02 +-4.0745448750381663e-03 -1.1012403671708904e-02 +-2.3467248524716390e-03 -9.6760958996121617e-03 +-6.8152189294237904e-04 -8.3914595733643876e-03 + 9.2197586420981136e-04 -7.1581616066291130e-03 + 2.4645029699152752e-03 -5.9762715552301032e-03 + 3.9461657585215769e-03 -4.8450596785047451e-03 + 5.3674270146767677e-03 -3.7631184471279434e-03 + 6.7290357638845229e-03 -2.7289254182701135e-03 + 8.0318927843500421e-03 -1.7410141157392204e-03 + 9.2769361819711356e-03 -7.9786145832566569e-04 + 1.0465379399193927e-02 1.0218250650781554e-04 + 1.1598617128037780e-02 9.6066139046368788e-04 + 1.2678094657027281e-02 1.7790525882037038e-03 + 1.3705671699612216e-02 2.5588635568843518e-03 + 1.4683958645705692e-02 3.3012574294552298e-03 + 1.5619815321366007e-02 4.0058996119534951e-03 + 1.6546896504309808e-02 4.6653392999114742e-03 + 1.7602362983794931e-02 5.2268625179505979e-03 +-8.4152535561017872e-02 -1.0852277131052356e-01 +-8.5216229945644442e-02 -1.0652883899302433e-01 +-8.5977132462873168e-02 -1.0431884570204927e-01 +-8.6400572871867587e-02 -1.0194855972802498e-01 +-8.6499894638150790e-02 -9.9476535477146855e-02 +-8.6271557866098164e-02 -9.6936916776409102e-02 +-8.5730794114582287e-02 -9.4381587568727970e-02 +-8.4929135501326761e-02 -9.1838710746764946e-02 +-8.3915965911757290e-02 -8.9309700034953546e-02 +-8.2715695917670737e-02 -8.6786443901097632e-02 +-8.1337987728972216e-02 -8.4280408300422452e-02 +-7.9815540314357419e-02 -8.1793292272798607e-02 +-7.8169505729862407e-02 -7.9313897186145774e-02 +-7.6406600713497683e-02 -7.6837729232528379e-02 +-7.4527464646365713e-02 -7.4372232309064715e-02 +-7.2542944995262815e-02 -7.1924287174885235e-02 +-7.0469347283875550e-02 -6.9491844766848554e-02 +-6.8321184045970929e-02 -6.7069580373147211e-02 +-6.6109466063667063e-02 -6.4653406020955179e-02 +-6.3837826064021927e-02 -6.2242235891022811e-02 +-6.1504793095998017e-02 -5.9846417729945714e-02 +-5.9120235177310736e-02 -5.7472581923464772e-02 +-5.6695308445048290e-02 -5.5119542995315275e-02 +-5.4237190170269754e-02 -5.2786896660862968e-02 +-5.1753937113815311e-02 -5.0478542866244251e-02 +-4.9258379169515316e-02 -4.8192309460288241e-02 +-4.6757221489458309e-02 -4.5926850373896974e-02 +-4.4253077984080715e-02 -4.3685612006850935e-02 +-4.1748356153021360e-02 -4.1476982996223377e-02 +-3.9250168522428353e-02 -3.9305021499811146e-02 +-3.6764432807757111e-02 -3.7172287880150583e-02 +-3.4298791780544631e-02 -3.5080406549095708e-02 +-3.1860156916828232e-02 -3.3029002358940282e-02 +-2.9451578167625395e-02 -3.1019437400725172e-02 +-2.7076548111991897e-02 -2.9056763555269604e-02 +-2.4742066087525647e-02 -2.7141572611362481e-02 +-2.2451376869027904e-02 -2.5273763629954007e-02 +-2.0206419991950011e-02 -2.3455818198263399e-02 +-1.8010466123726993e-02 -2.1690292328209272e-02 +-1.5866807156285856e-02 -1.9977603980372211e-02 +-1.3776933947160048e-02 -1.8318476406526642e-02 +-1.1743273758771412e-02 -1.6714392012393171e-02 +-9.7687932216811990e-03 -1.5164653037571177e-02 +-7.8544360437962091e-03 -1.3668523899220604e-02 +-6.0011752335804459e-03 -1.2226146480109622e-02 +-4.2102476924550146e-03 -1.0837180294539110e-02 +-2.4822158206480832e-03 -9.5006877566468709e-03 +-8.1675117524939269e-04 -8.2159041401764239e-03 + 7.8707786494291846e-04 -6.9824366927698812e-03 + 2.3299053272164525e-03 -5.8002897188662713e-03 + 3.8118089996440965e-03 -4.6688226228783058e-03 + 5.2332557861246186e-03 -3.5866692002342847e-03 + 6.5950015415431893e-03 -2.5523092643193949e-03 + 7.8979349579293805e-03 -1.5642643982851372e-03 + 9.1429936454496420e-03 -6.2102283607339600e-04 + 1.0331407639122650e-02 2.7905745315424127e-04 + 1.1464574322624457e-02 1.1375360154403102e-03 + 1.2543966090292362e-02 1.9558842892012972e-03 + 1.3571553882514929e-02 2.7355954553619517e-03 + 1.4550580441089892e-02 3.4777068542829891e-03 + 1.5491606786526918e-02 4.1810679183592282e-03 + 1.6441774928048495e-02 4.8354190004427575e-03 + 1.7564626687545513e-02 5.3739544743079092e-03 +-8.4349302859256417e-02 -1.0864910784402088e-01 +-8.5431115701060559e-02 -1.0662244575770279e-01 +-8.6204657783132924e-02 -1.0437795770458060e-01 +-8.6637705743930329e-02 -1.0197438254354048e-01 +-8.6739661486293848e-02 -9.9470598590565687e-02 +-8.6510831901638205e-02 -9.6900972579030006e-02 +-8.5968986972947872e-02 -9.4318995399825259e-02 +-8.5165038610118343e-02 -9.1754408274490301e-02 +-8.4147817070761535e-02 -8.9208234160303129e-02 +-8.2941735620569224e-02 -8.6670674709914255e-02 +-8.1559755272753498e-02 -8.4151667238479333e-02 +-8.0033468153492021e-02 -8.1654318360142947e-02 +-7.8383193727182651e-02 -7.9166955142915205e-02 +-7.6615401216916429e-02 -7.6683893370519784e-02 +-7.4731776571457478e-02 -7.4211613550209277e-02 +-7.2743639125110657e-02 -7.1757436662157767e-02 +-7.0667114975921902e-02 -6.9319883371097638e-02 +-6.8516483328256231e-02 -6.6893613907584512e-02 +-6.6302309017450115e-02 -6.4474319183094167e-02 +-6.4027553326092820e-02 -6.2060507981515994e-02 +-6.1691732389272218e-02 -5.9661527788437342e-02 +-5.9304944259745952e-02 -5.7284649813242147e-02 +-5.6877998264618125e-02 -5.4929161415018780e-02 +-5.4417950637474524e-02 -5.2594437650512714e-02 +-5.1933438867779694e-02 -5.0284028975141268e-02 +-4.9436850349922512e-02 -4.7996387366450184e-02 +-4.6934513813358114e-02 -4.5729940665120081e-02 +-4.4428848240175067e-02 -4.3487756603621842e-02 +-4.1922752476794736e-02 -4.1277805291010612e-02 +-3.9423275590821837e-02 -3.9104593194903413e-02 +-3.6936464221413660e-02 -3.6970654583012408e-02 +-3.4470023098112111e-02 -3.4877719168076027e-02 +-3.2030574021058758e-02 -3.2825584203574690e-02 +-2.9621012220278024e-02 -3.0815385957761232e-02 +-2.7245291252456571e-02 -2.8851824234957142e-02 +-2.4910213022409335e-02 -2.6935986090925429e-02 +-2.2618817363892145e-02 -2.5067705190096091e-02 +-2.0373131241925763e-02 -2.3249207665179246e-02 +-1.8176556658874000e-02 -2.1483059927938052e-02 +-1.6032253437019195e-02 -1.9769866303015051e-02 +-1.3941723700090383e-02 -1.8110231040956250e-02 +-1.1907584571336723e-02 -1.6505564088963091e-02 +-9.9326783331436987e-03 -1.4955404053493515e-02 +-8.0179011034254236e-03 -1.3458929116574340e-02 +-6.1642907364529605e-03 -1.2016195910212808e-02 +-4.3730920472598500e-03 -1.0626919461623661e-02 +-2.6447999374847667e-03 -9.2902016941471786e-03 +-9.7901894726189838e-04 -8.0052354241115856e-03 + 6.2519685715112054e-04 -6.7715574475536054e-03 + 2.1683812615983051e-03 -5.5891115468857709e-03 + 3.6505741767251273e-03 -4.4573429498230384e-03 + 5.0722441705143336e-03 -3.3749354022659097e-03 + 6.4341524852784774e-03 -2.3403739027425545e-03 + 7.7371771365882837e-03 -1.3521704272556189e-03 + 8.9822561589961887e-03 -4.0882357292752324e-04 + 1.0170635189753134e-02 4.9130224945602224e-04 + 1.1303720593603531e-02 1.3497792042883637e-03 + 1.2383027823227356e-02 2.1680730456014792e-03 + 1.3410739779332688e-02 2.9476411186372714e-03 + 1.4391338443844675e-02 3.6892646676271426e-03 + 1.5341150051342674e-02 4.3907211793404351e-03 + 1.6324022014772621e-02 5.0386474394126662e-03 + 1.7530318873896163e-02 5.5485251839397986e-03 +-8.4585754838264415e-02 -1.0880077627591746e-01 +-8.5688957895759976e-02 -1.0673485025075412e-01 +-8.6477881663488784e-02 -1.0444920192940704e-01 +-8.6922020518789264e-02 -1.0200563343493620e-01 +-8.7027458202003249e-02 -9.9463672973976305e-02 +-8.6798208935266560e-02 -9.6858175632043908e-02 +-8.6254925164371596e-02 -9.4244361895512760e-02 +-8.5448101921673431e-02 -9.1653662974628916e-02 +-8.4425973450097613e-02 -8.9086714800763939e-02 +-8.3213186680838824e-02 -8.6531851487769193e-02 +-8.1825962696983695e-02 -8.3997408597503181e-02 +-8.0294977886625485e-02 -8.1487735785051835e-02 +-7.8639586310135248e-02 -7.8990703761808723e-02 +-7.6866012452940127e-02 -7.6499287789066700e-02 +-7.4977036875324754e-02 -7.4018907989274393e-02 +-7.2984538935827056e-02 -7.1557301529058315e-02 +-7.0904479887430899e-02 -6.9113614641753973e-02 +-6.8750848172867890e-02 -6.6682521179305440e-02 +-6.6533673044774672e-02 -6.4259448822513915e-02 +-6.4255254463478642e-02 -6.1842390808168668e-02 +-6.1916105611007612e-02 -5.9439666495806981e-02 +-5.9526614083726774e-02 -5.7059174485020119e-02 +-5.7097234906722312e-02 -5.4700730120885617e-02 +-5.4634915485334140e-02 -5.2363487577892442e-02 +-5.2148859461492232e-02 -5.0050660659421820e-02 +-4.9651005128761472e-02 -4.7761312236783413e-02 +-4.7147238824632266e-02 -4.5493651531352902e-02 +-4.4639784431050149e-02 -4.3250300615451737e-02 +-4.2132035357618780e-02 -4.1038796838656383e-02 +-3.9631021465119952e-02 -3.8864082159417411e-02 +-3.7142924366385791e-02 -3.6728705998651801e-02 +-3.4675499967713443e-02 -3.4634519689912678e-02 +-3.2235060970123006e-02 -3.2581490011973795e-02 +-2.9824357641353542e-02 -3.0570503003554902e-02 +-2.7447791419581462e-02 -2.8605916850958275e-02 +-2.5111979968178325e-02 -2.6689297045513646e-02 +-2.2819744046250028e-02 -2.4820427908834958e-02 +-2.0573194801902787e-02 -2.3001268549824816e-02 +-1.8375863310629594e-02 -2.1234391498047761e-02 +-1.6230787939979584e-02 -1.9520580685302148e-02 +-1.4139489169445551e-02 -1.7860329068418408e-02 +-1.2104763209783915e-02 -1.6254986406086067e-02 +-1.0129341187581473e-02 -1.4704312865829478e-02 +-8.2140669709208324e-03 -1.3207414149285378e-02 +-6.3600383318825893e-03 -1.1764260028079251e-02 +-4.5685066472908277e-03 -1.0374616029432415e-02 +-2.8398940667544695e-03 -9.0376234701116335e-03 +-1.1737313349312948e-03 -7.7524296274486511e-03 + 4.3093569654828820e-04 -6.5184910070463951e-03 + 1.9745429690651009e-03 -5.3356971855752899e-03 + 3.4570827849757478e-03 -4.2035736586599447e-03 + 4.8790210264824871e-03 -3.1208622112641961e-03 + 6.2411223337842754e-03 -2.0860577066936521e-03 + 7.5442560133010782e-03 -1.0976658186642660e-03 + 8.7893615752974909e-03 -1.5419410250863225e-04 + 9.9776998227916053e-03 7.4598804613944930e-04 + 1.1110695453191240e-02 1.6044615104377044e-03 + 1.2189943494008445e-02 2.4226819617314396e-03 + 1.3218066169352076e-02 3.2020221242199630e-03 + 1.4201828428576597e-02 3.9428334136594858e-03 + 1.5165944353087371e-02 4.6416848146429547e-03 + 1.6193888301431526e-02 5.2818226268054654e-03 + 1.7502261391095255e-02 5.7560595915189397e-03 +-8.4869908665679922e-02 -1.0898283013894514e-01 +-8.5998401753896558e-02 -1.0686986618645065e-01 +-8.6805946383136059e-02 -1.0453509786943799e-01 +-8.7262940682093837e-02 -1.0204350244550445e-01 +-8.7372904791019779e-02 -9.9455673483127935e-02 +-8.7143377270006983e-02 -9.6807297567884906e-02 +-8.6598205108214352e-02 -9.4155455834715893e-02 +-8.5787760607229299e-02 -9.1533349977360096e-02 +-8.4759703612544687e-02 -8.8941239549490292e-02 +-8.3539179115785483e-02 -8.6365436015532121e-02 +-8.2145538107521732e-02 -8.3812609153914683e-02 +-8.0608791221845527e-02 -8.1288096610696470e-02 +-7.8947221872893297e-02 -7.8779318315487623e-02 +-7.7166813959020891e-02 -7.6277769822258965e-02 +-7.5271467264352895e-02 -7.3787715255708292e-02 +-7.3273714310881102e-02 -7.1317257289524927e-02 +-7.1189379246570372e-02 -6.8866212446681521e-02 +-6.9032092872357148e-02 -6.6429304680371531e-02 +-6.6811253636171894e-02 -6.4001648969453581e-02 +-6.4528531395096719e-02 -6.1580599288662087e-02 +-6.2185415549619212e-02 -5.9173441206540202e-02 +-5.9792646622369654e-02 -5.6788661342054590e-02 +-5.7360336498644547e-02 -5.4426650028830230e-02 +-5.4895341541460037e-02 -5.2086355201594818e-02 +-5.2407391184991506e-02 -4.9770682358255887e-02 +-4.9907976856579904e-02 -4.7479266137467564e-02 +-4.7402476606344474e-02 -4.5210107910883361e-02 +-4.4892921082896463e-02 -4.2965317052261184e-02 +-4.2383186645414149e-02 -4.0751990270060212e-02 +-3.9880341068912722e-02 -3.8575474099200376e-02 +-3.7390706156888623e-02 -3.6438384587380850e-02 +-3.4922072178011451e-02 -3.4342713800835291e-02 +-3.2480430791420142e-02 -3.2288586832460130e-02 +-3.0068402086504350e-02 -3.0276619792639448e-02 +-2.7690803518001669e-02 -2.8310851883767779e-02 +-2.5354089442390381e-02 -2.6393289718802972e-02 +-2.3060853809044553e-02 -2.4523687228565086e-02 +-2.0813282927678985e-02 -2.2703734042371422e-02 +-1.8615029876177205e-02 -2.0936001375367712e-02 +-1.6469029923999158e-02 -1.9221437764535138e-02 +-1.4376829637277074e-02 -1.7560439411119257e-02 +-1.2341386589800218e-02 -1.5954312200353649e-02 +-1.0365339180609565e-02 -1.4403014281241050e-02 +-8.4494764709686036e-03 -1.2905596312528319e-02 +-6.5949471890188200e-03 -1.1461943731225518e-02 +-4.8030060607551842e-03 -1.0071864422522564e-02 +-3.0739981054352795e-03 -8.7345363128908064e-03 +-1.4073756263283741e-03 -7.4490578904014794e-03 + 1.9781778300444254e-04 -6.2147978246293572e-03 + 1.7419243458369445e-03 -5.0315985479617341e-03 + 3.2248793959021404e-03 -3.8990586434011474e-03 + 4.6471395547424913e-03 -2.8159846046973179e-03 + 6.0094702095789343e-03 -1.7808878061795141e-03 + 7.3127342772261157e-03 -7.9227196006783479e-04 + 8.5578740535534742e-03 1.5134800345417397e-04 + 9.7461666751516105e-03 1.0515988437146469e-03 + 1.0879072190954525e-02 1.9100650064402189e-03 + 1.1958354726020916e-02 2.7281754104382526e-03 + 1.2987549118429814e-02 3.5071294477754394e-03 + 1.3977324747246785e-02 4.2466865803796085e-03 + 1.4963739768420916e-02 4.9423194535045999e-03 + 1.6052244765051456e-02 5.5732946838200860e-03 + 1.7484097248742041e-02 6.0032681482977768e-03 +-8.5211406413509161e-02 -1.0920132275613781e-01 +-8.6369848686419448e-02 -1.0703209015617370e-01 +-8.7199813197801956e-02 -1.0463869407700309e-01 +-8.7671791269986560e-02 -1.0208945827988400e-01 +-8.7787550565365288e-02 -9.9446553123164527e-02 +-8.7557973384137538e-02 -9.6746923751587360e-02 +-8.7010359629689144e-02 -9.4049661052613850e-02 +-8.6195347763480423e-02 -9.1389779152100489e-02 +-8.5160145298077736e-02 -8.8767175135676932e-02 +-8.3930675746275343e-02 -8.6166024744149500e-02 +-8.2529209721544081e-02 -8.3591269535806104e-02 +-8.0985381415731694e-02 -8.1048889725824899e-02 +-7.9316351285461106e-02 -7.8525827048398569e-02 +-7.7527867216917137e-02 -7.6011979465238549e-02 +-7.5624944463727292e-02 -7.3510363597097145e-02 +-7.3620860607349736e-02 -7.1029366175766967e-02 +-7.1531344604964200e-02 -6.8569499177970353e-02 +-6.9369595635707562e-02 -6.6125578065070689e-02 +-6.7144286879089160e-02 -6.3692348243209268e-02 +-6.4856507729109475e-02 -6.1266393537949437e-02 +-6.2508670041798456e-02 -5.8853981591269942e-02 +-6.0111929387367709e-02 -5.6464120322445278e-02 +-5.7676090502075533e-02 -5.4097806757624184e-02 +-5.5207941003985399e-02 -5.1753816733564696e-02 +-5.2717668114069721e-02 -4.9434791726665581e-02 +-5.0216325309222126e-02 -4.7140871870675477e-02 +-4.7708722604769487e-02 -4.4869860489718826e-02 +-4.5196698937104207e-02 -4.2623293197320299e-02 +-4.2684586745407961e-02 -4.0407823308605338e-02 +-4.0179559057831743e-02 -3.8229153021102108e-02 +-3.7688082953364850e-02 -3.6090023749277236e-02 +-3.5217960534822922e-02 -3.3992590304630435e-02 +-3.2774860647796472e-02 -3.1937116027786067e-02 +-3.0361291043703924e-02 -2.9923935460837731e-02 +-2.7982434546982998e-02 -2.7956802083260870e-02 +-2.5644609106576139e-02 -2.6038106175752678e-02 +-2.3350183003683550e-02 -2.4167590457365714e-02 +-2.1101402149069567e-02 -2.2346684220470599e-02 +-1.8902029755594584e-02 -2.0577946312293052e-02 +-1.6754923828541889e-02 -1.8862466663896474e-02 +-1.4661664854019124e-02 -1.7200566002961250e-02 +-1.2625348546052196e-02 -1.5593525593022557e-02 +-1.0648542657061971e-02 -1.4041471184624729e-02 +-8.7319818979027138e-03 -1.2543417738761659e-02 +-6.8768529004052262e-03 -1.1099173791583011e-02 +-5.0844079127305023e-03 -9.7085786224452176e-03 +-3.3549117269981157e-03 -8.3708403981762481e-03 +-1.6877366272149848e-03 -7.0850053757462676e-03 +-8.1928914138403367e-05 -5.8503504447065665e-03 + 1.4627651753506526e-03 -4.6666777100230527e-03 + 2.9462158099100781e-03 -3.5336508635623425e-03 + 4.3688615788861499e-03 -2.4501456116351734e-03 + 5.7314651116702605e-03 -1.4146982696582318e-03 + 7.0348852650358243e-03 -4.2581602144973617e-04 + 8.2800690750891980e-03 5.1798007166139841e-04 + 9.4683152040215685e-03 1.4183131788937638e-03 + 1.0601158271914456e-02 2.2767618472897913e-03 + 1.1680745996838158e-02 3.0946868125799054e-03 + 1.2712413925382013e-02 3.8729928436321095e-03 + 1.3712959597893122e-02 4.6108281666328342e-03 + 1.4732692210966800e-02 5.3029627157450939e-03 + 1.5900740769570845e-02 5.9232805842337590e-03 + 1.7480462224636114e-02 6.2983935017937309e-03 +-8.5621849744569781e-02 -1.0946350607635377e-01 +-8.6815809754981141e-02 -1.0722705947671851e-01 +-8.7672631055042860e-02 -1.0476368150205510e-01 +-8.8162184025848397e-02 -1.0214531933889318e-01 +-8.8285264960798152e-02 -9.9436332589325355e-02 +-8.8055970721297810e-02 -9.6675439437821767e-02 +-8.7505249157941556e-02 -9.3923919644812878e-02 +-8.6684483565817566e-02 -9.1218602023776699e-02 +-8.5640687356145745e-02 -8.8559033305433341e-02 +-8.4400840496768298e-02 -8.5927195618584196e-02 +-8.2989868759169527e-02 -8.3326231155186573e-02 +-8.1437329094867603e-02 -8.0762336563043338e-02 +-7.9759284895902546e-02 -7.8221890281059414e-02 +-7.7961254733238339e-02 -7.5693103319397145e-02 +-7.6049334225215509e-02 -7.3177660594284391e-02 +-7.4037627577707127e-02 -7.0684118569447160e-02 +-7.1941823232973406e-02 -6.8213680076682284e-02 +-6.9774612962659313e-02 -6.5761291969082605e-02 +-6.7543859789951893e-02 -6.3321266926678527e-02 +-6.5250133604140531e-02 -6.0889290567189253e-02 +-6.2896683773161599e-02 -5.8470645100143236e-02 +-6.0495135035128975e-02 -5.6074767235613394e-02 +-5.8055050324883103e-02 -5.3703269491278210e-02 +-5.5583173487289250e-02 -5.1354812273911900e-02 +-5.3090055367430361e-02 -4.9031831626973117e-02 +-5.0586322723756523e-02 -4.6734882095258001e-02 +-4.8076171143960719e-02 -4.4461571677593549e-02 +-4.5561245923007435e-02 -4.2212814146833547e-02 +-4.3046295001014812e-02 -3.9994819427554812e-02 +-4.0538668631081229e-02 -3.7813581256510062e-02 +-3.8044985072767906e-02 -3.5672026835522820e-02 +-3.5573031971747354e-02 -3.3572498021451409e-02 +-3.3128165671585726e-02 -3.1515368794552738e-02 +-3.0712799217478853e-02 -2.9500691812068942e-02 +-2.8332414158805417e-02 -2.7531974859478767e-02 +-2.5993221472782262e-02 -2.5611917772300291e-02 +-2.3697375485974333e-02 -2.3740267787202573e-02 +-2.1447159967417299e-02 -2.1918215729887603e-02 +-1.9246432335006634e-02 -2.0148293670991267e-02 +-1.7098004856843027e-02 -1.8431702945554563e-02 +-1.5003499345280943e-02 -1.6768715324934447e-02 +-1.2966123707352693e-02 -1.5160607879071353e-02 +-1.0988398255895569e-02 -1.3607640411960706e-02 +-9.0710072778420279e-03 -1.2108811035381981e-02 +-7.2151588005733968e-03 -1.0663863687004116e-02 +-5.4220935491931998e-03 -9.2726561465860634e-03 +-3.6919946295410539e-03 -7.9344161926301546e-03 +-2.0241563644911890e-03 -6.6481343046014690e-03 +-4.1763114808849910e-04 -5.4129960803696543e-03 + 1.1277520911724924e-03 -4.2287690978385396e-03 + 2.6117919220432326e-03 -3.0951741813708103e-03 + 4.0348984899632075e-03 -2.0111582465343622e-03 + 5.3978270599817539e-03 -9.7529203915995674e-04 + 6.7014343925153701e-03 1.3907214471326387e-05 + 7.9466759478583286e-03 9.5791240280891491e-04 + 9.1348883049645335e-03 1.8583407986040869e-03 + 1.0267782125965824e-02 2.7167433998571203e-03 + 1.1348362019107348e-02 3.5343365494416878e-03 + 1.2385227863867778e-02 4.3116450082150079e-03 + 1.3403930181973915e-02 5.0475070997316098e-03 + 1.4471519861481786e-02 5.7364442458259146e-03 + 1.5741981633284666e-02 6.3442096509045420e-03 + 1.7497199246059286e-02 6.6515821534804875e-03 +-8.6115204389358685e-02 -1.0977806981405566e-01 +-8.7351327674085544e-02 -1.0746143943093871e-01 +-8.8240185165376045e-02 -1.0491453241396125e-01 +-8.8750478306935818e-02 -1.0221334400093357e-01 +-8.8882708651036590e-02 -9.9425141905644582e-02 +-8.8654146726268326e-02 -9.6591020693100299e-02 +-8.8099531464464143e-02 -9.3774670767788920e-02 +-8.7271546636983097e-02 -9.1014706637866788e-02 +-8.6217430322760774e-02 -8.8310330207166970e-02 +-8.4965483141543674e-02 -8.5641331404305923e-02 +-8.3543004880736890e-02 -8.3008962828829524e-02 +-8.1979751849402552e-02 -8.0419149002155216e-02 +-8.0290811553172817e-02 -7.7857538958981551e-02 +-7.8481488648420666e-02 -7.5310595107624459e-02 +-7.6558892903617684e-02 -7.2778596979859403e-02 +-7.4538014802951441e-02 -7.0270124398462211e-02 +-7.2434564763409787e-02 -6.7787025522093661e-02 +-7.0260658434632625e-02 -6.5324406005557945e-02 +-6.8023283695995612e-02 -6.2876079070263421e-02 +-6.5722552168838072e-02 -6.0436719589076170e-02 +-6.3362440578514923e-02 -5.8010664476922928e-02 +-6.0955081811573393e-02 -5.5607665516900294e-02 +-5.8509892095359547e-02 -5.3229930362090803e-02 +-5.6033597001597664e-02 -5.0876082407978612e-02 +-5.3536996317883716e-02 -4.8548421208617555e-02 +-5.1030297720583373e-02 -4.6247806320840482e-02 +-4.8517055986849279e-02 -4.3971639385409766e-02 +-4.5998714611979095e-02 -4.1720183437232314e-02 +-4.3480386144432753e-02 -3.9499205004054780e-02 +-4.0969666220570536e-02 -3.7314915508000299e-02 +-3.8473331833211118e-02 -3.5170482010565586e-02 +-3.5999130196525217e-02 -3.3068458148954961e-02 +-3.3552127796071016e-02 -3.1009297259395996e-02 +-3.1134656385044587e-02 -2.8992783307693719e-02 +-2.8752419269687225e-02 -2.7022219412209836e-02 +-2.6411547761278065e-02 -2.5100530822134166e-02 +-2.4114004424881270e-02 -2.3227477670116934e-02 +-2.1862085048419893e-02 -2.1404045528801138e-02 +-1.9659722741988846e-02 -1.9632723402685341e-02 +-1.7509717752511818e-02 -1.7914790247110058e-02 +-1.5413739880582294e-02 -1.6250497431334478e-02 +-1.3375084249354283e-02 -1.4641137352672254e-02 +-1.1396245111644828e-02 -1.3087071871082599e-02 +-9.4778632649209337e-03 -1.1587298215295624e-02 +-7.6211495766604744e-03 -1.0141511597967549e-02 +-5.8273209148394130e-03 -8.7495748449345559e-03 +-4.0964790276436704e-03 -7.4107204826004925e-03 +-2.4278458724667227e-03 -6.1238797537759987e-03 +-8.2048173798057061e-04 -4.8881518022372205e-03 + 7.2570758480747352e-04 -3.7032742721862721e-03 + 2.2104446364908663e-03 -2.5690176933350125e-03 + 3.6341001490801232e-03 -1.4843998869504271e-03 + 4.9974161698243518e-03 -4.4803538938470818e-04 + 6.3012489060677310e-03 5.4154080958372414e-04 + 7.5465712224656017e-03 1.4857930391851866e-03 + 8.7348075450627977e-03 2.3863228983584880e-03 + 9.8681013344425229e-03 3.2446075370118265e-03 + 1.0951234840869331e-02 4.0616304391667152e-03 + 1.1998126480110612e-02 4.8376531873728463e-03 + 1.3045693633361066e-02 5.5718998174464325e-03 + 1.4179672131428858e-02 6.2586382951857400e-03 + 1.5579726554885029e-02 6.8511177098708924e-03 + 1.7541627863104335e-02 7.0753102737979145e-03 +-8.6708286697021852e-02 -1.1015542769479107e-01 +-8.7994482899976620e-02 -1.0774324630209452e-01 +-8.8921440805084698e-02 -1.0509667066331682e-01 +-8.9456333323274295e-02 -1.0229634491581596e-01 +-8.9599900174828981e-02 -9.9413277440221978e-02 +-8.9372645517756158e-02 -9.6491632228394048e-02 +-8.8813226360331149e-02 -9.3597786756619172e-02 +-8.7976243906895360e-02 -9.0772100601015843e-02 +-8.6909741939934712e-02 -8.8013427788994347e-02 +-8.5643597731433818e-02 -8.5299416654053009e-02 +-8.4207229566018990e-02 -8.2629313803181642e-02 +-8.2630822694953449e-02 -8.0008244096958822e-02 +-8.0928705094043998e-02 -7.7420865796880942e-02 +-7.9106003876319525e-02 -7.4851845487145172e-02 +-7.7170750505855520e-02 -7.2299995715311122e-02 +-7.5138846825806141e-02 -6.9773745428575909e-02 +-7.3026086596283513e-02 -6.7275491008827126e-02 +-7.0843959672855131e-02 -6.4800496515997980e-02 +-6.8598543541330201e-02 -6.2342009532355962e-02 +-6.6289540599542465e-02 -5.9893610038156804e-02 +-6.3921528690610588e-02 -5.7458726324239283e-02 +-6.1507167068229174e-02 -5.5047296965011289e-02 +-5.9055843657076688e-02 -5.2662072627764969e-02 +-5.6574290042044589e-02 -5.0301732960700701e-02 +-5.4073429467699934e-02 -4.7968514251203763e-02 +-5.1563048925865433e-02 -4.5663463477527318e-02 +-4.9046059561815611e-02 -4.3383746370342979e-02 +-4.6523687808069203e-02 -4.1128968322934549e-02 +-4.4001353936684369e-02 -3.8904450692646642e-02 +-4.1486953140553506e-02 -3.6716546128283220e-02 +-3.8987430468428709e-02 -3.4568699967473505e-02 +-3.6510473102984317e-02 -3.2463699352285068e-02 +-3.4060890540070624e-02 -3.0402048435924499e-02 +-3.1640938898580676e-02 -2.8383289187026092e-02 +-2.9256463592804417e-02 -2.6410555802505831e-02 +-2.6913536634213413e-02 -2.4486913433524427e-02 +-2.4613958752597889e-02 -2.2612133287165923e-02 +-2.2360011831682437e-02 -2.0787035545257602e-02 +-2.0155685608350900e-02 -1.9014050823491353e-02 +-1.8003799393514142e-02 -1.7294502332353020e-02 +-1.5906076910756451e-02 -1.5628647087642816e-02 +-1.3865880170981499e-02 -1.4017809525742785e-02 +-1.1885694419685275e-02 -1.2462427675855628e-02 +-9.9661252524121599e-03 -1.0961509479150823e-02 +-8.1083677451835000e-03 -9.5147182071725310e-03 +-6.3136001873823535e-03 -8.1219091650052578e-03 +-4.5818448535879467e-03 -6.7823017327308718e-03 +-2.9122595965254705e-03 -5.4947647531267477e-03 +-1.3039134682604082e-03 -4.2583189474385431e-03 + 2.4321652644505013e-04 -3.0726758855647981e-03 + 1.7287744101638315e-03 -1.9376491996776436e-03 + 3.1530813164939546e-03 -8.5232562307392516e-04 + 4.5168593165286364e-03 1.8462852494645709e-04 + 5.8209667150843913e-03 1.1746515267087425e-03 + 7.0664208431783894e-03 2.1191907683101295e-03 + 8.2548796802128822e-03 3.0198043401610916e-03 + 9.3895009699423871e-03 3.8778240807234039e-03 + 1.0478359315077294e-02 4.6940127040634256e-03 + 1.1543071454373860e-02 5.4688920590851790e-03 + 1.2634135418698289e-02 6.2029158155136642e-03 + 1.3857521696328340e-02 6.8890379724345120e-03 + 1.5419113907830229e-02 7.4621124491893592e-03 + 1.7622878064612005e-02 7.5848474029524904e-03 +-8.7421346478510992e-02 -1.1060805839680359e-01 +-8.8767004104684077e-02 -1.0808211527348956e-01 +-8.9739198289708597e-02 -1.0531667988998079e-01 +-9.0303371583647152e-02 -1.0239783269078342e-01 +-9.0460895665366442e-02 -9.9401278111457200e-02 +-9.0235657544807224e-02 -9.6375034513498992e-02 +-8.9670396120978393e-02 -9.3388509207328718e-02 +-8.8822297216493956e-02 -9.0483783609342353e-02 +-8.7740927667040031e-02 -8.7659355241966400e-02 +-8.6458015498547827e-02 -8.4890805301752262e-02 +-8.5004907503812871e-02 -8.2175229684137777e-02 +-8.3412395299587994e-02 -7.9516410876960542e-02 +-8.1694336911486073e-02 -7.6897661376518156e-02 +-7.9855754206445848e-02 -7.4301792731515409e-02 +-7.7905492273254509e-02 -7.1726097406892189e-02 +-7.5860343884522258e-02 -6.9178658095506593e-02 +-7.3736234501418155e-02 -6.6662262698141739e-02 +-7.1544010044471307e-02 -6.4172287843231174e-02 +-6.9288838805462757e-02 -6.1701353957910966e-02 +-6.6970041373306283e-02 -5.9241899452611539e-02 +-6.4592664305981873e-02 -5.6796467714671832e-02 +-6.2169888366621233e-02 -5.4375048255120011e-02 +-5.9711200169553585e-02 -5.1980853549347526e-02 +-5.7223359505872588e-02 -4.9612713379539965e-02 +-5.4717289330528357e-02 -4.7272870587114338e-02 +-5.2202342398889101e-02 -4.4962445622488682e-02 +-4.9680804968610777e-02 -4.2678320405389589e-02 +-4.7153666365945798e-02 -4.0419454916528860e-02 +-4.4626595415436829e-02 -3.8190722395545752e-02 +-4.2107817473094063e-02 -3.5998544386039395e-02 +-3.9604455600395633e-02 -3.3846658864653878e-02 +-3.7124130340869969e-02 -3.1738100409689801e-02 +-3.4671432944693173e-02 -2.9673405695496837e-02 +-3.2248540299858755e-02 -2.7651912052426054e-02 +-2.9861365283774779e-02 -2.5676610624534996e-02 +-2.7515930590747563e-02 -2.3750628069666789e-02 +-2.5213907363019691e-02 -2.1873734112755953e-02 +-2.2957542733944562e-02 -2.0046622486449766e-02 +-2.0750865628486773e-02 -1.8271654664990214e-02 +-1.8596738006290383e-02 -1.6550169654228154e-02 +-1.6496942894075332e-02 -1.4882449038641587e-02 +-1.4454895946773974e-02 -1.3269861899149631e-02 +-1.2473084940994130e-02 -1.1712905497019744e-02 +-1.0552087369290253e-02 -1.0210605731008904e-02 +-8.6930657954798277e-03 -8.7626081991622924e-03 +-6.8971448788120553e-03 -7.3687499527241972e-03 +-5.1642702332416910e-03 -6.0282188224680946e-03 +-3.4935451017087276e-03 -4.7398185254251841e-03 +-1.8840482016492699e-03 -3.5025007122752214e-03 +-3.3582248227361460e-04 -2.3159547452446445e-03 + 1.1506968441822305e-03 -1.1800318046390785e-03 + 2.5757731600938032e-03 -9.3884520938191060e-05 + 3.9401026308624413e-03 9.4376297745483550e-04 + 5.2445573682015122e-03 1.9343109017794010e-03 + 6.4902866567271827e-03 2.8791675618704778e-03 + 7.6795627419829300e-03 3.7797923644817392e-03 + 8.8176649301833134e-03 4.6373412668276265e-03 + 9.9179793987921525e-03 5.4526918391240445e-03 + 1.1012066736014460e-02 6.2275615196519555e-03 + 1.2165729054934840e-02 6.9640544951635750e-03 + 1.3506585583172673e-02 7.6513695407095308e-03 + 1.5266929554201274e-02 8.1989297147937405e-03 + 1.7752294992091008e-02 8.1987498550970348e-03 +-8.8278764609701313e-02 -1.1115091106438003e-01 +-8.9695007140069505e-02 -1.0848962503461894e-01 +-9.0720876855717211e-02 -1.0558255739857432e-01 +-9.1319977558390164e-02 -1.0252219487032892e-01 +-9.1494603208198161e-02 -9.9390025115010591e-02 +-9.1272241497008522e-02 -9.6238803029674622e-02 +-9.0699967502446244e-02 -9.3141388394254759e-02 +-8.9838267761948934e-02 -9.0141611799733484e-02 +-8.8739040605517933e-02 -8.7237608227123523e-02 +-8.7436196987184106e-02 -8.4402955742202135e-02 +-8.5962922073846648e-02 -8.1632427327558418e-02 +-8.4350757781082655e-02 -7.8927925490911738e-02 +-8.2613416787517727e-02 -7.6270987270855239e-02 +-8.0755933809172550e-02 -7.3642464541516503e-02 +-7.8787859895468104e-02 -7.1038071756414245e-02 +-7.6726807831786453e-02 -6.8465335137782385e-02 +-7.4588858370443475e-02 -6.5927214699820866e-02 +-7.2384234857251387e-02 -6.3419092914395625e-02 +-7.0117235369897141e-02 -6.0932907184701367e-02 +-6.7786802930768705e-02 -5.8459946215571962e-02 +-6.5398322460175629e-02 -5.6001875504173376e-02 +-6.2965469476579036e-02 -5.3568598023269215e-02 +-6.0497943512101533e-02 -5.1163685106538008e-02 +-5.8002552106451222e-02 -4.8786191263268004e-02 +-5.5490108997438357e-02 -4.6438423450017544e-02 +-5.2969509719795027e-02 -4.4121475929384278e-02 +-5.0442447934969166e-02 -4.1831887533648617e-02 +-4.7909656158501873e-02 -3.9567995670862818e-02 +-4.5376992084332345e-02 -3.7334224265482566e-02 +-4.2853012211838959e-02 -3.5136999631993140e-02 +-4.0345025660573360e-02 -3.2980337866354181e-02 +-3.7860596993996957e-02 -3.0867522232318669e-02 +-3.5404138673987659e-02 -2.8799119159790682e-02 +-3.2977737175686639e-02 -2.6774304286993164e-02 +-3.0587308725018105e-02 -2.4795940792207007e-02 +-2.8238825413836627e-02 -2.2867151475966199e-02 +-2.5933856795858971e-02 -2.0987683446445242e-02 +-2.3674603739068670e-02 -1.9158133913679293e-02 +-2.1465120405388265e-02 -1.7380791708706874e-02 +-1.9308324466209826e-02 -1.5656991452321207e-02 +-1.7206062889229944e-02 -1.3987048400114206e-02 +-1.5161799028355166e-02 -1.2372384144031785e-02 +-1.3178029591334676e-02 -1.0813547193577491e-02 +-1.1255307535950327e-02 -9.3095855554891863e-03 +-9.3947494554543747e-03 -7.8601360745520904e-03 +-7.5974137353509389e-03 -6.4650087378105084e-03 +-5.8631724032902387e-03 -5.1233440716231008e-03 +-4.1910833288004963e-03 -3.8338785736608226e-03 +-2.5802364780049976e-03 -2.5955036789206440e-03 +-1.0307361645031431e-03 -1.4078907823338455e-03 + 4.5690414339721544e-04 -2.7092444091367750e-04 + 1.8828853087876310e-03 8.1618022576718035e-04 + 3.2478789137473153e-03 1.8546361444206859e-03 + 4.5528228639659914e-03 2.8457865157619374e-03 + 5.7992600079195735e-03 3.7909537823694914e-03 + 6.9909058985619917e-03 4.6914527113261148e-03 + 8.1368360297068756e-03 5.5484728442242075e-03 + 9.2578688417938523e-03 6.3638209695536371e-03 + 1.0397313455237258e-02 7.1413528789192491e-03 + 1.1637711151779107e-02 7.8842858999051760e-03 + 1.3129783874839646e-02 8.5742826040439615e-03 + 1.5131941431912098e-02 9.0875988821604008e-03 + 1.7943922728094516e-02 8.9393977814891060e-03 +-8.9309890541474132e-02 -1.1180188954875038e-01 +-9.0809888457686908e-02 -1.0897969301455489e-01 +-9.1899449948161599e-02 -1.0590402314157041e-01 +-9.2540258679254458e-02 -1.0267491670985250e-01 +-9.2735759531640066e-02 -9.9380870032214269e-02 +-9.2517317513537645e-02 -9.6080363503454461e-02 +-9.1936726118319753e-02 -9.2850229611322888e-02 +-9.1058544711557998e-02 -8.9736156527898944e-02 +-8.9937859838130144e-02 -8.6735924073174792e-02 +-8.8611192926762200e-02 -8.3821130071719332e-02 +-8.7113607555721187e-02 -8.0984024266065643e-02 +-8.5477542921568284e-02 -7.8224111648488276e-02 +-8.3716888305399417e-02 -7.5520678975600053e-02 +-8.1836851038987135e-02 -7.2852440021598561e-02 +-7.9847598562677424e-02 -7.0213442877267621e-02 +-7.7767448019227581e-02 -6.7610432716697616e-02 +-7.5612627236265093e-02 -6.5046262953749323e-02 +-7.3392795370864072e-02 -6.2516146779279871e-02 +-7.1111452288996832e-02 -6.0011282373202281e-02 +-6.8767153103793208e-02 -5.7521829742944668e-02 +-6.6365498440183537e-02 -5.5048570403576587e-02 +-6.3920612244700498e-02 -5.2601186780412881e-02 +-6.1442486158198993e-02 -5.0183492639226043e-02 +-5.8937990368074220e-02 -4.7794802189647261e-02 +-5.6417746094277250e-02 -4.5437521940984577e-02 +-5.3890167123707880e-02 -4.3112641151317813e-02 +-5.1356389507252687e-02 -4.0816297309234584e-02 +-4.8816874424328291e-02 -3.8546228422886304e-02 +-4.6277608081048367e-02 -3.6306412498365151e-02 +-4.3747449216474436e-02 -3.4103224981923419e-02 +-4.1233895651663716e-02 -3.1940917426386647e-02 +-3.8744482433663179e-02 -2.9823007251597488e-02 +-3.6283479754012658e-02 -2.7750102510371313e-02 +-3.3852869490891530e-02 -2.5721260227161584e-02 +-3.1458519834633873e-02 -2.3739223125690864e-02 +-2.9106341489456504e-02 -2.1807059969803366e-02 +-2.6797821215983161e-02 -1.9924469361166239e-02 +-2.4535112184302387e-02 -1.8091967940734560e-02 +-2.2322284474200118e-02 -1.6311775321599709e-02 +-2.0162314389145834e-02 -1.4585210846564568e-02 +-1.8057115721494765e-02 -1.2912623597858571e-02 +-1.6010198695591747e-02 -1.1295490622616708e-02 +-1.4024071486510839e-02 -9.7344098441562703e-03 +-1.2099261835608758e-02 -8.2284537033703014e-03 +-1.0236830617523325e-02 -6.7772530918059175e-03 +-8.4377619353860085e-03 -5.3805835991945737e-03 +-6.7018574859374069e-03 -4.0375276746992018e-03 +-5.0281377113643418e-03 -2.7467536861980170e-03 +-3.4157060029975520e-03 -1.5071001963507687e-03 +-1.8647243489771127e-03 -3.1822495924567750e-04 +-3.7578156533893132e-04 8.1995661421388998e-04 + 1.0512634624291119e-03 1.9081693614695589e-03 + 2.4170912469122395e-03 2.9475537764499602e-03 + 3.7228950585604568e-03 3.9393582749969094e-03 + 4.9712584071679332e-03 4.8847687567448988e-03 + 6.1687395838638751e-03 5.7850907930107713e-03 + 7.3301400851598477e-03 6.6422241674920710e-03 + 8.4855175169531640e-03 7.4599601663720488e-03 + 9.6913316971704664e-03 8.2446683673061891e-03 + 1.1048291929172458e-02 8.9989822729636335e-03 + 1.2731751434594653e-02 9.6921603125533270e-03 + 1.5025327659196671e-02 1.0159236164525621e-02 + 1.8215082887712890e-02 9.8336170781292750e-03 +-9.0550051634346707e-02 -1.1258243468134660e-01 +-9.2149400372826359e-02 -1.0956905654089588e-01 +-9.3314562000068713e-02 -1.0629289558507519e-01 +-9.4005198810105856e-02 -1.0286285135972127e-01 +-9.4226104300808425e-02 -9.9375797032838872e-02 +-9.4012864975343155e-02 -9.5897048257559375e-02 +-9.3422517903766281e-02 -9.2508049591647393e-02 +-9.2524532829761544e-02 -8.9256559132995295e-02 +-9.1378071145418571e-02 -8.6140032505174421e-02 +-9.0022809414183988e-02 -8.3128054098569854e-02 +-8.8495886649856706e-02 -8.0210118052111604e-02 +-8.6830831419739310e-02 -7.7382842697492515e-02 +-8.5042010678468602e-02 -7.4622773061623501e-02 +-8.3134986266222927e-02 -7.1906220334018028e-02 +-8.1120482379208284e-02 -6.9225413958083251e-02 +-7.9017379022561646e-02 -6.6586067873973961e-02 +-7.6842012733524034e-02 -6.3990599889937133e-02 +-7.4603558412538559e-02 -6.1433814482473315e-02 +-7.2304812893281223e-02 -5.8906099592451668e-02 +-6.9943934028520699e-02 -5.6396517763136318e-02 +-6.7526627644505163e-02 -5.3904955089325565e-02 +-6.5067400376681600e-02 -5.1440748397200926e-02 +-6.2576564596217049e-02 -4.9007828347672033e-02 +-6.0061058352956789e-02 -4.6605750333315668e-02 +-5.7531258323861738e-02 -4.4237023555864848e-02 +-5.4995080851939944e-02 -4.1902474720630710e-02 +-5.2453134375851418e-02 -3.9597795437940099e-02 +-4.9905599730863823e-02 -3.7320142169234662e-02 +-4.7358529964168575e-02 -3.5073054219042006e-02 +-4.4821033041596910e-02 -3.2862806253634677e-02 +-4.2300789060330607e-02 -3.0693820916030137e-02 +-3.9805337308276484e-02 -2.8569819394763156e-02 +-3.7338838499931450e-02 -2.6491469181879463e-02 +-3.4903158410069759e-02 -2.4457747808371809e-02 +-3.2504078176339546e-02 -2.2471282907376839e-02 +-3.0147430286228925e-02 -2.0535053454011295e-02 +-2.7834627153078009e-02 -1.8648682747020060e-02 +-2.5567779113370548e-02 -1.6812609445039539e-02 +-2.3350967508784553e-02 -1.5028990351099366e-02 +-2.1187223610550022e-02 -1.3299126141448936e-02 +-1.9078527665507536e-02 -1.1623394966109353e-02 +-1.7028437243947349e-02 -1.0003327638885149e-02 +-1.5039471778119262e-02 -8.4395713999325540e-03 +-1.3112130347035154e-02 -6.9312237259157184e-03 +-1.1247412021347398e-02 -5.4779078395527899e-03 +-9.4462239074390459e-03 -4.0793589628285174e-03 +-7.7083015044562614e-03 -2.7345960923537528e-03 +-6.0326342659970172e-03 -1.4422205947265160e-03 +-4.4183411051553819e-03 -2.0102409581658723e-04 +-2.8656383119641830e-03 9.8934537672960908e-04 +-1.3751824749491748e-03 2.1289420634636879e-03 + 5.3138004911247920e-05 3.2184275315493682e-03 + 1.4201652864576737e-03 4.2588434842862699e-03 + 2.7278844049873664e-03 5.2512978508112724e-03 + 3.9811207057846992e-03 6.1969400115623125e-03 + 5.1910072130107584e-03 7.0976437876945292e-03 + 6.3798150340129570e-03 7.9570387958579052e-03 + 7.5882213777558761e-03 8.7816698168556341e-03 + 8.8870885509251245e-03 9.5798810608334478e-03 + 1.0396920192381892e-02 1.0350957897778339e-02 + 1.2319226227082323e-02 1.1046098628746209e-02 + 1.4961224960115134e-02 1.1450990157761760e-02 + 1.8587073789386149e-02 1.0913444736516337e-02 +)) + +(0 "Zone: 2 Block: 1") +(0 "Number of Cells : 36643") +(12 (2 1 8f23 1 0)( + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 3 3 + 3 3 3 3 3 3 3 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 + 1 1 1 1 +)) +(45 (2 fluid fluid) ()) + +(0 "Zone 3 (64355 faces), BC : interior ") +(13 (3 1 fb63 2 2)( +1 751 4c37 4c38 +76a 2 4c64 4c67 +7a0 3 4cc3 4cc6 +7ba 4 4cf2 4cf4 +5 fa 3663 3664 +6 be 3683 3684 +da 7 4bec 4bed +7 f9 4bec 8101 +117 7 4bed 8106 +7 21be 8101 8e37 +23c5 7 8106 8e37 +db 8 4bcd 7d89 +116 8 4bcc 4bcd +8 1c5 4bcc 7e52 +21d3 8 7d89 7e53 +8 21d5 7e52 7e53 +9 155 4c2c 8b82 +1b1 9 4c2c 4c2d +28e 9 4c2d 7e97 +2249 9 7e97 81cc +2250 9 83db 8b82 +2406 9 81cc 83db +a 195 36c3 36c4 +b 1c6 3658 3659 +1bc c 4bc2 7e5f +1e2 c 4bc1 4bc2 +c 270 4bc1 7e60 +c 21e1 7d98 7e5f +21e2 c 7d98 7e60 +271 d 3611 36cd +22a e 4b7a 7e91 +e 28d 4b7a 4c36 +e 296 4c36 7e92 +e 1f62 7dee 7e91 +1f63 e 7dee 7def +2240 e 7def 7e92 +2a0 f 35b4 35b5 +10 2c1 1194 1195 +10 301 1195 8cc4 +424 10 1194 8e2e +20cc 10 7b43 7b47 +10 20cd 7b43 8e2e +20d0 10 7b47 8cc4 +2d1 11 35c4 35c5 +12 2f2 11a4 11a5 +2f3 12 11a4 7a1f +12 333 11a5 4d53 +12 7f2 4d53 7a1f +311 13 35d4 35d5 +14 332 11b4 11b5 +341 14 11b4 7b59 +14 373 11b5 7a2b +14 1f95 7a2c 7b59 +14 1f96 7a2b 7a2c +351 15 35e4 35e5 +16 372 11c4 11c5 +381 16 11c4 7b6d +16 3ac 11c5 7a4a +1fac 16 7b6d 7b6f +1fad 16 7a49 7a4a +16 1fae 7a49 7b6f +382 17 11f0 7ba0 +3ce 17 10e1 11f0 +17 5c1 10e1 7ba1 +17 1fdf 7a7c 7ba0 +1fe0 17 7a7c 7ba1 +18 3ad 3501 3610 +19 3fa 1169 7bf7 +19 471 1168 1169 +4d1 19 1168 7bf6 +19 208f 7b0c 7bf6 +2090 19 7b0c 7bf7 +450 1a 3588 3589 +491 1b 3568 3569 +1c 4b2 1148 1149 +1c 4b3 1149 7ae7 +522 1c 1148 8d8b +1c 2065 8cac 8d8b +1c 2066 7ae7 8cac +4d2 1d 3538 3539 +1e 4f3 1118 1119 +1e 4f4 1119 7cab +568 1e 1118 7d34 +1e 216c 7cab 7d34 +1f 552 1101 7bc6 +1f 58a 1100 1101 +5df 1f 1100 7bc5 +2003 1f 7bc5 7bc6 +569 20 3520 3521 +63b 21 10b0 10b1 +5ff 22 1090 1091 +23 61b 40 41 +23 63a 41 7cf3 +712 23 40 7cf2 +23 211c 7c56 7cf2 +211d 23 7c56 7cf3 +61c 24 60 7d0c +24 657 60 61 +24 6b5 61 7d0d +24 2140 7c7d 7d0c +2141 24 7c7d 7d0d +25 6b6 1051 10e0 +687 26 90 7d35 +6d2 26 1 90 +26 750 1 7cb2 +26 2172 7cb0 7d35 +2173 26 7cb0 7d36 +26 2174 7cb2 7d36 +751 27 4c37 4c3a +27 752 4c39 4c3a +752 28 4c39 4c3c +28 753 4c3b 4c3d +754 28 4c3c 4c3d +753 29 4c3b 4c3f +29 755 4c3e 4c3f +755 2a 4c3e 4c41 +2a 756 4c40 4c41 +756 2b 4c40 4c43 +2b 757 4c42 4c43 +757 2c 4c42 4c45 +2c 758 4c44 4c45 +758 2d 4c44 4c47 +2d 759 4c46 4c47 +759 2e 4c46 4c49 +2e 75a 4c48 4c49 +75a 2f 4c48 4c4b +2f 75b 4c4a 4c4c +75c 2f 4c4b 4c4c +75b 30 4c4a 4c4e +30 75d 4c4d 4c4f +75e 30 4c4e 4c4f +75d 31 4c4d 4c51 +31 75f 4c50 4c51 +75f 32 4c50 4c53 +32 760 4c52 4c53 +760 33 4c52 4c55 +33 761 4c54 4c56 +762 33 4c55 4c56 +761 34 4c54 4c58 +34 763 4c57 4c58 +763 35 4c57 4c5a +35 764 4c59 4c5b +765 35 4c5a 4c5b +764 36 4c59 4c5d +36 766 4c5c 4c5d +766 37 4c5c 4c5f +37 767 4c5e 4c5f +767 38 4c5e 4c61 +38 768 4c60 4c61 +768 39 4c60 4c63 +39 769 4c62 4c63 +769 3a 4c62 4c65 +3a 76a 4c64 4c66 +76b 3a 4c65 4c66 +76a 3b 4c67 4c69 +3b 76c 4c68 4c69 +76c 3c 4c68 4c6b +3c 76d 4c6a 4c6c +76e 3c 4c6b 4c6c +76d 3d 4c6a 4c6e +3d 76f 4c6d 4c6e +76f 3e 4c6d 4c70 +3e 770 4c6f 4c70 +770 3f 4c6f 4c72 +3f 771 4c71 4c72 +771 40 4c71 4c74 +40 772 4c73 4c74 +772 41 4c73 4c76 +41 773 4c75 4c76 +773 42 4c75 4c78 +42 774 4c77 4c79 +775 42 4c78 4c79 +774 43 4c77 4c7b +43 776 4c7a 4c7b +776 44 4c7a 4c7d +44 777 4c7c 4c7d +777 45 4c7c 4c7f +45 778 4c7e 4c7f +778 46 4c7e 4c81 +46 779 4c80 4c82 +77a 46 4c81 4c82 +779 47 4c80 4c83 +779 48 4c83 4c85 +48 77b 4c84 4c86 +77c 48 4c85 4c86 +77b 49 4c84 4c88 +49 77d 4c87 4c89 +77e 49 4c88 4c89 +77d 4a 4c87 4c8b +4a 77f 4c8a 4c8b +77f 4b 4c8a 4c8d +4b 780 4c8c 4c8e +781 4b 4c8d 4c8e +780 4c 4c8c 4c90 +4c 782 4c8f 4c90 +782 4d 4c8f 4c92 +4d 783 4c91 4c92 +783 4e 4c91 4c94 +4e 784 4c93 4c95 +785 4e 4c94 4c95 +784 4f 4c93 4c97 +4f 786 4c96 4c97 +786 50 4c96 4c99 +50 787 4c98 4c99 +787 51 4c98 4c9b +51 788 4c9a 4c9c +789 51 4c9b 4c9c +788 52 4c9a 4c9e +52 78a 4c9d 4c9e +78a 53 4c9d 4ca0 +53 78b 4c9f 4ca1 +78c 53 4ca0 4ca1 +78b 54 4c9f 4ca3 +54 78d 4ca2 4ca3 +78d 55 4ca2 4ca5 +55 78e 4ca4 4ca5 +78e 56 4ca4 4ca7 +56 78f 4ca6 4ca7 +78f 57 4ca6 4ca9 +57 790 4ca8 4caa +791 57 4ca9 4caa +790 58 4ca8 4cac +58 792 4cab 4cac +792 59 4cab 4cae +59 793 4cad 4cae +793 5a 4cad 4cb0 +5a 794 4caf 4cb1 +795 5a 4cb0 4cb1 +794 5b 4caf 4cb3 +5b 796 4cb2 4cb3 +796 5c 4cb2 4cb5 +5c 797 4cb4 4cb5 +797 5d 4cb4 4cb7 +5d 798 4cb6 4cb8 +799 5d 4cb7 4cb8 +798 5e 4cb6 4cba +5e 79a 4cb9 4cba +79a 5f 4cb9 4cbc +5f 79b 4cbb 4cbd +79c 5f 4cbc 4cbd +79b 60 4cbb 4cbf +60 79d 4cbe 4cbf +79d 61 4cbe 4cc1 +61 79e 4cc0 4cc2 +79f 61 4cc1 4cc2 +79e 62 4cc0 4cc4 +62 7a0 4cc3 4cc5 +7a1 62 4cc4 4cc5 +7a0 63 4cc6 4cc8 +63 7a2 4cc7 4cc8 +7a2 64 4cc7 4cca +64 7a3 4cc9 4cca +7a3 65 4cc9 4ccc +65 7a4 4ccb 4ccc +7a4 66 4ccb 4cce +66 7a5 4ccd 4ccf +7a6 66 4cce 4ccf +7a5 67 4ccd 4cd1 +67 7a7 4cd0 4cd2 +7a8 67 4cd1 4cd2 +7a7 68 4cd0 4cd4 +68 7a9 4cd3 4cd4 +7a9 69 4cd3 4cd6 +69 7aa 4cd5 4cd6 +7aa 6a 4cd5 4cd8 +6a 7ab 4cd7 4cd8 +7ab 6b 4cd7 4cda +6b 7ac 4cd9 4cda +7ac 6c 4cd9 4cdc +6c 7ad 4cdb 4cdd +7ae 6c 4cdc 4cdd +7ad 6d 4cdb 4cdf +6d 7af 4cde 4cdf +7af 6e 4cde 4ce1 +6e 7b0 4ce0 4ce2 +7b1 6e 4ce1 4ce2 +7b0 6f 4ce0 4ce4 +6f 7b2 4ce3 4ce4 +7b2 70 4ce3 4ce6 +70 7b3 4ce5 4ce6 +7b3 71 4ce5 4ce8 +71 7b4 4ce7 4ce8 +7b4 72 4ce7 4cea +72 7b5 4ce9 4cea +7b5 73 4ce9 4cec +73 7b6 4ceb 4cec +7b6 74 4ceb 4cee +74 7b7 4ced 4cef +7b8 74 4cee 4cef +7b7 75 4ced 4cf1 +75 7b9 4cf0 4cf1 +7b9 76 4cf0 4cf3 +76 7ba 4cf2 4cf3 +7ba 77 4cf4 4cf6 +77 7bb 4cf5 4cf6 +7bb 78 4cf5 4cf8 +78 7bc 4cf7 4cf8 +7bc 79 4cf7 4cfa +79 7bd 4cf9 4cfb +7be 79 4cfa 4cfb +7bd 7a 4cf9 4cfd +7a 7bf 4cfc 4cfe +7c0 7a 4cfd 4cfe +7bf 7b 4cfc 4d00 +7b 7c1 4cff 4d00 +7c1 7c 4cff 4d02 +7c 7c2 4d01 4d02 +7c2 7d 4d01 4d04 +7d 7c3 4d03 4d04 +7c3 7e 4d03 4d06 +7e 7c4 4d05 4d07 +7c5 7e 4d06 4d07 +7c4 7f 4d05 4d09 +7f 7c6 4d08 4d09 +7c6 80 4d08 4d0b +80 7c7 4d0a 4d0b +7c7 81 4d0a 4d0d +81 7c8 4d0c 4d0d +7c8 82 4d0c 4d0f +82 7c9 4d0e 4d10 +7ca 82 4d0f 4d10 +7c9 83 4d0e 4d12 +83 7cb 4d11 4d12 +7cb 84 4d11 4d14 +84 7cc 4d13 4d14 +7cc 85 4d13 4d16 +85 7cd 4d15 4d17 +7ce 85 4d16 4d17 +7cd 86 4d15 4d19 +86 7cf 4d18 4d19 +7cf 87 4d18 4d1b +87 7d0 4d1a 4d1c +7d1 87 4d1b 4d1c +7d0 88 4d1a 4d1e +88 7d2 4d1d 4d1e +7d2 89 4d1d 4d20 +89 7d3 4d1f 4d21 +7d4 89 4d20 4d21 +7d3 8a 4d1f 4d23 +8a 7d5 4d22 4d23 +7d5 8b 4d22 4d25 +8b 7d6 4d24 4d25 +7d6 8c 4d24 4d27 +8c 7d7 4d26 4d27 +7d7 8d 4d26 4d29 +8d 7d8 4d28 4d2a +7d9 8d 4d29 4d2a +7d8 8e 4d28 4d2c +8e 7da 4d2b 4d2c +7da 8f 4d2b 4d2e +8f 7db 4d2d 4d2f +7dc 8f 4d2e 4d2f +7db 90 4d2d 4d31 +90 7dd 4d30 4d31 +7dd 91 4d30 4d33 +91 7de 4d32 4d33 +7de 92 4d32 4d35 +92 7df 4d34 4d36 +7e0 92 4d35 4d36 +7df 93 4d34 4d38 +93 7e1 4d37 4d38 +7e1 94 4d37 4d3a +94 7e2 4d39 4d3a +7e2 95 4d39 4d3c +95 7e3 4d3b 4d3c +7e3 96 4d3b 4d3e +96 7e4 4d3d 4d3f +7e5 96 4d3e 4d3f +7e4 97 4d3d 4d41 +97 7e6 4d40 4d41 +7e6 98 4d40 4d43 +98 7e7 4d42 4d44 +7e8 98 4d43 4d44 +7e7 99 4d42 4d46 +99 7e9 4d45 4d47 +7ea 99 4d46 4d47 +7e9 9a 4d45 4d49 +9a 7eb 4d48 4d49 +7eb 9b 4d48 4d4b +9b 7ec 4d4a 4d4b +7ec 9c 4d4a 4d4d +9c 7ed 4d4c 4d4d +7ed 9d 4d4c 4d4f +9d 7ee 4d4e 4d50 +7ef 9d 4d4f 4d50 +9e 751 4c38 4d51 +7ee 9e 4d4e 4d51 +9f 2759 3664 3665 +a0 275a 3665 3666 +a1 275b 3666 3667 +a2 275c 3667 3668 +a3 275d 3668 3669 +a4 275e 3669 366a +a5 275f 366a 366b +a6 2760 366b 366c +a7 2761 366c 366d +a8 2762 366d 366e +a9 2763 366e 366f +aa 2764 366f 3670 +ab 2765 3670 3671 +ac 2766 3671 3672 +ad 2767 3672 3673 +ae 2768 3673 3674 +af 2769 3674 3675 +b0 276a 3675 3676 +b1 276b 3676 3677 +b2 276c 3677 3678 +b3 276d 3678 3679 +b4 276e 3679 367a +b5 276f 367a 367b +b6 2770 367b 367c +b7 2771 367c 367d +b8 2772 367d 367e +b9 2773 367e 367f +ba 2774 367f 3680 +bb 2775 3680 3681 +bc 2776 3681 3682 +bd 2777 3682 3683 +be bf 3740 3741 +be 2777 3683 3740 +31fe be 3684 3741 +bf c0 37fd 37fe +bf 2796 3740 37fd +31bf bf 3741 37fe +c0 c1 38ba 38bb +c0 27b5 37fd 38ba +3180 c0 37fe 38bb +c1 c2 3977 3978 +c1 27d4 38ba 3977 +3141 c1 38bb 3978 +c2 c3 3a34 3a35 +c2 27f3 3977 3a34 +3102 c2 3978 3a35 +c3 c4 3af1 3af2 +c3 2812 3a34 3af1 +30c3 c3 3a35 3af2 +c4 c5 3bae 3baf +c4 2831 3af1 3bae +3084 c4 3af2 3baf +c5 c6 3c6b 3c6c +c5 2850 3bae 3c6b +3045 c5 3baf 3c6c +c6 c7 3d28 3d29 +c6 286f 3c6b 3d28 +3006 c6 3c6c 3d29 +c7 c8 3de5 3de6 +c7 288e 3d28 3de5 +2fc7 c7 3d29 3de6 +c8 c9 3ea2 3ea3 +c8 28ad 3de5 3ea2 +2f88 c8 3de6 3ea3 +c9 ca 3f5f 3f60 +c9 28cc 3ea2 3f5f +2f49 c9 3ea3 3f60 +ca cb 401c 401d +ca 28eb 3f5f 401c +2f0a ca 3f60 401d +cb cc 40d9 40da +cb 290a 401c 40d9 +2ecb cb 401d 40da +cc cd 4196 4197 +cc 2929 40d9 4196 +2e8c cc 40da 4197 +cd ce 4253 4254 +cd 2948 4196 4253 +2e4d cd 4197 4254 +ce cf 4310 4311 +ce 2967 4253 4310 +2e0e ce 4254 4311 +cf d0 43cd 43ce +cf 2986 4310 43cd +2dcf cf 4311 43ce +d0 d1 448a 448b +d0 29a5 43cd 448a +2d90 d0 43ce 448b +d1 d2 4547 4548 +d1 29c4 448a 4547 +2d51 d1 448b 4548 +d2 d3 4604 4605 +d2 29e3 4547 4604 +2d12 d2 4548 4605 +d3 d4 46c1 46c2 +d3 2a02 4604 46c1 +2cd3 d3 4605 46c2 +d4 d5 477e 477f +d4 2a21 46c1 477e +2c94 d4 46c2 477f +d5 d6 483b 483c +d5 2a40 477e 483b +2c55 d5 477f 483c +d6 d7 48f8 48f9 +d6 2a5f 483b 48f8 +2c16 d6 483c 48f9 +d7 d8 49b5 49b6 +d7 2a7e 48f8 49b5 +2bd7 d7 48f9 49b6 +d8 d9 4a72 4a73 +d8 2a9d 49b5 4a72 +2b98 d8 49b6 4a73 +d9 da 4b2f 4b30 +d9 2abc 4a72 4b2f +2b59 d9 4a73 4b30 +da 2adb 4b2f 4bec +2b1a da 4b30 4bed +dc db 4bce 7e50 +db 21d3 7d89 7e50 +2abd db 4bcd 4bce +dd dc 4bcf 7e4e +dc 21d1 7d88 7e4e +21d2 dc 7d88 7e51 +dc 21d3 7e50 7e51 +2abe dc 4bce 4bcf +de dd 4bd0 7e4d +dd 21d0 7d87 7e4d +21d1 dd 7d87 7e4e +2abf dd 4bcf 4bd0 +df de 4bd1 7e4c +de 21cf 7d86 7e4c +21d0 de 7d86 7e4d +2ac0 de 4bd0 4bd1 +e0 df 4bd2 7e4b +21cf df 7e4b 7e4c +2ac1 df 4bd1 4bd2 +e1 e0 4bd3 7e4a +e0 21cc 7d85 7e4a +21cf e0 7d85 7e4b +2ac2 e0 4bd2 4bd3 +e2 e1 4bd4 7e49 +e1 1f5d 7d82 7e49 +21cc e1 7d82 7e4a +2ac3 e1 4bd3 4bd4 +e3 e2 4bd5 7e48 +1f5d e2 7a09 7e49 +e2 1f5e 7a09 7e48 +2ac4 e2 4bd4 4bd5 +e4 e3 4bd6 7e47 +1f5e e3 7d7f 7e48 +e3 21c8 7d7f 7e47 +2ac5 e3 4bd5 4bd6 +e5 e4 4bd7 7e45 +e4 1fa5 7d7c 7e45 +21c7 e4 7d7c 7d7e +21c8 e4 7d7e 7e47 +2ac6 e4 4bd6 4bd7 +e6 e5 4bd8 7e43 +e5 1fa4 7a39 7e43 +1fa5 e5 7a39 7e45 +2ac7 e5 4bd7 4bd8 +e7 e6 4bd9 7e41 +1fa4 e6 7e41 7e43 +2ac8 e6 4bd8 4bd9 +e8 e7 4bda 7a3f +1fa4 e7 7a3a 7e41 +e7 1fa6 7a3a 7a3f +2ac9 e7 4bd9 4bda +e9 e8 4bdb 7b68 +1fa6 e8 7a3b 7a3f +e8 1fa7 7a3b 7b68 +2aca e8 4bda 4bdb +ea e9 4bdc 7e3e +e9 1fa7 7b68 7e40 +1faa e9 7e3e 7e40 +2acb e9 4bdb 4bdc +eb ea 4bdd 7a3e +1fa9 ea 7a3e 7a40 +1faa ea 7a40 7e3e +2acc ea 4bdc 4bdd +ec eb 4bde 7b6a +eb 1fa9 7a3e 7b6a +2acd eb 4bdd 4bde +ed ec 4bdf 7a44 +1fa9 ec 7a43 7b6a +ec 1fab 7a43 7a44 +2ace ec 4bde 4bdf +ee ed 4be0 7b6c +ed 1fab 7a44 7b6c +2acf ed 4bdf 4be0 +ef ee 4be1 7a47 +1fab ee 7a47 7b6c +2ad0 ee 4be0 4be1 +f0 ef 4be2 7a48 +1fab ef 7a46 7a47 +ef 1fac 7a46 7a48 +2ad1 ef 4be1 4be2 +f1 f0 4be3 8d51 +f0 1fac 7a48 7b6e +f0 20d5 7b6e 8d51 +2ad2 f0 4be2 4be3 +f2 f1 4be4 7eca +f1 20d5 8d51 8dfd +2290 f1 7eca 8dfd +2ad3 f1 4be3 4be4 +f3 f2 4be5 8d76 +21c6 f2 8d76 8e8b +f2 2290 7eca 8e8b +2ad4 f2 4be4 4be5 +f4 f3 4be6 8e84 +f3 21c5 7d7a 8e84 +21c6 f3 7d7a 8d76 +2ad5 f3 4be5 4be6 +f5 f4 4be7 8e3a +f4 21c4 7d79 8e3a +21c5 f4 7d79 8e84 +2ad6 f4 4be6 4be7 +f6 f5 4be8 8e87 +f5 21c3 8de2 8e87 +21c4 f5 8de2 8e3a +2ad7 f5 4be7 4be8 +f7 f6 4be9 8de5 +21c3 f6 8de5 8e87 +2ad8 f6 4be8 4be9 +f8 f7 4bea 8eba +f7 21c0 7d74 8eba +21c1 f7 7d74 8e86 +f7 21c3 8de5 8e86 +2ad9 f7 4be9 4bea +f9 f8 4beb 7d72 +21c0 f8 7d72 8eba +2ada f8 4bea 4beb +f9 21be 7d71 8101 +21bf f9 7d71 8e0f +f9 21c0 7d72 8e0f +2adb f9 4beb 4bec +fa fb 3720 3721 +2759 fa 3664 3721 +fa 3208 3663 3720 +fb fc 37dd 37de +2778 fb 3721 37de +fb 3212 3720 37dd +fc fd 389a 389b +2797 fc 37de 389b +fc 321c 37dd 389a +fd fe 3957 3958 +27b6 fd 389b 3958 +fd 3226 389a 3957 +fe ff 3a14 3a15 +27d5 fe 3958 3a15 +fe 3230 3957 3a14 +ff 100 3ad1 3ad2 +27f4 ff 3a15 3ad2 +ff 323a 3a14 3ad1 +100 101 3b8e 3b8f +2813 100 3ad2 3b8f +100 3244 3ad1 3b8e +101 102 3c4b 3c4c +2832 101 3b8f 3c4c +101 324e 3b8e 3c4b +102 103 3d08 3d09 +2851 102 3c4c 3d09 +102 3258 3c4b 3d08 +103 104 3dc5 3dc6 +2870 103 3d09 3dc6 +103 3262 3d08 3dc5 +104 105 3e82 3e83 +288f 104 3dc6 3e83 +104 326c 3dc5 3e82 +105 106 3f3f 3f40 +28ae 105 3e83 3f40 +105 3276 3e82 3f3f +106 107 3ffc 3ffd +28cd 106 3f40 3ffd +106 3280 3f3f 3ffc +107 108 40b9 40ba +28ec 107 3ffd 40ba +107 328a 3ffc 40b9 +108 109 4176 4177 +290b 108 40ba 4177 +108 3294 40b9 4176 +109 10a 4233 4234 +292a 109 4177 4234 +109 329e 4176 4233 +10a 10b 42f0 42f1 +2949 10a 4234 42f1 +10a 32a8 4233 42f0 +10b 10c 43ad 43ae +2968 10b 42f1 43ae +10b 32b2 42f0 43ad +10c 10d 446a 446b +2987 10c 43ae 446b +10c 32bc 43ad 446a +10d 10e 4527 4528 +29a6 10d 446b 4528 +10d 32c6 446a 4527 +10e 10f 45e4 45e5 +29c5 10e 4528 45e5 +10e 32d0 4527 45e4 +10f 110 46a1 46a2 +29e4 10f 45e5 46a2 +10f 32da 45e4 46a1 +110 111 475e 475f +2a03 110 46a2 475f +110 32e4 46a1 475e +111 112 481b 481c +2a22 111 475f 481c +111 32ee 475e 481b +112 113 48d8 48d9 +2a41 112 481c 48d9 +112 32f8 481b 48d8 +113 114 4995 4996 +2a60 113 48d9 4996 +113 3302 48d8 4995 +114 115 4a52 4a53 +2a7f 114 4996 4a53 +114 330c 4995 4a52 +115 116 4b0f 4b10 +2a9e 115 4a53 4b10 +115 3316 4a52 4b0f +2abd 116 4b10 4bcd +116 3320 4b0f 4bcc +118 117 4bee 7e3c +21bd 117 7e3c 8d93 +117 23c5 8106 8d93 +2b1a 117 4bed 4bee +119 118 4bef 7e3b +21bd 118 7e3b 7e3c +2b19 118 4bee 4bef +11a 119 4bf0 7e3a +119 21bc 7d70 7e3a +21bd 119 7d70 7e3b +2b18 119 4bef 4bf0 +11b 11a 4bf1 7d6d +21bb 11a 7d6d 7d6f +21bc 11a 7d6f 7e3a +2b17 11a 4bf0 4bf1 +11c 11b 4bf2 7e38 +11b 1f31 7d6e 7e39 +21b9 11b 7e38 7e39 +11b 21bb 7d6d 7d6e +2b16 11b 4bf1 4bf2 +11d 11c 4bf3 7e37 +11c 21b8 7d6b 7e37 +21b9 11c 7d6b 7e38 +2b15 11c 4bf2 4bf3 +11e 11d 4bf4 7e35 +11d 21b7 7d6a 7e35 +21b8 11d 7d6a 7e37 +2b14 11d 4bf3 4bf4 +11f 11e 4bf5 7e34 +11e 21b6 7d69 7e34 +21b7 11e 7d69 7e35 +2b13 11e 4bf4 4bf5 +120 11f 4bf6 7e33 +11f 21b5 7d68 7e33 +21b6 11f 7d68 7e34 +2b12 11f 4bf5 4bf6 +121 120 4bf7 7e32 +120 21b4 7d67 7e32 +21b5 120 7d67 7e33 +2b11 120 4bf6 4bf7 +122 121 4bf8 7e31 +121 21b3 7d66 7e31 +21b4 121 7d66 7e32 +2b10 121 4bf7 4bf8 +123 122 4bf9 7e30 +122 21b2 7d65 7e30 +21b3 122 7d65 7e31 +2b0f 122 4bf8 4bf9 +124 123 4bfa 7e2f +123 21b0 7d64 7e2f +21b2 123 7d64 7e30 +2b0e 123 4bf9 4bfa +125 124 4bfb 7e2e +124 21ae 7d62 7e2e +21b0 124 7d62 7e2f +2b0d 124 4bfa 4bfb +126 125 4bfc 7e2d +125 21ac 7d60 7e2d +21ae 125 7d60 7e2e +2b0c 125 4bfb 4bfc +127 126 4bfd 7e2c +126 21aa 7d5e 7e2c +21ac 126 7d5e 7e2d +2b0b 126 4bfc 4bfd +128 127 4bfe 7e2b +127 21a7 7d5c 7e2b +21aa 127 7d5c 7e2c +2b0a 127 4bfd 4bfe +129 128 4bff 7e2a +128 21a6 7d5a 7e2a +21a7 128 7d5a 7e2b +2b09 128 4bfe 4bff +12a 129 4c00 7e29 +129 21a5 7d59 7e29 +21a6 129 7d59 7e2a +2b08 129 4bff 4c00 +12b 12a 4c01 7e28 +12a 1f4e 7d58 7e28 +21a5 12a 7d58 7e29 +2b07 12a 4c00 4c01 +12c 12b 4c02 7e27 +12b 1f4d 7a03 7e27 +1f4e 12b 7a03 7e28 +2b06 12b 4c01 4c02 +12d 12c 4c03 7e26 +1f4d 12c 7e26 7e27 +2b05 12c 4c02 4c03 +12e 12d 4c04 7e25 +1f4d 12d 7d57 7e26 +12d 21a4 7d57 7e25 +2b04 12d 4c03 4c04 +12f 12e 4c05 7e24 +12e 21a1 7d55 7e24 +21a3 12e 7d55 7d56 +21a4 12e 7d56 7e25 +2b03 12e 4c04 4c05 +130 12f 4c06 7e23 +12f 219e 7d53 7e23 +21a1 12f 7d53 7e24 +2b02 12f 4c05 4c06 +131 130 4c07 7e22 +130 219d 7d51 7e22 +219e 130 7d51 7e23 +2b01 130 4c06 4c07 +132 131 4c08 7e20 +131 219b 7d50 7e20 +219d 131 7d50 7e22 +2b00 131 4c07 4c08 +133 132 4c09 7e1f +219b 132 7e1f 7e20 +2aff 132 4c08 4c09 +134 133 4c0a 7e1e +133 2199 7d4e 7e1e +219b 133 7d4e 7e1f +2afe 133 4c09 4c0a +135 134 4c0b 7e1d +134 2197 7d4c 7e1d +2199 134 7d4c 7e1e +2afd 134 4c0a 4c0b +136 135 4c0c 7e1c +135 2195 7d4a 7e1c +2197 135 7d4a 7e1d +2afc 135 4c0b 4c0c +137 136 4c0d 7e1b +136 2192 7d48 7e1b +2195 136 7d48 7e1c +2afb 136 4c0c 4c0d +138 137 4c0e 7e19 +137 2191 7d46 7e19 +2192 137 7d46 7e1b +2afa 137 4c0d 4c0e +139 138 4c0f 7e18 +138 218e 7d45 7e18 +2191 138 7d45 7e19 +2af9 138 4c0e 4c0f +13a 139 4c10 7e17 +139 218c 7d42 7e17 +218d 139 7d42 7d43 +218e 139 7d43 7e18 +2af8 139 4c0f 4c10 +13b 13a 4c11 7e16 +13a 218b 7d41 7e16 +218c 13a 7d41 7e17 +2af7 13a 4c10 4c11 +13c 13b 4c12 7e15 +13b 218a 7d40 7e15 +218b 13b 7d40 7e16 +2af6 13b 4c11 4c12 +13d 13c 4c13 7e14 +13c 1f76 7d3f 7e14 +218a 13c 7d3f 7e15 +2af5 13c 4c12 4c13 +13e 13d 4c14 7e13 +1f76 13d 7d3e 7e14 +13d 2187 7d3e 7e13 +2af4 13d 4c13 4c14 +13f 13e 4c15 7d3c +2187 13e 7d3c 7e13 +2af3 13e 4c14 4c15 +140 13f 4c16 7ea2 +1f52 13f 7ea2 7ea3 +13f 2187 7d3c 7e12 +13f 2189 7e12 7ea3 +2af2 13f 4c15 4c16 +141 140 4c17 7ea1 +1f52 140 7a05 7ea2 +140 1f53 7a05 7ea1 +2af1 140 4c16 4c17 +142 141 4c18 7ea0 +1f53 141 7e11 7ea1 +141 2265 7e11 7ea0 +2af0 141 4c17 4c18 +143 142 4c19 7e9f +142 2264 7e10 7e9f +2265 142 7e10 7ea0 +2aef 142 4c18 4c19 +144 143 4c1a 7e9e +143 2263 7e0f 7e9e +2264 143 7e0f 7e9f +2aee 143 4c19 4c1a +145 144 4c1b 7e9d +144 2261 7e0e 7e9d +2263 144 7e0e 7e9e +2aed 144 4c1a 4c1b +146 145 4c1c 7e9c +145 225f 7e0d 7e9c +2261 145 7e0d 7e9d +2aec 145 4c1b 4c1c +147 146 4c1d 7e9a +225f 146 7e9a 7e9c +2aeb 146 4c1c 4c1d +148 147 4c1e 7e99 +147 225d 7e0a 7e99 +225e 147 7e0a 7e0b +225f 147 7e0b 7e9a +2aea 147 4c1d 4c1e +149 148 4c1f 7e98 +148 225c 7e09 7e98 +225d 148 7e09 7e99 +2ae9 148 4c1e 4c1f +14a 149 4c20 7e08 +225c 149 7e08 7e98 +2ae8 149 4c1f 4c20 +14b 14a 4c21 8153 +14a 225c 7e08 8bc5 +2407 14a 8153 8c9f +14a 240a 8bc5 8c9f +2ae7 14a 4c20 4c21 +14c 14b 4c22 8c5b +225b 14b 8c5b 8d53 +14b 2407 8153 8d53 +2ae6 14b 4c21 4c22 +14d 14c 4c23 8d6c +14c 225a 7e06 8d6c +225b 14c 7e06 8c5b +2ae5 14c 4c22 4c23 +14e 14d 4c24 8e1b +14d 2259 7e05 8e1b +225a 14d 7e05 8d6c +2ae4 14d 4c23 4c24 +14f 14e 4c25 8d5e +14e 2257 7e04 8d5e +2259 14e 7e04 8e1b +2ae3 14e 4c24 4c25 +150 14f 4c26 7e00 +2254 14f 7e00 7e02 +2257 14f 7e02 8d5e +2ae2 14f 4c25 4c26 +151 150 4c27 8d42 +2253 150 8d42 8def +150 2254 7e00 8def +2ae1 150 4c26 4c27 +152 151 4c28 8c67 +151 2251 7dfe 8c67 +2253 151 7dfe 8d42 +2ae0 151 4c27 4c28 +153 152 4c29 8ef1 +2251 152 7dfc 8c67 +152 2252 7dfc 8ef1 +2adf 152 4c28 4c29 +154 153 4c2a 8df0 +2252 153 8df0 8ef1 +2ade 153 4c29 4c2a +155 154 4c2b 8cfd +224f 154 8cfd 8ef0 +154 2252 8df0 8ef0 +2add 154 4c2a 4c2b +224f 155 7dfb 8cfd +155 2250 7dfb 8b82 +2adc 155 4c2b 4c2c +156 31fe 3684 3685 +157 31fd 3685 3686 +158 31fc 3686 3687 +159 31fb 3687 3688 +15a 31fa 3688 3689 +15b 31f9 3689 368a +15c 31f8 368a 368b +15d 31f7 368b 368c +15e 31f6 368c 368d +15f 31f5 368d 368e +160 31f4 368e 368f +161 31f3 368f 3690 +162 31f2 3690 3691 +163 31f1 3691 3692 +164 31f0 3692 3693 +165 31ef 3693 3694 +166 31ee 3694 3695 +167 31ed 3695 3696 +168 31ec 3696 3697 +169 31eb 3697 3698 +16a 31ea 3698 3699 +16b 31e9 3699 369a +16c 31e8 369a 369b +16d 31e7 369b 369c +16e 31e6 369c 369d +16f 31e5 369d 369e +170 31e4 369e 369f +171 31e3 369f 36a0 +172 31e2 36a0 36a1 +173 31e1 36a1 36a2 +174 31e0 36a2 36a3 +175 31df 36a3 36a4 +176 31de 36a4 36a5 +177 31dd 36a5 36a6 +178 31dc 36a6 36a7 +179 31db 36a7 36a8 +17a 31da 36a8 36a9 +17b 31d9 36a9 36aa +17c 31d8 36aa 36ab +17d 31d7 36ab 36ac +17e 31d6 36ac 36ad +17f 31d5 36ad 36ae +180 31d4 36ae 36af +181 31d3 36af 36b0 +182 31d2 36b0 36b1 +183 31d1 36b1 36b2 +184 31d0 36b2 36b3 +185 31cf 36b3 36b4 +186 31ce 36b4 36b5 +187 31cd 36b5 36b6 +188 31cc 36b6 36b7 +189 31cb 36b7 36b8 +18a 31ca 36b8 36b9 +18b 31c9 36b9 36ba +18c 31c8 36ba 36bb +18d 31c7 36bb 36bc +18e 31c6 36bc 36bd +18f 31c5 36bd 36be +190 31c4 36be 36bf +191 31c3 36bf 36c0 +192 31c2 36c0 36c1 +193 31c1 36c1 36c2 +194 31c0 36c2 36c3 +195 196 3780 3781 +195 31c0 36c3 3780 +3c14 195 36c4 3781 +196 197 383d 383e +196 3181 3780 383d +3c15 196 3781 383e +197 198 38fa 38fb +197 3142 383d 38fa +3c16 197 383e 38fb +198 199 39b7 39b8 +198 3103 38fa 39b7 +3c17 198 38fb 39b8 +199 19a 3a74 3a75 +199 30c4 39b7 3a74 +3c18 199 39b8 3a75 +19a 19b 3b31 3b32 +19a 3085 3a74 3b31 +3c19 19a 3a75 3b32 +19b 19c 3bee 3bef +19b 3046 3b31 3bee +3c1a 19b 3b32 3bef +19c 19d 3cab 3cac +19c 3007 3bee 3cab +3c1b 19c 3bef 3cac +19d 19e 3d68 3d69 +19d 2fc8 3cab 3d68 +3c1c 19d 3cac 3d69 +19e 19f 3e25 3e26 +19e 2f89 3d68 3e25 +3c1d 19e 3d69 3e26 +19f 1a0 3ee2 3ee3 +19f 2f4a 3e25 3ee2 +3c1e 19f 3e26 3ee3 +1a0 1a1 3f9f 3fa0 +1a0 2f0b 3ee2 3f9f +3c1f 1a0 3ee3 3fa0 +1a1 1a2 405c 405d +1a1 2ecc 3f9f 405c +3c20 1a1 3fa0 405d +1a2 1a3 4119 411a +1a2 2e8d 405c 4119 +3c21 1a2 405d 411a +1a3 1a4 41d6 41d7 +1a3 2e4e 4119 41d6 +3c22 1a3 411a 41d7 +1a4 1a5 4293 4294 +1a4 2e0f 41d6 4293 +3c23 1a4 41d7 4294 +1a5 1a6 4350 4351 +1a5 2dd0 4293 4350 +3c24 1a5 4294 4351 +1a6 1a7 440d 440e +1a6 2d91 4350 440d +3c25 1a6 4351 440e +1a7 1a8 44ca 44cb +1a7 2d52 440d 44ca +3c26 1a7 440e 44cb +1a8 1a9 4587 4588 +1a8 2d13 44ca 4587 +3c27 1a8 44cb 4588 +1a9 1aa 4644 4645 +1a9 2cd4 4587 4644 +3c28 1a9 4588 4645 +1aa 1ab 4701 4702 +1aa 2c95 4644 4701 +3c29 1aa 4645 4702 +1ab 1ac 47be 47bf +1ab 2c56 4701 47be +3c2a 1ab 4702 47bf +1ac 1ad 487b 487c +1ac 2c17 47be 487b +3c2b 1ac 47bf 487c +1ad 1ae 4938 4939 +1ad 2bd8 487b 4938 +3c2c 1ad 487c 4939 +1ae 1af 49f5 49f6 +1ae 2b99 4938 49f5 +3c2d 1ae 4939 49f6 +1af 1b0 4ab2 4ab3 +1af 2b5a 49f5 4ab2 +3c2e 1af 49f6 4ab3 +1b0 1b1 4b6f 4b70 +1b0 2b1b 4ab2 4b6f +3c2f 1b0 4ab3 4b70 +1b1 2adc 4b6f 4c2c +3c30 1b1 4b70 4c2d +1b2 31ff 3659 365a +1b3 3200 365a 365b +1b4 3201 365b 365c +1b5 3202 365c 365d +1b6 3203 365d 365e +1b7 3204 365e 365f +1b8 3205 365f 3660 +1b9 3206 3660 3661 +1ba 3207 3661 3662 +1bb 3208 3662 3663 +1bd 1bc 4bc3 7e5e +1bc 21e0 7d97 7e5e +21e1 1bc 7d97 7e5f +3317 1bc 4bc2 4bc3 +1be 1bd 4bc4 7e5d +1bd 21de 7d95 7e5d +21df 1bd 7d95 7d96 +21e0 1bd 7d96 7e5e +3318 1bd 4bc3 4bc4 +1bf 1be 4bc5 7e5c +21de 1be 7e5c 7e5d +3319 1be 4bc4 4bc5 +1c0 1bf 4bc6 7e5b +1bf 21dc 7d94 7e5b +21de 1bf 7d94 7e5c +331a 1bf 4bc5 4bc6 +1c1 1c0 4bc7 7e5a +1c0 21db 7d92 7e5a +21dc 1c0 7d92 7e5b +331b 1c0 4bc6 4bc7 +1c2 1c1 4bc8 7e59 +1c1 1f5f 7d91 7e59 +21db 1c1 7d91 7e5a +331c 1c1 4bc7 4bc8 +1c3 1c2 4bc9 7e57 +1f5f 1c2 7d8f 7e59 +1c2 21d9 7d8f 7e57 +331d 1c2 4bc8 4bc9 +1c4 1c3 4bca 7e56 +1c3 21d8 7d8e 7e56 +21d9 1c3 7d8e 7e57 +331e 1c3 4bc9 4bca +1c5 1c4 4bcb 7e55 +1f7b 1c4 7d8c 7d8d +1c4 21d7 7d8c 7e55 +21d8 1c4 7d8d 7e56 +331f 1c4 4bca 4bcb +21d5 1c5 7e52 7e54 +21d7 1c5 7e54 7e55 +3320 1c5 4bcb 4bcc +1c6 1c7 3715 3716 +31ff 1c6 3659 3716 +1c6 3367 3658 3715 +1c7 1c8 37d2 37d3 +3209 1c7 3716 37d3 +1c7 33ae 3715 37d2 +1c8 1c9 388f 3890 +3213 1c8 37d3 3890 +1c8 33f5 37d2 388f +1c9 1ca 394c 394d +321d 1c9 3890 394d +1c9 343c 388f 394c +1ca 1cb 3a09 3a0a +3227 1ca 394d 3a0a +1ca 3483 394c 3a09 +1cb 1cc 3ac6 3ac7 +3231 1cb 3a0a 3ac7 +1cb 34ca 3a09 3ac6 +1cc 1cd 3b83 3b84 +323b 1cc 3ac7 3b84 +1cc 3511 3ac6 3b83 +1cd 1ce 3c40 3c41 +3245 1cd 3b84 3c41 +1cd 3558 3b83 3c40 +1ce 1cf 3cfd 3cfe +324f 1ce 3c41 3cfe +1ce 359f 3c40 3cfd +1cf 1d0 3dba 3dbb +3259 1cf 3cfe 3dbb +1cf 35e6 3cfd 3dba +1d0 1d1 3e77 3e78 +3263 1d0 3dbb 3e78 +1d0 362d 3dba 3e77 +1d1 1d2 3f34 3f35 +326d 1d1 3e78 3f35 +1d1 3674 3e77 3f34 +1d2 1d3 3ff1 3ff2 +3277 1d2 3f35 3ff2 +1d2 36bb 3f34 3ff1 +1d3 1d4 40ae 40af +3281 1d3 3ff2 40af +1d3 3702 3ff1 40ae +1d4 1d5 416b 416c +328b 1d4 40af 416c +1d4 3749 40ae 416b +1d5 1d6 4228 4229 +3295 1d5 416c 4229 +1d5 3790 416b 4228 +1d6 1d7 42e5 42e6 +329f 1d6 4229 42e6 +1d6 37d7 4228 42e5 +1d7 1d8 43a2 43a3 +32a9 1d7 42e6 43a3 +1d7 381e 42e5 43a2 +1d8 1d9 445f 4460 +32b3 1d8 43a3 4460 +1d8 3865 43a2 445f +1d9 1da 451c 451d +32bd 1d9 4460 451d +1d9 38ac 445f 451c +1da 1db 45d9 45da +32c7 1da 451d 45da +1da 38f3 451c 45d9 +1db 1dc 4696 4697 +32d1 1db 45da 4697 +1db 393a 45d9 4696 +1dc 1dd 4753 4754 +32db 1dc 4697 4754 +1dc 3981 4696 4753 +1dd 1de 4810 4811 +32e5 1dd 4754 4811 +1dd 39c8 4753 4810 +1de 1df 48cd 48ce +32ef 1de 4811 48ce +1de 3a0f 4810 48cd +1df 1e0 498a 498b +32f9 1df 48ce 498b +1df 3a56 48cd 498a +1e0 1e1 4a47 4a48 +3303 1e0 498b 4a48 +1e0 3a9d 498a 4a47 +1e1 1e2 4b04 4b05 +330d 1e1 4a48 4b05 +1e1 3ae4 4a47 4b04 +3317 1e2 4b05 4bc2 +1e2 3b2b 4b04 4bc1 +1e3 3321 3611 3612 +1e4 3322 3612 3613 +1e5 3323 3613 3614 +1e6 3324 3614 3615 +1e7 3325 3615 3616 +1e8 3326 3616 3617 +1e9 3327 3617 3618 +1ea 3328 3618 3619 +1eb 3329 3619 361a +1ec 332a 361a 361b +1ed 332b 361b 361c +1ee 332c 361c 361d +1ef 332d 361d 361e +1f0 332e 361e 361f +1f1 332f 361f 3620 +1f2 3330 3620 3621 +1f3 3331 3621 3622 +1f4 3332 3622 3623 +1f5 3333 3623 3624 +1f6 3334 3624 3625 +1f7 3335 3625 3626 +1f8 3336 3626 3627 +1f9 3337 3627 3628 +1fa 3338 3628 3629 +1fb 3339 3629 362a +1fc 333a 362a 362b +1fd 333b 362b 362c +1fe 333c 362c 362d +1ff 333d 362d 362e +200 333e 362e 362f +201 333f 362f 3630 +202 3340 3630 3631 +203 3341 3631 3632 +204 3342 3632 3633 +205 3343 3633 3634 +206 3344 3634 3635 +207 3345 3635 3636 +208 3346 3636 3637 +209 3347 3637 3638 +20a 3348 3638 3639 +20b 3349 3639 363a +20c 334a 363a 363b +20d 334b 363b 363c +20e 334c 363c 363d +20f 334d 363d 363e +210 334e 363e 363f +211 334f 363f 3640 +212 3350 3640 3641 +213 3351 3641 3642 +214 3352 3642 3643 +215 3353 3643 3644 +216 3354 3644 3645 +217 3355 3645 3646 +218 3356 3646 3647 +219 3357 3647 3648 +21a 3358 3648 3649 +21b 3359 3649 364a +21c 335a 364a 364b +21d 335b 364b 364c +21e 335c 364c 364d +21f 335d 364d 364e +220 335e 364e 364f +221 335f 364f 3650 +222 3360 3650 3651 +223 3361 3651 3652 +224 3362 3652 3653 +225 3363 3653 3654 +226 3364 3654 3655 +227 3365 3655 3656 +228 3366 3656 3657 +229 3367 3657 3658 +22b 22a 4b7b 7ded +1f62 22a 7e90 7e91 +223f 22a 7ded 7e90 +3ae5 22a 4b7a 4b7b +22c 22b 4b7c 7dec +223f 22b 7dec 7ded +3ae6 22b 4b7b 4b7c +22d 22c 4b7d 8c4f +223c 22c 8c4f 8d08 +22c 223f 7dec 8d08 +3ae7 22c 4b7c 4b7d +22e 22d 4b7e 8e13 +223c 22d 7dea 8c4f +22d 223d 7dea 8e13 +3ae8 22d 4b7d 4b7e +22f 22e 4b7f 8ccd +2239 22e 8ccd 8cf7 +223d 22e 8cf7 8e13 +3ae9 22e 4b7e 4b7f +230 22f 4b80 8e15 +22f 2238 7de7 8e15 +2239 22f 7de7 8ccd +3aea 22f 4b7f 4b80 +231 230 4b81 8e79 +230 2236 8d24 8e79 +230 2237 7de6 8d24 +2238 230 7de6 8e15 +3aeb 230 4b80 4b81 +232 231 4b82 8df6 +2236 231 8df6 8e79 +3aec 231 4b81 4b82 +233 232 4b83 8cda +2230 232 8cda 8e78 +232 2236 8df6 8e78 +3aed 232 4b82 4b83 +234 233 4b84 8d4b +2230 233 7de0 8cda +233 2231 7de0 8d4b +3aee 233 4b83 4b84 +235 234 4b85 8e98 +2228 234 7ddd 8e23 +234 2229 7ddd 8e98 +234 2231 8d4b 8e23 +3aef 234 4b84 4b85 +236 235 4b86 8dfb +2229 235 8dfb 8e98 +3af0 235 4b85 4b86 +237 236 4b87 7dda +2224 236 7dda 8ea0 +236 2225 8cc2 8ea0 +2229 236 8cc2 8dfb +3af1 236 4b86 4b87 +238 237 4b88 8cb4 +237 2224 7dda 8cb4 +3af2 237 4b87 4b88 +239 238 4b89 8e5d +1f39 238 79fb 8e19 +238 1f3a 79fb 8e5d +238 2224 8cb4 8e19 +3af3 238 4b88 4b89 +23a 239 4b8a 8d4c +1f3a 239 8d4c 8e5d +3af4 239 4b89 4b8a +23b 23a 4b8b 8dea +23a 1f3a 8d4c 8e5c +23a 221c 8cb2 8dea +2220 23a 8cb2 8e5c +3af5 23a 4b8a 4b8b +23c 23b 4b8c 8d06 +221c 23b 8d06 8dea +3af6 23b 4b8b 4b8c +23d 23c 4b8d 8ddd +23c 2219 8cc8 8ddd +23c 221b 7dd4 8cc8 +221c 23c 7dd4 8d06 +3af7 23c 4b8c 4b8d +23e 23d 4b8e 8d37 +23d 2217 7dd1 8d37 +2219 23d 7dd1 8ddd +3af8 23d 4b8d 4b8e +23f 23e 4b8f 8cc6 +2217 23e 8cc6 8d37 +3af9 23e 4b8e 4b8f +240 23f 4b90 7dcb +2213 23f 7dcb 8dac +23f 2217 8cc6 8dac +3afa 23f 4b8f 4b90 +241 240 4b91 8c9b +240 2213 7dcb 7dcd +240 2214 7dcd 8c9b +3afb 240 4b90 4b91 +242 241 4b92 7dc9 +2212 241 7dc9 8ccb +241 2214 8c9b 8ccb +3afc 241 4b91 4b92 +243 242 4b93 7dc7 +2210 242 7dc7 8cc1 +242 2212 7dc9 8cc1 +3afd 242 4b92 4b93 +244 243 4b94 7e8f +220f 243 7e8f 8c74 +243 2210 7dc7 8c74 +3afe 243 4b93 4b94 +245 244 4b95 7e8e +244 220e 7dc5 7e8e +220f 244 7dc5 7e8f +3aff 244 4b94 4b95 +246 245 4b96 7e8d +245 220d 7dc6 7e8d +220e 245 7dc6 7e8e +3b00 245 4b95 4b96 +247 246 4b97 7e8c +246 220c 7dc4 7e8c +220d 246 7dc4 7e8d +3b01 246 4b96 4b97 +248 247 4b98 7e8b +247 220b 7dc3 7e8b +220c 247 7dc3 7e8c +3b02 247 4b97 4b98 +249 248 4b99 7dc1 +220a 248 7dc1 7dc2 +220b 248 7dc2 7e8b +3b03 248 4b98 4b99 +24a 249 4b9a 7e89 +2208 249 7e89 7e8a +249 220a 7dc1 7e8a +3b04 249 4b99 4b9a +24b 24a 4b9b 7e88 +24a 2206 7dbf 7e88 +2208 24a 7dbf 7e89 +3b05 24a 4b9a 4b9b +24c 24b 4b9c 7e87 +24b 1f50 7dbd 7e87 +2206 24b 7dbd 7e88 +3b06 24b 4b9b 4b9c +24d 24c 4b9d 7e86 +1f50 24c 7dbc 7e87 +24c 2205 7dbc 7e86 +3b07 24c 4b9c 4b9d +24e 24d 4b9e 7e85 +24d 2204 7dbb 7e85 +2205 24d 7dbb 7e86 +3b08 24d 4b9d 4b9e +24f 24e 4b9f 7e84 +24e 2203 7dba 7e84 +2204 24e 7dba 7e85 +3b09 24e 4b9e 4b9f +250 24f 4ba0 7e82 +24f 2202 7db9 7e82 +2203 24f 7db9 7e84 +3b0a 24f 4b9f 4ba0 +251 250 4ba1 7e80 +250 2201 7db8 7e80 +2202 250 7db8 7e82 +3b0b 250 4ba0 4ba1 +252 251 4ba2 7e7f +251 2200 7db7 7e7f +2201 251 7db7 7e80 +3b0c 251 4ba1 4ba2 +253 252 4ba3 7e7e +252 21ff 7db6 7e7e +2200 252 7db6 7e7f +3b0d 252 4ba2 4ba3 +254 253 4ba4 7e7d +253 21fe 7db5 7e7d +21ff 253 7db5 7e7e +3b0e 253 4ba3 4ba4 +255 254 4ba5 7e7c +254 21fd 7db4 7e7c +21fe 254 7db4 7e7d +3b0f 254 4ba4 4ba5 +256 255 4ba6 7e7b +255 21fc 7db3 7e7b +21fd 255 7db3 7e7c +3b10 255 4ba5 4ba6 +257 256 4ba7 7e7a +256 21fb 7db2 7e7a +21fc 256 7db2 7e7b +3b11 256 4ba6 4ba7 +258 257 4ba8 7e79 +257 21fa 7db1 7e79 +21fb 257 7db1 7e7a +3b12 257 4ba7 4ba8 +259 258 4ba9 7e78 +258 21f9 7db0 7e78 +21fa 258 7db0 7e79 +3b13 258 4ba8 4ba9 +25a 259 4baa 7e77 +259 21f8 7daf 7e77 +21f9 259 7daf 7e78 +3b14 259 4ba9 4baa +25b 25a 4bab 7e76 +25a 21f7 7dae 7e76 +21f8 25a 7dae 7e77 +3b15 25a 4baa 4bab +25c 25b 4bac 7e75 +25b 21f6 7dad 7e75 +21f7 25b 7dad 7e76 +3b16 25b 4bab 4bac +25d 25c 4bad 7e74 +25c 21f5 7dac 7e74 +21f6 25c 7dac 7e75 +3b17 25c 4bac 4bad +25e 25d 4bae 7e73 +25d 21f4 7dab 7e73 +21f5 25d 7dab 7e74 +3b18 25d 4bad 4bae +25f 25e 4baf 7e72 +25e 21f3 7daa 7e72 +21f4 25e 7daa 7e73 +3b19 25e 4bae 4baf +260 25f 4bb0 7e71 +25f 21f2 7da9 7e71 +21f3 25f 7da9 7e72 +3b1a 25f 4baf 4bb0 +261 260 4bb1 7e70 +260 21f1 7da8 7e70 +21f2 260 7da8 7e71 +3b1b 260 4bb0 4bb1 +262 261 4bb2 7e6f +261 21f0 7da7 7e6f +21f1 261 7da7 7e70 +3b1c 261 4bb1 4bb2 +263 262 4bb3 7e6e +262 21ef 7da6 7e6e +21f0 262 7da6 7e6f +3b1d 262 4bb2 4bb3 +264 263 4bb4 7e6d +263 21ee 7da5 7e6d +21ef 263 7da5 7e6e +3b1e 263 4bb3 4bb4 +265 264 4bb5 7e6c +264 21ed 7da4 7e6c +21ee 264 7da4 7e6d +3b1f 264 4bb4 4bb5 +266 265 4bb6 7e6b +265 21ec 7da3 7e6b +21ed 265 7da3 7e6c +3b20 265 4bb5 4bb6 +267 266 4bb7 7e6a +266 21eb 7da2 7e6a +21ec 266 7da2 7e6b +3b21 266 4bb6 4bb7 +268 267 4bb8 7e69 +267 21ea 7da1 7e69 +21eb 267 7da1 7e6a +3b22 267 4bb7 4bb8 +269 268 4bb9 7e68 +268 21e9 7da0 7e68 +21ea 268 7da0 7e69 +3b23 268 4bb8 4bb9 +26a 269 4bba 7e67 +269 21e8 7d9f 7e67 +21e9 269 7d9f 7e68 +3b24 269 4bb9 4bba +26b 26a 4bbb 7e66 +26a 21e7 7d9e 7e66 +21e8 26a 7d9e 7e67 +3b25 26a 4bba 4bbb +26c 26b 4bbc 7e65 +26b 21e6 7d9d 7e65 +21e7 26b 7d9d 7e66 +3b26 26b 4bbb 4bbc +26d 26c 4bbd 7e64 +26c 21e5 7d9c 7e64 +21e6 26c 7d9c 7e65 +3b27 26c 4bbc 4bbd +26e 26d 4bbe 7e63 +26d 21e4 7d9b 7e63 +21e5 26d 7d9b 7e64 +3b28 26d 4bbd 4bbe +26f 26e 4bbf 7e62 +21e4 26e 7e62 7e63 +3b29 26e 4bbe 4bbf +270 26f 4bc0 7e61 +26f 21e3 7d9a 7e61 +21e4 26f 7d9a 7e62 +3b2a 26f 4bbf 4bc0 +270 21e2 7d99 7e60 +21e3 270 7d99 7e61 +3b2b 270 4bc0 4bc1 +272 271 36ce 378a +3321 271 3611 36ce +271 3b2c 36cd 378a +273 272 378b 3847 +3368 272 36ce 378b +272 3b2d 378a 3847 +274 273 3848 3904 +33af 273 378b 3848 +273 3b2e 3847 3904 +275 274 3905 39c1 +33f6 274 3848 3905 +274 3b2f 3904 39c1 +276 275 39c2 3a7e +343d 275 3905 39c2 +275 3b30 39c1 3a7e +277 276 3a7f 3b3b +3484 276 39c2 3a7f +276 3b31 3a7e 3b3b +278 277 3b3c 3bf8 +34cb 277 3a7f 3b3c +277 3b32 3b3b 3bf8 +279 278 3bf9 3cb5 +3512 278 3b3c 3bf9 +278 3b33 3bf8 3cb5 +27a 279 3cb6 3d72 +3559 279 3bf9 3cb6 +279 3b34 3cb5 3d72 +27b 27a 3d73 3e2f +35a0 27a 3cb6 3d73 +27a 3b35 3d72 3e2f +27c 27b 3e30 3eec +35e7 27b 3d73 3e30 +27b 3b36 3e2f 3eec +27d 27c 3eed 3fa9 +362e 27c 3e30 3eed +27c 3b37 3eec 3fa9 +27e 27d 3faa 4066 +3675 27d 3eed 3faa +27d 3b38 3fa9 4066 +27f 27e 4067 4123 +36bc 27e 3faa 4067 +27e 3b39 4066 4123 +280 27f 4124 41e0 +3703 27f 4067 4124 +27f 3b3a 4123 41e0 +281 280 41e1 429d +374a 280 4124 41e1 +280 3b3b 41e0 429d +282 281 429e 435a +3791 281 41e1 429e +281 3b3c 429d 435a +283 282 435b 4417 +37d8 282 429e 435b +282 3b3d 435a 4417 +284 283 4418 44d4 +381f 283 435b 4418 +283 3b3e 4417 44d4 +285 284 44d5 4591 +3866 284 4418 44d5 +284 3b3f 44d4 4591 +286 285 4592 464e +38ad 285 44d5 4592 +285 3b40 4591 464e +287 286 464f 470b +38f4 286 4592 464f +286 3b41 464e 470b +288 287 470c 47c8 +393b 287 464f 470c +287 3b42 470b 47c8 +289 288 47c9 4885 +3982 288 470c 47c9 +288 3b43 47c8 4885 +28a 289 4886 4942 +39c9 289 47c9 4886 +289 3b44 4885 4942 +28b 28a 4943 49ff +3a10 28a 4886 4943 +28a 3b45 4942 49ff +28c 28b 4a00 4abc +3a57 28b 4943 4a00 +28b 3b46 49ff 4abc +28d 28c 4abd 4b79 +3a9e 28c 4a00 4abd +28c 3b47 4abc 4b79 +3ae5 28d 4abd 4b7a +28d 3b48 4b79 4c36 +28f 28e 4c2e 7e96 +28e 2246 7df8 7e96 +2249 28e 7df8 7e97 +3c30 28e 4c2d 4c2e +290 28f 4c2f 7df7 +2246 28f 7df7 7e96 +3c13 28f 4c2e 4c2f +291 290 4c30 8c8b +2246 290 7df5 7df7 +290 2247 7df5 8c8b +3bf6 290 4c2f 4c30 +292 291 4c31 8cb1 +291 2247 8c8b 8d78 +2404 291 8cb1 8d78 +3bd9 291 4c30 4c31 +293 292 4c32 814d +2404 292 814b 8cb1 +292 2405 814b 814d +3bbc 292 4c31 4c32 +294 293 4c33 7e95 +2244 293 7e95 8c19 +293 2405 814d 8c19 +3b9f 293 4c32 4c33 +295 294 4c34 7e94 +2244 294 7e94 7e95 +3b82 294 4c33 4c34 +296 295 4c35 7e93 +295 2243 7df3 7e93 +2244 295 7df3 7e94 +3b65 295 4c34 4c35 +296 2240 7df2 7e92 +2243 296 7df2 7e93 +3b48 296 4c35 4c36 +297 3c14 36c4 36c5 +298 3bf7 36c5 36c6 +299 3bda 36c6 36c7 +29a 3bbd 36c7 36c8 +29b 3ba0 36c8 36c9 +29c 3b83 36c9 36ca +29d 3b66 36ca 36cb +29e 3b49 36cb 36cc +29f 3b2c 36cc 36cd +2a1 2a0 34a4 34a5 +3c52 2a0 34a5 35b5 +2a0 4d96 34a4 35b4 +2a2 2a1 3394 3395 +3c51 2a1 3395 34a5 +2a1 4d6b 3394 34a4 +2a3 2a2 3284 3285 +3c50 2a2 3285 3395 +2a2 4d40 3284 3394 +2a4 2a3 3174 3175 +3c4f 2a3 3175 3285 +2a3 4d15 3174 3284 +2a5 2a4 3064 3065 +3c4e 2a4 3065 3175 +2a4 4cea 3064 3174 +2a6 2a5 2f54 2f55 +3c4d 2a5 2f55 3065 +2a5 4cbf 2f54 3064 +2a7 2a6 2e44 2e45 +3c4c 2a6 2e45 2f55 +2a6 4c94 2e44 2f54 +2a8 2a7 2d34 2d35 +3c4b 2a7 2d35 2e45 +2a7 4c69 2d34 2e44 +2a9 2a8 2c24 2c25 +3c4a 2a8 2c25 2d35 +2a8 4c3e 2c24 2d34 +2aa 2a9 2b14 2b15 +3c49 2a9 2b15 2c25 +2a9 4c13 2b14 2c24 +2ab 2aa 2a04 2a05 +3c48 2aa 2a05 2b15 +2aa 4be8 2a04 2b14 +2ac 2ab 28f4 28f5 +3c47 2ab 28f5 2a05 +2ab 4bbd 28f4 2a04 +2ad 2ac 27e4 27e5 +3c46 2ac 27e5 28f5 +2ac 4b92 27e4 28f4 +2ae 2ad 26d4 26d5 +3c45 2ad 26d5 27e5 +2ad 4b67 26d4 27e4 +2af 2ae 25c4 25c5 +3c44 2ae 25c5 26d5 +2ae 4b3c 25c4 26d4 +2b0 2af 24b4 24b5 +3c43 2af 24b5 25c5 +2af 4b11 24b4 25c4 +2b1 2b0 23a4 23a5 +3c42 2b0 23a5 24b5 +2b0 4ae6 23a4 24b4 +2b2 2b1 2294 2295 +3c41 2b1 2295 23a5 +2b1 4abb 2294 23a4 +2b3 2b2 2184 2185 +3c40 2b2 2185 2295 +2b2 4a90 2184 2294 +2b4 2b3 2074 2075 +3c3f 2b3 2075 2185 +2b3 4a65 2074 2184 +2b5 2b4 1f64 1f65 +3c3e 2b4 1f65 2075 +2b4 4a3a 1f64 2074 +2b6 2b5 1e54 1e55 +3c3d 2b5 1e55 1f65 +2b5 4a0f 1e54 1f64 +2b7 2b6 1d44 1d45 +3c3c 2b6 1d45 1e55 +2b6 49e4 1d44 1e54 +2b8 2b7 1c34 1c35 +3c3b 2b7 1c35 1d45 +2b7 49b9 1c34 1d44 +2b9 2b8 1b24 1b25 +3c3a 2b8 1b25 1c35 +2b8 498e 1b24 1c34 +2ba 2b9 1a14 1a15 +3c39 2b9 1a15 1b25 +2b9 4963 1a14 1b24 +2bb 2ba 1904 1905 +3c38 2ba 1905 1a15 +2ba 4938 1904 1a14 +2bc 2bb 17f4 17f5 +3c37 2bb 17f5 1905 +2bb 490d 17f4 1904 +2bd 2bc 16e4 16e5 +3c36 2bc 16e5 17f5 +2bc 48e2 16e4 17f4 +2be 2bd 15d4 15d5 +3c35 2bd 15d5 16e5 +2bd 48b7 15d4 16e4 +2bf 2be 14c4 14c5 +3c34 2be 14c5 15d5 +2be 488c 14c4 15d4 +2c0 2bf 13b4 13b5 +3c33 2bf 13b5 14c5 +2bf 4861 13b4 14c4 +2c1 2c0 12a4 12a5 +3c32 2c0 12a5 13b5 +2c0 4836 12a4 13b4 +3c31 2c1 1195 12a5 +2c1 480b 1194 12a4 +3e2e 2c2 35c3 35c4 +3e0c 2c3 35c2 35c3 +3dea 2c4 35c1 35c2 +3dc8 2c5 35c0 35c1 +3da6 2c6 35bf 35c0 +3d84 2c7 35be 35bf +3d62 2c8 35bd 35be +3d40 2c9 35bc 35bd +3d1e 2ca 35bb 35bc +3cfc 2cb 35ba 35bb +3cda 2cc 35b9 35ba +3cb8 2cd 35b8 35b9 +3c96 2ce 35b7 35b8 +3c74 2cf 35b6 35b7 +3c52 2d0 35b5 35b6 +2d2 2d1 34b4 34b5 +2d1 3e2e 34b4 35c4 +3e50 2d1 34b5 35c5 +2d3 2d2 33a4 33a5 +2d2 3e2d 33a4 34b4 +3e4f 2d2 33a5 34b5 +2d4 2d3 3294 3295 +2d3 3e2c 3294 33a4 +3e4e 2d3 3295 33a5 +2d5 2d4 3184 3185 +2d4 3e2b 3184 3294 +3e4d 2d4 3185 3295 +2d6 2d5 3074 3075 +2d5 3e2a 3074 3184 +3e4c 2d5 3075 3185 +2d7 2d6 2f64 2f65 +2d6 3e29 2f64 3074 +3e4b 2d6 2f65 3075 +2d8 2d7 2e54 2e55 +2d7 3e28 2e54 2f64 +3e4a 2d7 2e55 2f65 +2d9 2d8 2d44 2d45 +2d8 3e27 2d44 2e54 +3e49 2d8 2d45 2e55 +2da 2d9 2c34 2c35 +2d9 3e26 2c34 2d44 +3e48 2d9 2c35 2d45 +2db 2da 2b24 2b25 +2da 3e25 2b24 2c34 +3e47 2da 2b25 2c35 +2dc 2db 2a14 2a15 +2db 3e24 2a14 2b24 +3e46 2db 2a15 2b25 +2dd 2dc 2904 2905 +2dc 3e23 2904 2a14 +3e45 2dc 2905 2a15 +2de 2dd 27f4 27f5 +2dd 3e22 27f4 2904 +3e44 2dd 27f5 2905 +2df 2de 26e4 26e5 +2de 3e21 26e4 27f4 +3e43 2de 26e5 27f5 +2e0 2df 25d4 25d5 +2df 3e20 25d4 26e4 +3e42 2df 25d5 26e5 +2e1 2e0 24c4 24c5 +2e0 3e1f 24c4 25d4 +3e41 2e0 24c5 25d5 +2e2 2e1 23b4 23b5 +2e1 3e1e 23b4 24c4 +3e40 2e1 23b5 24c5 +2e3 2e2 22a4 22a5 +2e2 3e1d 22a4 23b4 +3e3f 2e2 22a5 23b5 +2e4 2e3 2194 2195 +2e3 3e1c 2194 22a4 +3e3e 2e3 2195 22a5 +2e5 2e4 2084 2085 +2e4 3e1b 2084 2194 +3e3d 2e4 2085 2195 +2e6 2e5 1f74 1f75 +2e5 3e1a 1f74 2084 +3e3c 2e5 1f75 2085 +2e7 2e6 1e64 1e65 +2e6 3e19 1e64 1f74 +3e3b 2e6 1e65 1f75 +2e8 2e7 1d54 1d55 +2e7 3e18 1d54 1e64 +3e3a 2e7 1d55 1e65 +2e9 2e8 1c44 1c45 +2e8 3e17 1c44 1d54 +3e39 2e8 1c45 1d55 +2ea 2e9 1b34 1b35 +2e9 3e16 1b34 1c44 +3e38 2e9 1b35 1c45 +2eb 2ea 1a24 1a25 +2ea 3e15 1a24 1b34 +3e37 2ea 1a25 1b35 +2ec 2eb 1914 1915 +2eb 3e14 1914 1a24 +3e36 2eb 1915 1a25 +2ed 2ec 1804 1805 +2ec 3e13 1804 1914 +3e35 2ec 1805 1915 +2ee 2ed 16f4 16f5 +2ed 3e12 16f4 1804 +3e34 2ed 16f5 1805 +2ef 2ee 15e4 15e5 +2ee 3e11 15e4 16f4 +3e33 2ee 15e5 16f5 +2f0 2ef 14d4 14d5 +2ef 3e10 14d4 15e4 +3e32 2ef 14d5 15e5 +2f1 2f0 13c4 13c5 +2f0 3e0f 13c4 14d4 +3e31 2f0 13c5 14d5 +2f2 2f1 12b4 12b5 +2f1 3e0e 12b4 13c4 +3e30 2f1 12b5 13c5 +2f2 3e0d 11a4 12b4 +3e2f 2f2 11a5 12b5 +2f4 2f3 11a3 7ead +2f3 7f2 7a1f 7ead +2f3 3e0d 11a3 11a4 +2f5 2f4 11a2 8ce3 +2f4 7f2 7ead 8dcb +1f88 2f4 8be6 8dcb +2f4 2702 8be6 8ce3 +2f4 3deb 11a2 11a3 +2f6 2f5 11a1 8849 +2702 2f5 8849 8ce3 +2f5 3dc9 11a1 11a2 +2f7 2f6 11a0 8ac6 +2271 2f6 8ac6 8c3d +2f6 2702 8849 8c3d +2f6 3da7 11a0 11a1 +2f8 2f7 119f 7eb1 +2270 2f7 7eb1 8c3c +2f7 2271 8ac6 8c3c +2f7 3d85 119f 11a0 +2f9 2f8 119e 7b4e +1f87 2f8 7b4e 89b8 +2270 2f8 7eaa 7eb1 +2f8 2274 7eaa 89b8 +2f8 3d63 119e 119f +2fa 2f9 119d 7b4d +2f9 1f86 7a1b 7b4d +1f87 2f9 7a1b 7b4e +2f9 3d41 119d 119e +2fb 2fa 119c 7b4c +1f86 2fa 7b4c 7b4d +2fa 3d1f 119c 119d +2fc 2fb 119b 7b4b +2fb 1f84 7a19 7b4b +1f85 2fb 7a19 7a1a +1f86 2fb 7a1a 7b4c +2fb 3cfd 119b 119c +2fd 2fc 119a 7b4a +2fc 1f83 7a17 7b4a +1f84 2fc 7a17 7b4b +2fc 3cdb 119a 119b +2fe 2fd 1199 7a18 +1f83 2fd 7a18 7b4a +2fd 3cb9 1199 119a +2ff 2fe 1198 8c8c +1f81 2fe 7a16 8b19 +2fe 1f82 7a16 7ea7 +2fe 1f83 7a18 8b19 +2fe 226c 7ea7 8c8c +2fe 3c97 1198 1199 +300 2ff 1197 8d2f +2ff 20d1 7ea5 8d2f +226c 2ff 7ea5 8c8c +2ff 3c75 1197 1198 +301 300 1196 8de8 +300 20d0 7b48 8de8 +20d1 300 7b48 8d2f +300 3c53 1196 1197 +20d0 301 8cc4 8de8 +301 3c31 1195 1196 +402c 302 35d3 35d4 +400a 303 35d2 35d3 +3fe8 304 35d1 35d2 +3fc6 305 35d0 35d1 +3fa4 306 35cf 35d0 +3f82 307 35ce 35cf +3f60 308 35cd 35ce +3f3e 309 35cc 35cd +3f1c 30a 35cb 35cc +3efa 30b 35ca 35cb +3ed8 30c 35c9 35ca +3eb6 30d 35c8 35c9 +3e94 30e 35c7 35c8 +3e72 30f 35c6 35c7 +3e50 310 35c5 35c6 +312 311 34c4 34c5 +311 402c 34c4 35d4 +404e 311 34c5 35d5 +313 312 33b4 33b5 +312 402b 33b4 34c4 +404d 312 33b5 34c5 +314 313 32a4 32a5 +313 402a 32a4 33b4 +404c 313 32a5 33b5 +315 314 3194 3195 +314 4029 3194 32a4 +404b 314 3195 32a5 +316 315 3084 3085 +315 4028 3084 3194 +404a 315 3085 3195 +317 316 2f74 2f75 +316 4027 2f74 3084 +4049 316 2f75 3085 +318 317 2e64 2e65 +317 4026 2e64 2f74 +4048 317 2e65 2f75 +319 318 2d54 2d55 +318 4025 2d54 2e64 +4047 318 2d55 2e65 +31a 319 2c44 2c45 +319 4024 2c44 2d54 +4046 319 2c45 2d55 +31b 31a 2b34 2b35 +31a 4023 2b34 2c44 +4045 31a 2b35 2c45 +31c 31b 2a24 2a25 +31b 4022 2a24 2b34 +4044 31b 2a25 2b35 +31d 31c 2914 2915 +31c 4021 2914 2a24 +4043 31c 2915 2a25 +31e 31d 2804 2805 +31d 4020 2804 2914 +4042 31d 2805 2915 +31f 31e 26f4 26f5 +31e 401f 26f4 2804 +4041 31e 26f5 2805 +320 31f 25e4 25e5 +31f 401e 25e4 26f4 +4040 31f 25e5 26f5 +321 320 24d4 24d5 +320 401d 24d4 25e4 +403f 320 24d5 25e5 +322 321 23c4 23c5 +321 401c 23c4 24d4 +403e 321 23c5 24d5 +323 322 22b4 22b5 +322 401b 22b4 23c4 +403d 322 22b5 23c5 +324 323 21a4 21a5 +323 401a 21a4 22b4 +403c 323 21a5 22b5 +325 324 2094 2095 +324 4019 2094 21a4 +403b 324 2095 21a5 +326 325 1f84 1f85 +325 4018 1f84 2094 +403a 325 1f85 2095 +327 326 1e74 1e75 +326 4017 1e74 1f84 +4039 326 1e75 1f85 +328 327 1d64 1d65 +327 4016 1d64 1e74 +4038 327 1d65 1e75 +329 328 1c54 1c55 +328 4015 1c54 1d64 +4037 328 1c55 1d65 +32a 329 1b44 1b45 +329 4014 1b44 1c54 +4036 329 1b45 1c55 +32b 32a 1a34 1a35 +32a 4013 1a34 1b44 +4035 32a 1a35 1b45 +32c 32b 1924 1925 +32b 4012 1924 1a34 +4034 32b 1925 1a35 +32d 32c 1814 1815 +32c 4011 1814 1924 +4033 32c 1815 1925 +32e 32d 1704 1705 +32d 4010 1704 1814 +4032 32d 1705 1815 +32f 32e 15f4 15f5 +32e 400f 15f4 1704 +4031 32e 15f5 1705 +330 32f 14e4 14e5 +32f 400e 14e4 15f4 +4030 32f 14e5 15f5 +331 330 13d4 13d5 +330 400d 13d4 14e4 +402f 330 13d5 14e5 +332 331 12c4 12c5 +331 400c 12c4 13d4 +402e 331 12c5 13d5 +332 400b 11b4 12c4 +402d 332 11b5 12c5 +333 334 11a6 8dca +7f2 333 4d53 8dca +333 3e2f 11a5 11a6 +334 335 11a7 8c42 +334 7f2 7a1c 8dca +1f88 334 7a1c 8c42 +334 3e51 11a6 11a7 +335 336 11a8 7eae +335 1f88 7a1d 8c42 +1f89 335 7a1d 7eae +335 3e73 11a7 11a8 +336 337 11a9 7a1e +336 1f89 7eac 7eae +336 1f8a 7a1e 8af1 +2273 336 7eac 8af1 +336 3e95 11a8 11a9 +337 338 11aa 7b4f +1f8a 337 7a1e 7b4f +337 3eb7 11a9 11aa +338 339 11ab 7b50 +338 1f8a 7a20 7b4f +1f8b 338 7a20 7b50 +338 3ed9 11aa 11ab +339 33a 11ac 7b51 +339 1f8b 7a21 7b50 +1f8c 339 7a21 7b51 +339 3efb 11ab 11ac +33a 33b 11ad 7b52 +33a 1f8c 7a22 7b51 +1f8d 33a 7a22 7b52 +33a 3f1d 11ac 11ad +33b 33c 11ae 7b53 +33b 1f8d 7a23 7b52 +1f8e 33b 7a23 7a24 +1f8f 33b 7a24 7b53 +33b 3f3f 11ad 11ae +33c 33d 11af 7b54 +1f8f 33c 7b53 7b54 +33c 3f61 11ae 11af +33d 33e 11b0 7b55 +33d 1f8f 7a25 7b54 +1f90 33d 7a25 7b55 +33d 3f83 11af 11b0 +33e 33f 11b1 7b56 +33e 1f90 7a26 7b55 +1f91 33e 7a26 7b57 +33e 1f93 7b56 7b57 +33e 3fa5 11b0 11b1 +33f 340 11b2 7a27 +33f 1f92 7a27 7a29 +33f 1f93 7a29 7b56 +33f 3fc7 11b1 11b2 +340 341 11b3 7b58 +1f92 340 7a27 7a2a +1f95 340 7a2a 7b58 +340 3fe9 11b2 11b3 +1f95 341 7b58 7b59 +341 400b 11b3 11b4 +422a 342 35e3 35e4 +4208 343 35e2 35e3 +41e6 344 35e1 35e2 +41c4 345 35e0 35e1 +41a2 346 35df 35e0 +4180 347 35de 35df +415e 348 35dd 35de +413c 349 35dc 35dd +411a 34a 35db 35dc +40f8 34b 35da 35db +40d6 34c 35d9 35da +40b4 34d 35d8 35d9 +4092 34e 35d7 35d8 +4070 34f 35d6 35d7 +404e 350 35d5 35d6 +352 351 34d4 34d5 +351 422a 34d4 35e4 +47b6 351 34d5 35e5 +353 352 33c4 33c5 +352 4229 33c4 34d4 +478b 352 33c5 34d5 +354 353 32b4 32b5 +353 4228 32b4 33c4 +4760 353 32b5 33c5 +355 354 31a4 31a5 +354 4227 31a4 32b4 +4735 354 31a5 32b5 +356 355 3094 3095 +355 4226 3094 31a4 +470a 355 3095 31a5 +357 356 2f84 2f85 +356 4225 2f84 3094 +46df 356 2f85 3095 +358 357 2e74 2e75 +357 4224 2e74 2f84 +46b4 357 2e75 2f85 +359 358 2d64 2d65 +358 4223 2d64 2e74 +4689 358 2d65 2e75 +35a 359 2c54 2c55 +359 4222 2c54 2d64 +465e 359 2c55 2d65 +35b 35a 2b44 2b45 +35a 4221 2b44 2c54 +4633 35a 2b45 2c55 +35c 35b 2a34 2a35 +35b 4220 2a34 2b44 +4608 35b 2a35 2b45 +35d 35c 2924 2925 +35c 421f 2924 2a34 +45dd 35c 2925 2a35 +35e 35d 2814 2815 +35d 421e 2814 2924 +45b2 35d 2815 2925 +35f 35e 2704 2705 +35e 421d 2704 2814 +4587 35e 2705 2815 +360 35f 25f4 25f5 +35f 421c 25f4 2704 +455c 35f 25f5 2705 +361 360 24e4 24e5 +360 421b 24e4 25f4 +4531 360 24e5 25f5 +362 361 23d4 23d5 +361 421a 23d4 24e4 +4506 361 23d5 24e5 +363 362 22c4 22c5 +362 4219 22c4 23d4 +44db 362 22c5 23d5 +364 363 21b4 21b5 +363 4218 21b4 22c4 +44b0 363 21b5 22c5 +365 364 20a4 20a5 +364 4217 20a4 21b4 +4485 364 20a5 21b5 +366 365 1f94 1f95 +365 4216 1f94 20a4 +445a 365 1f95 20a5 +367 366 1e84 1e85 +366 4215 1e84 1f94 +442f 366 1e85 1f95 +368 367 1d74 1d75 +367 4214 1d74 1e84 +4404 367 1d75 1e85 +369 368 1c64 1c65 +368 4213 1c64 1d74 +43d9 368 1c65 1d75 +36a 369 1b54 1b55 +369 4212 1b54 1c64 +43ae 369 1b55 1c65 +36b 36a 1a44 1a45 +36a 4211 1a44 1b54 +4383 36a 1a45 1b55 +36c 36b 1934 1935 +36b 4210 1934 1a44 +4358 36b 1935 1a45 +36d 36c 1824 1825 +36c 420f 1824 1934 +432d 36c 1825 1935 +36e 36d 1714 1715 +36d 420e 1714 1824 +4302 36d 1715 1825 +36f 36e 1604 1605 +36e 420d 1604 1714 +42d7 36e 1605 1715 +370 36f 14f4 14f5 +36f 420c 14f4 1604 +42ac 36f 14f5 1605 +371 370 13e4 13e5 +370 420b 13e4 14f4 +4281 370 13e5 14f5 +372 371 12d4 12d5 +371 420a 12d4 13e4 +4256 371 12d5 13e5 +372 4209 11c4 12d4 +422b 372 11c5 12d5 +373 374 11b6 7b5a +1f96 373 7a2b 7b5a +373 402d 11b5 11b6 +374 375 11b7 7b5b +374 1f96 7a2d 7b5a +1f97 374 7a2d 7b5b +374 404f 11b6 11b7 +375 376 11b8 7b5c +375 1f97 7a2f 7b5b +1f99 375 7a2f 7b5c +375 4071 11b7 11b8 +376 377 11b9 7b5d +376 1f99 7a30 7b5c +1f9a 376 7a30 7b5d +376 4093 11b8 11b9 +377 378 11ba 7b5e +377 1f9a 7a31 7b5d +1f9b 377 7a31 7b5e +377 40b5 11b9 11ba +378 379 11bb 7b5f +378 1f9b 7a33 7b5e +1f9e 378 7a33 7b5f +378 40d7 11ba 11bb +379 37a 11bc 7b60 +379 1f9e 7a34 7b5f +1f9f 379 7a34 7b60 +379 40f9 11bb 11bc +37a 37b 11bd 7b61 +37a 1f9f 7a35 7b60 +1fa0 37a 7a35 7b61 +37a 411b 11bc 11bd +37b 37c 11be 7b62 +37b 1fa0 7a36 7b61 +1fa1 37b 7a36 7b62 +37b 413d 11bd 11be +37c 37d 11bf 7b63 +37c 1fa1 7a37 7b62 +1fa2 37c 7a37 7b63 +37c 415f 11be 11bf +37d 37e 11c0 7b65 +37d 1fa2 7a38 7b63 +1fa3 37d 7a38 7b65 +37d 4181 11bf 11c0 +37e 37f 11c1 7b67 +37e 1fa3 7a3c 7b65 +1fa8 37e 7a3c 7b67 +37e 41a3 11c0 11c1 +37f 380 11c2 7b69 +37f 1fa8 7a3d 7b67 +1fa9 37f 7a3d 7b69 +37f 41c5 11c1 11c2 +380 381 11c3 7b6b +380 1fa9 7a42 7b69 +1fab 380 7a42 7b6b +380 41e7 11c2 11c3 +381 1fab 7a45 7b6b +1fac 381 7a45 7b6d +381 4209 11c3 11c4 +383 382 11ef 7b9f +382 7f4 7a7b 7b9f +1fdf 382 7a7b 7ba0 +382 4255 11ef 11f0 +384 383 11ee 7b9e +383 7f3 4d54 7b9e +7f4 383 4d54 7b9f +383 4254 11ee 11ef +385 384 11ed 7b9c +7f3 384 7a79 7b9e +384 1fdc 7a79 7b9c +384 4253 11ed 11ee +386 385 11ec 7b9b +385 1fdb 7a78 7b9b +1fdc 385 7a78 7b9c +385 4252 11ec 11ed +387 386 11eb 7b9a +386 1fda 7a77 7b9a +1fdb 386 7a77 7b9b +386 4251 11eb 11ec +388 387 11ea 7b99 +387 1fd9 7a76 7b99 +1fda 387 7a76 7b9a +387 4250 11ea 11eb +389 388 11e9 7b97 +388 1fd7 7a75 7b97 +1fd9 388 7a75 7b99 +388 424f 11e9 11ea +38a 389 11e8 7b96 +389 1fd4 7a73 7b96 +1fd7 389 7a73 7b97 +389 424e 11e8 11e9 +38b 38a 11e7 7b95 +38a 1fd3 7a71 7b95 +1fd4 38a 7a71 7b96 +38a 424d 11e7 11e8 +38c 38b 11e6 7b94 +38b 1f40 7a70 7b94 +1fd3 38b 7a70 7b95 +38b 424c 11e6 11e7 +38d 38c 11e5 7b93 +1f40 38c 7b93 7b94 +38c 424b 11e5 11e6 +38e 38d 11e4 7b92 +1f40 38d 79fe 7b93 +38d 1f41 79fe 7b92 +38d 424a 11e4 11e5 +38f 38e 11e3 7b91 +1f41 38e 7a6e 7b92 +38e 1fd2 7a6e 7b91 +38e 4249 11e3 11e4 +390 38f 11e2 7b90 +38f 1fd1 7a6f 7b90 +1fd2 38f 7a6f 7b91 +38f 4248 11e2 11e3 +391 390 11e1 7b8f +390 1fd0 7a6d 7b8f +1fd1 390 7a6d 7b90 +390 4247 11e1 11e2 +392 391 11e0 7b8e +391 1fcf 7a6c 7b8e +1fd0 391 7a6c 7b8f +391 4246 11e0 11e1 +393 392 11df 7b8d +392 1fce 7a6b 7b8d +1fcf 392 7a6b 7b8e +392 4245 11df 11e0 +394 393 11de 7b8c +393 1fcd 7a6a 7b8c +1fce 393 7a6a 7b8d +393 4244 11de 11df +395 394 11dd 7b8b +394 1fcc 7a69 7b8b +1fcd 394 7a69 7b8c +394 4243 11dd 11de +396 395 11dc 7b8a +395 1fca 7a68 7b8a +1fcc 395 7a68 7b8b +395 4242 11dc 11dd +397 396 11db 7b89 +396 1fc9 7a66 7b89 +1fca 396 7a66 7b8a +396 4241 11db 11dc +398 397 11da 7b88 +397 1f68 7a65 7b88 +1fc9 397 7a65 7b89 +397 4240 11da 11db +399 398 11d9 7b87 +1f68 398 7a64 7b88 +398 1fc8 7a64 7b87 +398 423f 11d9 11da +39a 399 11d8 7b86 +399 1fc6 7a63 7b86 +1fc8 399 7a63 7b87 +399 423e 11d8 11d9 +39b 39a 11d7 7b85 +39a 1fc4 7a61 7b85 +1fc6 39a 7a61 7b86 +39a 423d 11d7 11d8 +39c 39b 11d6 7b84 +39b 1fc1 7a5f 7b84 +1fc4 39b 7a5f 7b85 +39b 423c 11d6 11d7 +39d 39c 11d5 7b83 +39c 1fc0 7a5d 7b83 +1fc1 39c 7a5d 7b84 +39c 423b 11d5 11d6 +39e 39d 11d4 7b81 +39d 1fbf 7a5c 7b81 +1fc0 39d 7a5c 7b83 +39d 423a 11d4 11d5 +39f 39e 11d3 7b7f +39e 1fbe 7a5b 7b7f +1fbf 39e 7a5b 7b81 +39e 4239 11d3 11d4 +3a0 39f 11d2 7b7d +39f 1fbd 7a5a 7b7d +1fbe 39f 7a5a 7b7f +39f 4238 11d2 11d3 +3a1 3a0 11d1 7b7c +3a0 1fbc 7a59 7b7c +1fbd 3a0 7a59 7b7d +3a0 4237 11d1 11d2 +3a2 3a1 11d0 7b7b +3a1 1fbb 7a58 7b7b +1fbc 3a1 7a58 7b7c +3a1 4236 11d0 11d1 +3a3 3a2 11cf 7b7a +3a2 1fba 7a57 7b7a +1fbb 3a2 7a57 7b7b +3a2 4235 11cf 11d0 +3a4 3a3 11ce 7b79 +3a3 1fb9 7a56 7b79 +1fba 3a3 7a56 7b7a +3a3 4234 11ce 11cf +3a5 3a4 11cd 7b78 +3a4 1fb8 7a55 7b78 +1fb9 3a4 7a55 7b79 +3a4 4233 11cd 11ce +3a6 3a5 11cc 7b77 +3a5 1fb7 7a54 7b77 +1fb8 3a5 7a54 7b78 +3a5 4232 11cc 11cd +3a7 3a6 11cb 7b76 +3a6 1fb6 7a53 7b76 +1fb7 3a6 7a53 7b77 +3a6 4231 11cb 11cc +3a8 3a7 11ca 7b75 +3a7 1fb4 7a52 7b75 +1fb6 3a7 7a52 7b76 +3a7 4230 11ca 11cb +3a9 3a8 11c9 7a4e +1fb2 3a8 7a4e 7a50 +1fb4 3a8 7a50 7b75 +3a8 422f 11c9 11ca +3aa 3a9 11c8 7b72 +1fb1 3a9 7b72 7b74 +3a9 1fb2 7a4e 7b74 +3a9 422e 11c8 11c9 +3ab 3aa 11c7 7b71 +3aa 1fb0 7a4d 7b71 +1fb1 3aa 7a4d 7b72 +3aa 422d 11c7 11c8 +3ac 3ab 11c6 7b70 +3ab 1faf 7a4c 7b70 +1fb0 3ab 7a4c 7b71 +3ab 422c 11c6 11c7 +1fad 3ac 7a4a 7a4b +1faf 3ac 7a4b 7b70 +3ac 422b 11c5 11c6 +3ad 3ae 33f1 3500 +3ad 47e0 3500 3610 +5b01 3ad 33f1 3501 +3ae 3af 32e1 33f0 +3ae 47b5 33f0 3500 +5b20 3ae 32e1 33f1 +3af 3b0 31d1 32e0 +3af 478a 32e0 33f0 +5b3f 3af 31d1 32e1 +3b0 3b1 30c1 31d0 +3b0 475f 31d0 32e0 +5b5e 3b0 30c1 31d1 +3b1 3b2 2fb1 30c0 +3b1 4734 30c0 31d0 +5b7d 3b1 2fb1 30c1 +3b2 3b3 2ea1 2fb0 +3b2 4709 2fb0 30c0 +5b9c 3b2 2ea1 2fb1 +3b3 3b4 2d91 2ea0 +3b3 46de 2ea0 2fb0 +5bbb 3b3 2d91 2ea1 +3b4 3b5 2c81 2d90 +3b4 46b3 2d90 2ea0 +5bda 3b4 2c81 2d91 +3b5 3b6 2b71 2c80 +3b5 4688 2c80 2d90 +5bf9 3b5 2b71 2c81 +3b6 3b7 2a61 2b70 +3b6 465d 2b70 2c80 +5c18 3b6 2a61 2b71 +3b7 3b8 2951 2a60 +3b7 4632 2a60 2b70 +5c37 3b7 2951 2a61 +3b8 3b9 2841 2950 +3b8 4607 2950 2a60 +5c56 3b8 2841 2951 +3b9 3ba 2731 2840 +3b9 45dc 2840 2950 +5c75 3b9 2731 2841 +3ba 3bb 2621 2730 +3ba 45b1 2730 2840 +5c94 3ba 2621 2731 +3bb 3bc 2511 2620 +3bb 4586 2620 2730 +5cb3 3bb 2511 2621 +3bc 3bd 2401 2510 +3bc 455b 2510 2620 +5cd2 3bc 2401 2511 +3bd 3be 22f1 2400 +3bd 4530 2400 2510 +5cf1 3bd 22f1 2401 +3be 3bf 21e1 22f0 +3be 4505 22f0 2400 +5d10 3be 21e1 22f1 +3bf 3c0 20d1 21e0 +3bf 44da 21e0 22f0 +5d2f 3bf 20d1 21e1 +3c0 3c1 1fc1 20d0 +3c0 44af 20d0 21e0 +5d4e 3c0 1fc1 20d1 +3c1 3c2 1eb1 1fc0 +3c1 4484 1fc0 20d0 +5d6d 3c1 1eb1 1fc1 +3c2 3c3 1da1 1eb0 +3c2 4459 1eb0 1fc0 +5d8c 3c2 1da1 1eb1 +3c3 3c4 1c91 1da0 +3c3 442e 1da0 1eb0 +5dab 3c3 1c91 1da1 +3c4 3c5 1b81 1c90 +3c4 4403 1c90 1da0 +5dca 3c4 1b81 1c91 +3c5 3c6 1a71 1b80 +3c5 43d8 1b80 1c90 +5de9 3c5 1a71 1b81 +3c6 3c7 1961 1a70 +3c6 43ad 1a70 1b80 +5e08 3c6 1961 1a71 +3c7 3c8 1851 1960 +3c7 4382 1960 1a70 +5e27 3c7 1851 1961 +3c8 3c9 1741 1850 +3c8 4357 1850 1960 +5e46 3c8 1741 1851 +3c9 3ca 1631 1740 +3c9 432c 1740 1850 +5e65 3c9 1631 1741 +3ca 3cb 1521 1630 +3ca 4301 1630 1740 +5e84 3ca 1521 1631 +3cb 3cc 1411 1520 +3cb 42d6 1520 1630 +5ea3 3cb 1411 1521 +3cc 3cd 1301 1410 +3cc 42ab 1410 1520 +5ec2 3cc 1301 1411 +3cd 3ce 11f1 1300 +3cd 4280 1300 1410 +5ee1 3cd 11f1 1301 +3ce 4255 11f0 1300 +5f00 3ce 10e1 11f1 +47e0 3cf 360f 3610 +47df 3d0 360e 360f +47de 3d1 360d 360e +47dd 3d2 360c 360d +47dc 3d3 360b 360c +47db 3d4 360a 360b +47da 3d5 3609 360a +47d9 3d6 3608 3609 +47d8 3d7 3607 3608 +47d7 3d8 3606 3607 +47d6 3d9 3605 3606 +47d5 3da 3604 3605 +47d4 3db 3603 3604 +47d3 3dc 3602 3603 +47d2 3dd 3601 3602 +47d1 3de 3600 3601 +47d0 3df 35ff 3600 +47cf 3e0 35fe 35ff +47ce 3e1 35fd 35fe +47cd 3e2 35fc 35fd +47cc 3e3 35fb 35fc +47cb 3e4 35fa 35fb +47ca 3e5 35f9 35fa +47c9 3e6 35f8 35f9 +47c8 3e7 35f7 35f8 +47c7 3e8 35f6 35f7 +47c6 3e9 35f5 35f6 +47c5 3ea 35f4 35f5 +47c4 3eb 35f3 35f4 +47c3 3ec 35f2 35f3 +47c2 3ed 35f1 35f2 +47c1 3ee 35f0 35f1 +47c0 3ef 35ef 35f0 +47bf 3f0 35ee 35ef +47be 3f1 35ed 35ee +47bd 3f2 35ec 35ed +47bc 3f3 35eb 35ec +47bb 3f4 35ea 35eb +47ba 3f5 35e9 35ea +47b9 3f6 35e8 35e9 +47b8 3f7 35e7 35e8 +47b7 3f8 35e6 35e7 +47b6 3f9 35e5 35e6 +3fa 3fb 116a 7bf8 +3fa 2090 7b0d 7bf7 +2091 3fa 7b0d 7b0e +2092 3fa 7b0e 7bf8 +3fa 47e1 1169 116a +3fb 3fc 116b 7bf9 +3fb 2092 7b0f 7bf8 +2093 3fb 7b0f 7bf9 +3fb 47e2 116a 116b +3fc 3fd 116c 7b10 +2093 3fc 7bf9 7bfa +3fc 2094 7b10 7bfa +3fc 47e3 116b 116c +3fd 3fe 116d 7bfb +2094 3fd 7b10 7b11 +2095 3fd 7b11 7bfb +3fd 47e4 116c 116d +3fe 3ff 116e 7bfd +3fe 2095 7b13 7bfb +2098 3fe 7b13 7bfd +3fe 47e5 116d 116e +3ff 400 116f 7bfe +3ff 2098 7b14 7bfd +2099 3ff 7b14 7bfe +3ff 47e6 116e 116f +400 401 1170 7bff +400 2099 7b15 7bfe +209a 400 7b15 7bff +400 47e7 116f 1170 +401 402 1171 7c00 +401 209a 7b16 7bff +209b 401 7b16 7c00 +401 47e8 1170 1171 +402 403 1172 7c01 +1f54 402 7b17 7c01 +402 209b 7b17 7c00 +402 47e9 1171 1172 +403 404 1173 7c02 +403 1f54 7b18 7c01 +209c 403 7b18 7c02 +403 47ea 1172 1173 +404 405 1174 7c03 +209c 404 7c02 7c03 +404 47eb 1173 1174 +405 406 1175 7c04 +405 209c 7b19 7c03 +209d 405 7b19 7c04 +405 47ec 1174 1175 +406 407 1176 7c05 +406 209d 7b1a 7c04 +209e 406 7b1a 7c05 +406 47ed 1175 1176 +407 408 1177 7c06 +407 209e 7b1b 7c05 +209f 407 7b1b 7c06 +407 47ee 1176 1177 +408 409 1178 7c07 +408 209f 7b1c 7c06 +20a0 408 7b1c 7c07 +408 47ef 1177 1178 +409 40a 1179 7c08 +409 20a0 7b1e 7c07 +20a3 409 7b1e 7c08 +409 47f0 1178 1179 +40a 40b 117a 7c09 +40a 20a3 7b20 7c08 +20a5 40a 7b20 7c09 +40a 47f1 1179 117a +40b 40c 117b 7c0a +40b 20a5 7b22 7c09 +20a7 40b 7b22 7c0a +40b 47f2 117a 117b +40c 40d 117c 7c0b +40c 20a7 7b24 7c0a +20a9 40c 7b24 7c0b +40c 47f3 117b 117c +40d 40e 117d 7c0c +40d 20a9 7b26 7c0b +20ab 40d 7b26 7c0c +40d 47f4 117c 117d +40e 40f 117e 7c0d +40e 20ab 7b28 7c0c +20ad 40e 7b28 7c0d +40e 47f5 117d 117e +40f 410 117f 7c0e +40f 20ad 7b2a 7c0d +20af 40f 7b2a 7c0e +40f 47f6 117e 117f +410 411 1180 7c0f +410 20af 7b2c 7c0e +20b1 410 7b2c 7c0f +410 47f7 117f 1180 +411 412 1181 7c10 +411 20b1 7b2e 7c0f +20b3 411 7b2e 7c10 +411 47f8 1180 1181 +412 413 1182 7c11 +412 20b3 7b2f 7c10 +20b4 412 7b2f 7c11 +412 47f9 1181 1182 +413 414 1183 7c12 +413 20b4 7b30 7c11 +20b5 413 7b30 7c12 +413 47fa 1182 1183 +414 415 1184 7c13 +414 20b5 7b31 7c12 +20b6 414 7b31 7c13 +414 47fb 1183 1184 +415 416 1185 7c14 +415 20b6 7b32 7c13 +20b7 415 7b32 7c14 +415 47fc 1184 1185 +416 417 1186 7c15 +416 20b7 7b33 7c14 +20b8 416 7b33 7c15 +416 47fd 1185 1186 +417 418 1187 7c16 +417 20b8 7b34 7c15 +20b9 417 7b34 7c16 +417 47fe 1186 1187 +418 419 1188 7c17 +418 20b9 7b35 7c16 +20ba 418 7b35 7c17 +418 47ff 1187 1188 +419 41a 1189 7c18 +419 20ba 7b37 7c17 +20be 419 7b37 7c18 +419 4800 1188 1189 +41a 41b 118a 7c19 +41a 20be 7b38 7c18 +20bf 41a 7b38 7c19 +41a 4801 1189 118a +41b 41c 118b 7c1a +41b 20bf 7b39 7c19 +20c0 41b 7b39 7c1a +41b 4802 118a 118b +41c 41d 118c 7c1b +41c 20c0 7b3a 7c1a +20c1 41c 7b3a 7c1b +41c 4803 118b 118c +41d 41e 118d 7c1c +41d 20c1 7b3b 7c1b +20c2 41d 7b3b 7c1c +41d 4804 118c 118d +41e 41f 118e 7f5f +20c2 41e 7c1c 8b41 +41e 20c4 7f5f 8b41 +41e 4805 118d 118e +41f 420 118f 8bf1 +20c4 41f 7f5f 8d04 +41f 20c5 8bf1 8d04 +41f 4806 118e 118f +420 421 1190 8c4c +20c5 420 8bf1 8d05 +420 20c8 8c4c 8d05 +420 4807 118f 1190 +421 422 1191 8c6e +421 20c6 8c6e 8db7 +20c7 421 8d8d 8db7 +20c8 421 8c4c 8d8d +421 4808 1190 1191 +422 423 1192 7b3e +422 20c6 7b3e 8c6e +422 4809 1191 1192 +423 424 1193 8d71 +20c6 423 7b3e 7b41 +20ca 423 7b41 8c5d +271d 423 8c5d 8d71 +423 480a 1192 1193 +424 20cd 8e2e 8e4d +271d 424 8d71 8e4d +424 480b 1193 1194 +4d96 425 35b3 35b4 +4d95 426 35b2 35b3 +4d94 427 35b1 35b2 +4d93 428 35b0 35b1 +4d92 429 35af 35b0 +4d91 42a 35ae 35af +4d90 42b 35ad 35ae +4d8f 42c 35ac 35ad +4d8e 42d 35ab 35ac +4d8d 42e 35aa 35ab +4d8c 42f 35a9 35aa +4d8b 430 35a8 35a9 +4d8a 431 35a7 35a8 +4d89 432 35a6 35a7 +4d88 433 35a5 35a6 +4d87 434 35a4 35a5 +4d86 435 35a3 35a4 +4d85 436 35a2 35a3 +4d84 437 35a1 35a2 +4d83 438 35a0 35a1 +4d82 439 359f 35a0 +4d81 43a 359e 359f +4d80 43b 359d 359e +4d7f 43c 359c 359d +4d7e 43d 359b 359c +4d7d 43e 359a 359b +4d7c 43f 3599 359a +4d7b 440 3598 3599 +4d7a 441 3597 3598 +4d79 442 3596 3597 +4d78 443 3595 3596 +4d77 444 3594 3595 +4d76 445 3593 3594 +4d75 446 3592 3593 +4d74 447 3591 3592 +4d73 448 3590 3591 +4d72 449 358f 3590 +4d71 44a 358e 358f +4d70 44b 358d 358e +4d6f 44c 358c 358d +4d6e 44d 358b 358c +4d6d 44e 358a 358b +4d6c 44f 3589 358a +451 450 3478 3479 +4d6c 450 3479 3589 +450 4db8 3478 3588 +452 451 3368 3369 +4d41 451 3369 3479 +451 4db7 3368 3478 +453 452 3258 3259 +4d16 452 3259 3369 +452 4db6 3258 3368 +454 453 3148 3149 +4ceb 453 3149 3259 +453 4db5 3148 3258 +455 454 3038 3039 +4cc0 454 3039 3149 +454 4db4 3038 3148 +456 455 2f28 2f29 +4c95 455 2f29 3039 +455 4db3 2f28 3038 +457 456 2e18 2e19 +4c6a 456 2e19 2f29 +456 4db2 2e18 2f28 +458 457 2d08 2d09 +4c3f 457 2d09 2e19 +457 4db1 2d08 2e18 +459 458 2bf8 2bf9 +4c14 458 2bf9 2d09 +458 4db0 2bf8 2d08 +45a 459 2ae8 2ae9 +4be9 459 2ae9 2bf9 +459 4daf 2ae8 2bf8 +45b 45a 29d8 29d9 +4bbe 45a 29d9 2ae9 +45a 4dae 29d8 2ae8 +45c 45b 28c8 28c9 +4b93 45b 28c9 29d9 +45b 4dad 28c8 29d8 +45d 45c 27b8 27b9 +4b68 45c 27b9 28c9 +45c 4dac 27b8 28c8 +45e 45d 26a8 26a9 +4b3d 45d 26a9 27b9 +45d 4dab 26a8 27b8 +45f 45e 2598 2599 +4b12 45e 2599 26a9 +45e 4daa 2598 26a8 +460 45f 2488 2489 +4ae7 45f 2489 2599 +45f 4da9 2488 2598 +461 460 2378 2379 +4abc 460 2379 2489 +460 4da8 2378 2488 +462 461 2268 2269 +4a91 461 2269 2379 +461 4da7 2268 2378 +463 462 2158 2159 +4a66 462 2159 2269 +462 4da6 2158 2268 +464 463 2048 2049 +4a3b 463 2049 2159 +463 4da5 2048 2158 +465 464 1f38 1f39 +4a10 464 1f39 2049 +464 4da4 1f38 2048 +466 465 1e28 1e29 +49e5 465 1e29 1f39 +465 4da3 1e28 1f38 +467 466 1d18 1d19 +49ba 466 1d19 1e29 +466 4da2 1d18 1e28 +468 467 1c08 1c09 +498f 467 1c09 1d19 +467 4da1 1c08 1d18 +469 468 1af8 1af9 +4964 468 1af9 1c09 +468 4da0 1af8 1c08 +46a 469 19e8 19e9 +4939 469 19e9 1af9 +469 4d9f 19e8 1af8 +46b 46a 18d8 18d9 +490e 46a 18d9 19e9 +46a 4d9e 18d8 19e8 +46c 46b 17c8 17c9 +48e3 46b 17c9 18d9 +46b 4d9d 17c8 18d8 +46d 46c 16b8 16b9 +48b8 46c 16b9 17c9 +46c 4d9c 16b8 17c8 +46e 46d 15a8 15a9 +488d 46d 15a9 16b9 +46d 4d9b 15a8 16b8 +46f 46e 1498 1499 +4862 46e 1499 15a9 +46e 4d9a 1498 15a8 +470 46f 1388 1389 +4837 46f 1389 1499 +46f 4d99 1388 1498 +471 470 1278 1279 +480c 470 1279 1389 +470 4d98 1278 1388 +47e1 471 1169 1279 +471 4d97 1168 1278 +4db8 472 3587 3588 +4dda 473 3586 3587 +4dfc 474 3585 3586 +4e1e 475 3584 3585 +4e40 476 3583 3584 +4e62 477 3582 3583 +4e84 478 3581 3582 +4ea6 479 3580 3581 +4ec8 47a 357f 3580 +4eea 47b 357e 357f +4f0c 47c 357d 357e +4f2e 47d 357c 357d +4f50 47e 357b 357c +4f72 47f 357a 357b +4f94 480 3579 357a +4fb6 481 3578 3579 +4fd8 482 3577 3578 +4ffa 483 3576 3577 +501c 484 3575 3576 +503e 485 3574 3575 +5060 486 3573 3574 +5082 487 3572 3573 +50a4 488 3571 3572 +50c6 489 3570 3571 +50e8 48a 356f 3570 +510a 48b 356e 356f +512c 48c 356d 356e +514e 48d 356c 356d +5170 48e 356b 356c +5192 48f 356a 356b +51b4 490 3569 356a +492 491 3458 3459 +51b4 491 3459 3569 +491 57d1 3458 3568 +493 492 3348 3349 +51b3 492 3349 3459 +492 57d2 3348 3458 +494 493 3238 3239 +51b2 493 3239 3349 +493 57d3 3238 3348 +495 494 3128 3129 +51b1 494 3129 3239 +494 57d4 3128 3238 +496 495 3018 3019 +51b0 495 3019 3129 +495 57d5 3018 3128 +497 496 2f08 2f09 +51af 496 2f09 3019 +496 57d6 2f08 3018 +498 497 2df8 2df9 +51ae 497 2df9 2f09 +497 57d7 2df8 2f08 +499 498 2ce8 2ce9 +51ad 498 2ce9 2df9 +498 57d8 2ce8 2df8 +49a 499 2bd8 2bd9 +51ac 499 2bd9 2ce9 +499 57d9 2bd8 2ce8 +49b 49a 2ac8 2ac9 +51ab 49a 2ac9 2bd9 +49a 57da 2ac8 2bd8 +49c 49b 29b8 29b9 +51aa 49b 29b9 2ac9 +49b 57db 29b8 2ac8 +49d 49c 28a8 28a9 +51a9 49c 28a9 29b9 +49c 57dc 28a8 29b8 +49e 49d 2798 2799 +51a8 49d 2799 28a9 +49d 57dd 2798 28a8 +49f 49e 2688 2689 +51a7 49e 2689 2799 +49e 57de 2688 2798 +4a0 49f 2578 2579 +51a6 49f 2579 2689 +49f 57df 2578 2688 +4a1 4a0 2468 2469 +51a5 4a0 2469 2579 +4a0 57e0 2468 2578 +4a2 4a1 2358 2359 +51a4 4a1 2359 2469 +4a1 57e1 2358 2468 +4a3 4a2 2248 2249 +51a3 4a2 2249 2359 +4a2 57e2 2248 2358 +4a4 4a3 2138 2139 +51a2 4a3 2139 2249 +4a3 57e3 2138 2248 +4a5 4a4 2028 2029 +51a1 4a4 2029 2139 +4a4 57e4 2028 2138 +4a6 4a5 1f18 1f19 +51a0 4a5 1f19 2029 +4a5 57e5 1f18 2028 +4a7 4a6 1e08 1e09 +519f 4a6 1e09 1f19 +4a6 57e6 1e08 1f18 +4a8 4a7 1cf8 1cf9 +519e 4a7 1cf9 1e09 +4a7 57e7 1cf8 1e08 +4a9 4a8 1be8 1be9 +519d 4a8 1be9 1cf9 +4a8 57e8 1be8 1cf8 +4aa 4a9 1ad8 1ad9 +519c 4a9 1ad9 1be9 +4a9 57e9 1ad8 1be8 +4ab 4aa 19c8 19c9 +519b 4aa 19c9 1ad9 +4aa 57ea 19c8 1ad8 +4ac 4ab 18b8 18b9 +519a 4ab 18b9 19c9 +4ab 57eb 18b8 19c8 +4ad 4ac 17a8 17a9 +5199 4ac 17a9 18b9 +4ac 57ec 17a8 18b8 +4ae 4ad 1698 1699 +5198 4ad 1699 17a9 +4ad 57ed 1698 17a8 +4af 4ae 1588 1589 +5197 4ae 1589 1699 +4ae 57ee 1588 1698 +4b0 4af 1478 1479 +5196 4af 1479 1589 +4af 57ef 1478 1588 +4b1 4b0 1368 1369 +5195 4b0 1369 1479 +4b0 57f0 1368 1478 +4b2 4b1 1258 1259 +5194 4b1 1259 1369 +4b1 57f1 1258 1368 +5193 4b2 1149 1259 +4b2 57f2 1148 1258 +4b3 4b4 114a 8d44 +2066 4b3 7ae7 8c58 +2067 4b3 8c58 8d44 +4b3 5193 1149 114a +4b4 4b5 114b 7ae8 +4b4 2067 7ae8 8d44 +4b4 5171 114a 114b +4b5 4b6 114c 8bf5 +2067 4b5 7ae8 7aea +2069 4b5 7aea 7f25 +206c 4b5 7f25 8bf5 +4b5 514f 114b 114c +4b6 4b7 114d 7aed +4b6 206a 7aed 8c70 +206c 4b6 8bf5 8c70 +4b6 512d 114c 114d +4b7 4b8 114e 7bda +4b7 206a 7aec 7aed +206d 4b7 7aec 7bda +4b7 510b 114d 114e +4b8 4b9 114f 7bdb +4b8 206d 7aee 7bda +206e 4b8 7aee 7bdb +4b8 50e9 114e 114f +4b9 4ba 1150 7bdc +4b9 206e 7aef 7bdb +206f 4b9 7aef 7bdc +4b9 50c7 114f 1150 +4ba 4bb 1151 7bdd +4ba 206f 7af1 7bdc +2072 4ba 7af1 7bdd +4ba 50a5 1150 1151 +4bb 4bc 1152 7bde +4bb 2072 7af2 7bdd +2073 4bb 7af2 7bde +4bb 5083 1151 1152 +4bc 4bd 1153 7bdf +4bc 2073 7af3 7bde +2074 4bc 7af3 7bdf +4bc 5061 1152 1153 +4bd 4be 1154 7be1 +4bd 2074 7af4 7bdf +2075 4bd 7af4 7be1 +4bd 503f 1153 1154 +4be 4bf 1155 7be2 +4be 2075 7af5 7be1 +2076 4be 7af5 7be2 +4be 501d 1154 1155 +4bf 4c0 1156 7be3 +4bf 2076 7af7 7be2 +2079 4bf 7af7 7be3 +4bf 4ffb 1155 1156 +4c0 4c1 1157 7be4 +4c0 2079 7af9 7be3 +207b 4c0 7af9 7be4 +4c0 4fd9 1156 1157 +4c1 4c2 1158 7be5 +4c1 207b 7afa 7be4 +207c 4c1 7afa 7be5 +4c1 4fb7 1157 1158 +4c2 4c3 1159 7be6 +4c2 207c 7afb 7be5 +207d 4c2 7afb 7be6 +4c2 4f95 1158 1159 +4c3 4c4 115a 7be7 +4c3 207d 7afc 7be6 +207e 4c3 7afc 7be7 +4c3 4f73 1159 115a +4c4 4c5 115b 7be8 +4c4 207e 7afd 7be7 +207f 4c4 7afd 7be8 +4c4 4f51 115a 115b +4c5 4c6 115c 7be9 +4c5 207f 7afe 7be8 +2080 4c5 7afe 7be9 +4c5 4f2f 115b 115c +4c6 4c7 115d 7bea +4c6 2080 7aff 7be9 +2081 4c6 7aff 7bea +4c6 4f0d 115c 115d +4c7 4c8 115e 7beb +4c7 2081 7b00 7bea +2082 4c7 7b00 7beb +4c7 4eeb 115d 115e +4c8 4c9 115f 7bec +4c8 2082 7b01 7beb +2083 4c8 7b01 7bec +4c8 4ec9 115e 115f +4c9 4ca 1160 7bed +4c9 2083 7b02 7bec +2084 4c9 7b02 7bed +4c9 4ea7 115f 1160 +4ca 4cb 1161 7bee +4ca 2084 7b03 7bed +2085 4ca 7b03 7bee +4ca 4e85 1160 1161 +4cb 4cc 1162 7bf0 +4cb 2085 7b05 7bee +2087 4cb 7b05 7bf0 +4cb 4e63 1161 1162 +4cc 4cd 1163 7bf1 +2086 4cc 7b04 7bf1 +4cc 2087 7b04 7bf0 +4cc 4e41 1162 1163 +4cd 4ce 1164 7bf2 +4cd 2086 7b07 7bf1 +208a 4cd 7b07 7bf2 +4cd 4e1f 1163 1164 +4ce 4cf 1165 7bf3 +4ce 208a 7b08 7bf2 +208b 4ce 7b08 7bf3 +4ce 4dfd 1164 1165 +4cf 4d0 1166 7bf4 +4cf 208b 7b09 7bf3 +208c 4cf 7b09 7bf4 +4cf 4ddb 1165 1166 +4d0 4d1 1167 7bf5 +4d0 208c 7b0b 7bf4 +208f 4d0 7b0b 7bf5 +4d0 4db9 1166 1167 +208f 4d1 7bf5 7bf6 +4d1 4d97 1167 1168 +4d3 4d2 3428 3429 +51b5 4d2 3429 3539 +4d2 57f3 3428 3538 +4d4 4d3 3318 3319 +51b6 4d3 3319 3429 +4d3 57f4 3318 3428 +4d5 4d4 3208 3209 +51b7 4d4 3209 3319 +4d4 57f5 3208 3318 +4d6 4d5 30f8 30f9 +51b8 4d5 30f9 3209 +4d5 57f6 30f8 3208 +4d7 4d6 2fe8 2fe9 +51b9 4d6 2fe9 30f9 +4d6 57f7 2fe8 30f8 +4d8 4d7 2ed8 2ed9 +51ba 4d7 2ed9 2fe9 +4d7 57f8 2ed8 2fe8 +4d9 4d8 2dc8 2dc9 +51bb 4d8 2dc9 2ed9 +4d8 57f9 2dc8 2ed8 +4da 4d9 2cb8 2cb9 +51bc 4d9 2cb9 2dc9 +4d9 57fa 2cb8 2dc8 +4db 4da 2ba8 2ba9 +51bd 4da 2ba9 2cb9 +4da 57fb 2ba8 2cb8 +4dc 4db 2a98 2a99 +51be 4db 2a99 2ba9 +4db 57fc 2a98 2ba8 +4dd 4dc 2988 2989 +51bf 4dc 2989 2a99 +4dc 57fd 2988 2a98 +4de 4dd 2878 2879 +51c0 4dd 2879 2989 +4dd 57fe 2878 2988 +4df 4de 2768 2769 +51c1 4de 2769 2879 +4de 57ff 2768 2878 +4e0 4df 2658 2659 +51c2 4df 2659 2769 +4df 5800 2658 2768 +4e1 4e0 2548 2549 +51c3 4e0 2549 2659 +4e0 5801 2548 2658 +4e2 4e1 2438 2439 +51c4 4e1 2439 2549 +4e1 5802 2438 2548 +4e3 4e2 2328 2329 +51c5 4e2 2329 2439 +4e2 5803 2328 2438 +4e4 4e3 2218 2219 +51c6 4e3 2219 2329 +4e3 5804 2218 2328 +4e5 4e4 2108 2109 +51c7 4e4 2109 2219 +4e4 5805 2108 2218 +4e6 4e5 1ff8 1ff9 +51c8 4e5 1ff9 2109 +4e5 5806 1ff8 2108 +4e7 4e6 1ee8 1ee9 +51c9 4e6 1ee9 1ff9 +4e6 5807 1ee8 1ff8 +4e8 4e7 1dd8 1dd9 +51ca 4e7 1dd9 1ee9 +4e7 5808 1dd8 1ee8 +4e9 4e8 1cc8 1cc9 +51cb 4e8 1cc9 1dd9 +4e8 5809 1cc8 1dd8 +4ea 4e9 1bb8 1bb9 +51cc 4e9 1bb9 1cc9 +4e9 580a 1bb8 1cc8 +4eb 4ea 1aa8 1aa9 +51cd 4ea 1aa9 1bb9 +4ea 580b 1aa8 1bb8 +4ec 4eb 1998 1999 +51ce 4eb 1999 1aa9 +4eb 580c 1998 1aa8 +4ed 4ec 1888 1889 +51cf 4ec 1889 1999 +4ec 580d 1888 1998 +4ee 4ed 1778 1779 +51d0 4ed 1779 1889 +4ed 580e 1778 1888 +4ef 4ee 1668 1669 +51d1 4ee 1669 1779 +4ee 580f 1668 1778 +4f0 4ef 1558 1559 +51d2 4ef 1559 1669 +4ef 5810 1558 1668 +4f1 4f0 1448 1449 +51d3 4f0 1449 1559 +4f0 5811 1448 1558 +4f2 4f1 1338 1339 +51d4 4f1 1339 1449 +4f1 5812 1338 1448 +4f3 4f2 1228 1229 +51d5 4f2 1229 1339 +4f2 5813 1228 1338 +51d6 4f3 1119 1229 +4f3 5814 1118 1228 +4f4 4f5 111a 8362 +216c 4f4 7cab 8362 +4f4 51d6 1119 111a +4f5 4f6 111b 7d30 +4f5 216c 80e1 8362 +4f5 2185 7d30 80e1 +4f5 51f8 111a 111b +4f6 4f7 111c 80e0 +4f6 2169 80e0 8db2 +2185 4f6 7d30 8db2 +4f6 521a 111b 111c +4f7 4f8 111d 8db3 +2169 4f7 80e0 8db3 +4f7 523c 111c 111d +4f8 4f9 111e 8bb7 +2164 4f8 7ca3 8bb7 +4f8 2169 7ca3 8db3 +4f8 525e 111d 111e +4f9 4fa 111f 8d62 +2164 4f9 8bb7 8e09 +4f9 271b 8d62 8e09 +4f9 5280 111e 111f +4fa 4fb 1120 8076 +4fa 2395 8076 8eb7 +2398 4fa 8c50 8eb7 +4fa 271b 8c50 8d62 +4fa 52a2 111f 1120 +4fb 4fc 1121 8de1 +2395 4fb 8076 8de1 +4fb 52c4 1120 1121 +4fc 4fd 1122 8e6d +4fc 2395 8077 8de1 +2396 4fc 8077 8e6d +4fc 52e6 1121 1122 +4fd 4fe 1123 8eed +4fd 2396 8cbe 8e6d +270a 4fd 8cbe 8eed +4fd 5308 1122 1123 +4fe 4ff 1124 8e72 +239d 4fe 8b3e 8e72 +4fe 270a 8b3e 8eed +4fe 532a 1123 1124 +4ff 500 1125 8ec0 +4ff 239d 807b 8e72 +239e 4ff 807b 8ec0 +4ff 534c 1124 1125 +500 501 1126 8dc6 +500 239e 8318 8ec0 +24cb 500 8318 8ebc +500 24cd 8dc6 8ebc +500 536e 1125 1126 +501 502 1127 8ebd +24cd 501 8dc6 8ebd +501 5390 1126 1127 +502 503 1128 8f07 +24cc 502 831b 8f07 +502 24cd 831b 8ebd +502 53b2 1127 1128 +503 504 1129 8eb8 +503 24cc 8e07 8f07 +24d2 503 8d3a 8eb8 +503 24d3 8d3a 8e07 +503 53d4 1128 1129 +504 505 112a 8ef4 +24d2 504 8eb8 8ef4 +504 53f6 1129 112a +505 506 112b 8e1e +505 24ca 8e1e 8eee +24d1 505 831d 8eee +505 24d2 831d 8ef4 +505 5418 112a 112b +506 507 112c 8eef +201d 506 8317 8eef +506 24ca 8317 8e1e +506 543a 112b 112c +507 508 112d 8e61 +507 201b 8e61 8f20 +201d 507 8eef 8f20 +507 545c 112c 112d +508 509 112e 8ef6 +201b 508 8e61 8f05 +508 201f 8ef6 8f05 +508 547e 112d 112e +509 50a 112f 8df3 +509 201f 8df3 8ef6 +509 54a0 112e 112f +50a 50b 1130 8e70 +50a 201f 8c76 8df3 +50a 2022 8e70 8f10 +2721 50a 8c76 8f10 +50a 54c2 112f 1130 +50b 50c 1131 8d0f +2022 50b 8e70 8f11 +50b 2023 8d0f 8f11 +50b 54e4 1130 1131 +50c 50d 1132 8f0b +2023 50c 8d0f 8ea9 +202e 50c 8ea9 8f0b +50c 5506 1131 1132 +50d 50e 1133 8e1c +202d 50d 7abc 8e1c +50d 202e 7abc 8f0b +50d 5528 1132 1133 +50e 50f 1134 8eea +202d 50e 8e1c 8f22 +50e 2728 8eea 8f22 +50e 554a 1133 1134 +50f 510 1135 8ed3 +2728 50f 8eea 8f23 +50f 2729 8ed3 8f23 +50f 556c 1134 1135 +510 511 1136 7ac2 +510 2034 7ac2 8db9 +510 2729 8db9 8ed3 +510 558e 1135 1136 +511 512 1137 8e38 +2034 511 7ac2 8f1c +511 2038 8e38 8f1c +511 55b0 1136 1137 +512 513 1138 8d2c +2037 512 7ac4 8d2c +512 2038 7ac4 8e38 +512 55d2 1137 1138 +513 514 1139 8eb1 +2037 513 8d2c 8f0d +513 2041 8eb1 8f0d +513 55f4 1138 1139 +514 515 113a 8f03 +2040 514 7ac8 8f03 +514 2041 7ac8 8eb1 +514 5616 1139 113a +515 516 113b 8e94 +515 2040 8e3e 8f03 +515 2042 8e94 8eff +2737 515 8e3e 8eff +515 5638 113a 113b +516 517 113c 7aca +516 2042 7aca 8e94 +516 565a 113b 113c +517 518 113d 7ad0 +2042 517 7aca 8d29 +517 204b 7ad0 8e6f +274a 517 8d29 8e6f +517 567c 113c 113d +518 519 113e 8de7 +204b 518 7ad0 8cdc +2736 518 8cdc 8de7 +518 569e 113d 113e +519 51a 113f 8e91 +2736 519 8de7 8e91 +519 56c0 113e 113f +51a 51b 1140 8d00 +51a 2050 8d00 8e82 +51a 2736 8e82 8e91 +51a 56e2 113f 1140 +51b 51c 1141 7ad4 +204f 51b 7ad3 7ad4 +51b 2050 7ad3 8d00 +51b 5704 1140 1141 +51c 51d 1142 8e8f +204f 51c 7ad4 8cd1 +2730 51c 8cd1 8e8f +51c 5726 1141 1142 +51d 51e 1143 7ada +51d 2059 7ada 8cf9 +51d 2730 8cf9 8e8f +51d 5748 1142 1143 +51e 51f 1144 8d97 +2059 51e 7ada 7adb +205a 51e 7adb 8d97 +51e 576a 1143 1144 +51f 520 1145 7add +51f 205a 8c73 8d97 +51f 205c 7add 7adf +51f 205e 7adf 8c73 +51f 578c 1144 1145 +520 521 1146 8d9e +205c 520 7add 8d9e +520 57ae 1145 1146 +521 522 1147 8c33 +521 205c 7ae1 8d9e +205f 521 7ae1 8c33 +521 57d0 1146 1147 +205f 522 8c33 8cbd +2065 522 8cbd 8d8b +522 57f2 1147 1148 +57d1 523 3567 3568 +57af 524 3566 3567 +578d 525 3565 3566 +576b 526 3564 3565 +5749 527 3563 3564 +5727 528 3562 3563 +5705 529 3561 3562 +56e3 52a 3560 3561 +56c1 52b 355f 3560 +569f 52c 355e 355f +567d 52d 355d 355e +565b 52e 355c 355d +5639 52f 355b 355c +5617 530 355a 355b +55f5 531 3559 355a +55d3 532 3558 3559 +55b1 533 3557 3558 +558f 534 3556 3557 +556d 535 3555 3556 +554b 536 3554 3555 +5529 537 3553 3554 +5507 538 3552 3553 +54e5 539 3551 3552 +54c3 53a 3550 3551 +54a1 53b 354f 3550 +547f 53c 354e 354f +545d 53d 354d 354e +543b 53e 354c 354d +5419 53f 354b 354c +53f7 540 354a 354b +53d5 541 3549 354a +53b3 542 3548 3549 +5391 543 3547 3548 +536f 544 3546 3547 +534d 545 3545 3546 +532b 546 3544 3545 +5309 547 3543 3544 +52e7 548 3542 3543 +52c5 549 3541 3542 +52a3 54a 3540 3541 +5281 54b 353f 3540 +525f 54c 353e 353f +523d 54d 353d 353e +521b 54e 353c 353d +51f9 54f 353b 353c +51d7 550 353a 353b +51b5 551 3539 353a +552 553 1102 7bc7 +552 2003 7aa0 7bc6 +2004 552 7aa0 7bc7 +552 5b00 1101 1102 +553 554 1103 7bc8 +553 2004 7aa1 7bc7 +2005 553 7aa1 7bc8 +553 5ade 1102 1103 +554 555 1104 7bc9 +554 2005 7aa2 7bc8 +2006 554 7aa2 7bc9 +554 5abc 1103 1104 +555 556 1105 7bca +555 2006 7aa3 7bc9 +2007 555 7aa3 7bca +555 5a9a 1104 1105 +556 557 1106 7bcb +556 2007 7aa4 7bca +2008 556 7aa4 7bcb +556 5a78 1105 1106 +557 558 1107 7bcc +557 2008 7aa5 7bcb +2009 557 7aa5 7bcc +557 5a56 1106 1107 +558 559 1108 7bcd +558 2009 7aa6 7bcc +200a 558 7aa6 7bcd +558 5a34 1107 1108 +559 55a 1109 7bce +559 200a 7aa7 7bcd +200b 559 7aa7 7bce +559 5a12 1108 1109 +55a 55b 110a 7bcf +55a 200b 7aa8 7bce +200c 55a 7aa8 7bcf +55a 59f0 1109 110a +55b 55c 110b 7bd0 +55b 200c 7aa9 7bcf +200d 55b 7aa9 7bd0 +55b 59ce 110a 110b +55c 55d 110c 7bd1 +55c 200d 7aaa 7bd0 +200e 55c 7aaa 7bd1 +55c 59ac 110b 110c +55d 55e 110d 7bd2 +55d 200e 7aab 7bd1 +200f 55d 7aab 7bd2 +55d 598a 110c 110d +55e 55f 110e 7bd3 +1f43 55e 7aac 7bd3 +55e 200f 7aac 7bd2 +55e 5968 110d 110e +55f 560 110f 7bd4 +7f0 55f 7aad 7bd4 +55f 1f43 7aad 7bd3 +55f 5946 110e 110f +560 561 1110 7bd5 +560 7f0 4d52 7bd4 +7f1 560 4d52 7bd5 +560 5924 110f 1110 +561 562 1111 7aaf +7f1 561 7bd5 7bd7 +561 2010 7aaf 7bd7 +561 5902 1110 1111 +562 563 1112 7bd8 +2010 562 7aaf 7ab0 +2011 562 7ab0 7bd8 +562 58e0 1111 1112 +563 564 1113 7bd9 +563 2011 7ab1 7bd8 +2013 563 7ab1 7bd9 +563 58be 1112 1113 +564 565 1114 7caf +2013 564 7bd9 7caf +564 589c 1113 1114 +565 566 1115 7cad +565 2013 7caa 7caf +216e 565 7caa 7cad +565 587a 1114 1115 +566 567 1116 8364 +216e 566 7cad 8364 +566 5858 1115 1116 +567 568 1117 80e3 +567 216e 80e3 8364 +567 5836 1116 1117 +216c 568 7ca9 7d34 +568 216e 7ca9 80e3 +568 5814 1117 1118 +56a 569 3410 3411 +5adf 569 3411 3521 +569 5b1f 3410 3520 +56b 56a 3300 3301 +5ae0 56a 3301 3411 +56a 5b3e 3300 3410 +56c 56b 31f0 31f1 +5ae1 56b 31f1 3301 +56b 5b5d 31f0 3300 +56d 56c 30e0 30e1 +5ae2 56c 30e1 31f1 +56c 5b7c 30e0 31f0 +56e 56d 2fd0 2fd1 +5ae3 56d 2fd1 30e1 +56d 5b9b 2fd0 30e0 +56f 56e 2ec0 2ec1 +5ae4 56e 2ec1 2fd1 +56e 5bba 2ec0 2fd0 +570 56f 2db0 2db1 +5ae5 56f 2db1 2ec1 +56f 5bd9 2db0 2ec0 +571 570 2ca0 2ca1 +5ae6 570 2ca1 2db1 +570 5bf8 2ca0 2db0 +572 571 2b90 2b91 +5ae7 571 2b91 2ca1 +571 5c17 2b90 2ca0 +573 572 2a80 2a81 +5ae8 572 2a81 2b91 +572 5c36 2a80 2b90 +574 573 2970 2971 +5ae9 573 2971 2a81 +573 5c55 2970 2a80 +575 574 2860 2861 +5aea 574 2861 2971 +574 5c74 2860 2970 +576 575 2750 2751 +5aeb 575 2751 2861 +575 5c93 2750 2860 +577 576 2640 2641 +5aec 576 2641 2751 +576 5cb2 2640 2750 +578 577 2530 2531 +5aed 577 2531 2641 +577 5cd1 2530 2640 +579 578 2420 2421 +5aee 578 2421 2531 +578 5cf0 2420 2530 +57a 579 2310 2311 +5aef 579 2311 2421 +579 5d0f 2310 2420 +57b 57a 2200 2201 +5af0 57a 2201 2311 +57a 5d2e 2200 2310 +57c 57b 20f0 20f1 +5af1 57b 20f1 2201 +57b 5d4d 20f0 2200 +57d 57c 1fe0 1fe1 +5af2 57c 1fe1 20f1 +57c 5d6c 1fe0 20f0 +57e 57d 1ed0 1ed1 +5af3 57d 1ed1 1fe1 +57d 5d8b 1ed0 1fe0 +57f 57e 1dc0 1dc1 +5af4 57e 1dc1 1ed1 +57e 5daa 1dc0 1ed0 +580 57f 1cb0 1cb1 +5af5 57f 1cb1 1dc1 +57f 5dc9 1cb0 1dc0 +581 580 1ba0 1ba1 +5af6 580 1ba1 1cb1 +580 5de8 1ba0 1cb0 +582 581 1a90 1a91 +5af7 581 1a91 1ba1 +581 5e07 1a90 1ba0 +583 582 1980 1981 +5af8 582 1981 1a91 +582 5e26 1980 1a90 +584 583 1870 1871 +5af9 583 1871 1981 +583 5e45 1870 1980 +585 584 1760 1761 +5afa 584 1761 1871 +584 5e64 1760 1870 +586 585 1650 1651 +5afb 585 1651 1761 +585 5e83 1650 1760 +587 586 1540 1541 +5afc 586 1541 1651 +586 5ea2 1540 1650 +588 587 1430 1431 +5afd 587 1431 1541 +587 5ec1 1430 1540 +589 588 1320 1321 +5afe 588 1321 1431 +588 5ee0 1320 1430 +58a 589 1210 1211 +5aff 589 1211 1321 +589 5eff 1210 1320 +5b00 58a 1101 1211 +58a 5f1e 1100 1210 +57f3 58b 3537 3538 +5815 58c 3536 3537 +5837 58d 3535 3536 +5859 58e 3534 3535 +587b 58f 3533 3534 +589d 590 3532 3533 +58bf 591 3531 3532 +58e1 592 3530 3531 +5903 593 352f 3530 +5925 594 352e 352f +5947 595 352d 352e +5969 596 352c 352d +598b 597 352b 352c +59ad 598 352a 352b +59cf 599 3529 352a +59f1 59a 3528 3529 +5a13 59b 3527 3528 +5a35 59c 3526 3527 +5a57 59d 3525 3526 +5a79 59e 3524 3525 +5a9b 59f 3523 3524 +5abd 5a0 3522 3523 +5adf 5a1 3521 3522 +5b1f 5a2 351f 3520 +5b1e 5a3 351e 351f +5b1d 5a4 351d 351e +5b1c 5a5 351c 351d +5b1b 5a6 351b 351c +5b1a 5a7 351a 351b +5b19 5a8 3519 351a +5b18 5a9 3518 3519 +5b17 5aa 3517 3518 +5b16 5ab 3516 3517 +5b15 5ac 3515 3516 +5b14 5ad 3514 3515 +5b13 5ae 3513 3514 +5b12 5af 3512 3513 +5b11 5b0 3511 3512 +5b10 5b1 3510 3511 +5b0f 5b2 350f 3510 +5b0e 5b3 350e 350f +5b0d 5b4 350d 350e +5b0c 5b5 350c 350d +5b0b 5b6 350b 350c +5b0a 5b7 350a 350b +5b09 5b8 3509 350a +5b08 5b9 3508 3509 +5b07 5ba 3507 3508 +5b06 5bb 3506 3507 +5b05 5bc 3505 3506 +5b04 5bd 3504 3505 +5b03 5be 3503 3504 +5b02 5bf 3502 3503 +5b01 5c0 3501 3502 +5c1 5c2 10e2 7ba2 +5c1 1fe0 7a7d 7ba1 +1fe1 5c1 7a7d 7a7e +1fe2 5c1 7a7e 7ba2 +5c1 5f00 10e1 10e2 +5c2 5c3 10e3 7ba3 +5c2 1fe2 7a7f 7ba2 +1fe3 5c2 7a7f 7ba3 +5c2 5f01 10e2 10e3 +5c3 5c4 10e4 7ba4 +c64 5c3 7a80 7ba4 +5c3 1fe3 7a80 7ba3 +5c3 5f02 10e3 10e4 +5c4 5c5 10e5 7ba5 +5c4 c64 7a81 7ba4 +1fe4 5c4 7a81 7ba5 +5c4 5f03 10e4 10e5 +5c5 5c6 10e6 7ba6 +5c5 1fe4 7a82 7ba5 +1fe5 5c5 7a82 7ba6 +5c5 5f04 10e5 10e6 +5c6 5c7 10e7 7ba7 +5c6 1fe5 7a84 7ba6 +1fe7 5c6 7a84 7ba7 +5c6 5f05 10e6 10e7 +5c7 5c8 10e8 7ba9 +5c7 1fe7 7a85 7ba7 +1fe8 5c7 7a85 7ba9 +5c7 5f06 10e7 10e8 +5c8 5c9 10e9 7bab +5c8 1fe8 7a86 7ba9 +1fe9 5c8 7a86 7bab +5c8 5f07 10e8 10e9 +5c9 5ca 10ea 7bac +5c9 1fe9 7a87 7bab +1fea 5c9 7a87 7bac +5c9 5f08 10e9 10ea +5ca 5cb 10eb 7bad +5ca 1fea 7a88 7bac +1feb 5ca 7a88 7bad +5ca 5f09 10ea 10eb +5cb 5cc 10ec 7bae +5cb 1feb 7a89 7bad +1fec 5cb 7a89 7bae +5cb 5f0a 10eb 10ec +5cc 5cd 10ed 7baf +5cc 1fec 7a8a 7bae +1fed 5cc 7a8a 7baf +5cc 5f0b 10ec 10ed +5cd 5ce 10ee 7bb0 +5cd 1fed 7a8b 7baf +1fee 5cd 7a8b 7bb0 +5cd 5f0c 10ed 10ee +5ce 5cf 10ef 7bb1 +1fee 5ce 7bb0 7bb1 +5ce 5f0d 10ee 10ef +5cf 5d0 10f0 7bb2 +5cf 1fee 7a8c 7bb1 +1fef 5cf 7a8c 7bb2 +5cf 5f0e 10ef 10f0 +5d0 5d1 10f1 7bb3 +5d0 1fef 7a8d 7bb2 +1ff0 5d0 7a8d 7bb3 +5d0 5f0f 10f0 10f1 +5d1 5d2 10f2 7bb4 +5d1 1ff0 7a8e 7bb3 +1ff1 5d1 7a8e 7bb4 +5d1 5f10 10f1 10f2 +5d2 5d3 10f3 7bb5 +5d2 1ff1 7a8f 7bb4 +1ff2 5d2 7a8f 7bb5 +5d2 5f11 10f2 10f3 +5d3 5d4 10f4 7bb6 +5d3 1ff2 7a90 7bb5 +1ff3 5d3 7a90 7bb6 +5d3 5f12 10f3 10f4 +5d4 5d5 10f5 7bb7 +5d4 1ff3 7a91 7bb6 +1ff4 5d4 7a91 7bb7 +5d4 5f13 10f4 10f5 +5d5 5d6 10f6 7bb8 +5d5 1ff4 7a92 7bb7 +1ff5 5d5 7a92 7bb8 +5d5 5f14 10f5 10f6 +5d6 5d7 10f7 7bb9 +5d6 1ff5 7a93 7bb8 +1ff6 5d6 7a93 7bb9 +5d6 5f15 10f6 10f7 +5d7 5d8 10f8 7bba +5d7 1ff6 7a94 7bb9 +1ff7 5d7 7a94 7bba +5d7 5f16 10f7 10f8 +5d8 5d9 10f9 7bbb +5d8 1ff7 7a95 7bba +1ff8 5d8 7a95 7bbb +5d8 5f17 10f8 10f9 +5d9 5da 10fa 7bbc +5d9 1ff8 7a96 7bbb +1ff9 5d9 7a96 7bbc +5d9 5f18 10f9 10fa +5da 5db 10fb 7bbd +5da 1ff9 7a97 7bbc +1ffa 5da 7a97 7bbd +5da 5f19 10fa 10fb +5db 5dc 10fc 7bbf +5db 1ffa 7a98 7bbd +1ffb 5db 7a98 7bbf +5db 5f1a 10fb 10fc +5dc 5dd 10fd 7a9a +1ffb 5dc 7bbf 7bc1 +5dc 1ffe 7a9a 7a9c +5dc 1fff 7a9c 7bc1 +5dc 5f1b 10fc 10fd +5dd 5de 10fe 7bc2 +1ffe 5dd 7a9a 7a9d +2001 5dd 7a9d 7bc2 +5dd 5f1c 10fd 10fe +5de 5df 10ff 7bc4 +5de 2001 7a9e 7bc2 +2002 5de 7a9e 7bc4 +5de 5f1d 10fe 10ff +5df 2002 7a9f 7bc4 +2003 5df 7a9f 7bc5 +5df 5f1e 10ff 1100 +5f1f 5e0 10af 10b0 +5f20 5e1 10ae 10af +5f21 5e2 10ad 10ae +5f22 5e3 10ac 10ad +5f23 5e4 10ab 10ac +5f24 5e5 10aa 10ab +5f25 5e6 10a9 10aa +5f26 5e7 10a8 10a9 +5f27 5e8 10a7 10a8 +5f28 5e9 10a6 10a7 +5f29 5ea 10a5 10a6 +5f2a 5eb 10a4 10a5 +5f2b 5ec 10a3 10a4 +5f2c 5ed 10a2 10a3 +5f2d 5ee 10a1 10a2 +5f2e 5ef 10a0 10a1 +5f2f 5f0 109f 10a0 +5f30 5f1 109e 109f +5f31 5f2 109d 109e +5f32 5f3 109c 109d +5f33 5f4 109b 109c +5f34 5f5 109a 109b +5f35 5f6 1099 109a +5f36 5f7 1098 1099 +5f37 5f8 1097 1098 +5f38 5f9 1096 1097 +5f39 5fa 1095 1096 +5f3a 5fb 1094 1095 +5f3b 5fc 1093 1094 +5f3c 5fd 1092 1093 +5f3d 5fe 1091 1092 +600 5ff 1000 1001 +5f3d 5ff 1001 1091 +5ff 67f5 1000 1090 +601 600 f70 f71 +5f5c 600 f71 1001 +600 6834 f70 1000 +602 601 ee0 ee1 +5f7b 601 ee1 f71 +601 6873 ee0 f70 +603 602 e50 e51 +5f9a 602 e51 ee1 +602 68b2 e50 ee0 +604 603 dc0 dc1 +5fb9 603 dc1 e51 +603 68f1 dc0 e50 +605 604 d30 d31 +5fd8 604 d31 dc1 +604 6930 d30 dc0 +606 605 ca0 ca1 +5ff7 605 ca1 d31 +605 696f ca0 d30 +607 606 c10 c11 +6016 606 c11 ca1 +606 69ae c10 ca0 +608 607 b80 b81 +6035 607 b81 c11 +607 69ed b80 c10 +609 608 af0 af1 +6054 608 af1 b81 +608 6a2c af0 b80 +60a 609 a60 a61 +6073 609 a61 af1 +609 6a6b a60 af0 +60b 60a 9d0 9d1 +6092 60a 9d1 a61 +60a 6aaa 9d0 a60 +60c 60b 940 941 +60b1 60b 941 9d1 +60b 6ae9 940 9d0 +60d 60c 8b0 8b1 +60d0 60c 8b1 941 +60c 6b28 8b0 940 +60e 60d 820 821 +60ef 60d 821 8b1 +60d 6b67 820 8b0 +60f 60e 790 791 +610e 60e 791 821 +60e 6ba6 790 820 +610 60f 700 701 +612d 60f 701 791 +60f 6be5 700 790 +611 610 670 671 +614c 610 671 701 +610 6c24 670 700 +612 611 5e0 5e1 +616b 611 5e1 671 +611 6c63 5e0 670 +613 612 550 551 +618a 612 551 5e1 +612 6ca2 550 5e0 +614 613 4c0 4c1 +61a9 613 4c1 551 +613 6ce1 4c0 550 +615 614 430 431 +61c8 614 431 4c1 +614 6d20 430 4c0 +616 615 3a0 3a1 +61e7 615 3a1 431 +615 6d5f 3a0 430 +617 616 310 311 +6206 616 311 3a1 +616 6d9e 310 3a0 +618 617 280 281 +6225 617 281 311 +617 6ddd 280 310 +619 618 1f0 1f1 +6244 618 1f1 281 +618 6e1c 1f0 280 +61a 619 160 161 +6263 619 161 1f1 +619 6e5b 160 1f0 +61b 61a d0 d1 +6282 61a d1 161 +61a 6e9a d0 160 +62a1 61b 41 d1 +61b 6ed9 40 d0 +61d 61c 5f 7d0b +1f44 61c 7c7a 7c7c +61c 213d 7c7a 7d0b +2140 61c 7c7c 7d0c +61c 6283 5f 60 +61e 61d 5e 7d0a +61d 213c 7c78 7d0a +213d 61d 7c78 7d0b +61d 6284 5e 5f +61f 61e 5d 7d09 +61e 213b 7c77 7d09 +213c 61e 7c77 7d0a +61e 6285 5d 5e +620 61f 5c 7c76 +213b 61f 7c76 7d09 +61f 6286 5c 5d +621 620 5b 8d47 +620 2139 7c75 8c65 +620 213a 8c65 8d47 +213b 620 7c75 7c76 +620 6287 5b 5c +622 621 5a 8cf1 +213a 621 8cf1 8d47 +621 6288 5a 5b +623 622 59 8c83 +622 2138 8c02 8c83 +213a 622 8c02 8cf1 +622 6289 59 5a +624 623 58 8cfb +623 2135 7c70 8cfb +2136 623 7c70 8cf0 +623 2138 8c83 8cf0 +623 628a 58 59 +625 624 57 8c7e +2135 624 8c7e 8cfb +624 628b 57 58 +626 625 56 8d16 +625 2131 7c6b 8d16 +2132 625 7c6b 8cfa +625 2135 8c7e 8cfa +625 628c 56 57 +627 626 55 8c6a +2131 626 8c6a 8d16 +626 628d 55 56 +628 627 54 7d07 +212f 627 7d07 8055 +2131 627 7c6c 8c6a +627 2133 7c6c 8055 +627 628e 54 55 +629 628 53 7c69 +212f 628 7c69 7d07 +628 628f 53 54 +62a 629 52 7d05 +629 212f 7c69 7c6a +629 2130 7c6a 7d05 +629 6290 52 53 +62b 62a 51 7d04 +212e 62a 7d04 7d06 +62a 2130 7d05 7d06 +62a 6291 51 52 +62c 62b 50 7d03 +62b 212d 7c68 7d03 +212e 62b 7c68 7d04 +62b 6292 50 51 +62d 62c 4f 7d02 +62c 212c 7c67 7d02 +212d 62c 7c67 7d03 +62c 6293 4f 50 +62e 62d 4e 7d01 +62d 212b 7c66 7d01 +212c 62d 7c66 7d02 +62d 6294 4e 4f +62f 62e 4d 7d00 +62e 212a 7c65 7d00 +212b 62e 7c65 7d01 +62e 6295 4d 4e +630 62f 4c 7cff +62f 2129 7c64 7cff +212a 62f 7c64 7d00 +62f 6296 4c 4d +631 630 4b 7cfe +630 1f36 7c63 7cfe +2129 630 7c63 7cff +630 6297 4b 4c +632 631 4a 7cfd +1f36 631 7c61 7cfe +631 2126 7c61 7cfd +631 6298 4a 4b +633 632 49 7cfb +632 2125 7c5f 7cfb +2126 632 7c5f 7cfd +632 6299 49 4a +634 633 48 7cfa +633 2124 7c5e 7cfa +2125 633 7c5e 7cfb +633 629a 48 49 +635 634 47 7cf9 +634 2123 7c5d 7cf9 +2124 634 7c5d 7cfa +634 629b 47 48 +636 635 46 7cf8 +635 2122 7c5c 7cf8 +2123 635 7c5c 7cf9 +635 629c 46 47 +637 636 45 7cf7 +636 2121 7c5b 7cf7 +2122 636 7c5b 7cf8 +636 629d 45 46 +638 637 44 7cf6 +637 2120 7c5a 7cf6 +2121 637 7c5a 7cf7 +637 629e 44 45 +639 638 43 7cf5 +638 211f 7c59 7cf5 +2120 638 7c59 7cf6 +638 629f 43 44 +63a 639 42 7cf4 +639 211e 7c58 7cf4 +211f 639 7c58 7cf5 +639 62a0 42 43 +63a 211d 7c57 7cf3 +211e 63a 7c57 7cf4 +63a 62a1 41 42 +63c 63b 1020 1021 +63b 5f1f 1020 10b0 +62d0 63b 1021 10b1 +63d 63c f90 f91 +63c 5f3e f90 1020 +62ff 63c f91 1021 +63e 63d f00 f01 +63d 5f5d f00 f90 +632e 63d f01 f91 +63f 63e e70 e71 +63e 5f7c e70 f00 +635d 63e e71 f01 +640 63f de0 de1 +63f 5f9b de0 e70 +638c 63f de1 e71 +641 640 d50 d51 +640 5fba d50 de0 +63bb 640 d51 de1 +642 641 cc0 cc1 +641 5fd9 cc0 d50 +63ea 641 cc1 d51 +643 642 c30 c31 +642 5ff8 c30 cc0 +6419 642 c31 cc1 +644 643 ba0 ba1 +643 6017 ba0 c30 +6448 643 ba1 c31 +645 644 b10 b11 +644 6036 b10 ba0 +6477 644 b11 ba1 +646 645 a80 a81 +645 6055 a80 b10 +64a6 645 a81 b11 +647 646 9f0 9f1 +646 6074 9f0 a80 +64d5 646 9f1 a81 +648 647 960 961 +647 6093 960 9f0 +6504 647 961 9f1 +649 648 8d0 8d1 +648 60b2 8d0 960 +6533 648 8d1 961 +64a 649 840 841 +649 60d1 840 8d0 +6562 649 841 8d1 +64b 64a 7b0 7b1 +64a 60f0 7b0 840 +6591 64a 7b1 841 +64c 64b 720 721 +64b 610f 720 7b0 +65c0 64b 721 7b1 +64d 64c 690 691 +64c 612e 690 720 +65ef 64c 691 721 +64e 64d 600 601 +64d 614d 600 690 +661e 64d 601 691 +64f 64e 570 571 +64e 616c 570 600 +664d 64e 571 601 +650 64f 4e0 4e1 +64f 618b 4e0 570 +667c 64f 4e1 571 +651 650 450 451 +650 61aa 450 4e0 +66ab 650 451 4e1 +652 651 3c0 3c1 +651 61c9 3c0 450 +66da 651 3c1 451 +653 652 330 331 +652 61e8 330 3c0 +6709 652 331 3c1 +654 653 2a0 2a1 +653 6207 2a0 330 +6738 653 2a1 331 +655 654 210 211 +654 6226 210 2a0 +6767 654 211 2a1 +656 655 180 181 +655 6245 180 210 +6796 655 181 211 +657 656 f0 f1 +656 6264 f0 180 +67c5 656 f1 181 +657 6283 60 f0 +67f4 657 61 f1 +62a2 658 10df 10e0 +62a3 659 10de 10df +62a4 65a 10dd 10de +62a5 65b 10dc 10dd +62a6 65c 10db 10dc +62a7 65d 10da 10db +62a8 65e 10d9 10da +62a9 65f 10d8 10d9 +62aa 660 10d7 10d8 +62ab 661 10d6 10d7 +62ac 662 10d5 10d6 +62ad 663 10d4 10d5 +62ae 664 10d3 10d4 +62af 665 10d2 10d3 +62b0 666 10d1 10d2 +62b1 667 10d0 10d1 +62b2 668 10cf 10d0 +62b3 669 10ce 10cf +62b4 66a 10cd 10ce +62b5 66b 10cc 10cd +62b6 66c 10cb 10cc +62b7 66d 10ca 10cb +62b8 66e 10c9 10ca +62b9 66f 10c8 10c9 +62ba 670 10c7 10c8 +62bb 671 10c6 10c7 +62bc 672 10c5 10c6 +62bd 673 10c4 10c5 +62be 674 10c3 10c4 +62bf 675 10c2 10c3 +62c0 676 10c1 10c2 +62c1 677 10c0 10c1 +62c2 678 10bf 10c0 +62c3 679 10be 10bf +62c4 67a 10bd 10be +62c5 67b 10bc 10bd +62c6 67c 10bb 10bc +62c7 67d 10ba 10bb +62c8 67e 10b9 10ba +62c9 67f 10b8 10b9 +62ca 680 10b7 10b8 +62cb 681 10b6 10b7 +62cc 682 10b5 10b6 +62cd 683 10b4 10b5 +62ce 684 10b3 10b4 +62cf 685 10b2 10b3 +62d0 686 10b1 10b2 +688 687 8f 7d33 +687 216d 7cae 7d33 +2172 687 7cae 7d35 +687 67c6 8f 90 +689 688 8e 7d32 +688 216a 7ca7 7d32 +216d 688 7ca7 7d33 +688 67c7 8e 8f +68a 689 8d 7d2f +689 2167 7ca4 7d2f +216a 689 7ca4 7d32 +689 67c8 8d 8e +68b 68a 8c 7d2d +68a 2161 7ca1 7d2d +2167 68a 7ca1 7d2f +68a 67c9 8c 8d +68c 68b 8b 7d2c +68b 2160 7c9e 7d2c +2161 68b 7c9e 7d2d +68b 67ca 8b 8c +68d 68c 8a 7d2b +68c 215f 7c9d 7d2b +2160 68c 7c9d 7d2c +68c 67cb 8a 8b +68e 68d 89 7d2a +68d 2014 7c9c 7d2a +215f 68d 7c9c 7d2b +68d 67cc 89 8a +68f 68e 88 7d29 +2014 68e 7c9b 7d2a +68e 215e 7c9b 7d29 +68e 67cd 88 89 +690 68f 87 7d28 +68f 215b 7c9a 7d28 +215e 68f 7c9a 7d29 +68f 67ce 87 88 +691 690 86 7d27 +215b 690 7c99 7d28 +690 215d 7c99 7d27 +690 67cf 86 87 +692 691 85 7d26 +691 215a 7c98 7d26 +215d 691 7c98 7d27 +691 67d0 85 86 +693 692 84 7d25 +692 2159 7c96 7d25 +215a 692 7c96 7d26 +692 67d1 84 85 +694 693 83 7d24 +2159 693 7d24 7d25 +693 67d2 83 84 +695 694 82 7d23 +694 2158 7c95 7d23 +2159 694 7c95 7d24 +694 67d3 82 83 +696 695 81 7d22 +695 2157 7c94 7d22 +2158 695 7c94 7d23 +695 67d4 81 82 +697 696 80 7d21 +696 2156 7c93 7d21 +2157 696 7c93 7d22 +696 67d5 80 81 +698 697 7f 7d20 +697 2155 7c92 7d20 +2156 697 7c92 7d21 +697 67d6 7f 80 +699 698 7e 7d1f +698 2154 7c91 7d1f +2155 698 7c91 7d20 +698 67d7 7e 7f +69a 699 7d 7d1e +699 2153 7c90 7d1e +2154 699 7c90 7d1f +699 67d8 7d 7e +69b 69a 7c 7d1d +69a 2152 7c8f 7d1d +2153 69a 7c8f 7d1e +69a 67d9 7c 7d +69c 69b 7b 7d1c +69b 2151 7c8e 7d1c +2152 69b 7c8e 7d1d +69b 67da 7b 7c +69d 69c 7a 7d1b +69c 2150 7c8d 7d1b +2151 69c 7c8d 7d1c +69c 67db 7a 7b +69e 69d 79 7d1a +69d 214f 7c8c 7d1a +2150 69d 7c8c 7d1b +69d 67dc 79 7a +69f 69e 78 7d19 +69e 214e 7c8b 7d19 +214f 69e 7c8b 7d1a +69e 67dd 78 79 +6a0 69f 77 7d18 +69f 214d 7c8a 7d18 +214e 69f 7c8a 7d19 +69f 67de 77 78 +6a1 6a0 76 7d17 +6a0 214c 7c89 7d17 +214d 6a0 7c89 7d18 +6a0 67df 76 77 +6a2 6a1 75 7d16 +6a1 214b 7c88 7d16 +214c 6a1 7c88 7d17 +6a1 67e0 75 76 +6a3 6a2 74 7d15 +6a2 214a 7c87 7d15 +214b 6a2 7c87 7d16 +6a2 67e1 74 75 +6a4 6a3 73 7d14 +6a3 2149 7c86 7d14 +214a 6a3 7c86 7d15 +6a3 67e2 73 74 +6a5 6a4 72 7d13 +6a4 2148 7c85 7d13 +2149 6a4 7c85 7d14 +6a4 67e3 72 73 +6a6 6a5 71 7d12 +6a5 2146 7c84 7d12 +2148 6a5 7c84 7d13 +6a5 67e4 71 72 +6a7 6a6 70 7d11 +6a6 2145 7c82 7d11 +2146 6a6 7c82 7d12 +6a6 67e5 70 71 +6a8 6a7 6f 7c80 +2144 6a7 7c80 7c81 +2145 6a7 7c81 7d11 +6a7 67e6 6f 70 +6a9 6a8 6e 8d75 +6a8 2144 7c80 8c94 +24a4 6a8 82f8 8c94 +6a8 24a6 82f8 8d75 +6a8 67e7 6e 6f +6aa 6a9 6d 82f9 +24a6 6a9 8c25 8d75 +24a7 6a9 82f9 8c25 +6a9 67e8 6d 6e +6ab 6aa 6c 8ea7 +6aa 24a7 82f9 82fa +6aa 24a8 82fa 8ea7 +6aa 67e9 6c 6d +6ac 6ab 6b 8d34 +24a8 6ab 8d34 8ea7 +6ab 67ea 6b 6c +6ad 6ac 6a 8ebe +24a8 6ac 82fc 8d34 +6ac 24a9 82fc 8ebe +6ac 67eb 6a 6b +6ae 6ad 69 8e35 +24a1 6ad 8e35 8f16 +6ad 24a9 8ebe 8f16 +6ad 67ec 69 6a +6af 6ae 68 8f14 +6ae 24a1 8e35 8f14 +6ae 67ed 68 69 +6b0 6af 67 8ec5 +24a1 6af 82f5 8f14 +6af 24a2 82f5 8ec5 +6af 67ee 67 68 +6b1 6b0 66 8e51 +24a2 6b0 82ff 8ec5 +6b0 24af 82ff 8e51 +6b0 67ef 66 67 +6b2 6b1 65 8c92 +24ae 6b1 8c92 8ec4 +6b1 24af 8e51 8ec4 +6b1 67f0 65 66 +6b3 6b2 64 7d10 +2143 6b2 7d10 8a95 +24ae 6b2 8a95 8c92 +6b2 67f1 64 65 +6b4 6b3 63 7d0f +2143 6b3 7d0f 7d10 +6b3 67f2 63 64 +6b5 6b4 62 7d0e +6b4 2142 7c7f 7d0e +2143 6b4 7c7f 7d0f +6b4 67f3 62 63 +6b5 2141 7c7e 7d0d +2142 6b5 7c7e 7d0e +6b5 67f4 61 62 +6b6 6b7 fc1 1050 +6b6 62a2 1050 10e0 +6833 6b6 fc1 1051 +6b7 6b8 f31 fc0 +6b7 62d1 fc0 1050 +6872 6b7 f31 fc1 +6b8 6b9 ea1 f30 +6b8 6300 f30 fc0 +68b1 6b8 ea1 f31 +6b9 6ba e11 ea0 +6b9 632f ea0 f30 +68f0 6b9 e11 ea1 +6ba 6bb d81 e10 +6ba 635e e10 ea0 +692f 6ba d81 e11 +6bb 6bc cf1 d80 +6bb 638d d80 e10 +696e 6bb cf1 d81 +6bc 6bd c61 cf0 +6bc 63bc cf0 d80 +69ad 6bc c61 cf1 +6bd 6be bd1 c60 +6bd 63eb c60 cf0 +69ec 6bd bd1 c61 +6be 6bf b41 bd0 +6be 641a bd0 c60 +6a2b 6be b41 bd1 +6bf 6c0 ab1 b40 +6bf 6449 b40 bd0 +6a6a 6bf ab1 b41 +6c0 6c1 a21 ab0 +6c0 6478 ab0 b40 +6aa9 6c0 a21 ab1 +6c1 6c2 991 a20 +6c1 64a7 a20 ab0 +6ae8 6c1 991 a21 +6c2 6c3 901 990 +6c2 64d6 990 a20 +6b27 6c2 901 991 +6c3 6c4 871 900 +6c3 6505 900 990 +6b66 6c3 871 901 +6c4 6c5 7e1 870 +6c4 6534 870 900 +6ba5 6c4 7e1 871 +6c5 6c6 751 7e0 +6c5 6563 7e0 870 +6be4 6c5 751 7e1 +6c6 6c7 6c1 750 +6c6 6592 750 7e0 +6c23 6c6 6c1 751 +6c7 6c8 631 6c0 +6c7 65c1 6c0 750 +6c62 6c7 631 6c1 +6c8 6c9 5a1 630 +6c8 65f0 630 6c0 +6ca1 6c8 5a1 631 +6c9 6ca 511 5a0 +6c9 661f 5a0 630 +6ce0 6c9 511 5a1 +6ca 6cb 481 510 +6ca 664e 510 5a0 +6d1f 6ca 481 511 +6cb 6cc 3f1 480 +6cb 667d 480 510 +6d5e 6cb 3f1 481 +6cc 6cd 361 3f0 +6cc 66ac 3f0 480 +6d9d 6cc 361 3f1 +6cd 6ce 2d1 360 +6cd 66db 360 3f0 +6ddc 6cd 2d1 361 +6ce 6cf 241 2d0 +6ce 670a 2d0 360 +6e1b 6ce 241 2d1 +6cf 6d0 1b1 240 +6cf 6739 240 2d0 +6e5a 6cf 1b1 241 +6d0 6d1 121 1b0 +6d0 6768 1b0 240 +6e99 6d0 121 1b1 +6d1 6d2 91 120 +6d1 6797 120 1b0 +6ed8 6d1 91 121 +6d2 67c6 90 120 +6f17 6d2 1 91 +67f5 6d3 108f 1090 +67f6 6d4 108e 108f +67f7 6d5 108d 108e +67f8 6d6 108c 108d +67f9 6d7 108b 108c +67fa 6d8 108a 108b +67fb 6d9 1089 108a +67fc 6da 1088 1089 +67fd 6db 1087 1088 +67fe 6dc 1086 1087 +67ff 6dd 1085 1086 +6800 6de 1084 1085 +6801 6df 1083 1084 +6802 6e0 1082 1083 +6803 6e1 1081 1082 +6804 6e2 1080 1081 +6805 6e3 107f 1080 +6806 6e4 107e 107f +6807 6e5 107d 107e +6808 6e6 107c 107d +6809 6e7 107b 107c +680a 6e8 107a 107b +680b 6e9 1079 107a +680c 6ea 1078 1079 +680d 6eb 1077 1078 +680e 6ec 1076 1077 +680f 6ed 1075 1076 +6810 6ee 1074 1075 +6811 6ef 1073 1074 +6812 6f0 1072 1073 +6813 6f1 1071 1072 +6814 6f2 1070 1071 +6815 6f3 106f 1070 +6816 6f4 106e 106f +6817 6f5 106d 106e +6818 6f6 106c 106d +6819 6f7 106b 106c +681a 6f8 106a 106b +681b 6f9 1069 106a +681c 6fa 1068 1069 +681d 6fb 1067 1068 +681e 6fc 1066 1067 +681f 6fd 1065 1066 +6820 6fe 1064 1065 +6821 6ff 1063 1064 +6822 700 1062 1063 +6823 701 1061 1062 +6824 702 1060 1061 +6825 703 105f 1060 +6826 704 105e 105f +6827 705 105d 105e +6828 706 105c 105d +6829 707 105b 105c +682a 708 105a 105b +682b 709 1059 105a +682c 70a 1058 1059 +682d 70b 1057 1058 +682e 70c 1056 1057 +682f 70d 1055 1056 +6830 70e 1054 1055 +6831 70f 1053 1054 +6832 710 1052 1053 +6833 711 1051 1052 +713 712 3f 7cf1 +712 211b 7c55 7cf1 +211c 712 7c55 7cf2 +712 6ed9 3f 40 +714 713 3e 7cf0 +713 2119 7c53 7cf0 +211a 713 7c53 7c54 +211b 713 7c54 7cf1 +713 6eda 3e 3f +715 714 3d 7cef +714 2118 7c52 7cef +2119 714 7c52 7cf0 +714 6edb 3d 3e +716 715 3c 7cee +715 2117 7c51 7cee +2118 715 7c51 7cef +715 6edc 3c 3d +717 716 3b 7ced +716 2116 7c50 7ced +2117 716 7c50 7cee +716 6edd 3b 3c +718 717 3a 7cec +717 2115 7c4f 7cec +2116 717 7c4f 7ced +717 6ede 3a 3b +719 718 39 7ceb +718 2114 7c4e 7ceb +2115 718 7c4e 7cec +718 6edf 39 3a +71a 719 38 7cea +719 2113 7c4d 7cea +2114 719 7c4d 7ceb +719 6ee0 38 39 +71b 71a 37 7ce9 +71a 2112 7c4c 7ce9 +2113 71a 7c4c 7cea +71a 6ee1 37 38 +71c 71b 36 7ce8 +71b 2111 7c4b 7ce8 +2112 71b 7c4b 7ce9 +71b 6ee2 36 37 +71d 71c 35 7ce7 +71c 2110 7c4a 7ce7 +2111 71c 7c4a 7ce8 +71c 6ee3 35 36 +71e 71d 34 7ce6 +71d 210f 7c49 7ce6 +2110 71d 7c49 7ce7 +71d 6ee4 34 35 +71f 71e 33 7ce5 +71e 210e 7c48 7ce5 +210f 71e 7c48 7ce6 +71e 6ee5 33 34 +720 71f 32 7ce4 +71f 210d 7c47 7ce4 +210e 71f 7c47 7ce5 +71f 6ee6 32 33 +721 720 31 7ce3 +720 210c 7c46 7ce3 +210d 720 7c46 7ce4 +720 6ee7 31 32 +722 721 30 7ce2 +721 210b 7c45 7ce2 +210c 721 7c45 7ce3 +721 6ee8 30 31 +723 722 2f 7ce1 +722 210a 7c44 7ce1 +210b 722 7c44 7ce2 +722 6ee9 2f 30 +724 723 2e 7ce0 +723 2109 7c43 7ce0 +210a 723 7c43 7ce1 +723 6eea 2e 2f +725 724 2d 7cdf +724 2108 7c42 7cdf +2109 724 7c42 7ce0 +724 6eeb 2d 2e +726 725 2c 7cde +725 2107 7c41 7cde +2108 725 7c41 7cdf +725 6eec 2c 2d +727 726 2b 7cdd +726 2106 7c40 7cdd +2107 726 7c40 7cde +726 6eed 2b 2c +728 727 2a 7cdc +727 2105 7c3f 7cdc +2106 727 7c3f 7cdd +727 6eee 2a 2b +729 728 29 7cdb +728 2104 7c3e 7cdb +2105 728 7c3e 7cdc +728 6eef 29 2a +72a 729 28 7cda +729 2103 7c3d 7cda +2104 729 7c3d 7cdb +729 6ef0 28 29 +72b 72a 27 7cd9 +72a 2102 7c3c 7cd9 +2103 72a 7c3c 7cda +72a 6ef1 27 28 +72c 72b 26 7cd8 +72b 2101 7c3b 7cd8 +2102 72b 7c3b 7cd9 +72b 6ef2 26 27 +72d 72c 25 7cd7 +72c 2100 7c3a 7cd7 +2101 72c 7c3a 7cd8 +72c 6ef3 25 26 +72e 72d 24 7cd6 +72d 20ff 7c39 7cd6 +2100 72d 7c39 7cd7 +72d 6ef4 24 25 +72f 72e 23 7cd5 +72e 1f48 7c38 7cd5 +20ff 72e 7c38 7cd6 +72e 6ef5 23 24 +730 72f 22 7cd4 +1f48 72f 7c37 7cd5 +72f 20fd 7c37 7cd4 +72f 6ef6 22 23 +731 730 21 7cd3 +730 1f5a 7c35 7cd3 +20fd 730 7c35 7cd4 +730 6ef7 21 22 +732 731 20 7cd1 +1f5a 731 7c34 7cd3 +731 1f5c 7c34 7cd1 +731 6ef8 20 21 +733 732 1f 7cd0 +1f5c 732 7c33 7cd1 +732 20fc 7c33 7cd0 +732 6ef9 1f 20 +734 733 1e 7ccf +733 20fb 7c32 7ccf +20fc 733 7c32 7cd0 +733 6efa 1e 1f +735 734 1d 7cce +734 20fa 7c31 7cce +20fb 734 7c31 7ccf +734 6efb 1d 1e +736 735 1c 7ccd +735 20f9 7c30 7ccd +20fa 735 7c30 7cce +735 6efc 1c 1d +737 736 1b 7ccc +736 20f8 7c2f 7ccc +20f9 736 7c2f 7ccd +736 6efd 1b 1c +738 737 1a 7ccb +737 1f58 7c2e 7ccb +20f8 737 7c2e 7ccc +737 6efe 1a 1b +739 738 19 7cca +1f58 738 7c29 7ccb +738 20f5 7c29 7cca +738 6eff 19 1a +73a 739 18 7cc9 +20f5 739 7c2c 7cca +739 20f6 7c2c 7cc9 +739 6f00 18 19 +73b 73a 17 7cc8 +73a 20f3 7c2a 7cc8 +20f6 73a 7c2a 7cc9 +73a 6f01 17 18 +73c 73b 16 7cc7 +73b 20f2 7c27 7cc7 +20f3 73b 7c27 7cc8 +73b 6f02 16 17 +73d 73c 15 7cc6 +73c 13ff 7c26 7cc6 +20f2 73c 7c26 7cc7 +73c 6f03 15 16 +73e 73d 14 7cc5 +13ff 73d 7c25 7cc6 +73d 20f1 7c25 7cc5 +73d 6f04 14 15 +73f 73e 13 7cc4 +73e 20f0 7c23 7cc4 +20f1 73e 7c23 7cc5 +73e 6f05 13 14 +740 73f 12 7c24 +73f 20ef 7c22 7c24 +20f0 73f 7c22 7cc4 +73f 6f06 12 13 +741 740 11 7cc2 +20ee 740 7cc2 7cc3 +740 20ef 7c24 7cc3 +740 6f07 11 12 +742 741 10 7cc1 +741 20ea 7c21 7cc1 +20ee 741 7c21 7cc2 +741 6f08 10 11 +743 742 f 7c1d +20ea 742 7c1d 7cc1 +742 6f09 f 10 +744 743 e 8c60 +743 20ea 7c1d 7c1e +743 20eb 7c1e 8c60 +743 6f0a e f +745 744 d 8d68 +20eb 744 7c1f 8c60 +744 20ec 7c1f 8d68 +744 6f0b d e +746 745 c 7cbf +20ec 745 8caf 8d68 +2182 745 7cbf 8caf +745 6f0c c d +747 746 b 7c20 +20ed 746 7c20 8d83 +746 2182 7cbf 8d83 +746 6f0d b c +748 747 a 8da9 +747 20ed 7c20 7cbd +747 2180 7cbd 8da9 +747 6f0e a b +749 748 9 7cba +217d 748 7cba 8d49 +2180 748 8d49 8da9 +748 6f0f 9 a +74a 749 8 8c91 +749 217d 7cba 8da1 +217e 749 8c91 8da1 +749 6f10 8 9 +74b 74a 7 8d4e +74a 217a 8080 8d4e +217e 74a 8080 8c91 +74a 6f11 7 8 +74c 74b 6 8c36 +217a 74b 8c36 8d4e +74b 6f12 6 7 +74d 74c 5 7d3b +2179 74c 7d3b 8085 +217a 74c 7cb7 8c36 +74c 217b 7cb7 8085 +74c 6f13 5 6 +74e 74d 4 7d3a +2179 74d 7d3a 7d3b +74d 6f14 4 5 +74f 74e 3 7cb3 +2175 74e 7cb3 7cb6 +2179 74e 7cb6 7d3a +74e 6f15 3 4 +750 74f 2 7d37 +74f 2175 7cb3 7cb5 +74f 2178 7cb5 7d37 +74f 6f16 2 3 +2174 750 7cb2 7d39 +750 2178 7d37 7d39 +750 6f17 1 2 +751 752 4c3a 4d55 +7ee 751 4d51 4d56 +751 7f5 4d55 4d56 +752 754 4c3c 4d57 +7f5 752 4d55 4d57 +754 753 4c3d 4d58 +753 755 4c3f 4d59 +7f6 753 4d58 4d59 +7f5 754 4d57 4d5a +754 7f6 4d58 4d5b +7f7 754 4d5a 4d5c +754 7f8 4d5b 4d5c +755 756 4c41 4d5d +7f6 755 4d59 4d5e +755 7f9 4d5d 4d5f +7fa 755 4d5e 4d60 +755 7fb 4d5f 4d60 +756 757 4c43 4d61 +7f9 756 4d5d 4d61 +757 758 4c45 4d62 +7f9 757 4d61 4d63 +757 7fc 4d62 4d64 +7fd 757 4d63 4d65 +757 7fe 4d64 4d65 +758 759 4c47 4d66 +7fc 758 4d62 4d67 +758 7ff 4d66 4d67 +759 75a 4c49 4d68 +7ff 759 4d66 4d69 +759 800 4d68 4d69 +75a 75c 4c4b 4d6a +800 75a 4d68 4d6a +75c 75b 4c4c 4d6b +75b 75e 4c4e 4d6c +801 75b 4d6b 4d6d +75b 802 4d6c 4d6d +800 75c 4d6a 4d6e +75c 801 4d6b 4d6f +803 75c 4d6e 4d6f +75e 75d 4c4f 4d70 +75d 75f 4c51 4d71 +804 75d 4d70 4d72 +75d 805 4d71 4d72 +802 75e 4d6c 4d73 +75e 804 4d70 4d73 +75f 760 4c53 4d74 +805 75f 4d71 4d75 +75f 806 4d74 4d75 +760 762 4c55 4d76 +806 760 4d74 4d76 +762 761 4c56 4d77 +761 763 4c58 4d78 +807 761 4d77 4d79 +761 808 4d78 4d79 +806 762 4d76 4d7a +762 807 4d77 4d7b +809 762 4d7a 4d7b +763 765 4c5a 4d7c +808 763 4d78 4d7c +765 764 4c5b 4d7d +764 766 4c5d 4d7e +80a 764 4d7d 4d7f +764 80b 4d7e 4d7f +808 765 4d7c 4d80 +765 80a 4d7d 4d81 +80c 765 4d80 4d81 +766 767 4c5f 4d82 +80b 766 4d7e 4d83 +766 80d 4d82 4d83 +767 768 4c61 4d84 +80d 767 4d82 4d85 +767 80e 4d84 4d86 +80f 767 4d85 4d86 +768 769 4c63 4d87 +80e 768 4d84 4d87 +769 76b 4c65 4d88 +80e 769 4d87 4d89 +769 810 4d88 4d89 +76b 76a 4c66 4d8a +76a 76c 4c69 4d8a +76b 76c 4d8a 4d8b +76b 76e 4d8b 4d8c +810 76b 4d88 4d8c +76c 76e 4c6b 4d8b +76e 76d 4c6c 4d8d +76d 76f 4c6e 4d8e +811 76d 4d8d 4d8e +810 76e 4d8c 4d8f +76e 811 4d8d 4d90 +812 76e 4d8f 4d90 +76f 770 4c70 4d91 +811 76f 4d8e 4d92 +76f 813 4d91 4d93 +814 76f 4d92 4d93 +770 771 4c72 4d94 +813 770 4d91 4d95 +770 815 4d94 4d95 +771 772 4c74 4d96 +815 771 4d94 4d97 +771 816 4d96 4d97 +772 773 4c76 4d98 +816 772 4d96 4d99 +772 817 4d98 4d9a +818 772 4d99 4d9b +772 819 4d9a 4d9b +773 775 4c78 4d9c +817 773 4d98 4d9c +775 774 4c79 4d9d +774 776 4c7b 4d9e +81a 774 4d9d 4d9f +774 81b 4d9e 4d9f +817 775 4d9c 4da0 +775 81a 4d9d 4da1 +81c 775 4da0 4da1 +776 777 4c7d 4da2 +81b 776 4d9e 4da3 +776 81d 4da2 4da4 +81e 776 4da3 4da4 +777 778 4c7f 4da5 +81d 777 4da2 4da5 +778 77a 4c81 4da6 +81d 778 4da5 4da7 +778 81f 4da6 4da7 +77a 779 4c82 4da8 +779 77c 4c85 4da9 +820 779 4da8 4da9 +81f 77a 4da6 4daa +77a 820 4da8 4dab +821 77a 4daa 4dab +77c 77b 4c86 4dac +77b 77e 4c88 4dad +822 77b 4dac 4dae +77b 823 4dad 4dae +820 77c 4da9 4daf +77c 822 4dac 4db0 +824 77c 4daf 4db0 +77e 77d 4c89 4db1 +77d 77f 4c8b 4db2 +825 77d 4db1 4db3 +77d 826 4db2 4db3 +823 77e 4dad 4db4 +77e 825 4db1 4db4 +77f 781 4c8d 4db5 +826 77f 4db2 4db5 +781 780 4c8e 4db6 +780 782 4c90 4db7 +827 780 4db6 4db8 +780 828 4db7 4db8 +826 781 4db5 4db9 +781 827 4db6 4dba +829 781 4db9 4dba +782 783 4c92 4dbb +828 782 4db7 4dbb +783 785 4c94 4dbc +828 783 4dbb 4dbd +783 82a 4dbc 4dbd +785 784 4c95 4dbe +784 786 4c97 4dbf +82b 784 4dbe 4dc0 +784 82c 4dbf 4dc0 +82a 785 4dbc 4dc1 +785 82b 4dbe 4dc2 +82d 785 4dc1 4dc3 +785 82e 4dc2 4dc3 +786 787 4c99 4dc4 +82c 786 4dbf 4dc4 +787 789 4c9b 4dc5 +82c 787 4dc4 4dc6 +787 82f 4dc5 4dc6 +789 788 4c9c 4dc7 +788 78a 4c9e 4dc8 +830 788 4dc7 4dc8 +82f 789 4dc5 4dc9 +789 830 4dc7 4dca +831 789 4dc9 4dcb +789 832 4dca 4dcb +78a 78c 4ca0 4dcc +830 78a 4dc8 4dcd +78a 833 4dcc 4dcd +78c 78b 4ca1 4dce +78b 78d 4ca3 4dcf +834 78b 4dce 4dcf +833 78c 4dcc 4dd0 +78c 834 4dce 4dd1 +835 78c 4dd0 4dd1 +78d 78e 4ca5 4dd2 +834 78d 4dcf 4dd3 +78d 836 4dd2 4dd4 +837 78d 4dd3 4dd4 +78e 78f 4ca7 4dd5 +836 78e 4dd2 4dd6 +78e 838 4dd5 4dd6 +78f 791 4ca9 4dd7 +838 78f 4dd5 4dd7 +791 790 4caa 4dd8 +790 792 4cac 4dd9 +839 790 4dd8 4dd9 +838 791 4dd7 4dda +791 839 4dd8 4ddb +83a 791 4dda 4ddc +791 83b 4ddb 4ddc +792 793 4cae 4ddd +839 792 4dd9 4dde +792 83c 4ddd 4ddf +83d 792 4dde 4ddf +793 795 4cb0 4de0 +83c 793 4ddd 4de1 +793 83e 4de0 4de1 +795 794 4cb1 4de2 +794 796 4cb3 4de3 +83f 794 4de2 4de3 +83e 795 4de0 4de4 +795 83f 4de2 4de5 +840 795 4de4 4de6 +795 841 4de5 4de6 +796 797 4cb5 4de7 +83f 796 4de3 4de8 +796 842 4de7 4de8 +797 799 4cb7 4de9 +842 797 4de7 4dea +797 843 4de9 4dea +799 798 4cb8 4deb +798 79a 4cba 4dec +844 798 4deb 4ded +798 845 4dec 4ded +843 799 4de9 4dee +799 844 4deb 4def +846 799 4dee 4def +79a 79c 4cbc 4df0 +845 79a 4dec 4df1 +79a 847 4df0 4df1 +79c 79b 4cbd 4df2 +79b 79d 4cbf 4df3 +848 79b 4df2 4df3 +847 79c 4df0 4df4 +79c 848 4df2 4df5 +849 79c 4df4 4df5 +79d 79f 4cc1 4df6 +848 79d 4df3 4df6 +79f 79e 4cc2 4df7 +79e 7a1 4cc4 4df7 +79f 7a1 4df7 4df8 +848 79f 4df6 4df9 +79f 84a 4df8 4dfa +84b 79f 4df9 4dfa +7a1 7a0 4cc5 4dfb +7a0 7a2 4cc8 4dfb +7a1 7a2 4dfb 4dfc +84a 7a1 4df8 4dfc +7a2 7a3 4cca 4dfd +84a 7a2 4dfc 4dfe +7a2 84c 4dfd 4dfe +7a3 7a4 4ccc 4dff +84c 7a3 4dfd 4e00 +7a3 84d 4dff 4e00 +7a4 7a6 4cce 4e01 +84d 7a4 4dff 4e01 +7a6 7a5 4ccf 4e02 +7a5 7a8 4cd1 4e03 +84e 7a5 4e02 4e03 +84d 7a6 4e01 4e04 +7a6 84e 4e02 4e05 +84f 7a6 4e04 4e05 +7a8 7a7 4cd2 4e06 +7a7 7a9 4cd4 4e07 +850 7a7 4e06 4e07 +84e 7a8 4e03 4e08 +7a8 850 4e06 4e09 +851 7a8 4e08 4e0a +7a8 852 4e09 4e0a +7a9 7aa 4cd6 4e0b +850 7a9 4e07 4e0c +7a9 853 4e0b 4e0c +7aa 7ab 4cd8 4e0d +853 7aa 4e0b 4e0e +7aa 854 4e0d 4e0e +7ab 7ac 4cda 4e0f +854 7ab 4e0d 4e10 +7ab 855 4e0f 4e10 +7ac 7ae 4cdc 4e11 +855 7ac 4e0f 4e12 +7ac 856 4e11 4e12 +7ae 7ad 4cdd 4e13 +7ad 7af 4cdf 4e14 +857 7ad 4e13 4e14 +856 7ae 4e11 4e15 +7ae 857 4e13 4e16 +858 7ae 4e15 4e16 +7af 7b1 4ce1 4e17 +857 7af 4e14 4e18 +7af 859 4e17 4e18 +7b1 7b0 4ce2 4e19 +7b0 7b2 4ce4 4e1a +85a 7b0 4e19 4e1b +7b0 85b 4e1a 4e1c +85c 7b0 4e1b 4e1c +859 7b1 4e17 4e1d +7b1 85a 4e19 4e1d +7b2 7b3 4ce6 4e1e +85b 7b2 4e1a 4e1e +7b3 7b4 4ce8 4e1f +85b 7b3 4e1e 4e20 +7b3 85d 4e1f 4e21 +85e 7b3 4e20 4e22 +7b3 85f 4e21 4e22 +7b4 7b5 4cea 4e23 +85d 7b4 4e1f 4e24 +7b4 860 4e23 4e24 +7b5 7b6 4cec 4e25 +860 7b5 4e23 4e25 +7b6 7b8 4cee 4e26 +860 7b6 4e25 4e27 +7b6 861 4e26 4e27 +7b8 7b7 4cef 4e28 +7b7 7b9 4cf1 4e29 +862 7b7 4e28 4e29 +861 7b8 4e26 4e2a +7b8 862 4e28 4e2b +863 7b8 4e2a 4e2b +7b9 7ba 4cf3 4e2c +862 7b9 4e29 4e2d +7b9 864 4e2c 4e2e +865 7b9 4e2d 4e2e +7ba 7bb 4cf6 4e2f +864 7ba 4e2c 4e2f +7bb 7bc 4cf8 4e30 +864 7bb 4e2f 4e31 +7bb 866 4e30 4e31 +7bc 7be 4cfa 4e32 +866 7bc 4e30 4e33 +7bc 867 4e32 4e33 +7be 7bd 4cfb 4e34 +7bd 7c0 4cfd 4e35 +868 7bd 4e34 4e35 +867 7be 4e32 4e36 +7be 868 4e34 4e36 +7c0 7bf 4cfe 4e37 +7bf 7c1 4d00 4e38 +869 7bf 4e37 4e38 +868 7c0 4e35 4e39 +7c0 869 4e37 4e3a +86a 7c0 4e39 4e3a +7c1 7c2 4d02 4e3b +869 7c1 4e38 4e3c +7c1 86b 4e3b 4e3d +86c 7c1 4e3c 4e3d +7c2 7c3 4d04 4e3e +86b 7c2 4e3b 4e3f +7c2 86d 4e3e 4e3f +7c3 7c5 4d06 4e40 +86d 7c3 4e3e 4e41 +7c3 86e 4e40 4e41 +7c5 7c4 4d07 4e42 +7c4 7c6 4d09 4e43 +86f 7c4 4e42 4e43 +86e 7c5 4e40 4e44 +7c5 86f 4e42 4e44 +7c6 7c7 4d0b 4e45 +86f 7c6 4e43 4e46 +7c6 870 4e45 4e47 +871 7c6 4e46 4e47 +7c7 7c8 4d0d 4e48 +870 7c7 4e45 4e49 +7c7 872 4e48 4e4a +873 7c7 4e49 4e4a +7c8 7ca 4d0f 4e4b +872 7c8 4e48 4e4b +7ca 7c9 4d10 4e4c +7c9 7cb 4d12 4e4d +874 7c9 4e4c 4e4e +7c9 875 4e4d 4e4e +872 7ca 4e4b 4e4f +7ca 874 4e4c 4e50 +876 7ca 4e4f 4e50 +7cb 7cc 4d14 4e51 +875 7cb 4e4d 4e51 +7cc 7ce 4d16 4e52 +875 7cc 4e51 4e53 +7cc 877 4e52 4e54 +878 7cc 4e53 4e54 +7ce 7cd 4d17 4e55 +7cd 7cf 4d19 4e56 +879 7cd 4e55 4e57 +7cd 87a 4e56 4e57 +877 7ce 4e52 4e58 +7ce 879 4e55 4e58 +7cf 7d1 4d1b 4e59 +87a 7cf 4e56 4e59 +7d1 7d0 4d1c 4e5a +7d0 7d2 4d1e 4e5b +87b 7d0 4e5a 4e5b +87a 7d1 4e59 4e5c +7d1 87b 4e5a 4e5d +87c 7d1 4e5c 4e5d +7d2 7d4 4d20 4e5e +87b 7d2 4e5b 4e5f +7d2 87d 4e5e 4e5f +7d4 7d3 4d21 4e60 +7d3 7d5 4d23 4e61 +87e 7d3 4e60 4e62 +7d3 87f 4e61 4e62 +87d 7d4 4e5e 4e63 +7d4 87e 4e60 4e63 +7d5 7d6 4d25 4e64 +87f 7d5 4e61 4e65 +7d5 880 4e64 4e65 +7d6 7d7 4d27 4e66 +880 7d6 4e64 4e67 +7d6 881 4e66 4e68 +882 7d6 4e67 4e68 +7d7 7d9 4d29 4e69 +881 7d7 4e66 4e69 +7d9 7d8 4d2a 4e6a +7d8 7da 4d2c 4e6b +883 7d8 4e6a 4e6b +881 7d9 4e69 4e6c +7d9 883 4e6a 4e6d +884 7d9 4e6c 4e6e +7d9 885 4e6d 4e6e +7da 7dc 4d2e 4e6f +883 7da 4e6b 4e70 +7da 886 4e6f 4e70 +7dc 7db 4d2f 4e71 +7db 7dd 4d31 4e72 +887 7db 4e71 4e72 +886 7dc 4e6f 4e73 +7dc 887 4e71 4e74 +888 7dc 4e73 4e74 +7dd 7de 4d33 4e75 +887 7dd 4e72 4e76 +7dd 889 4e75 4e77 +88a 7dd 4e76 4e77 +7de 7e0 4d35 4e78 +889 7de 4e75 4e78 +7e0 7df 4d36 4e79 +7df 7e1 4d38 4e7a +88b 7df 4e79 4e7b +7df 88c 4e7a 4e7c +88d 7df 4e7b 4e7c +889 7e0 4e78 4e7d +7e0 88b 4e79 4e7d +7e1 7e2 4d3a 4e7e +88c 7e1 4e7a 4e7e +7e2 7e3 4d3c 4e7f +88c 7e2 4e7e 4e80 +7e2 88e 4e7f 4e81 +88f 7e2 4e80 4e81 +7e3 7e5 4d3e 4e82 +88e 7e3 4e7f 4e83 +7e3 890 4e82 4e83 +7e5 7e4 4d3f 4e84 +7e4 7e6 4d41 4e85 +891 7e4 4e84 4e86 +7e4 892 4e85 4e86 +890 7e5 4e82 4e87 +7e5 891 4e84 4e87 +7e6 7e8 4d43 4e88 +892 7e6 4e85 4e88 +7e8 7e7 4d44 4e89 +7e7 7ea 4d46 4e8a +893 7e7 4e89 4e8a +892 7e8 4e88 4e8b +7e8 893 4e89 4e8c +894 7e8 4e8b 4e8c +7ea 7e9 4d47 4e8d +7e9 7eb 4d49 4e8e +895 7e9 4e8d 4e8f +7e9 896 4e8e 4e8f +893 7ea 4e8a 4e90 +7ea 895 4e8d 4e91 +897 7ea 4e90 4e91 +7eb 7ec 4d4b 4e92 +896 7eb 4e8e 4e93 +7eb 898 4e92 4e93 +7ec 7ed 4d4d 4e94 +898 7ec 4e92 4e95 +7ec 899 4e94 4e95 +7ed 7ef 4d4f 4e96 +899 7ed 4e94 4e96 +7ef 7ee 4d50 4e97 +7ee 7f5 4d56 4e97 +7ef 7f5 4e97 4e98 +7ef 7f7 4e98 4e99 +899 7ef 4e96 4e9a +7ef 89a 4e99 4e9a +7f0 7f1 4d52 8321 +1f42 7f0 79ff 8321 +7f0 1f43 79ff 7aad +1f42 7f1 8321 8322 +7f1 2010 7bd7 8369 +20e6 7f1 8322 8369 +7f2 1f88 7a1c 8dcb +7f3 7f4 4d54 7fa5 +1fdc 7f3 7a79 7fa4 +7f3 1fdd 7a7a 7fa4 +1fde 7f3 7a7a 7fa5 +1fde 7f4 7fa5 81f8 +7f4 1fdf 7a7b 8953 +22bb 7f4 81f8 8953 +7f5 7f7 4d5a 4e98 +7f8 7f6 4d5b 4e9b +7f6 7fa 4d5e 4e9b +7f7 7f8 4d5c 4e9c +89a 7f7 4e99 4e9c +7f8 7fa 4e9b 4e9d +89a 7f8 4e9c 4e9e +7f8 89b 4e9d 4e9f +89c 7f8 4e9e 4e9f +7fb 7f9 4d5f 4ea0 +7f9 7fd 4d63 4ea0 +7fa 7fb 4d60 4ea1 +89b 7fa 4e9d 4ea1 +7fb 7fd 4ea0 4ea2 +89b 7fb 4ea1 4ea3 +7fb 89d 4ea2 4ea4 +89e 7fb 4ea3 4ea4 +7fe 7fc 4d64 4ea5 +7fc 7ff 4d67 4ea6 +89f 7fc 4ea5 4ea6 +7fd 7fe 4d65 4ea7 +89d 7fd 4ea2 4ea7 +89d 7fe 4ea7 4ea8 +7fe 89f 4ea5 4ea9 +8a0 7fe 4ea8 4ea9 +7ff 800 4d69 4eaa +89f 7ff 4ea6 4eab +7ff 8a1 4eaa 4eab +800 803 4d6e 4eac +8a1 800 4eaa 4eac +801 802 4d6d 4ead +803 801 4d6f 4eae +801 8a2 4ead 4eae +802 804 4d73 4eaf +8a2 802 4ead 4eb0 +802 8a3 4eaf 4eb0 +8a1 803 4eac 4eb1 +803 8a2 4eae 4eb2 +8a4 803 4eb1 4eb3 +803 8a5 4eb2 4eb3 +804 805 4d72 4eb4 +8a3 804 4eaf 4eb5 +804 8a6 4eb4 4eb6 +8a7 804 4eb5 4eb6 +805 806 4d75 4eb7 +8a6 805 4eb4 4eb8 +805 8a8 4eb7 4eb8 +806 809 4d7a 4eb9 +8a8 806 4eb7 4eb9 +807 808 4d79 4eba +809 807 4d7b 4ebb +807 8a9 4eba 4ebc +8aa 807 4ebb 4ebc +808 80c 4d80 4ebd +8a9 808 4eba 4ebd +8a8 809 4eb9 4ebe +809 8aa 4ebb 4ebf +8ab 809 4ebe 4ebf +80a 80b 4d7f 4ec0 +80c 80a 4d81 4ec1 +80a 8ac 4ec0 4ec2 +8ad 80a 4ec1 4ec2 +80b 80d 4d83 4ec3 +8ac 80b 4ec0 4ec3 +8a9 80c 4ebd 4ec4 +80c 8ad 4ec1 4ec5 +8ae 80c 4ec4 4ec5 +80d 80f 4d85 4ec6 +8ac 80d 4ec3 4ec7 +80d 8af 4ec6 4ec8 +8b0 80d 4ec7 4ec9 +80d 8b1 4ec8 4ec9 +80f 80e 4d86 4eca +80e 810 4d89 4eca +80f 810 4eca 4ecb +8af 80f 4ec6 4ecb +810 812 4d8f 4ecc +8af 810 4ecb 4ecc +812 811 4d90 4ecd +811 814 4d92 4ece +8b2 811 4ecd 4ece +8af 812 4ecc 4ecf +812 8b2 4ecd 4ecf +814 813 4d93 4ed0 +813 815 4d95 4ed1 +8b3 813 4ed0 4ed2 +813 8b4 4ed1 4ed2 +8b2 814 4ece 4ed3 +814 8b3 4ed0 4ed4 +8b5 814 4ed3 4ed4 +815 816 4d97 4ed5 +8b4 815 4ed1 4ed5 +816 818 4d99 4ed6 +8b4 816 4ed5 4ed7 +816 8b6 4ed6 4ed7 +819 817 4d9a 4ed8 +817 81c 4da0 4ed8 +818 819 4d9b 4ed9 +8b6 818 4ed6 4eda +818 8b7 4ed9 4eda +819 81c 4ed8 4edb +8b7 819 4ed9 4edc +819 8b8 4edb 4edc +81a 81b 4d9f 4edd +81c 81a 4da1 4ede +81a 8b9 4edd 4edf +8ba 81a 4ede 4edf +81b 81e 4da3 4ee0 +8b9 81b 4edd 4ee1 +81b 8bb 4ee0 4ee1 +8b8 81c 4edb 4ee2 +81c 8ba 4ede 4ee2 +81e 81d 4da4 4ee3 +81d 81f 4da7 4ee4 +8bc 81d 4ee3 4ee5 +81d 8bd 4ee4 4ee5 +8bb 81e 4ee0 4ee6 +81e 8bc 4ee3 4ee6 +81f 821 4daa 4ee7 +8bd 81f 4ee4 4ee7 +821 820 4dab 4eed +820 824 4daf 4eee +8c0 820 4eed 4eef +820 8c1 4eee 4ef0 +8c2 820 4eef 4ef0 +8bd 821 4ee7 4eeb +8c0 821 4eeb 4eed +822 823 4dae 4ef1 +824 822 4db0 4ef2 +822 8c3 4ef1 4ef2 +823 825 4db4 4ef3 +8c3 823 4ef1 4ef4 +823 8c4 4ef3 4ef5 +8c5 823 4ef4 4ef5 +8c1 824 4eee 4ef6 +824 8c3 4ef2 4ef7 +8c6 824 4ef6 4ef7 +825 826 4db3 4ef8 +8c4 825 4ef3 4ef9 +825 8c7 4ef8 4ef9 +826 829 4db9 4efa +8c7 826 4ef8 4efa +827 828 4db8 4efb +829 827 4dba 4efc +827 8c8 4efb 4efd +8c9 827 4efc 4efe +827 8ca 4efd 4efe +828 82a 4dbd 4eff +8c8 828 4efb 4eff +8c7 829 4efa 4f00 +829 8c9 4efc 4f01 +8cb 829 4f00 4f01 +82a 82d 4dc1 4f02 +8c8 82a 4eff 4f02 +82b 82c 4dc0 4f03 +82e 82b 4dc2 4f04 +82b 8cc 4f03 4f05 +8cd 82b 4f04 4f06 +82b 8ce 4f05 4f06 +82c 82f 4dc6 4f07 +8cc 82c 4f03 4f07 +82d 82e 4dc3 4f08 +8c8 82d 4f02 4f09 +82d 8cf 4f08 4f09 +82e 8cd 4f04 4f0a +8cf 82e 4f08 4f0a +82f 831 4dc9 4f0b +8cc 82f 4f07 4f0c +82f 8d0 4f0b 4f0c +832 830 4dca 4f0d +830 833 4dcd 4f0e +8d1 830 4f0d 4f0e +831 832 4dcb 4f0f +8d0 831 4f0b 4f0f +8d0 832 4f0f 4f10 +832 8d1 4f0d 4f11 +8d2 832 4f10 4f12 +832 8d3 4f11 4f12 +833 835 4dd0 4f13 +8d1 833 4f0e 4f14 +833 8d4 4f13 4f14 +835 834 4dd1 4f15 +834 837 4dd3 4f16 +8d5 834 4f15 4f16 +8d4 835 4f13 4f17 +835 8d5 4f15 4f17 +837 836 4dd4 4f18 +836 838 4dd6 4f19 +8d6 836 4f18 4f1a +836 8d7 4f19 4f1b +8d8 836 4f1a 4f1b +8d5 837 4f16 4f1c +837 8d6 4f18 4f1c +838 83a 4dda 4f1d +8d7 838 4f19 4f1d +83b 839 4ddb 4f1e +839 83d 4dde 4f1e +83a 83b 4ddc 4f1f +8d7 83a 4f1d 4f20 +83a 8d9 4f1f 4f20 +83b 83d 4f1e 4f21 +8d9 83b 4f1f 4f22 +83b 8da 4f21 4f23 +8db 83b 4f22 4f24 +83b 8dc 4f23 4f24 +83d 83c 4ddf 4f25 +83c 83e 4de1 4f26 +8dd 83c 4f25 4f26 +8da 83d 4f21 4f27 +83d 8dd 4f25 4f27 +83e 840 4de4 4f28 +8dd 83e 4f26 4f28 +841 83f 4de5 4f29 +83f 842 4de8 4f2a +8de 83f 4f29 4f2a +840 841 4de6 4f2b +8dd 840 4f28 4f2c +840 8df 4f2b 4f2d +8e0 840 4f2c 4f2d +841 8de 4f29 4f2e +8df 841 4f2b 4f2e +842 843 4dea 4f2f +8de 842 4f2a 4f30 +842 8e1 4f2f 4f30 +843 846 4dee 4f31 +8e1 843 4f2f 4f31 +844 845 4ded 4f32 +846 844 4def 4f33 +844 847 4f32 4f34 +8e2 844 4f33 4f34 +845 847 4df1 4f32 +8e1 846 4f31 4f35 +846 8e2 4f33 4f36 +8e3 846 4f35 4f36 +847 849 4df4 4f37 +8e2 847 4f34 4f38 +847 8e4 4f37 4f39 +8e5 847 4f38 4f39 +849 848 4df5 4f3a +848 84b 4df9 4f3b +8e6 848 4f3a 4f3b +8e4 849 4f37 4f3c +849 8e6 4f3a 4f3d +8e7 849 4f3c 4f3d +84b 84a 4dfa 4f3e +84a 84c 4dfe 4f3f +8e8 84a 4f3e 4f3f +8e6 84b 4f3b 4f40 +84b 8e8 4f3e 4f41 +8e9 84b 4f40 4f41 +84c 84d 4e00 4f42 +8e8 84c 4f3f 4f42 +84d 84f 4e04 4f43 +8e8 84d 4f42 4f43 +84f 84e 4e05 4f44 +84e 851 4e08 4f45 +8ea 84e 4f44 4f46 +84e 8eb 4f45 4f46 +8e8 84f 4f43 4f47 +8e9 84f 4f47 4f48 +84f 8ea 4f44 4f48 +852 850 4e09 4f49 +850 853 4e0c 4f4a +8ec 850 4f49 4f4b +850 8ed 4f4a 4f4b +851 852 4e0a 4f4c +8eb 851 4f45 4f4d +851 8ee 4f4c 4f4e +8ef 851 4f4d 4f4e +852 8ec 4f49 4f4f +8ee 852 4f4c 4f4f +853 854 4e0e 4f50 +8ed 853 4f4a 4f50 +854 855 4e10 4f51 +8ed 854 4f50 4f52 +854 8f0 4f51 4f53 +8f1 854 4f52 4f53 +855 856 4e12 4f54 +8f0 855 4f51 4f54 +856 858 4e15 4f55 +8f0 856 4f54 4f56 +856 8f2 4f55 4f57 +8f3 856 4f56 4f57 +858 857 4e16 4f58 +857 859 4e18 4f58 +858 859 4f58 4f59 +8f2 858 4f55 4f5a +858 8f4 4f59 4f5b +8f5 858 4f5a 4f5b +859 85a 4e1d 4f5c +8f4 859 4f59 4f5d +859 8f6 4f5c 4f5e +8f7 859 4f5d 4f5e +85a 85c 4e1b 4f5f +8f6 85a 4f5c 4f5f +85c 85b 4e1c 4f60 +85b 85e 4e20 4f60 +85c 85e 4f60 4f61 +8f6 85c 4f5f 4f62 +85c 8f8 4f61 4f63 +8f9 85c 4f62 4f63 +85f 85d 4e21 4f64 +85d 860 4e24 4f65 +8fa 85d 4f64 4f66 +85d 8fb 4f65 4f66 +85e 85f 4e22 4f67 +8f8 85e 4f61 4f68 +85e 8fc 4f67 4f68 +85f 8fa 4f64 4f69 +8fc 85f 4f67 4f69 +860 861 4e27 4f6a +8fb 860 4f65 4f6b +860 8fd 4f6a 4f6b +861 863 4e2a 4f6d +8fd 861 4f6a 4f6c +8fe 861 4f6c 4f6d +863 862 4e2b 4f73 +862 865 4e2d 4f73 +863 865 4f73 4f74 +8fe 863 4f6d 4f75 +863 902 4f74 4f75 +865 864 4e2e 4f76 +864 866 4e31 4f76 +865 866 4f76 4f77 +865 867 4f77 4f78 +902 865 4f74 4f79 +865 903 4f78 4f79 +866 867 4e33 4f77 +867 868 4e36 4f7a +903 867 4f78 4f7a +868 86a 4e39 4f7b +903 868 4f7a 4f7c +868 904 4f7b 4f7c +86a 869 4e3a 4f7d +869 86c 4e3c 4f7e +905 869 4f7d 4f7e +904 86a 4f7b 4f7f +86a 905 4f7d 4f7f +86c 86b 4e3d 4f80 +86b 86d 4e3f 4f81 +906 86b 4f80 4f82 +86b 907 4f81 4f82 +905 86c 4f7e 4f83 +86c 906 4f80 4f84 +908 86c 4f83 4f84 +86d 86e 4e41 4f85 +907 86d 4f81 4f86 +86d 909 4f85 4f86 +86e 86f 4e44 4f87 +909 86e 4f85 4f88 +86e 90a 4f87 4f88 +86f 871 4e46 4f89 +90a 86f 4f87 4f8a +86f 90b 4f89 4f8a +871 870 4e47 4f8b +870 873 4e49 4f8c +90c 870 4f8b 4f8c +90b 871 4f89 4f8d +871 90c 4f8b 4f8d +873 872 4e4a 4f8e +872 876 4e4f 4f8f +90d 872 4f8e 4f90 +872 90e 4f8f 4f90 +90c 873 4f8c 4f91 +873 90d 4f8e 4f91 +874 875 4e4e 4f92 +876 874 4e50 4f93 +874 90f 4f92 4f94 +910 874 4f93 4f95 +874 911 4f94 4f95 +875 878 4e53 4f96 +90f 875 4f92 4f96 +90e 876 4f8f 4f97 +876 910 4f93 4f97 +878 877 4e54 4f98 +877 879 4e58 4f99 +912 877 4f98 4f9a +877 913 4f99 4f9b +914 877 4f9a 4f9b +90f 878 4f96 4f9c +878 912 4f98 4f9c +879 87a 4e57 4f9d +913 879 4f99 4f9e +879 915 4f9d 4f9e +87a 87c 4e5c 4f9f +915 87a 4f9d 4f9f +87c 87b 4e5d 4fa0 +87b 87d 4e5f 4fa1 +916 87b 4fa0 4fa1 +915 87c 4f9f 4fa2 +87c 916 4fa0 4fa3 +917 87c 4fa2 4fa3 +87d 87e 4e63 4fa4 +916 87d 4fa1 4fa5 +87d 918 4fa4 4fa5 +87e 87f 4e62 4fa6 +918 87e 4fa4 4fa7 +87e 919 4fa6 4fa8 +91a 87e 4fa7 4fa8 +87f 880 4e65 4fa9 +919 87f 4fa6 4faa +87f 91b 4fa9 4faa +880 882 4e67 4fab +91b 880 4fa9 4fab +882 881 4e68 4fac +881 884 4e6c 4fac +882 884 4fac 4fad +91b 882 4fab 4fae +882 91c 4fad 4faf +91d 882 4fae 4faf +885 883 4e6d 4fb0 +883 886 4e70 4fb1 +91e 883 4fb0 4fb1 +884 885 4e6e 4fb2 +91c 884 4fad 4fb3 +884 91f 4fb2 4fb4 +920 884 4fb3 4fb5 +884 921 4fb4 4fb5 +885 91e 4fb0 4fb6 +91f 885 4fb2 4fb6 +886 888 4e73 4fb7 +91e 886 4fb1 4fb8 +886 922 4fb7 4fb9 +923 886 4fb8 4fb9 +888 887 4e74 4fba +887 88a 4e76 4fbb +924 887 4fba 4fbb +922 888 4fb7 4fbc +888 924 4fba 4fbc +88a 889 4e77 4fbd +889 88b 4e7d 4fbe +925 889 4fbd 4fbe +924 88a 4fbb 4fbf +88a 925 4fbd 4fc0 +926 88a 4fbf 4fc0 +88b 88d 4e7b 4fc1 +925 88b 4fbe 4fc2 +88b 927 4fc1 4fc2 +88d 88c 4e7c 4fc3 +88c 88f 4e80 4fc4 +928 88c 4fc3 4fc4 +927 88d 4fc1 4fc5 +88d 928 4fc3 4fc6 +929 88d 4fc5 4fc6 +88f 88e 4e81 4fc7 +88e 890 4e83 4fc8 +92a 88e 4fc7 4fc8 +928 88f 4fc4 4fc9 +88f 92a 4fc7 4fca +92b 88f 4fc9 4fca +890 891 4e87 4fcb +92a 890 4fc8 4fcc +890 92c 4fcb 4fcd +92d 890 4fcc 4fcd +891 892 4e86 4fce +92c 891 4fcb 4fcf +891 92e 4fce 4fcf +892 894 4e8b 4fd0 +92e 892 4fce 4fd0 +894 893 4e8c 4fd1 +893 897 4e90 4fd2 +92f 893 4fd1 4fd3 +893 930 4fd2 4fd3 +92e 894 4fd0 4fd4 +894 92f 4fd1 4fd5 +931 894 4fd4 4fd5 +895 896 4e8f 4fd6 +897 895 4e91 4fd7 +895 932 4fd6 4fd8 +933 895 4fd7 4fd8 +896 898 4e93 4fd9 +932 896 4fd6 4fd9 +930 897 4fd2 4fda +897 933 4fd7 4fdb +934 897 4fda 4fdc +897 935 4fdb 4fdc +898 899 4e95 4fdd +898 89a 4fdd 4fde +932 898 4fd9 4fdf +898 936 4fde 4fdf +899 89a 4e9a 4fdd +89a 89c 4e9e 4fe0 +936 89a 4fde 4fe0 +89c 89b 4e9f 4fe1 +89b 89e 4ea3 4fe2 +937 89b 4fe1 4fe2 +936 89c 4fe0 4fe3 +89c 937 4fe1 4fe4 +938 89c 4fe3 4fe4 +89e 89d 4ea4 4fe5 +89d 8a0 4ea8 4fe6 +939 89d 4fe5 4fe7 +89d 93a 4fe6 4fe7 +937 89e 4fe2 4fe8 +89e 939 4fe5 4fe9 +93b 89e 4fe8 4fe9 +8a0 89f 4ea9 4fea +89f 8a1 4eab 4feb +93c 89f 4fea 4feb +93a 8a0 4fe6 4fec +8a0 93c 4fea 4fed +93d 8a0 4fec 4fed +8a1 8a4 4eb1 4fee +93c 8a1 4feb 4fef +8a1 93e 4fee 4fef +8a2 8a3 4eb0 4ff0 +8a5 8a2 4eb2 4ff1 +8a2 93f 4ff0 4ff1 +8a3 8a7 4eb5 4ff2 +93f 8a3 4ff0 4ff3 +8a3 940 4ff2 4ff3 +8a4 8a5 4eb3 4ff4 +93e 8a4 4fee 4ff5 +8a4 941 4ff4 4ff5 +8a5 93f 4ff1 4ff6 +941 8a5 4ff4 4ff7 +8a5 942 4ff6 4ff8 +943 8a5 4ff7 4ff8 +8a7 8a6 4eb6 4ff9 +8a6 8a8 4eb8 4ffa +944 8a6 4ff9 4ffa +940 8a7 4ff2 4ffc +8a7 944 4ff9 4ffb +8a7 945 4ffb 4ffc +8a8 8ab 4ebe 4ffd +944 8a8 4ffa 4ffd +8aa 8a9 4ebc 4ffe +8a9 8ae 4ec4 4fff +946 8a9 4ffe 5000 +8a9 947 4fff 5000 +8ab 8aa 4ebf 5001 +8aa 946 4ffe 5002 +948 8aa 5001 5002 +944 8ab 4ffd 5003 +8ab 948 5001 5003 +8ad 8ac 4ec2 5004 +8ac 8b0 4ec7 5005 +949 8ac 5004 5005 +8ae 8ad 4ec5 5006 +8ad 949 5004 5007 +94a 8ad 5006 5007 +947 8ae 4fff 5009 +8ae 94a 5006 5008 +8ae 94b 5008 5009 +8b1 8af 4ec8 500a +8af 8b2 4ecf 500b +94c 8af 500a 500b +8b0 8b1 4ec9 500c +949 8b0 5005 500f +8b0 94d 500c 500f +8b1 94c 500a 500d +94d 8b1 500c 500e +8b1 94e 500d 500e +8b2 8b5 4ed3 5010 +94c 8b2 500b 5010 +8b3 8b4 4ed2 5011 +8b5 8b3 4ed4 5012 +8b3 94f 5011 5013 +950 8b3 5012 5013 +8b4 8b6 4ed7 5014 +94f 8b4 5011 5014 +94c 8b5 5010 5015 +94e 8b5 5015 5016 +8b5 950 5012 5016 +8b6 8b7 4eda 5017 +94f 8b6 5014 5018 +8b6 951 5017 5018 +8b7 8b8 4edc 5019 +951 8b7 5017 501a +8b7 952 5019 501b +953 8b7 501a 501c +8b7 954 501b 501d +955 8b7 501c 501d +8b8 8ba 4ee2 501e +952 8b8 5019 501e +8ba 8b9 4edf 501f +8b9 8bb 4ee1 5020 +956 8b9 501f 5021 +8b9 957 5020 5021 +952 8ba 501e 5022 +8ba 956 501f 5022 +8bb 8bc 4ee6 4ee9 +8bb 8bf 4ee9 5024 +957 8bb 5020 5023 +958 8bb 5023 5024 +8bc 8bd 4ee5 4ee8 +8bc 8be 4ee8 4eea +8bf 8bc 4ee9 4eea +8be 8bd 4ee8 4eec +8bd 8c0 4eeb 4eec +8bf 8be 4eea 502b +8be 8c0 4eec 502e +95c 8be 502b 502f +8be 95e 502e 502f +958 8bf 5024 502a +95c 8bf 502a 502b +8c0 8c2 4eef 5030 +95e 8c0 502e 5030 +8c2 8c1 4ef0 5031 +8c1 8c6 4ef6 5032 +95f 8c1 5031 5033 +8c1 960 5032 5033 +95e 8c2 5030 5034 +8c2 95f 5031 5035 +961 8c2 5034 5035 +8c3 8c5 4ef4 5036 +8c6 8c3 4ef7 5036 +8c5 8c4 4ef5 5038 +8c4 8c7 4ef9 5039 +962 8c4 5038 503a +8c4 963 5039 503a +8c6 8c5 5036 5037 +960 8c5 5037 503c +8c5 962 5038 503b +8c5 964 503b 503c +960 8c6 5032 5037 +8c7 8cb 4f00 503d +963 8c7 5039 503d +8ca 8c8 4efd 503e +8c8 8cf 4f09 503f +965 8c8 503e 503f +8c9 8ca 4efe 5040 +8cb 8c9 4f01 5041 +8c9 966 5040 5042 +967 8c9 5041 5042 +8ca 965 503e 5043 +966 8ca 5040 5043 +963 8cb 503d 5044 +8cb 967 5041 5044 +8ce 8cc 4f05 5057 +8cc 8d0 4f0c 5058 +973 8cc 5057 5058 +8cd 8ce 4f06 5059 +8cf 8cd 4f0a 5049 +968 8cd 5049 504d +96d 8cd 504d 5059 +96d 8ce 5059 505b +8ce 973 5057 505a +8ce 974 505a 505b +965 8cf 503f 5045 +968 8cf 5045 5049 +8d0 8d2 4f10 505c +973 8d0 5058 505d +8d0 975 505c 505d +8d3 8d1 4f11 505e +8d1 8d4 4f14 505f +976 8d1 505e 505f +8d2 8d3 4f12 5060 +975 8d2 505c 5065 +8d2 977 5060 5064 +8d2 97a 5064 5065 +8d3 976 505e 5063 +977 8d3 5060 5062 +978 8d3 5061 5063 +8d3 979 5061 5062 +8d4 8d5 4f17 5066 +976 8d4 505f 5067 +8d4 97b 5066 5067 +8d5 8d6 4f1c 5068 +97b 8d5 5066 5069 +8d5 97c 5068 5069 +8d6 8d8 4f1a 506a +97c 8d6 5068 506b +8d6 97d 506a 506c +97e 8d6 506b 506c +8d8 8d7 4f1b 506d +8d7 8d9 4f20 506d +8d8 8d9 506d 506e +97d 8d8 506a 506f +8d8 97f 506e 506f +8d9 8db 4f22 5070 +97f 8d9 506e 5070 +8dc 8da 4f23 5071 +8da 8dd 4f27 5072 +980 8da 5071 5072 +8db 8dc 4f24 5073 +97f 8db 5070 5076 +8db 981 5073 5075 +8db 982 5075 5076 +8dc 980 5071 5074 +981 8dc 5073 5074 +8dd 8e0 4f2c 5077 +980 8dd 5072 5079 +8dd 983 5077 5078 +8dd 984 5078 5079 +8df 8de 4f2e 507a +8de 8e1 4f30 507b +985 8de 507a 507b +8e0 8df 4f2d 507c +8df 985 507a 507d +986 8df 507c 507e +8df 987 507d 507e +983 8e0 5077 507f +8e0 986 507c 507f +8e1 8e3 4f35 5080 +985 8e1 507b 5081 +8e1 988 5080 5081 +8e3 8e2 4f36 5082 +8e2 8e5 4f38 5083 +989 8e2 5082 5083 +988 8e3 5080 5085 +8e3 989 5082 5084 +8e3 98a 5084 5085 +8e5 8e4 4f39 5086 +8e4 8e7 4f3c 5087 +98b 8e4 5086 5087 +989 8e5 5083 5089 +8e5 98b 5086 5088 +8e5 98c 5088 5089 +8e7 8e6 4f3d 508a +8e6 8e9 4f40 508a +8e7 8e9 508a 508b +98b 8e7 5087 508c +8e7 98d 508b 508c +8e9 8e8 4f41 4f47 +8e9 8ea 4f48 508d +98d 8e9 508b 508d +8ea 8eb 4f46 508e +98d 8ea 508d 508f +8ea 98e 508e 508f +8eb 8ef 4f4d 5090 +98e 8eb 508e 5090 +8ec 8ed 4f4b 5091 +8ee 8ec 4f4f 5092 +8ec 8f1 5091 5093 +98f 8ec 5092 5094 +8ec 990 5093 5094 +8ed 8f1 4f52 5091 +8ef 8ee 4f4e 5095 +8ee 98f 5092 5096 +991 8ee 5095 5096 +98e 8ef 5090 5097 +8ef 991 5095 5098 +992 8ef 5097 5098 +8f1 8f0 4f53 5099 +8f0 8f3 4f56 5099 +8f1 8f3 5099 509a +990 8f1 5093 509b +8f1 993 509a 509b +8f3 8f2 4f57 509c +8f2 8f5 4f5a 509d +994 8f2 509c 509e +8f2 995 509d 509e +993 8f3 509a 509f +8f3 994 509c 50a0 +996 8f3 509f 50a0 +8f5 8f4 4f5b 50a1 +8f4 8f7 4f5d 50a2 +997 8f4 50a1 50a2 +995 8f5 509d 50a3 +8f5 997 50a1 50a3 +8f7 8f6 4f5e 50a4 +8f6 8f9 4f62 50a5 +998 8f6 50a4 50a5 +997 8f7 50a2 50a6 +8f7 998 50a4 50a7 +999 8f7 50a6 50a7 +8f9 8f8 4f63 50a8 +8f8 8fc 4f68 50a9 +99a 8f8 50a8 50a9 +998 8f9 50a5 50aa +8f9 99a 50a8 50ab +99b 8f9 50aa 50ab +8fa 8fb 4f66 4f6f +8fc 8fa 4f69 50ac +8fa 8ff 4f6f 50ad +99c 8fa 50ac 50ae +8fa 99d 50ad 50ae +8fb 8fd 4f6b 4f6e +8fb 8ff 4f6e 4f6f +99a 8fc 50a9 50b0 +8fc 99c 50ac 50af +8fc 99e 50af 50b0 +8fd 8fe 4f6c 4f70 +8ff 8fd 4f6e 4f71 +8fd 900 4f70 4f72 +901 8fd 4f71 4f72 +900 8fe 4f70 50b1 +8fe 902 4f75 50b2 +99f 8fe 50b1 50b2 +8ff 901 4f71 50b3 +99d 8ff 50ad 50b3 +901 900 4f72 50b4 +900 99f 50b1 50b5 +9a0 900 50b4 50b7 +900 9a1 50b5 50b6 +900 9a2 50b6 50b7 +99d 901 50b3 50b8 +901 9a0 50b4 50b8 +902 903 4f79 50b9 +99f 902 50b2 50b9 +903 904 4f7c 50ba +99f 903 50b9 50ba +904 905 4f7f 50bb +99f 904 50ba 50bc +9a1 904 50bc 50bd +904 9a3 50bb 50bd +905 908 4f83 50be +9a3 905 50bb 50be +906 907 4f82 50c2 +908 906 4f84 50c3 +906 9a5 50c2 50c5 +9a6 906 50c3 50c4 +9a7 906 50c4 50c5 +907 909 4f86 50c6 +9a5 907 50c2 50c6 +9a3 908 50be 50c1 +9a4 908 50c1 50c7 +908 9a6 50c3 50c7 +909 90a 4f88 50c8 +9a5 909 50c6 50c9 +909 9a8 50c8 50c9 +90a 90b 4f8a 50ca +9a8 90a 50c8 50cb +90a 9a9 50ca 50cb +90b 90c 4f8d 50cc +9a9 90b 50ca 50cd +90b 9aa 50cc 50cd +90c 90d 4f91 50ce +9aa 90c 50cc 50ce +90d 90e 4f90 50cf +9aa 90d 50ce 50d0 +90d 9ab 50cf 50d1 +9ac 90d 50d0 50d1 +90e 910 4f97 50d2 +9ab 90e 50cf 50d3 +90e 9ad 50d2 50d3 +911 90f 4f94 50d4 +90f 912 4f9c 50d5 +9ae 90f 50d4 50d5 +910 911 4f95 50d6 +9ad 910 50d2 50d7 +910 9af 50d6 50d7 +911 9ae 50d4 50d8 +9af 911 50d6 50d9 +911 9b0 50d8 50d9 +912 914 4f9a 50da +9ae 912 50d5 50db +912 9b1 50da 50db +914 913 4f9b 50dc +913 915 4f9e 50dd +9b2 913 50dc 50de +913 9b3 50dd 50de +9b1 914 50da 50e0 +914 9b2 50dc 50df +914 9b4 50df 50e0 +915 917 4fa2 50e3 +9b3 915 50dd 50e3 +917 916 4fa3 50e4 +916 918 4fa5 50e5 +9b6 916 50e4 50e6 +916 9b7 50e5 50e6 +9b3 917 50e3 50e8 +917 9b6 50e4 50e7 +917 9b8 50e7 50e8 +918 91a 4fa7 50e9 +9b7 918 50e5 50eb +918 9b9 50e9 50ea +918 9ba 50ea 50eb +91a 919 4fa8 50ec +919 91b 4faa 50ed +919 91d 50ed 50ee +9b9 919 50ec 50ef +919 9bb 50ee 50ef +9b9 91a 50e9 50ec +91b 91d 4fae 50ed +91d 91c 4faf 50f0 +91c 920 4fb3 50f1 +9bc 91c 50f0 50f1 +9bb 91d 50ee 50f2 +91d 9bc 50f0 50f2 +91f 91e 4fb6 50f3 +91e 923 4fb8 50f3 +921 91f 4fb4 50f4 +91f 923 50f3 50f5 +9bd 91f 50f4 50f6 +91f 9be 50f5 50f6 +920 921 4fb5 50f7 +9bc 920 50f1 50f8 +920 9bf 50f7 50fa +9c0 920 50f8 50f9 +9c1 920 50f9 50fa +921 9bd 50f4 50fc +9bf 921 50f7 50fb +9c2 921 50fb 50fc +923 922 4fb9 50fd +922 924 4fbc 50fe +9c3 922 50fd 50ff +922 9c4 50fe 5100 +9c5 922 50ff 5100 +9be 923 50f5 5101 +923 9c3 50fd 5101 +924 926 4fbf 5102 +9c4 924 50fe 5103 +924 9c6 5102 5103 +926 925 4fc0 5104 +925 927 4fc2 5105 +9c7 925 5104 5105 +9c6 926 5102 5106 +926 9c7 5104 5106 +927 929 4fc5 5107 +9c7 927 5105 5109 +927 9c8 5107 5108 +927 9c9 5108 5109 +929 928 4fc6 510a +928 92b 4fc9 510b +9ca 928 510a 510c +928 9cb 510b 510c +9c8 929 5107 510d +929 9ca 510a 510d +92b 92a 4fca 510e +92a 92d 4fcc 510f +9cc 92a 510e 5110 +92a 9cd 510f 5110 +9cb 92b 510b 5111 +92b 9cc 510e 5111 +92d 92c 4fcd 5112 +92c 92e 4fcf 5113 +92c 931 5113 5114 +9ce 92c 5112 5114 +9cd 92d 510f 5115 +92d 9ce 5112 5115 +92e 931 4fd4 5113 +92f 930 4fd3 5116 +931 92f 4fd5 5117 +92f 9cf 5116 5118 +9d0 92f 5117 5118 +930 934 4fda 5119 +9cf 930 5116 5119 +9ce 931 5114 511b +931 9d0 5117 511a +931 9d1 511a 511b +933 932 4fd8 511c +932 936 4fdf 511d +9d2 932 511c 511e +932 9d3 511d 511e +935 933 4fdb 511f +933 9d2 511c 511f +934 935 4fdc 5120 +9cf 934 5119 5123 +934 9d4 5120 5122 +934 9d5 5122 5123 +935 9d2 511f 5121 +9d4 935 5120 5121 +936 938 4fe3 5124 +9d3 936 511d 5124 +938 937 4fe4 53eb +937 93b 4fe8 53eb +938 93b 53eb 53ec +9d3 938 5124 53ed +938 b64 53ec 53ee +b65 938 53ed 53ef +938 b66 53ee 53ef +939 93a 4fe7 54e3 +93b 939 4fe9 54e4 +939 bf0 54e3 54e4 +93a 93d 4fec 54e5 +bf0 93a 54e3 54e6 +93a bf1 54e5 54e6 +b64 93b 53ec 54e7 +93b bf0 54e4 54e7 +93d 93c 4fed 54e9 +93c 93e 4fef 54e9 +93d 93e 54e9 54eb +bf1 93d 54e5 54ea +bf2 93d 54ea 54ec +93d bf3 54eb 54ec +93e 941 4ff5 54fd +bf3 93e 54eb 54fd +93f 940 4ff3 54bb +942 93f 4ff6 54cb +93f bdc 54bb 54cb +940 945 4ffc 54b0 +940 bd7 54b0 54b9 +940 bdc 54b9 54bb +941 943 4ff7 54fe +bf3 941 54fd 54fe +943 942 4ff8 5506 +942 bdc 54cb 54cd +942 be6 54cd 5507 +bfb 942 5506 5507 +bf3 943 54fe 5501 +bfb 943 5501 5506 +945 944 4ffb 54a9 +944 948 5003 54a8 +944 bd3 54a8 54a9 +945 bd3 54a9 54ab +945 bd4 54ab 54af +945 bd7 54af 54b0 +946 947 5000 5431 +948 946 5002 5432 +946 b91 5431 5434 +b93 946 5432 5433 +b94 946 5433 5434 +947 94b 5009 542d +947 b91 542d 5431 +948 b93 5432 54aa +bd3 948 54a8 54aa +94a 949 5007 51ec +949 94d 500f 51e9 +949 a3a 51e9 51ec +94b 94a 5008 542b +94a a3a 51ec 51ee +94a a3c 51ee 542b +94b a3c 542b 542c +94b b90 542c 542e +b91 94b 542d 542e +94e 94c 500d 5015 +94d 94e 500e 51e6 +94d a36 51e6 51e8 +94d a3a 51e8 51e9 +94e 950 5016 51e1 +94e a36 51e1 51e6 +950 94f 5013 51e2 +94f 951 5018 51e7 +a37 94f 51e2 51e7 +a36 950 51e1 51e3 +950 a37 51e2 51e5 +a38 950 51e3 51e4 +a39 950 51e4 51e5 +951 953 501a 51f2 +a37 951 51e7 51f2 +954 952 501b 541c +952 956 5022 5028 +952 95b 5028 541c +953 955 501c 541d +953 a37 51f1 51f2 +a39 953 51f1 51f3 +a3e 953 51f3 541d +955 954 501d 541e +954 95b 541c 5421 +b89 954 541e 5421 +a3e 955 541d 541f +955 b89 541e 5420 +b8a 955 541f 5420 +956 957 5021 5025 +956 959 5025 5029 +95b 956 5028 5029 +957 958 5023 5026 +959 957 5025 5027 +957 95a 5026 5027 +95a 958 5026 502c +958 95c 502a 502d +95d 958 502c 502d +959 95a 5027 5435 +95b 959 5029 5426 +b8e 959 5426 5439 +959 b95 5435 5438 +959 b97 5438 5439 +95a 95d 502c 5436 +b95 95a 5435 5437 +95a b96 5436 5437 +b89 95b 5421 5425 +b8d 95b 5425 5427 +95b b8e 5426 5427 +95d 95c 502d 543a +95c 95e 502f 543b +b98 95c 543a 543b +b96 95d 5436 543c +95d b98 543a 543c +95e 961 5034 5492 +b98 95e 543b 546d +bb4 95e 546d 5492 +95f 960 5033 65d6 +961 95f 5035 5494 +bc7 95f 5494 5496 +bc9 95f 5496 65d6 +960 964 503c 65d8 +bc9 960 65d6 65d7 +1584 960 65d7 65d8 +bb4 961 5492 5493 +bc7 961 5493 5494 +962 963 503a 64fc +964 962 503b 64fe +962 1506 64fc 64fe +963 967 5044 5056 +963 972 5056 64fd +1506 963 64fc 64fd +964 1506 64fe 6500 +964 1507 6500 65da +1584 964 65d8 65da +966 965 5043 5046 +965 968 5045 5047 +969 965 5046 5048 +965 96a 5047 5048 +967 966 5042 504b +966 969 5046 504a +966 96b 504a 504b +967 96b 504b 5053 +967 970 5053 5054 +967 971 5054 5055 +967 972 5055 5056 +96a 968 5047 504c +96c 968 504c 504f +968 96d 504d 504e +968 96e 504e 504f +969 96a 5048 5050 +96b 969 504a 5052 +969 96f 5050 5052 +96a 96c 504c 5051 +96f 96a 5050 5051 +96b 96f 5052 5fa3 +970 96b 5053 5fa3 +96c 96e 504f 5f3d +96f 96c 5051 5f40 +96c 11b3 5f3d 5f3f +96c 11b4 5f3f 5f40 +96e 96d 504e 5d27 +96d 974 505b 5d23 +96d 108c 5d23 5d27 +108c 96e 5d26 5d27 +96e 108d 5d26 5d28 +96e 108f 5d28 5f3e +11b3 96e 5f3d 5f3e +970 96f 5fa3 62e4 +96f 11b4 5f40 62da +96f 13dd 62da 62e4 +971 970 5054 62eb +970 13dd 62e4 62e5 +970 13e2 62e5 62eb +972 971 5055 62fc +971 13e2 62eb 62ed +971 13e7 62ed 62fb +971 13ee 62fb 62fc +972 13ee 62fc 64ff +1506 972 64fd 64ff +974 973 505a 5b3f +973 975 505d 5b3e +973 f89 5b3e 5b3f +974 f89 5b3f 5b40 +974 f8d 5b40 5d20 +974 108c 5d20 5d23 +975 97a 5065 5b2e +975 f89 5b2e 5b3e +978 976 5063 5b17 +976 97b 5067 5b17 +977 979 5062 5b14 +97a 977 5064 5b21 +977 f7e 5b14 5b19 +977 f82 5b19 5b21 +979 978 5061 5b0f +97b 978 5b16 5b17 +f7d 978 5b0f 5b11 +f7f 978 5b11 5b15 +f81 978 5b15 5b16 +979 f7d 5b0f 5b10 +979 f7e 5b10 5b14 +97a f82 5b21 5b27 +97a f86 5b27 5b2d +97a f89 5b2d 5b2e +97b 97c 5069 5b22 +f81 97b 5b16 5b22 +97c 97e 506b 5b2f +f81 97c 5b22 5b24 +f85 97c 5b24 5b2f +97e 97d 506c 5b41 +97d 97f 506f 577c +97d b16 577c 5b45 +f8b 97d 5b41 5b45 +f85 97e 5b2f 5b32 +f8b 97e 5b32 5b41 +97f 982 5076 5357 +97f b16 5357 577c +981 980 5074 5341 +980 984 5079 533f +980 b09 533f 5341 +982 981 5075 5349 +981 b09 5341 5345 +981 b0c 5345 5349 +982 b0c 5349 5351 +982 b12 5351 5358 +b16 982 5357 5359 +982 b17 5358 5359 +984 983 5078 533e +983 986 507f 5328 +983 afd 5328 533e +984 afd 533e 5340 +b09 984 533f 5340 +987 985 507d 51d4 +985 988 5081 51b6 +985 a18 51b6 51d4 +986 987 507e 5326 +986 afc 5326 5329 +afd 986 5328 5329 +987 a18 51d4 5324 +987 afb 5324 5327 +afc 987 5326 5327 +988 98a 5085 519e +988 a0f 519e 51a7 +988 a18 51a7 51b6 +98a 989 5084 518f +989 98c 5089 518d +989 a07 518d 518f +a07 98a 518e 518f +98a a09 518e 5193 +98a a0f 5193 519e +98c 98b 5088 5181 +98b 98d 508c 5176 +98b a01 5176 5181 +a01 98c 5180 5181 +98c a04 5180 5186 +98c a07 5186 518d +98d 98e 508f 5175 +98d a01 5175 5176 +98e 992 5097 5177 +a01 98e 5175 5177 +98f 990 5094 518b +991 98f 5096 517d +a05 98f 517d 5187 +a0a 98f 5187 518b +990 993 509b 519d +a0a 990 518b 5197 +a12 990 5197 519d +992 991 5098 5178 +a02 991 5178 517c +a05 991 517c 517d +a01 992 5177 517a +992 a02 5178 5179 +992 a03 5179 517b +a04 992 517a 517b +993 996 509f 51ae +a12 993 519d 51ae +994 995 509e 51b5 +996 994 50a0 51b2 +a1f 994 51b2 51b5 +995 997 50a3 51b8 +a1f 995 51b5 51b7 +a21 995 51b7 51b8 +a12 996 51ae 51af +a1c 996 51af 51b3 +996 a1f 51b2 51b4 +a20 996 51b3 51b4 +997 999 50a6 51d5 +a21 997 51b8 51c9 +a2b 997 51c9 51d5 +999 998 50a7 532f +998 99b 50aa 533a +b00 998 532f 533a +a2b 999 51d5 532b +afe 999 532b 532e +b00 999 532e 532f +99b 99a 50ab 53d3 +99a 99e 50b0 53d2 +99a b57 53d2 53d3 +b00 99b 533a 533d +b07 99b 533d 53d1 +b57 99b 53d1 53d3 +99c 99d 50ae 53c2 +99e 99c 50af 53c3 +99c b1c 53c2 53c3 +99d 9a0 50b8 5362 +99d b1c 5362 53c2 +99e b1c 53c3 53ca +99e b35 53ca 53cb +99e b57 53cb 53d2 +9a1 99f 50b5 50bc +9a0 9a2 50b7 51da +9a0 a32 51da 5363 +b1c 9a0 5362 5363 +9a2 9a1 50b6 50c0 +9a1 9a3 50bd 50bf +9a1 9a4 50bf 50c0 +9a2 9a4 50c0 51d6 +9a2 a30 51d6 51d9 +9a2 a32 51d9 51da +9a4 9a3 50bf 50c1 +9a4 9a6 50c7 51d7 +a30 9a4 51d6 51d8 +9a4 a31 51d7 51d8 +9a7 9a5 50c5 51de +9a5 9a8 50c9 51e0 +a33 9a5 51de 51df +a35 9a5 51df 51e0 +9a6 9a7 50c4 51db +a31 9a6 51d7 51dd +9a6 a33 51db 51dc +9a6 a34 51dc 51dd +a33 9a7 51db 51de +9a8 9a9 50cb 5200 +a35 9a8 51e0 51fd +a43 9a8 51fd 5200 +9a9 9aa 50cd 537c +a43 9a9 5200 536d +b22 9a9 536d 537c +9aa 9ac 50d0 5380 +b22 9aa 537c 5380 +9ac 9ab 50d1 539a +9ab 9ad 50d3 53df +b3a 9ab 539a 53de +b5e 9ab 53de 53df +b22 9ac 5380 5381 +b2b 9ac 5381 5396 +b37 9ac 5396 539b +9ac b3a 539a 539b +9ad 9af 50d7 53e4 +b5e 9ad 53df 53e3 +b60 9ad 53e3 53e4 +9b0 9ae 50d8 50e2 +9ae 9b1 50db 50e1 +9ae 9b5 50e1 50e2 +9af 9b0 50d9 53e7 +b60 9af 53e4 53e8 +9af b62 53e7 53e8 +9b0 9b5 50e2 53e9 +b62 9b0 53e7 53ea +9b0 b63 53e9 53ea +9b1 9b4 50e0 531f +9b5 9b1 50e1 531f +9b2 9b3 50de 52ef +9b4 9b2 50df 52f1 +9b2 9b8 52ef 52f0 +9b2 ad4 52f0 52f1 +9b3 9b8 50e8 52ef +9b5 9b4 531f 5321 +9b4 ad4 52f1 5320 +9b4 af9 5320 5321 +9b5 af9 5321 5755 +b63 9b5 53e9 5754 +d19 9b5 5754 5755 +9b6 9b7 50e6 5172 +9b8 9b6 50e7 5173 +9b6 9ed 5172 5174 +a00 9b6 5173 5174 +9b7 9ba 50eb 514e +9b7 9ed 514e 5172 +9b8 a00 5173 52f3 +ad4 9b8 52f0 52f2 +ad5 9b8 52f2 52f3 +9ba 9b9 50ea 5137 +9b9 9bb 50ef 512d +9b9 9d9 512d 5137 +9ba 9d9 5137 5139 +9ba 9e0 5139 514d +9ba 9ec 514d 514f +9ed 9ba 514e 514f +9bb 9bc 50f2 5126 +9bb 9d6 5126 512a +9bb 9d9 512a 512d +9bc 9c0 50f8 5125 +9bc 9d6 5125 5126 +9bd 9be 50f6 5143 +9c2 9bd 50fc 5143 +9c2 9be 5143 5145 +9be 9c3 5101 515f +9e7 9be 5145 515f +9c1 9bf 50fa 512e +9bf 9c2 50fb 5131 +9db 9bf 512e 5131 +9c0 9c1 50f9 5128 +9d6 9c0 5125 5127 +9d7 9c0 5127 5129 +9c0 9d8 5128 5129 +9d8 9c1 5128 512f +9c1 9db 512e 5130 +9dc 9c1 512f 5130 +9db 9c2 5131 513d +9e3 9c2 513d 5144 +9e7 9c2 5144 5145 +9c3 9c5 50ff 5168 +9e7 9c3 515f 5161 +9f6 9c3 5161 5168 +9c5 9c4 5100 66c4 +9c4 9c6 5103 66c1 +9c4 9fb 66c1 66c4 +9f6 9c5 5168 516a +9fb 9c5 516a 66c4 +9c6 9c7 5106 66c0 +9fb 9c6 66c1 66c3 +9c6 15e9 66c0 66c2 +9c6 15ea 66c2 66c3 +9c7 9c9 5109 66be +9c7 15e9 66be 66c0 +9c9 9c8 5108 55b2 +9c8 9ca 510d 5597 +9c8 c3f 5597 5598 +9c8 c48 5598 55b2 +9c9 c48 55b2 55b3 +9c9 c53 55b3 66bf +15e9 9c9 66be 66bf +9ca 9cb 510c 5595 +9ca c3f 5595 5597 +9cb 9cc 5111 557f +9cb c38 557f 5583 +9cb c3f 5583 5595 +9cc 9cd 5110 556c +9cc c30 556c 556e +9cc c38 556e 557f +9cd 9ce 5115 5571 +9cd c30 556a 556c +c31 9cd 556a 5571 +9ce 9d1 511b 5576 +9ce c31 5570 5571 +c33 9ce 5570 5576 +9d0 9cf 5118 551d +9cf 9d5 5123 550f +9cf c02 550f 551e +c08 9cf 551d 551e +9d1 9d0 511a 5562 +9d0 c08 551d 5563 +c2e 9d0 5562 5563 +9d1 c2e 5562 557b +9d1 c33 5575 5576 +c35 9d1 5575 557b +9d2 9d3 511e 54e8 +9d4 9d2 5121 54fc +9d2 b65 54e8 54fc +9d3 b65 53ed 54e8 +9d5 9d4 5122 54fa +b65 9d4 54f7 54fc +b66 9d4 54f6 54f7 +9d4 bf7 54f6 54fa +9d5 bf7 54fa 54fb +9d5 bf9 54fb 5510 +c02 9d5 550f 5510 +9d6 9d7 5127 512b +9d9 9d6 512a 512c +9d6 9da 512b 512c +9d7 9d8 5129 5132 +9da 9d7 512b 5133 +9d7 9dc 5132 5134 +9dd 9d7 5133 5135 +9d7 9de 5134 5135 +9d8 9dc 512f 5132 +9d9 9da 512c 5136 +9d9 9df 5136 5138 +9d9 9e0 5138 5139 +9da 9dd 5133 513a +9df 9da 5136 513b +9da 9e1 513a 513b +9dc 9db 5130 513c +9e2 9db 513c 513e +9db 9e3 513d 513f +9e4 9db 513e 513f +9de 9dc 5134 5140 +9dc 9e2 513c 5141 +9e5 9dc 5140 5142 +9dc 9e6 5141 5142 +9dd 9de 5135 5146 +9e1 9dd 513a 5147 +9dd 9e8 5146 5148 +9e9 9dd 5147 5148 +9de 9e5 5140 5149 +9e8 9de 5146 514a +9de 9ea 5149 514a +9e0 9df 5138 514b +9df 9e1 513b 514c +9eb 9df 514b 514c +9e0 9eb 514b 5150 +9ec 9e0 514d 5150 +9e1 9e9 5147 5151 +9eb 9e1 514c 5152 +9e1 9ee 5151 5152 +9e2 9e4 513e 5153 +9e6 9e2 5141 5154 +9e2 9ef 5153 5155 +9f0 9e2 5154 5155 +9e4 9e3 513f 5156 +9e3 9e7 5144 5157 +9f1 9e3 5156 5158 +9e3 9f2 5157 5158 +9ef 9e4 5153 5159 +9e4 9f1 5156 5159 +9e5 9e6 5142 515a +9ea 9e5 5149 515b +9e5 9f3 515a 515c +9f4 9e5 515b 515c +9e6 9f0 5154 515e +9f3 9e6 515a 515d +9f5 9e6 515d 515e +9f2 9e7 5157 5160 +9f6 9e7 5160 5161 +9e9 9e8 5148 516b +9e8 9ea 514a 516c +9fc 9e8 516b 516d +9e8 9fd 516c 516e +9fe 9e8 516d 516e +9ee 9e9 5151 516f +9e9 9fc 516b 5170 +9ff 9e9 516f 5170 +9ea 9f4 515b 5171 +9fd 9ea 516c 5171 +9ec 9eb 5150 52b8 +9eb 9ee 5152 529c +9eb aa6 529c 52b6 +9eb ab5 52b6 52b8 +9ed 9ec 514f 52e3 +9ec a00 52e0 52e3 +9ec ab5 52b8 52e0 +a00 9ed 5174 52e3 +9ee 9ff 516f 5289 +9ee a96 5289 528a +9ee a9b 528a 529a +9ee aa6 529a 529c +9f0 9ef 5155 6717 +9ef 9f1 5159 5167 +9ef 9fa 5167 6710 +9ef 1606 6710 6717 +9f5 9f0 515e 6718 +9f0 1606 6717 6719 +1609 9f0 6718 6719 +9f1 9f2 5158 5162 +9f1 9f7 5162 5165 +9f1 9f9 5165 5166 +9f1 9fa 5166 5167 +9f2 9f6 5160 5163 +9f7 9f2 5162 5164 +9f2 9f8 5163 5164 +9f4 9f3 515c 6713 +9f3 9f5 515d 6715 +1607 9f3 6713 6716 +9f3 1608 6715 6716 +9fd 9f4 5171 6712 +ad3 9f4 6712 6714 +9f4 1607 6713 6714 +1608 9f5 6715 671a +9f5 1609 6718 671a +9f8 9f6 5163 5169 +9fb 9f6 5169 516a +9f7 9f8 5164 6707 +9f9 9f7 5165 6709 +9f7 1600 6707 6709 +9f8 9fb 5169 6704 +9f8 1600 6706 6707 +9f8 1601 6705 6706 +9f8 1603 6704 6705 +9fa 9f9 5166 670c +1600 9f9 6708 6709 +9f9 1602 6708 670a +9f9 1604 670a 670c +9fa 1604 670c 670e +9fa 1605 670e 6711 +1606 9fa 6710 6711 +9fb 15ea 66c3 6703 +9fb 1603 6703 6704 +9fc 9fe 516d 52b5 +9ff 9fc 5170 5299 +a9d 9fc 5299 52a0 +aa9 9fc 52a0 52b5 +9fe 9fd 516e 52df +aba 9fd 52df 52ed +ad3 9fd 52ed 6712 +aa9 9fe 52b5 52bf +aba 9fe 52bf 52df +9ff a96 5287 5289 +a97 9ff 5287 528c +a9d 9ff 528c 5299 +a00 ab5 52e0 52e2 +a00 acd 52e2 6746 +ad5 a00 52f3 6746 +a01 a04 517a 5180 +a03 a02 5179 517e +a02 a05 517c 517f +a06 a02 517e 517f +a04 a03 517b 5182 +a03 a06 517e 5183 +a07 a03 5182 5184 +a03 a08 5183 5185 +a09 a03 5184 5185 +a04 a07 5182 5186 +a06 a05 517f 5188 +a05 a0a 5187 5189 +a0b a05 5188 518a +a05 a0c 5189 518a +a08 a06 5183 518c +a06 a0b 5188 518c +a07 a09 5184 518e +a09 a08 5185 5190 +a08 a0b 518c 5191 +a0d a08 5190 5192 +a08 a0e 5191 5192 +a09 a0d 5190 5194 +a0f a09 5193 5195 +a09 a10 5194 5195 +a0c a0a 5189 5196 +a11 a0a 5196 5198 +a0a a12 5197 5198 +a0b a0c 518a 5199 +a0e a0b 5191 519a +a0b a13 5199 519a +a0c a11 5196 519c +a13 a0c 5199 519b +a14 a0c 519b 519c +a0d a0e 5192 519f +a10 a0d 5194 51a0 +a0d a15 519f 51a1 +a16 a0d 51a0 51a2 +a0d a17 51a1 51a2 +a0e a13 519a 51a3 +a15 a0e 519f 51a3 +a0f a10 5195 51a4 +a0f a18 51a4 51a7 +a10 a16 51a0 51a6 +a18 a10 51a4 51a5 +a19 a10 51a5 51a6 +a11 a12 5198 51ab +a14 a11 519c 51ac +a11 a1c 51ab 51ad +a1d a11 51ac 51ad +a1c a12 51ab 51af +a13 a14 519b 51a8 +a15 a13 51a3 51aa +a13 a1a 51a8 51a9 +a13 a1b 51a9 51aa +a1a a14 51a8 51b1 +a14 a1d 51ac 51b0 +a14 a1e 51b0 51b1 +a17 a15 51a1 51d0 +a15 a1b 51aa 51d0 +a16 a17 51a2 5c16 +a19 a16 51a6 5c00 +a2e a16 5c05 5c16 +b19 a16 5c00 5c01 +ff4 a16 5c01 5c05 +a17 a1b 51d0 51d1 +a17 a2e 51d1 5c16 +a18 a19 51a5 5325 +afb a18 5324 5325 +afb a19 5325 535a +b0f a19 535a 535d +b19 a19 535d 5c00 +a1b a1a 51a9 51c7 +a1a a1e 51b1 51c2 +a1a a26 51c2 51c7 +a1b a26 51c7 51d3 +a2e a1b 51d1 51d2 +a2f a1b 51d2 51d3 +a1d a1c 51ad 51b9 +a1c a20 51b3 51ba +a22 a1c 51b9 51ba +a1e a1d 51b0 51bb +a1d a22 51b9 51bb +a1e a22 51bb 51c0 +a1e a25 51c0 51c3 +a26 a1e 51c2 51c6 +a1e a27 51c3 51c4 +a1e a28 51c4 51c5 +a1e a29 51c5 51c6 +a20 a1f 51b4 51bd +a1f a21 51b7 51bd +a20 a21 51bd 51be +a22 a20 51ba 51bc +a23 a20 51bc 51bf +a20 a24 51be 51bf +a24 a21 51be 51c8 +a2a a21 51c8 51ca +a21 a2b 51c9 51ca +a22 a23 51bc 51c1 +a25 a22 51c0 51c1 +a23 a24 51bf 51cb +a25 a23 51c1 51cc +a23 a2c 51cb 51cc +a24 a2a 51c8 51cd +a2c a24 51cb 51ce +a24 a2d 51cd 51ce +a27 a25 51c3 51cf +a25 a2c 51cc 51cf +a26 a29 51c6 6913 +a2f a26 51d3 6913 +a28 a27 51c4 6942 +a27 a2c 51cf 5336 +a27 b02 5336 6943 +172e a27 6942 6943 +a29 a28 51c5 6944 +171a a28 6944 6946 +a28 1729 6945 6946 +a28 172e 6942 6945 +a29 a2f 6912 6913 +1003 a29 6912 6914 +171a a29 6914 6944 +a2a a2b 51ca 532a +a2d a2a 51cd 532d +a2a afe 532a 532c +a2a aff 532c 532d +afe a2b 532a 532b +a2c a2d 51ce 5332 +a2c b02 5332 5336 +a2d aff 532d 5333 +b02 a2d 5332 5335 +a2d b03 5333 5334 +a2d b04 5334 5335 +a2e a2f 51d2 5c17 +ff4 a2e 5c05 5c06 +ff8 a2e 5c06 5c17 +ff8 a2f 5c17 5c19 +1003 a2f 5c19 6912 +a30 a31 51d8 51fb +a32 a30 51d9 5202 +a30 a42 51fb 5201 +a30 a45 5201 5202 +a31 a34 51dd 51fa +a31 a42 51fa 51fb +a32 a45 5202 538f +b1c a32 5363 53c4 +a32 b33 538f 53c4 +a34 a33 51dc 51f6 +a33 a35 51df 51f7 +a3f a33 51f6 51f9 +a33 a40 51f7 51f8 +a33 a41 51f8 51f9 +a34 a3f 51f6 51fc +a42 a34 51fa 51fc +a40 a35 51f7 51fe +a35 a43 51fd 51ff +a44 a35 51fe 51ff +a36 a38 51e3 51eb +a3a a36 51e8 51ea +a3b a36 51ea 51eb +a39 a37 51e5 51f1 +a38 a39 51e4 51ef +a3b a38 51eb 51f0 +a38 a3d 51ef 51f0 +a3d a39 51ef 51f4 +a39 a3e 51f3 51f4 +a3a a3b 51ea 51ed +a3a a3c 51ed 51ee +a3c a3b 51ed 51f5 +a3b a3d 51f0 51f5 +a3c a3d 51f5 5430 +b90 a3c 542c 542f +b92 a3c 542f 5430 +a3d a3e 51f4 5424 +a3d b8c 5424 695e +b92 a3d 5430 695e +a3e b8a 541f 5422 +a3e b8b 5422 5423 +a3e b8c 5423 5424 +a3f a41 51f9 5365 +a42 a3f 51fc 536a +a3f b1d 5365 5369 +a3f b20 5369 536a +a41 a40 51f8 5364 +a40 a44 51fe 5364 +a41 a44 5364 5366 +b1d a41 5365 5367 +a41 b1e 5366 5368 +b1f a41 5367 5368 +a45 a42 5201 5378 +a42 b20 536a 5378 +a44 a43 51ff 536b +b21 a43 536b 536e +a43 b22 536d 536e +b1e a44 5366 536c +a44 b21 536b 536c +a45 b20 5378 537a +a45 b2a 537a 538e +a45 b33 538e 538f +a47 a46 5203 5204 +a46 a48 5203 5205 +a49 a46 5204 5206 +a46 a4a 5205 5207 +a4b a46 5206 5208 +a46 a4c 5207 5208 +a48 a47 5203 5209 +a47 a49 5204 520a +a4d a47 5209 520b +a47 a4e 520a 520c +a4f a47 520b 520c +a4a a48 5205 520d +a48 a4d 5209 520e +a50 a48 520d 520f +a48 a51 520e 520f +a49 a4b 5206 5210 +a4e a49 520a 5211 +a49 a52 5210 5212 +a53 a49 5211 5212 +a4c a4a 5207 5213 +a4a a50 520d 5214 +a54 a4a 5213 5215 +a4a a55 5214 5215 +a4b a4c 5208 5216 +a52 a4b 5210 5217 +a4b a56 5216 5218 +a57 a4b 5217 5219 +a4b a58 5218 5219 +a4c a54 5213 521a +a56 a4c 5216 521b +a4c a59 521a 521b +a4d a4f 520b 521c +a51 a4d 520e 521d +a4d a5a 521c 521e +a5b a4d 521d 521e +a4f a4e 520c 521f +a4e a53 5211 5220 +a5c a4e 521f 5221 +a4e a5d 5220 5221 +a5a a4f 521c 5222 +a4f a5c 521f 5223 +a5e a4f 5222 5223 +a50 a51 520f 5224 +a55 a50 5214 5225 +a50 a5f 5224 5226 +a60 a50 5225 5226 +a51 a5b 521d 5227 +a5f a51 5224 5227 +a53 a52 5212 5228 +a52 a57 5217 5229 +a61 a52 5228 522a +a52 a62 5229 522a +a5d a53 5220 522b +a53 a61 5228 522c +a63 a53 522b 522c +a54 a55 5215 522d +a59 a54 521a 522e +a54 a64 522d 522f +a65 a54 522e 5230 +a54 a66 522f 5230 +a55 a60 5225 5231 +a64 a55 522d 5232 +a55 a67 5231 5232 +a58 a56 5218 5233 +a56 a59 521b 5234 +a68 a56 5233 5234 +a57 a58 5219 5235 +a62 a57 5229 5236 +a57 a69 5235 5237 +a6a a57 5236 5237 +a58 a68 5233 5238 +a69 a58 5235 5238 +a59 a65 522e 5239 +a68 a59 5234 523a +a59 a6b 5239 523a +a5b a5a 521e 523b +a5a a5e 5222 523c +a6c a5a 523b 523d +a5a a6d 523c 523e +a6e a5a 523d 523e +a5f a5b 5227 523f +a5b a6c 523b 523f +a5c a5d 5221 5240 +a5e a5c 5223 5241 +a5c a6f 5240 5242 +a70 a5c 5241 5242 +a5d a63 522b 5243 +a6f a5d 5240 5244 +a5d a71 5243 5245 +a72 a5d 5244 5245 +a6d a5e 523c 5246 +a5e a70 5241 5247 +a73 a5e 5246 5247 +a60 a5f 5226 5248 +a5f a6c 523f 5249 +a74 a5f 5248 5249 +a67 a60 5231 524a +a60 a74 5248 524b +a75 a60 524a 524d +a60 a76 524b 524c +a60 a77 524c 524d +a61 a62 522a 524e +a63 a61 522c 524f +a61 a78 524e 5250 +a79 a61 524f 5250 +a62 a6a 5236 5251 +a78 a62 524e 5252 +a62 a7a 5251 5253 +a7b a62 5252 5253 +a71 a63 5243 5254 +a63 a79 524f 5254 +a66 a64 522f 5255 +a64 a67 5232 5256 +a7c a64 5255 5256 +a65 a66 5230 5257 +a6b a65 5239 5258 +a65 a7d 5257 5259 +a7e a65 5258 5259 +a66 a7c 5255 525a +a7d a66 5257 525a +a67 a75 524a 525b +a7c a67 5256 525c +a67 a7f 525b 525c +a69 a68 5238 525e +a68 a6b 523a 525d +a68 a80 525d 525f +a81 a68 525e 525f +a6a a69 5237 5263 +a69 a81 525e 5264 +a84 a69 5263 5264 +a7a a6a 5251 5266 +a6a a84 5263 5265 +a6a a85 5265 5266 +a6b a7e 5258 5260 +a80 a6b 525d 5262 +a6b a82 5260 5261 +a6b a83 5261 5262 +a6c a6e 523d 5267 +a74 a6c 5249 5268 +a6c a86 5267 5269 +a87 a6c 5268 526a +a6c a88 5269 526a +a6e a6d 523e 526b +a6d a73 5246 526c +a89 a6d 526b 526d +a6d a8a 526c 526d +a86 a6e 5267 526e +a6e a89 526b 526e +a70 a6f 5242 526f +a6f a72 5244 5270 +a8b a6f 526f 5271 +a6f a8c 5270 5272 +a8d a6f 5271 5272 +a73 a70 5247 5273 +a70 a8b 526f 5273 +a72 a71 5245 5274 +a71 a79 5254 5277 +a8e a71 5274 5277 +a8c a72 5270 5275 +a72 a8e 5274 5276 +a8f a72 5275 5276 +a8a a73 526c 5278 +a73 a8b 5273 5279 +a90 a73 5278 5279 +a76 a74 524b 527a +a74 a87 5268 527a +a75 a77 524d 527e +a7f a75 525b 5281 +a75 a93 527e 5280 +a75 a94 5280 5281 +a77 a76 524c 527b +a76 a87 527a 527c +a91 a76 527b 527d +a76 a92 527c 527d +a77 a91 527b 527f +a93 a77 527e 527f +a79 a78 5250 69f9 +a78 a7b 5252 6a06 +177a a78 69f9 6a02 +177e a78 6a02 6a06 +a8e a79 5277 69f1 +1776 a79 69f1 69f8 +177a a79 69f8 69f9 +a7b a7a 5253 789d +a7a a85 5266 78a4 +179c a7a 789d 789f +1ec5 a7a 789f 78a4 +177e a7b 6a06 6a44 +179c a7b 6a44 789d +a7d a7c 525a 7350 +a7c a7f 525c 6a8f +a7c 17c2 6a8f 734f +a7c 1c5b 734f 7350 +a7e a7d 5259 7354 +a7d 1c5b 7350 7353 +a7d 1c5d 7353 7354 +a82 a7e 5260 7881 +a7e 1c5d 7354 787c +a7e 1eb7 787c 7881 +a7f a94 5281 6a49 +a7f 17a0 6a49 6a8d +a7f 17c2 6a8d 6a8f +a81 a80 525f 7889 +a80 a83 5262 7884 +a80 1eba 7884 7889 +a84 a81 5264 788c +a81 1eba 7889 788b +a81 1ebe 788b 788d +1ebf a81 788c 788d +a83 a82 5261 7883 +a82 1eb7 7881 7882 +a82 1eb9 7882 7883 +a83 1eb9 7883 7885 +1eba a83 7884 7886 +a83 1ebb 7885 7887 +1ebc a83 7886 7888 +a83 1ebd 7887 7888 +a85 a84 5265 7897 +a84 1ebf 788c 7897 +a85 1ebf 7897 789a +a85 1ec3 789a 78ae +1ec5 a85 78a4 78a5 +1ec7 a85 78a5 78ab +1ecb a85 78ab 78ae +a88 a86 5269 5805 +a86 a89 526e 5806 +ac2 a86 5805 5806 +a87 a88 526a 5808 +a92 a87 527c 580a +a87 ac6 5808 580a +a88 ab1 52d7 52d8 +ac2 a88 52d7 5805 +a88 ac6 52d8 5808 +a89 a8a 526d 580c +ac1 a89 5804 5807 +a89 ac2 5804 5806 +ac4 a89 5807 580b +d40 a89 580b 580c +a8a a90 5278 5747 +d2b a8a 5745 5747 +a8a d2c 5745 5749 +a8a d40 5749 580c +a8b a8d 5271 5816 +a90 a8b 5279 5816 +a8d a8c 5272 581b +a8c a8f 5275 69e5 +daf a8c 581b 69e7 +a8c 1772 69e5 69e6 +a8c 1773 69e6 69e7 +a90 a8d 5816 5817 +d41 a8d 5817 5818 +daf a8d 5818 581b +a8f a8e 5276 69e9 +1774 a8e 69e9 69f0 +1776 a8e 69f0 69f1 +1772 a8f 69e5 69e8 +1774 a8f 69e8 69e9 +d2b a90 5747 5748 +d41 a90 5748 5817 +a91 a92 527d 580e +a93 a91 527f 5811 +a91 ac5 580e 580f +a91 ac8 580f 5811 +a92 ac5 5809 580e +ac6 a92 5809 580a +a94 a93 5280 6a45 +a93 ac8 5811 5813 +a93 dae 5813 6a45 +a94 dae 6a45 6a46 +a94 f02 6a46 6a47 +a94 f03 6a47 6a48 +a94 17a0 6a48 6a49 +a96 a95 5282 5283 +a95 a97 5282 5284 +a98 a95 5283 5285 +a95 a99 5284 5286 +a9a a95 5285 5286 +a97 a96 5282 5287 +a96 a98 5283 5288 +a96 a9b 5288 528a +a99 a97 5284 528b +a9c a97 528b 528d +a97 a9d 528c 528e +a9e a97 528d 528e +a98 a9a 5285 528f +a9b a98 5288 5290 +a98 a9f 528f 5291 +aa0 a98 5290 5291 +a9a a99 5286 5292 +a99 a9c 528b 5293 +aa1 a99 5292 5294 +a99 aa2 5293 5295 +aa3 a99 5294 5295 +a9f a9a 528f 5296 +a9a aa1 5292 5297 +aa4 a9a 5296 5298 +a9a aa5 5297 5298 +a9b aa0 5290 529b +aa6 a9b 529a 529b +a9c a9e 528d 529d +aa2 a9c 5293 529e +a9c aa7 529d 529e +a9e a9d 528e 529f +aa8 a9d 529f 52a1 +a9d aa9 52a0 52a1 +aa7 a9e 529d 52a2 +a9e aa8 529f 52a2 +aa0 a9f 5291 52a3 +a9f aa4 5296 52a4 +aaa a9f 52a3 52a4 +aa6 aa0 529b 52a5 +aa0 aaa 52a3 52a6 +aab aa0 52a5 52a7 +aa0 aac 52a6 52a7 +aa1 aa3 5294 52a8 +aa5 aa1 5297 52a9 +aa1 aad 52a8 52aa +aae aa1 52a9 52aa +aa3 aa2 5295 52ab +aa2 aa7 529e 52ac +aaf aa2 52ab 52ad +aa2 ab0 52ac 52ad +aad aa3 52a8 52ae +aa3 aaf 52ab 52af +ab1 aa3 52ae 52af +aa4 aa5 5298 52b0 +aaa aa4 52a4 52b1 +aa4 ab2 52b0 52b1 +aa5 aae 52a9 52b2 +ab2 aa5 52b0 52b3 +aa5 ab3 52b2 52b4 +ab4 aa5 52b3 52b4 +aa6 aab 52a5 52b7 +ab5 aa6 52b6 52b7 +aa7 aa8 52a2 52b9 +ab0 aa7 52ac 52ba +aa7 ab6 52b9 52ba +aa8 aa9 52a1 52bb +ab6 aa8 52b9 52bd +aa8 ab7 52bb 52bc +aa8 ab8 52bc 52be +ab9 aa8 52bd 52be +ab7 aa9 52bb 52c0 +aa9 aba 52bf 52c0 +aac aaa 52a6 52c1 +aaa ab2 52b1 52c2 +abb aaa 52c1 52c4 +aaa abc 52c2 52c3 +aaa abd 52c3 52c4 +aab aac 52a7 52c5 +ab5 aab 52b7 52c6 +aab abe 52c5 52c7 +abf aab 52c6 52c7 +aac abb 52c1 52c8 +abe aac 52c5 52c9 +aac ac0 52c8 52c9 +aae aad 52aa 52ca +aad ab1 52ae 52cb +ac1 aad 52ca 52cc +aad ac2 52cb 52cc +ab3 aae 52b2 52cd +aae ac1 52ca 52ce +ac3 aae 52cd 52cf +aae ac4 52ce 52cf +aaf ab0 52ad 52d0 +ab1 aaf 52af 52d1 +aaf ac5 52d0 52d2 +ac6 aaf 52d1 52d2 +ab0 ab6 52ba 52d3 +ac5 ab0 52d0 52d4 +ab0 ac7 52d3 52d6 +ac8 ab0 52d4 52d5 +ac9 ab0 52d5 52d6 +ac2 ab1 52cb 52d7 +ab1 ac6 52d1 52d8 +ab2 ab4 52b3 52d9 +abc ab2 52c2 52da +ab2 aca 52d9 52da +ab4 ab3 52b4 52db +ab3 ac3 52cd 52de +acb ab3 52db 52de +aca ab4 52d9 52dc +ab4 acb 52db 52dd +acc ab4 52dc 52dd +ab5 abf 52c6 52e1 +ab5 acd 52e1 52e2 +ab6 ab9 52bd 52e6 +ac7 ab6 52d3 52e6 +ab8 ab7 52bc 52e4 +ab7 aba 52c0 52e5 +ace ab7 52e4 52e5 +ab9 ab8 52be 52e7 +ab8 ace 52e4 52ec +acf ab8 52e7 52ea +ad1 ab8 52ea 52eb +ad2 ab8 52eb 52ec +ac7 ab9 52e6 52e8 +ab9 acf 52e7 52e9 +ad0 ab9 52e8 52e9 +ace aba 52e5 52ee +aba ad3 52ed 52ee +abb abd 52c4 56a5 +ac0 abb 52c8 56a5 +abd abc 52c3 56a3 +abc aca 52da 56a7 +ce7 abc 56a3 56a7 +abd ac0 56a4 56a5 +ce7 abd 56a2 56a3 +abd ce8 56a2 56a4 +abf abe 52c7 56c1 +abe ac0 52c9 56af +abe cee 56af 56c0 +abe cf9 56c0 56c1 +acd abf 52e1 56de +abf cf9 56c1 56de +ac0 ce8 56a4 56ab +ac0 cec 56ab 56ad +ac0 ced 56ad 56ae +ac0 cee 56ae 56af +ac1 ac2 52cc 5804 +ac4 ac1 52ce 5807 +ac3 ac4 52cf 580d +acb ac3 52de 56f5 +d13 ac3 56f5 5744 +d40 ac3 5744 580d +ac4 d40 580b 580d +ac6 ac5 52d2 5809 +ac5 ac8 52d4 580f +ac9 ac7 52d6 5814 +ac7 ad0 52e8 5814 +ac8 ac9 52d5 5810 +ac8 dad 5810 5812 +ac8 dae 5812 5813 +ac9 ad0 5814 5815 +dad ac9 5810 5815 +aca acc 52dc 56b6 +ce7 aca 56a7 56a9 +ceb aca 56a9 56b4 +cf2 aca 56b4 56b5 +cf3 aca 56b5 56b6 +acc acb 52dd 56cd +cf3 acb 56cd 56cf +d00 acb 56cf 56f4 +d13 acb 56f4 56f5 +cf3 acc 56b6 56cd +acd ad5 56df 6746 +acd cf9 56de 56df +ad2 ace 52ec 5a62 +ace ad3 52ee 671e +f13 ace 5a62 671e +ad0 acf 52e9 5a33 +acf ad1 52ea 5a0f +acf edc 5a0f 5a10 +acf eea 5a10 5a33 +dad ad0 5815 5a34 +ad0 eea 5a33 5a34 +ad1 ad2 52eb 5a32 +ad1 edc 5a0d 5a0f +ee6 ad1 5a0d 5a2b +efb ad1 5a2b 5a32 +efb ad2 5a32 5a5a +f13 ad2 5a5a 5a62 +ad3 f13 671d 671e +ad3 15e4 671b 671c +ad3 1607 6714 671b +ad3 160a 671c 671d +ad4 ad5 52f2 5323 +af9 ad4 5320 5322 +afa ad4 5322 5323 +afa ad5 5323 56dd +cf9 ad5 56dd 56df +ad7 ad6 52f4 8c5e +ad6 ad8 52f4 8c5f +ad6 ad9 52f5 52f7 +ada ad6 52f5 8bfc +ad6 adb 52f7 8c5e +253c ad6 8bfc 8c5f +ad8 ad7 52f4 7df4 +adb ad7 52f6 8c5e +ad7 adc 52f6 8c18 +2245 ad7 7df4 8c00 +2403 ad7 8c00 8c18 +ad8 2245 7df4 8bca +2248 ad8 83d9 8bca +ad8 253c 83d9 8c5f +ad9 ada 52f5 52fb +adb ad9 52f7 52f9 +ade ad9 52f9 52fd +ad9 adf 52fb 52fe +ae1 ad9 52fd 52ff +ad9 ae2 52fe 52ff +adf ada 52fb 52fc +ae0 ada 52fc 8b1f +253c ada 8b1f 8bfc +adc adb 52f6 52f8 +add adb 52f8 52fa +adb ade 52f9 52fa +adc add 52f8 7054 +adc 1ae3 7054 814a +adc 2403 814a 8c18 +add ade 52fa 5300 +add ae3 5300 5301 +add ae4 5301 8ae7 +1ae3 add 7054 83d8 +253b add 83d8 8ae7 +ade ae1 52fd 5302 +ae3 ade 5300 5303 +ade ae5 5302 5303 +adf ae0 52fc 5304 +ae2 adf 52fe 5305 +adf ae6 5304 5306 +ae7 adf 5305 5306 +ae6 ae0 5304 5307 +ae8 ae0 5307 5308 +ae9 ae0 5308 83de +253c ae0 83de 8b1f +ae1 ae2 52ff 5309 +ae5 ae1 5302 530b +ae1 aea 5309 530c +aeb ae1 530b 530c +ae2 ae7 5305 530a +aea ae2 5309 530a +ae4 ae3 5301 5318 +ae3 ae5 5303 5319 +af4 ae3 5318 5319 +ae4 af4 5318 531a +ae4 af5 531a 83d6 +ae4 253b 83d6 8ae7 +ae5 aeb 530b 531d +af4 ae5 5319 531e +af6 ae5 531b 531d +ae5 af7 531b 531c +ae5 af8 531c 531e +ae7 ae6 5306 530e +ae6 ae8 5307 530d +ae6 aec 530d 530f +aed ae6 530e 530f +aea ae7 530a 5314 +ae7 aed 530e 5317 +af1 ae7 5314 5315 +af2 ae7 5315 5316 +af3 ae7 5316 5317 +ae8 ae9 5308 5310 +aec ae8 530d 5312 +ae8 aee 5310 5311 +ae8 aef 5311 5312 +aee ae9 5310 5313 +af0 ae9 5313 8bc7 +ae9 17c6 83dd 8bc7 +ae9 253c 83de 8bfd +253d ae9 83dd 8bfd +aeb aea 530c 7037 +aea af1 5314 7037 +af1 aeb 7026 7037 +af6 aeb 531d 7024 +1ace aeb 7024 7026 +aed aec 530f 79f3 +aec aef 5312 79f0 +aec 1aec 79f0 79f1 +aec 1f2b 79f1 79f3 +af3 aed 5317 79f4 +aed 1f2b 79f3 79f4 +aef aee 5311 6a9c +aee af0 5313 6a98 +aee fdc 6a98 6a9a +aee 17c8 6a9a 6a9c +aef 17c8 6a9c 7064 +aef 1aec 7064 79f0 +b56 af0 5bc4 83dc +af0 fd5 5bc4 5bc9 +af0 fdc 5bc9 6a98 +17c6 af0 6a99 8bc7 +af0 17c7 6a99 83dc +af1 af2 5315 7039 +af1 1ace 7025 7026 +1ad3 af1 7025 7033 +1ad8 af1 7033 7038 +1ada af1 7038 7039 +af2 af3 5316 704c +1ada af2 7039 704a +1ae1 af2 704a 704c +1ae1 af3 704c 79e0 +1f29 af3 79e0 79e3 +1f2b af3 79e3 79f4 +af5 af4 531a 7040 +af4 af8 531e 7036 +af4 1ad6 7036 7040 +af5 1ad6 7040 7042 +af5 1add 7042 83d5 +af5 253b 83d5 83d6 +af7 af6 531b 7017 +1aca af6 7017 7018 +1ace af6 7018 7024 +af8 af7 531c 7023 +1aca af7 7015 7017 +af7 1acc 7015 701d +af7 1ad1 701d 7023 +af8 1ad1 7023 702d +af8 1ad6 702d 7036 +af9 afa 5322 56db +af9 cf8 56db 56dc +af9 d05 56dc 56ff +af9 d19 56ff 5755 +cee afa 56c2 56c3 +afa cf8 56c2 56db +cf9 afa 56c3 56dd +afc afb 5327 534b +b0f afb 534b 535a +afd afc 5329 5343 +b0b afc 5343 534a +b0f afc 534a 534b +b09 afd 5340 5342 +b0a afd 5342 5344 +afd b0b 5343 5344 +aff afe 532c 5330 +afe b00 532e 5331 +b01 afe 5330 5331 +aff b01 5330 5338 +b03 aff 5333 5339 +b05 aff 5337 5338 +aff b06 5337 5339 +b01 b00 5331 533c +b07 b00 533b 533d +b00 b08 533b 533c +b05 b01 5338 53d4 +b01 b08 533c 53d4 +b02 b04 5335 6941 +b02 1728 6941 6947 +172e b02 6943 6947 +b04 b03 5334 6940 +b03 b06 5339 6940 +b06 b04 6931 6940 +b5c b04 692f 6931 +b04 1720 692f 6930 +b04 1722 6930 6935 +b04 1728 6935 6941 +b06 b05 5337 53d8 +b08 b05 53cd 53d4 +b05 b36 53cd 53ce +b05 b58 53ce 53d8 +b58 b06 53d7 53d8 +b06 b59 53d7 53db +b06 b5c 53db 6931 +b08 b07 533b 53c9 +b07 b34 53c8 53c9 +b57 b07 53c8 53d1 +b34 b08 53c7 53c9 +b08 b36 53c7 53cd +b09 b0a 5342 5346 +b0c b09 5345 5347 +b09 b0d 5346 5348 +b0e b09 5347 5348 +b0a b0b 5344 534c +b0d b0a 5346 534d +b0a b10 534c 534e +b11 b0a 534d 534e +b0b b0f 534a 534f +b10 b0b 534c 534f +b0c b0e 5347 5350 +b0c b12 5350 5351 +b0e b0d 5348 5352 +b0d b11 534d 5353 +b13 b0d 5352 5353 +b12 b0e 5350 5356 +b0e b13 5352 5354 +b0e b14 5354 5355 +b0e b15 5355 5356 +b10 b0f 534f 535b +b18 b0f 535b 535c +b19 b0f 535c 535d +b11 b10 534e 535e +b10 b18 535b 535e +b13 b11 5353 5360 +b11 b18 535e 535f +b11 b1a 535f 5361 +b1b b11 5360 5361 +b12 b15 5356 5c12 +b17 b12 5358 5c13 +b12 1001 5c12 5c13 +b14 b13 5354 5bfb +b13 b1b 5360 5bfa +b13 ff5 5bfa 5bfb +b15 b14 5355 5c0b +b14 ff5 5bfb 5c07 +b14 ffa 5c07 5c0c +ffd b14 5c0b 5c0c +b15 ffd 5c0b 5c14 +1001 b15 5c12 5c15 +b15 1002 5c14 5c15 +b16 b17 5359 5b44 +b16 f8b 5b44 5b45 +f8a b17 5b42 5b43 +b17 f8b 5b42 5b44 +f8f b17 5b43 5c3f +b17 1001 5c13 5c3f +b18 b19 535c 5bf8 +b1a b18 535f 5bf7 +ff3 b18 5bf7 5bf9 +b18 ff4 5bf8 5bf9 +ff4 b19 5bf8 5c01 +b1b b1a 5361 5bfc +b1a ff3 5bf7 5bfd +ff6 b1a 5bfc 5bfe +b1a ff7 5bfd 5bfe +ff5 b1b 5bfa 5bff +b1b ff6 5bfc 5bff +b1c b33 53c4 53c5 +b1c b35 53c5 53ca +b1d b1f 5367 536f +b20 b1d 5369 5370 +b1d b23 536f 5371 +b24 b1d 5370 5372 +b1d b25 5371 5372 +b1f b1e 5368 5373 +b1e b21 536c 5374 +b26 b1e 5373 5375 +b1e b27 5374 5375 +b23 b1f 536f 5376 +b1f b26 5373 5377 +b28 b1f 5376 5377 +b20 b24 5370 5379 +b20 b29 5379 537b +b2a b20 537a 537b +b21 b22 536e 537d +b27 b21 5374 537e +b21 b2b 537d 537f +b2c b21 537e 537f +b2b b22 537d 5381 +b25 b23 5371 5382 +b23 b28 5376 5383 +b2d b23 5382 5384 +b23 b2e 5383 5384 +b24 b25 5372 5385 +b29 b24 5379 5385 +b29 b25 5385 5386 +b25 b2d 5382 5387 +b2f b25 5386 5387 +b26 b27 5375 5388 +b28 b26 5377 5389 +b26 b30 5388 5389 +b27 b2c 537e 538a +b30 b27 5388 538b +b27 b31 538a 538b +b2e b28 5383 538c +b28 b30 5389 538d +b32 b28 538c 538d +b2a b29 537b 5390 +b29 b2f 5386 5394 +b34 b29 5390 5393 +b36 b29 5393 5394 +b33 b2a 538e 5391 +b2a b34 5390 5392 +b35 b2a 5391 5392 +b2c b2b 537f 5395 +b37 b2b 5395 5396 +b31 b2c 538a 5399 +b2c b37 5395 5397 +b2c b38 5397 5398 +b2c b39 5398 5399 +b2d b2e 5384 53d6 +b2f b2d 5387 53cf +b59 b2d 53cf 53d5 +b5a b2d 53d5 53d6 +b2e b32 538c 53dc +b5a b2e 53d6 53dd +b2e b5d 53dc 53dd +b36 b2f 5394 53cc +b58 b2f 53cc 53d0 +b2f b59 53cf 53d0 +b30 b31 538b 576f +b32 b30 538d 577b +b30 d4e 576f 5775 +b30 d52 5775 577b +b31 b39 5399 5768 +b31 d4e 5768 576f +b5d b32 53dc 691b +b32 d52 577b 68f5 +b32 1712 68f5 691b +b33 b35 5391 53c5 +b35 b34 5392 53c6 +b34 b36 5393 53c7 +b57 b34 53c6 53c8 +b35 b57 53c6 53cb +b36 b58 53cc 53ce +b38 b37 5397 53e2 +b37 b3a 539b 53e0 +b37 b5f 53e0 53e2 +b39 b38 5398 575f +b38 b5f 53e2 575b +b38 d47 575b 575e +b38 d49 575e 575f +b39 d49 575f 5765 +b39 d4c 5765 5769 +d4e b39 5768 5769 +b3a b5e 53de 53e1 +b5f b3a 53e0 53e1 +b3c b3b 539c 539d +b3b b3d 539c 539e +b3e b3b 539d 8dc4 +b3b b3f 539e 539f +b3b b40 539f 8dce +2256 b3b 8dc4 8dce +b3d b3c 539c 53a0 +b3c b3e 539d 53a1 +b41 b3c 53a0 53a2 +b3c b42 53a1 53a3 +b43 b3c 53a2 53a3 +b3f b3d 539e 53a4 +b3d b41 53a0 53a5 +b44 b3d 53a4 53a5 +b42 b3e 53a1 8c5a +b3e 1f3e 7e07 8c5a +2256 b3e 7e03 8dc4 +b3e 2258 7e03 7e07 +b40 b3f 539f 53a6 +b3f b44 53a4 53a7 +b45 b3f 53a6 53a7 +b40 b45 53a6 8da6 +224a b40 8d43 8da6 +2255 b40 7e01 8d43 +b40 2256 7e01 8dce +b41 b43 53a2 53a8 +b44 b41 53a5 53a9 +b41 b46 53a8 53aa +b47 b41 53a9 53ab +b41 b48 53aa 53ac +b49 b41 53ab 53ad +b41 b4a 53ac 53ad +b43 b42 53a3 53ae +b4b b42 53ae 53b0 +b4c b42 53b0 8d5a +b42 1f3e 8c5a 8d5a +b46 b43 53a8 53af +b43 b4b 53ae 53af +b45 b44 53a7 53b1 +b44 b47 53a9 53b2 +b4d b44 53b1 53b3 +b44 b4e 53b2 53b3 +b45 b4d 53b1 8cf2 +b45 224a 7dfd 8da6 +224e b45 7dfd 8cf2 +b48 b46 53aa 53b4 +b46 b4b 53af 53b5 +b4f b46 53b4 53b5 +b47 b49 53ab 53b6 +b4e b47 53b2 53b7 +b47 b50 53b6 53b8 +b51 b47 53b7 53b8 +b4a b48 53ac 53b9 +b48 b4f 53b4 53ba +b52 b48 53b9 53bb +b48 b53 53ba 53bb +b49 b4a 53ad 53bc +b50 b49 53b6 53bc +b50 b4a 53bc 53be +b4a b52 53b9 53bd +b4a b54 53bd 53be +b4b b4c 53b0 8c30 +b4f b4b 53b5 53bf +b55 b4b 53bf 8c30 +b4c b55 8150 8c30 +b4c 1f3d 8152 8d1b +1f3e b4c 8152 8d5a +2408 b4c 8150 8d1b +b4d b4e 53b3 53c0 +b4d b56 53c0 8c21 +17c7 b4d 8b83 8c21 +224d b4d 7dfa 8b83 +b4d 224e 7dfa 8cf2 +b4e b51 53b7 53c1 +b56 b4e 53c0 53c1 +b53 b4f 53ba 5bb2 +b4f b55 53bf 5bb3 +fcf b4f 5bb2 5bb4 +b4f fd0 5bb3 5bb4 +b51 b50 53b8 5bba +b50 b54 53be 5bbb +fd4 b50 5bba 5bbb +b56 b51 53c1 5bbc +b51 fd4 5bba 5bbd +fd5 b51 5bbc 5bbe +b51 fd6 5bbd 5bbe +b52 b53 53bb 5bb5 +b54 b52 53bd 5bb6 +b52 fd1 5bb5 5bb7 +fd2 b52 5bb6 5bb7 +b53 fcf 5bb2 5bb8 +fd1 b53 5bb5 5bb9 +b53 fd3 5bb8 5bb9 +b54 fd2 5bb6 5bc0 +fd4 b54 5bbb 5bbf +fd7 b54 5bbf 5bc0 +fd0 b55 5bb3 8b74 +b55 2408 8150 8154 +b55 240b 8154 8b74 +b56 fd5 5bbc 5bc4 +b56 17c7 83dc 8c21 +b58 b59 53d0 53d7 +b59 b5a 53d5 53d9 +b59 b5b 53d9 53da +b59 b5c 53da 53db +b5b b5a 53d9 691d +b5a b5d 53dd 691d +b5c b5b 53da 6925 +b5d b5b 691c 691d +b5b 171c 691c 691f +b5b 171e 691f 6924 +b5b 1720 6924 6925 +b5c 1720 6925 692f +1712 b5d 6916 691b +b5d 171b 6916 6917 +b5d 171c 6917 691c +b5f b5e 53e1 53e6 +b5e b60 53e3 53e5 +b5e b61 53e5 53e6 +b5f b61 53e6 575c +d47 b5f 575b 575d +b5f d48 575c 575d +b61 b60 53e5 5757 +b60 b62 53e8 5757 +b61 b62 5757 5758 +b61 d18 5758 5760 +d48 b61 575c 5760 +b62 b63 53ea 5756 +b62 d17 5756 5759 +d18 b62 5758 5759 +d17 b63 5756 575a +b63 d19 5754 575a +b66 b64 53ee 54f2 +b64 bf0 54e7 54ee +b64 bf4 54ee 54f1 +b64 bf6 54f1 54f3 +bf7 b64 54f2 54f3 +b65 b66 53ef 54f7 +b66 bf7 54f2 54f6 +b68 b67 53f0 7de5 +b67 b69 53f0 53f1 +b67 b6a 53f1 8e31 +b67 222e 8e31 8e67 +2234 b67 7de5 8e67 +b69 b68 53f0 53f2 +b6b b68 53f2 53f4 +b6c b68 53f3 8d7a +b68 b6d 53f3 53f4 +2233 b68 8d7a 8e30 +b68 2234 7de5 8e30 +b6a b69 53f1 53f5 +b69 b6b 53f2 53f6 +b6e b69 53f5 53f7 +b69 b6f 53f6 53f7 +b6a b6e 53f5 53f8 +b6a b70 53f8 8d98 +b6a 222b 8d98 8e32 +b6a 222e 8cdb 8e31 +2735 b6a 8cdb 8e32 +b6b b6d 53f4 53fa +b6f b6b 53f6 53fb +b6b b72 53fa 53fc +b73 b6b 53fb 53fc +b6d b6c 53f3 53f9 +b71 b6c 53f9 7de8 +1f3b b6c 79fc 8ccc +b6c 1f3c 79fc 7de8 +2233 b6c 8ccc 8d7a +b6d b71 53f9 53fd +b72 b6d 53fa 53fd +b6e b6f 53f7 53fe +b70 b6e 53f8 53ff +b6e b74 53fe 5400 +b75 b6e 53ff 5400 +b6f b73 53fb 5401 +b74 b6f 53fe 5402 +b6f b76 5401 5403 +b77 b6f 5402 5403 +b70 b75 53ff 5404 +b70 b78 5404 5405 +b70 b79 5405 8cc3 +222b b70 8d98 8e33 +b70 222c 8cc3 8e33 +b72 b71 53fd 5406 +b7a b71 5406 5407 +b7b b71 5407 8d89 +b71 1f3c 7de8 8d89 +b73 b72 53fc 5408 +b72 b7a 5406 5409 +b7c b72 5408 540a +b72 b7d 5409 540a +b76 b73 5401 540b +b73 b7c 5408 540c +b7e b73 540b 540c +b75 b74 5400 540d +b74 b77 5402 540f +b7f b74 540d 5410 +b74 b80 540f 5410 +b78 b75 5404 540e +b75 b7f 540d 540e +b77 b76 5403 5415 +b76 b7e 540b 5418 +b84 b76 5415 5416 +b85 b76 5416 5417 +b86 b76 5417 5418 +b80 b77 540f 541a +b77 b84 5415 5419 +b77 b87 5419 541a +b79 b78 5405 5411 +b78 b7f 540e 5413 +b81 b78 5411 5412 +b82 b78 5412 5413 +b79 b81 5411 5414 +b79 b83 5414 8daa +2222 b79 7dd9 8daa +b79 2223 7dd9 8dc0 +222c b79 8cc3 8dc0 +b7a b7b 5407 8ca4 +b7d b7a 5409 541b +b88 b7a 541b 8147 +223e b7a 8147 8ca4 +b7b 1f3c 8d89 8dba +b7b 223a 7de9 7deb +223b b7b 7de9 8dba +b7b 223e 7deb 8ca4 +b7c b7d 540a 57f2 +b7e b7c 540c 57e6 +b7c d9a 57e5 57e6 +d9d b7c 57e5 57f2 +b7d b88 541b 59a1 +d9d b7d 57f2 57f4 +da4 b7d 57f4 59a1 +b86 b7e 5418 57e4 +d9a b7e 57e4 57e6 +b7f b80 5410 55ed +b82 b7f 5413 55e5 +c7b b7f 55e5 55ed +b80 b87 541a 55f0 +c7b b80 55ed 55f0 +b81 b82 5412 55de +b83 b81 5414 55dc +c75 b81 55dc 55de +c75 b82 55de 55e0 +c78 b82 55e0 55e4 +c7b b82 55e4 55e5 +b83 c75 55dc 55dd +b83 c76 55dd 8d60 +b83 221f 8d60 8e0a +2222 b83 8daa 8e0a +b84 b85 5416 5668 +b87 b84 5419 5666 +b84 caa 5664 5666 +cab b84 5664 5668 +b85 b86 5417 57dc +b85 cab 5667 5668 +cb8 b85 5667 567d +cd2 b85 567d 57d9 +d98 b85 57d9 57dc +d98 b86 57dc 57de +d9a b86 57de 57e4 +b87 c7b 55ef 55f0 +c80 b87 55ef 5665 +caa b87 5665 5666 +da4 b88 59a1 83d2 +b88 223e 8147 8ca5 +23ff b88 83d2 8af9 +2400 b88 8af9 8ca5 +b8a b89 5420 5428 +b89 b8d 5425 5429 +b8f b89 5428 5429 +b8b b8a 5422 542a +b8a b8f 5428 542a +b8c b8b 5423 695c +b8b b8f 542a 5489 +b8b bb1 5489 548c +b8b bc5 548c 695c +b8c b92 695d 695e +bc5 b8c 695b 695c +b8c be7 695b 695d +b8d b8e 5427 5463 +b8f b8d 5429 5467 +b8d bae 5463 5467 +b8e b97 5439 545e +b8e ba3 545e 545f +b8e bae 545f 5463 +b8f bae 5467 5468 +b8f bb1 5468 5489 +b91 b90 542e 54ca +b90 b92 542f 54e2 +bde b90 54ca 54d3 +be7 b90 54d3 54e2 +b94 b91 5434 54bd +bde b91 54bd 54ca +be7 b92 54e2 695d +b93 b94 5433 54b1 +bd3 b93 54aa 54ac +bd5 b93 54ac 54b1 +bd5 b94 54b1 54b6 +bda b94 54b6 54bc +bdd b94 54bc 54be +b94 bde 54bd 54be +b95 b96 5437 5450 +b97 b95 5438 544e +b95 b9d 544c 544e +b9f b95 544c 5450 +b96 b98 543c 5451 +b9e b96 544f 5451 +b96 b9f 544f 5450 +b9d b97 544d 544e +b97 ba3 544d 545e +b9e b98 5451 5453 +ba6 b98 5453 546c +bb4 b98 546c 546d +b9a b99 543d 543e +b99 b9b 543d 543f +b9c b99 543e 5440 +b99 b9d 543f 5441 +b9e b99 5440 5442 +b99 b9f 5441 5442 +b9b b9a 543d 5443 +b9a b9c 543e 5444 +ba0 b9a 5443 5445 +b9a ba1 5444 5446 +ba2 b9a 5445 5446 +b9d b9b 543f 5447 +b9b ba0 5443 5448 +ba3 b9b 5447 5449 +b9b ba4 5448 5449 +b9c b9e 5440 544a +ba1 b9c 5444 544b +b9c ba5 544a 544b +b9f b9d 5441 544c +b9d ba3 5447 544d +b9e b9f 5442 544f +ba5 b9e 544a 5452 +ba6 b9e 5452 5453 +ba0 ba2 5445 5454 +ba4 ba0 5448 5455 +ba0 ba7 5454 5457 +ba8 ba0 5455 5456 +ba9 ba0 5456 5457 +ba2 ba1 5446 5458 +ba1 ba5 544b 5459 +baa ba1 5458 545a +ba1 bab 5459 545a +ba7 ba2 5454 545b +ba2 baa 5458 545c +bac ba2 545b 545c +ba3 ba4 5449 545d +ba3 bad 545d 5460 +bae ba3 545f 5460 +ba4 ba8 5455 5462 +bad ba4 545d 5461 +baf ba4 5461 5462 +ba5 ba6 5452 5469 +bab ba5 5459 546a +ba5 bb2 5469 546b +bb3 ba5 546a 546b +bb2 ba6 5469 546e +ba6 bb4 546c 546e +ba9 ba7 5457 5472 +ba7 bac 545b 5473 +bb7 ba7 5472 5474 +ba7 bb8 5473 5474 +ba8 ba9 5456 546f +baf ba8 5462 5470 +ba8 bb5 546f 5471 +bb6 ba8 5470 5471 +bb5 ba9 546f 5475 +ba9 bb7 5472 5475 +baa bab 545a 5478 +bac baa 545c 5479 +baa bba 5478 547a +bbb baa 5479 547a +bab bb3 546a 547b +bba bab 5478 547c +bab bbc 547b 547c +bb8 bac 5473 547d +bac bbb 5479 547e +bbd bac 547d 547e +bae bad 5460 5464 +bad baf 5461 5465 +bb0 bad 5464 5465 +bae bb0 5464 5466 +bae bb1 5466 5468 +bb0 baf 5465 5476 +baf bb6 5470 5477 +bb9 baf 5476 5477 +bb1 bb0 5466 5480 +bb0 bb9 5476 547f +bb0 bbe 547f 5480 +bb1 bbe 5480 548b +bc4 bb1 548a 548b +bb1 bc5 548a 548c +bb3 bb2 546b 548d +bb2 bb4 546e 548e +bc6 bb2 548d 5490 +bb2 bc7 548e 548f +bb2 bc8 548f 5490 +bbc bb3 547b 5491 +bb3 bc6 548d 5491 +bc7 bb4 548e 5493 +bb6 bb5 5471 5481 +bb5 bb7 5475 5484 +bbf bb5 5481 5486 +bb5 bc1 5484 5485 +bb5 bc2 5485 5486 +bb9 bb6 5477 5482 +bb6 bbf 5481 5483 +bc0 bb6 5482 5483 +bb7 bb8 5474 549b +bc1 bb7 5484 549c +bb7 bcc 549b 549c +bb8 bbd 547d 549d +bcc bb8 549b 549f +bb8 bcd 549d 549e +bb8 bce 549e 549f +bbe bb9 547f 5488 +bb9 bc0 5482 5487 +bb9 bc3 5487 5488 +bbb bba 547a 54a0 +bba bbc 547c 54a3 +bcf bba 54a0 54a4 +bba bd1 54a3 54a5 +bd2 bba 54a4 54a5 +bbd bbb 547e 54a1 +bbb bcf 54a0 54a2 +bd0 bbb 54a1 54a2 +bbc bc6 5491 5499 +bbc bcb 5499 54a7 +bd1 bbc 54a3 54a7 +bcd bbd 549d 54a6 +bbd bd0 54a1 54a6 +bbe bc3 5488 6911 +bc4 bbe 548b 6911 +bc0 bbf 5483 690c +bbf bc2 5486 690a +bbf c1c 6907 6909 +c1d bbf 6907 690a +bbf 1719 6909 690c +bc3 bc0 5487 690d +bc0 1719 690c 690d +bc2 bc1 5485 6623 +bc1 bcc 549c 6606 +bc1 159c 6606 6623 +bc2 c1d 6627 690a +bc2 159c 6623 6627 +bc3 bc4 6910 6911 +bc3 be8 690f 6910 +bc3 be9 690e 690f +bc3 1719 690d 690e +bc5 bc4 548a 54d1 +bc4 bdd 54d0 54d1 +be8 bc4 54d0 6910 +bc5 bdd 54d1 54d2 +bc5 be7 54d2 695b +bc6 bc8 5490 5497 +bc6 bca 5497 549a +bcb bc6 5499 549a +bc8 bc7 548f 5495 +bc9 bc7 5495 5496 +bc8 bc9 5495 5498 +bca bc8 5497 5498 +bca bc9 5498 65d9 +bc9 1584 65d7 65d9 +bcb bca 549a 65de +bca 1584 65d9 65db +bca 1585 65db 65dd +bca 1586 65dd 65de +bd1 bcb 54a7 65f6 +bcb 1586 65de 660d +1593 bcb 65f6 660d +bcc bce 549f 6602 +bcc 159a 6602 6605 +bcc 159c 6605 6606 +bce bcd 549e 65e9 +bcd bd0 54a6 65e4 +bcd 1589 65e4 65e8 +bcd 158b 65e8 65e9 +bce 158b 65e9 6603 +159a bce 6602 6604 +bce 159b 6603 6604 +bd0 bcf 54a2 65e3 +bcf bd2 54a4 65e7 +1588 bcf 65e3 65e6 +158a bcf 65e6 65e7 +bd0 1588 65e3 65e5 +1589 bd0 65e4 65e5 +bd2 bd1 54a5 65f0 +1590 bd1 65f0 65f5 +1593 bd1 65f5 65f6 +158a bd2 65e7 65ef +158f bd2 65ef 65f2 +bd2 1590 65f0 65f1 +bd2 1591 65f1 65f2 +bd4 bd3 54ab 54ad +bd3 bd5 54ac 54ae +bd6 bd3 54ad 54ae +bd4 bd6 54ad 54b2 +bd7 bd4 54af 54b3 +bd4 bd8 54b2 54b4 +bd9 bd4 54b3 54b4 +bd6 bd5 54ae 54b5 +bda bd5 54b5 54b6 +bd8 bd6 54b2 54b7 +bd6 bda 54b5 54b8 +bdb bd6 54b7 54b8 +bd7 bd9 54b3 54ba +bdc bd7 54b9 54ba +bd9 bd8 54b4 54bf +bd8 bdb 54b7 54c0 +bdf bd8 54bf 54c2 +bd8 be0 54c0 54c1 +bd8 be1 54c1 54c2 +bdc bd9 54ba 54c3 +bd9 bdf 54bf 54c4 +be2 bd9 54c3 54c4 +bdb bda 54b8 54c5 +bda bdd 54bc 54c6 +be3 bda 54c5 54c6 +be0 bdb 54c0 54c8 +bdb be3 54c5 54c7 +bdb be4 54c7 54c9 +be5 bdb 54c8 54c9 +bdc be2 54c3 54cc +bdc be6 54cc 54cd +bdd bde 54be 54ce +be3 bdd 54c6 54cf +bdd be7 54ce 54d2 +be8 bdd 54cf 54d0 +be7 bde 54ce 54d3 +bdf be1 54c2 54d7 +be2 bdf 54c4 54d8 +bdf bea 54d7 54d9 +beb bdf 54d8 54d9 +be1 be0 54c1 54d6 +be0 be5 54c8 54d6 +be1 be5 54d6 54da +bea be1 54d7 54db +be1 bec 54da 54db +be6 be2 54cc 54e0 +be2 beb 54d8 54e1 +bef be2 54e0 54e1 +be4 be3 54c7 54d4 +be3 be8 54cf 54d5 +be9 be3 54d4 54d5 +be5 be4 54c9 54dc +be4 be9 54d4 54dd +bed be4 54dc 54dd +bec be5 54da 54de +be5 bed 54dc 54df +bee be5 54de 54df +be6 bef 54e0 5511 +bfb be6 5507 5508 +bfe be6 5508 5511 +be9 be8 54d5 690f +bed be9 54dd 690b +1719 be9 690b 690e +beb bea 54d9 551c +bea bec 54db 5524 +c06 bea 551c 551f +c09 bea 551f 5523 +c0c bea 5523 5524 +bef beb 54e1 5516 +c04 beb 5516 5518 +c06 beb 5518 551c +bec bee 54de 5530 +c0c bec 5524 552d +c11 bec 552d 552f +c12 bec 552f 5530 +bee bed 54df 5544 +c1c bed 5544 6908 +1719 bed 6908 690b +c12 bee 5530 5541 +c1c bee 5541 5544 +bfe bef 5511 5513 +c04 bef 5513 5516 +bf0 bf1 54e6 54ed +bf0 bf4 54ed 54ee +bf1 bf2 54ea 54f0 +bf4 bf1 54ed 54ef +bf5 bf1 54ef 54f0 +bf2 bf3 54ec 54ff +bf5 bf2 54f0 5503 +bf2 bfa 54ff 5502 +bf2 bfc 5502 5503 +bfa bf3 54ff 5500 +bfb bf3 5500 5501 +bf4 bf5 54ef 54f5 +bf6 bf4 54f1 54f4 +bf8 bf4 54f4 54f5 +bf8 bf5 54f5 550d +bf5 bfc 5503 550a +bf5 bff 550a 550b +bf5 c00 550b 550c +bf5 c01 550c 550d +bf7 bf6 54f3 54f8 +bf6 bf8 54f4 54f9 +bf9 bf6 54f8 54f9 +bf7 bf9 54f8 54fb +bf9 bf8 54f9 6903 +bf8 c01 550d 6903 +bf9 c01 6903 6904 +c02 bf9 5510 6906 +bf9 c4d 6905 6906 +bf9 c4e 6904 6905 +bfa bfb 5500 5504 +bfc bfa 5502 5505 +bfa bfd 5504 5505 +bfd bfb 5504 5509 +bfb bfe 5508 5509 +bfc bfd 5505 550e +bff bfc 550a 550e +bfd bfe 5509 5512 +bff bfd 550e 5515 +bfd c03 5512 5515 +c03 bfe 5512 5514 +bfe c04 5513 5514 +c00 bff 550b 5531 +bff c03 5515 551b +bff c07 551b 5531 +c01 c00 550c 5546 +c00 c07 5531 5533 +c00 c13 5533 5545 +c00 c1e 5545 5546 +c01 c1e 5546 6902 +c01 c4e 6902 6904 +c08 c02 551e 55a4 +c4d c02 55a4 6906 +c03 c04 5514 5517 +c03 c05 5517 551a +c03 c07 551a 551b +c05 c04 5517 5519 +c04 c06 5518 5519 +c05 c06 5519 5521 +c07 c05 551a 5529 +c05 c0b 5521 5528 +c05 c0f 5528 5529 +c06 c09 551f 5520 +c06 c0a 5520 5522 +c0b c06 5521 5522 +c07 c0f 5529 5532 +c07 c13 5532 5533 +c2e c08 5563 5590 +c44 c08 5590 55a2 +c4d c08 55a2 55a4 +c0a c09 5520 5525 +c09 c0c 5523 5526 +c0d c09 5525 5527 +c09 c0e 5526 5527 +c0b c0a 5522 552a +c0a c0d 5525 552a +c0b c0d 552a 552b +c0f c0b 5528 552c +c0b c10 552b 552c +c0e c0c 5526 552e +c0c c11 552d 552e +c0d c0e 5527 5534 +c10 c0d 552b 5535 +c0d c14 5534 5536 +c15 c0d 5535 5537 +c0d c16 5536 5537 +c0e c11 552e 5538 +c14 c0e 5534 5539 +c0e c17 5538 5539 +c0f c10 552c 553a +c13 c0f 5532 553b +c0f c18 553a 553c +c19 c0f 553b 553c +c10 c15 5535 553e +c18 c10 553a 553d +c1a c10 553d 553e +c11 c12 552f 553f +c17 c11 5538 5540 +c11 c1b 553f 5540 +c1b c12 553f 5542 +c12 c1c 5541 5543 +c1d c12 5542 5543 +c13 c19 553b 5547 +c1e c13 5545 5548 +c13 c1f 5547 5548 +c16 c14 5536 554e +c14 c17 5539 554f +c23 c14 554e 5550 +c14 c24 554f 5550 +c15 c16 5537 5551 +c1a c15 553e 5552 +c15 c25 5551 5552 +c16 c23 554e 5554 +c25 c16 5551 5553 +c26 c16 5553 5554 +c17 c1b 5540 5556 +c24 c17 554f 5555 +c27 c17 5555 5556 +c19 c18 553c 5549 +c18 c1a 553d 554a +c20 c18 5549 554b +c18 c21 554a 554b +c1f c19 5547 554d +c19 c20 5549 554c +c19 c22 554c 554d +c21 c1a 554a 5558 +c1a c25 5552 5557 +c1a c28 5557 5558 +c1b c1d 5542 6625 +c27 c1b 5556 6626 +c1b 159c 6625 6626 +c1d c1c 5543 6907 +c1c 1719 6908 6909 +159c c1d 6625 6627 +c1e c1f 5548 55a6 +c1e c4e 55a6 6902 +c1f c22 554d 558f +c1f c45 558f 55a5 +c1f c4e 55a5 55a6 +c20 c21 554b 559c +c22 c20 554c 558c +c3c c20 558c 558d +c41 c20 558d 559c +c21 c28 5558 55a8 +c41 c21 559c 559d +c49 c21 559d 55a8 +c34 c22 5579 557a +c22 c3b 5579 558a +c3c c22 557a 558c +c22 c44 558a 558e +c22 c45 558e 558f +c23 c24 5550 555c +c26 c23 5554 555b +c2a c23 555b 555d +c23 c2b 555c 555d +c24 c27 5555 5561 +c2b c24 555c 5561 +c25 c26 5553 5559 +c28 c25 5557 555a +c25 c29 5559 555a +c29 c26 5559 555e +c26 c2a 555b 5560 +c2c c26 555e 555f +c2d c26 555f 5560 +c2b c27 5561 6633 +159c c27 6624 6626 +c27 15a7 6624 6633 +c28 c29 555a 55aa +c49 c28 55a8 55a9 +c4a c28 55a9 55aa +c29 c2c 555e 66c9 +c4a c29 55aa 55ab +c4f c29 55ab 66c9 +c2a c2b 555d 6636 +c2d c2a 5560 6635 +15aa c2a 6635 6636 +15a7 c2b 6631 6633 +c2b 15a8 6631 6632 +c2b 15aa 6632 6636 +c2c c2d 555f 66cd +c4f c2c 66c9 66ca +c2c 15ae 66cd 66ce +15ed c2c 66ca 66ce +c2d 15a9 6634 6637 +15aa c2d 6634 6635 +c2d 15ae 6637 66cd +c35 c2e 557b 557c +c3b c2e 557c 558b +c44 c2e 558b 5590 +c30 c2f 5564 5565 +c2f c31 5564 5566 +c32 c2f 5565 5567 +c2f c33 5566 5568 +c34 c2f 5567 5569 +c2f c35 5568 5569 +c31 c30 5564 556a +c30 c32 5565 556b +c30 c36 556b 556d +c30 c37 556d 556f +c38 c30 556e 556f +c33 c31 5566 5570 +c32 c34 5567 5572 +c36 c32 556b 5573 +c32 c39 5572 5574 +c3a c32 5573 5574 +c35 c33 5568 5575 +c34 c35 5569 5577 +c39 c34 5572 5578 +c34 c3b 5577 5579 +c3c c34 5578 557a +c3b c35 5577 557c +c37 c36 556d 557d +c36 c3a 5573 557e +c3d c36 557d 557e +c38 c37 556f 5580 +c37 c3d 557d 5581 +c3e c37 5580 5581 +c38 c3e 5580 5582 +c38 c3f 5582 5583 +c3a c39 5574 5584 +c39 c3c 5578 5585 +c40 c39 5584 5586 +c39 c41 5585 5586 +c3d c3a 557e 5587 +c3a c40 5584 5588 +c42 c3a 5587 5589 +c3a c43 5588 5589 +c44 c3b 558a 558b +c41 c3c 5585 558d +c3e c3d 5581 5591 +c3d c42 5587 5592 +c46 c3d 5591 5593 +c3d c47 5592 5593 +c3f c3e 5582 5594 +c3e c46 5591 5594 +c3f c46 5594 5596 +c3f c48 5596 5598 +c40 c41 5586 5599 +c43 c40 5588 559a +c40 c49 5599 559b +c4a c40 559a 559b +c49 c41 5599 559d +c42 c43 5589 559e +c47 c42 5592 55a0 +c42 c4b 559e 55a1 +c4c c42 55a0 55a1 +c43 c4a 559a 559f +c4b c43 559e 559f +c45 c44 558e 55a3 +c44 c4d 55a2 55a3 +c45 c4d 55a3 55a7 +c4e c45 55a5 55a7 +c46 c47 5593 55ad +c48 c46 5596 55ae +c46 c50 55ad 55af +c51 c46 55ae 55af +c47 c4c 55a0 55b0 +c50 c47 55ad 55b1 +c47 c52 55b0 55b1 +c48 c51 55ae 55b4 +c53 c48 55b3 55b4 +c4a c49 559b 55a9 +c4b c4a 559f 55ac +c4a c4f 55ab 55ac +c4c c4b 55a1 66d2 +c4b c4f 55ac 66cb +c4b 15ee 66cb 66d1 +c4b 15f0 66d1 66d2 +c52 c4c 55b0 66dc +c4c 15f0 66d2 66db +c4c 15f5 66db 66dc +c4e c4d 55a7 6905 +c4f 15ed 66ca 66cc +15ee c4f 66cb 66cc +c51 c50 55af 66e1 +c50 c52 55b1 66de +c50 15f6 66de 66e1 +c53 c51 55b4 66c7 +15ec c51 66c7 66e3 +c51 15f6 66e1 66e3 +c52 15f5 66dc 66e0 +15f6 c52 66de 66df +15f7 c52 66df 66e0 +15e9 c53 66bf 66c5 +15eb c53 66c5 66c8 +c53 15ec 66c7 66c8 +c55 c54 55b5 55b6 +c54 c56 55b5 7fa3 +c57 c54 55b6 55b7 +c58 c54 55b7 8916 +c54 231a 7fa3 8916 +c56 c55 55b5 55b8 +c55 c57 55b6 55b9 +c59 c55 55b8 55ba +c55 c5a 55b9 55bb +c5b c55 55ba 55bc +c55 c5c 55bb 55bc +c56 c59 55b8 8888 +231a c56 7fa3 81f9 +2433 c56 81f9 88f7 +c56 2699 8888 88f7 +c57 c58 55b7 55bd +c5a c57 55b9 55be +c57 c5d 55bd 81fb +c5e c57 55be 55bf +c5f c57 55bf 8949 +c57 2436 81fb 8949 +c5d c58 55bd 7ef3 +22bb c58 7ef3 8952 +c58 231a 8916 8952 +c59 c5b 55ba 55c0 +c59 c60 55c0 86bc +c59 2699 86bc 8888 +c5c c5a 55bb 55c1 +c5a c5e 55be 55c2 +c61 c5a 55c1 55c2 +c5b c5c 55bc 55c3 +c60 c5b 55c0 55c4 +c5b c62 55c3 55c5 +c63 c5b 55c4 55c5 +c5c c61 55c1 55c6 +c62 c5c 55c3 55c6 +c5d 22ba 893e 8972 +c5d 22bb 7ef3 893e +22bd c5d 88ca 8972 +2436 c5d 81fb 8948 +c5d 2437 88ca 8948 +c5e c5f 55bf 55c8 +c61 c5e 55c2 55c9 +c5e c67 55c8 55ca +c68 c5e 55c9 55ca +c67 c5f 55c8 8202 +c5f 2434 8201 8202 +2436 c5f 8201 8949 +c60 c63 55c4 55cb +c60 c69 55cb 55cc +c60 c6a 55cc 8869 +2699 c60 86bc 86c0 +269a c60 86c0 8869 +c62 c61 55c6 55cd +c61 c68 55c9 55ce +c6b c61 55cd 55ce +c63 c62 55c5 55cf +c62 c6b 55cd 55d0 +c6c c62 55cf 55d1 +c62 c6d 55d0 55d1 +c69 c63 55cb 55d2 +c63 c6c 55cf 55d4 +c6e c63 55d2 55d3 +c6f c63 55d3 55d4 +c65 c64 55c7 7fa6 +c64 c66 55c7 7ef7 +1fe3 c64 7a80 7ef7 +c64 1fe4 7a81 7fa6 +c66 c65 55c7 8894 +1fe4 c65 7a83 7fa6 +c65 1fe6 7a83 8981 +243a c65 8894 8981 +1fe3 c66 7ef7 898f +2434 c66 81fa 88cb +c66 2435 81fa 898f +c66 243a 8894 88cb +c68 c67 55ca 55d5 +c70 c67 55d5 55d7 +c71 c67 55d7 81fe +c67 2434 8202 8957 +2438 c67 81fe 8957 +c6b c68 55ce 55d6 +c68 c70 55d5 55d6 +c6a c69 55cc 55d8 +c69 c6e 55d2 55da +c72 c69 55d8 55d9 +c73 c69 55d9 55da +c6a c72 55d8 55db +c6a c74 55db 86bf +25d4 c6a 86be 86bf +c6a 269a 86be 8869 +c6d c6b 55d0 6b02 +c6b c70 55d6 6b00 +c6b 1800 6b00 6b01 +c6b 1801 6b01 6b02 +c6c c6d 55d1 6ddc +c6f c6c 55d4 6ddd +c6c 1191 6ddc 6ddd +c6d 1191 6dcb 6ddc +c6d 1801 6b02 6dc9 +c6d 1986 6dc9 6dcb +c6e c6f 55d3 5ef1 +c73 c6e 55da 5ecf +117a c6e 5ecf 5ef1 +c6f 117a 5ef0 5ef1 +1186 c6f 5ef0 5efc +1191 c6f 5efc 6ddd +c70 c71 55d7 6b03 +1800 c70 6b00 6b04 +c70 1802 6b03 6b04 +1802 c71 6b03 6b05 +1803 c71 6b05 8895 +c71 2438 81fe 8895 +c72 c73 55d9 5ec8 +c74 c72 55db 5ec4 +1175 c72 5ec4 5ec6 +1176 c72 5ec6 5ec8 +1176 c73 5ec8 5eca +1178 c73 5eca 5ece +117a c73 5ece 5ecf +c74 1174 5ec2 86bb +1175 c74 5ec2 5ec4 +c74 2590 86bb 8883 +25d4 c74 86bf 8883 +c76 c75 55dd 55df +c77 c75 55df 55e1 +c75 c78 55e0 55e1 +c76 c77 55df 55e2 +c76 c79 55e2 55e3 +c76 c7a 55e3 8d9d +221e c76 7dd7 8d9d +c76 221f 7dd7 8d60 +c77 c78 55e1 55e6 +c79 c77 55e2 55e7 +c77 c7c 55e6 55e8 +c7d c77 55e7 55e8 +c78 c7b 55e4 55e9 +c7c c78 55e6 55e9 +c7a c79 55e3 55ea +c79 c7d 55e7 55eb +c7e c79 55ea 55eb +c7a c7e 55ea 55ec +c7a c7f 55ec 8d7f +221a c7a 8cb3 8d7f +c7a 221e 8cb3 8d9d +c7c c7b 55e9 55ee +c80 c7b 55ee 55ef +c7d c7c 55e8 55f1 +c7c c80 55ee 55f3 +c81 c7c 55f1 55f2 +c82 c7c 55f2 55f3 +c7e c7d 55eb 55f4 +c7d c81 55f1 55f5 +c83 c7d 55f4 55f5 +c7f c7e 55ec 55f6 +c7e c83 55f4 55f7 +c84 c7e 55f6 55f7 +c7f c84 55f6 55f8 +c7f c85 55f8 8cc9 +c7f 2216 8cc9 8d7c +2218 c7f 7dd2 8d7c +c7f 221a 7dd2 8d7f +c82 c80 55f3 5637 +c99 c80 5637 5638 +caa c80 5638 5665 +c81 c82 55f2 5633 +c83 c81 55f5 5662 +c81 c98 5633 5634 +c81 cae 5634 5662 +c82 c98 5631 5633 +c99 c82 5636 5637 +c9a c82 5631 5636 +c84 c83 55f7 5690 +c83 cae 5662 5663 +c83 cc6 5663 5690 +c85 c84 55f8 5698 +c84 cc6 5690 5692 +c84 cde 5692 5697 +c84 ce1 5697 5698 +c85 ce1 5698 8cc7 +c85 2215 8cc7 8d7d +2216 c85 8cc9 8d7d +c87 c86 55f9 55fa +c86 c88 55f9 55fb +c89 c86 55fa 55fc +c86 c8a 55fb 55fd +c8b c86 55fc 55fe +c86 c8c 55fd 55ff +c8d c86 55fe 5600 +c86 c8e 55ff 5600 +c88 c87 55f9 5601 +c87 c89 55fa 5602 +c8f c87 5601 5603 +c87 c90 5602 5604 +c91 c87 5603 5604 +c8a c88 55fb 5605 +c88 c8f 5601 5606 +c92 c88 5605 5607 +c88 c93 5606 5607 +c89 c8b 55fc 5608 +c90 c89 5602 5609 +c89 c94 5608 5609 +c8c c8a 55fd 560a +c8a c92 5605 560b +c95 c8a 560a 560b +c8b c8d 55fe 560c +c94 c8b 5608 560d +c8b c96 560c 560d +c8e c8c 55ff 560e +c8c c95 560a 560f +c97 c8c 560e 560f +c8d c8e 5600 5610 +c96 c8d 560c 5611 +c8d c98 5610 5612 +c99 c8d 5611 5613 +c8d c9a 5612 5613 +c8e c97 560e 5614 +c98 c8e 5610 5615 +c8e c9b 5614 5615 +c8f c91 5603 5616 +c93 c8f 5606 5617 +c8f c9c 5616 5618 +c9d c8f 5617 5619 +c8f c9e 5618 5619 +c91 c90 5604 561a +c90 c94 5609 561b +c9f c90 561a 561c +c90 ca0 561b 561d +ca1 c90 561c 561d +c9c c91 5616 561e +c91 c9f 561a 561f +ca2 c91 561e 561f +c92 c93 5607 5620 +c95 c92 560b 5621 +c92 ca3 5620 5622 +ca4 c92 5621 5623 +c92 ca5 5622 5623 +c93 c9d 5617 5624 +ca3 c93 5620 5624 +c94 c96 560d 5625 +ca0 c94 561b 5626 +c94 ca6 5625 5626 +c97 c95 560f 5627 +c95 ca4 5621 5628 +ca7 c95 5627 5629 +c95 ca8 5628 562a +ca9 c95 5629 562a +c96 c99 5611 562b +ca6 c96 5625 562c +c96 caa 562b 562d +cab c96 562c 562d +c9b c97 5614 562e +c97 ca7 5627 562f +cac c97 562e 562f +c9a c98 5612 5631 +c98 c9b 5615 5630 +c98 cad 5630 5632 +c98 cae 5632 5634 +c99 c9a 5613 5636 +caa c99 562b 5638 +c9b cac 562e 5635 +cad c9b 5630 5635 +c9e c9c 5618 5639 +c9c ca2 561e 563a +caf c9c 5639 563b +c9c cb0 563a 563c +cb1 c9c 563b 563c +c9d c9e 5619 563d +ca3 c9d 5624 563e +c9d cb2 563d 563f +cb3 c9d 563e 5640 +c9d cb4 563f 5640 +c9e caf 5639 5641 +cb2 c9e 563d 5641 +c9f ca1 561c 5642 +ca2 c9f 561f 5643 +c9f cb5 5642 5644 +cb6 c9f 5643 5644 +ca1 ca0 561d 5645 +ca0 ca6 5626 5646 +cb7 ca0 5645 5647 +ca0 cb8 5646 5647 +cb5 ca1 5642 5648 +ca1 cb7 5645 5649 +cb9 ca1 5648 564a +ca1 cba 5649 564a +cb0 ca2 563a 564b +ca2 cb6 5643 564c +cbb ca2 564b 564c +ca5 ca3 5622 564d +ca3 cb3 563e 564d +ca4 ca5 5623 564e +ca8 ca4 5628 564f +ca4 cbc 564e 564f +ca5 cb3 564d 5650 +cbc ca5 564e 5651 +ca5 cbd 5650 5653 +cbe ca5 5651 5652 +cbf ca5 5652 5653 +ca6 cab 562c 5654 +cb8 ca6 5646 5654 +ca7 ca9 5629 5655 +cac ca7 562f 5656 +ca7 cc0 5655 5656 +ca9 ca8 562a 5657 +ca8 cbc 564f 5658 +cc1 ca8 5657 5659 +ca8 cc2 5658 565a +cc3 ca8 5659 565a +cc0 ca9 5655 565b +ca9 cc1 5657 565b +cab caa 562d 5664 +cb8 cab 5654 5667 +cad cac 5635 565c +cac cc0 5656 565e +cc4 cac 565c 565d +cc5 cac 565d 565e +cae cad 5632 565f +cad cc4 565c 5661 +cc6 cad 565f 5660 +cc7 cad 5660 5661 +cae cc6 565f 5663 +caf cb1 563b 5669 +cb2 caf 5641 566a +caf cc8 5669 566b +cc9 caf 566a 566b +cb1 cb0 563c 566c +cb0 cbb 564b 566d +cca cb0 566c 566d +cc8 cb1 5669 566e +cb1 cca 566c 566f +ccb cb1 566e 566f +cb4 cb2 563f 5670 +cb2 cc9 566a 5671 +ccc cb2 5670 5671 +cb3 cb4 5640 5672 +cbd cb3 5650 5673 +cb3 ccd 5672 5673 +cb4 ccc 5670 5676 +ccd cb4 5672 5674 +cce cb4 5674 5675 +ccf cb4 5675 5676 +cb6 cb5 5644 5677 +cb5 cb9 5648 5678 +cd0 cb5 5677 5678 +cbb cb6 564c 5679 +cb6 cd0 5677 567a +cd1 cb6 5679 567a +cb7 cb8 5647 567b +cba cb7 5649 567c +cb7 cd2 567b 567c +cd2 cb8 567b 567d +cb9 cba 564a 567e +cd0 cb9 5678 5683 +cb9 cd3 567e 5681 +cb9 cd5 5681 5682 +cb9 cd6 5682 5683 +cba cd2 567c 567f +cd3 cba 567e 5680 +cba cd4 567f 5680 +cca cbb 566d 5686 +cbb cd1 5679 5684 +cbb cd7 5684 5685 +cbb cd8 5685 5686 +cbc cbe 5651 5687 +cc2 cbc 5658 5688 +cbc cd9 5687 5688 +cbf cbd 5653 568b +cbd ccd 5673 568f +cdb cbd 568b 568e +cdd cbd 568e 568f +cbe cbf 5652 5689 +cd9 cbe 5687 568a +cbe cda 5689 568a +cda cbf 5689 568c +cbf cdb 568b 568d +cdc cbf 568c 568d +cc0 cc1 565b 569c +cc5 cc0 565e 5699 +ce2 cc0 5699 569c +cc1 cc3 5659 6cb4 +ce2 cc1 569c 58fe +e3b cc1 58fe 6cb4 +cc3 cc2 565a 6cb8 +cc2 cd9 5688 6cbf +18ee cc2 6cb8 6cbf +cc3 e3b 6cb3 6cb4 +18ec cc3 6cb3 6cb5 +18ee cc3 6cb5 6cb8 +cc4 cc5 565d 5694 +cc7 cc4 5661 5693 +cdf cc4 5693 5695 +cc4 ce0 5694 5695 +ce0 cc5 5694 569a +cc5 ce2 5699 569b +ce3 cc5 569a 569b +cc6 cc7 5660 5691 +cc6 cde 5691 5692 +cde cc7 5691 5696 +cc7 cdf 5693 5696 +cc9 cc8 566b 734c +cc8 ccb 566e 79b0 +193b cc8 7006 7008 +cc8 193c 7006 700a +1ac7 cc8 7008 79b0 +cc8 1ac8 700a 734c +ccc cc9 5671 734b +1ac8 cc9 734b 734c +ccb cca 566f 79b2 +cca cd8 5686 79b2 +cd8 ccb 79b1 79b2 +1ac7 ccb 79b0 79b1 +ccf ccc 5676 7339 +1ac8 ccc 733c 734b +1c4f ccc 7339 733c +ccd cce 5674 6f61 +cdd ccd 568f 6f61 +cce ccf 5675 732b +cdd cce 6f61 6f62 +1a6b cce 6f62 6f6d +1a73 cce 6f6d 7326 +1c4a cce 7326 732b +1c4a ccf 732b 732d +1c4f ccf 732d 7339 +cd1 cd0 567a 57ef +cd0 cd6 5683 57ee +cd0 da2 57ee 57ef +cd7 cd1 5684 57fc +cd1 da2 57ef 57f8 +cd1 da7 57f8 57fc +cd4 cd2 567f 57d8 +d98 cd2 57d8 57d9 +cd3 cd4 5680 57db +cd5 cd3 5681 57e0 +cd3 d99 57db 57df +cd3 d9b 57df 57e1 +d9c cd3 57e0 57e1 +cd4 d98 57d8 57da +cd4 d99 57da 57db +cd6 cd5 5682 57e8 +cd5 d9c 57e0 57e7 +cd5 d9e 57e7 57e8 +cd6 d9e 57e8 57f0 +da2 cd6 57ee 57f1 +cd6 da3 57f0 57f1 +cd8 cd7 5685 6d84 +cd7 da7 57fc 6d6f +cd7 195e 6d6f 6d84 +cd8 193f 6d85 700f +cd8 195e 6d84 6d85 +cd8 1ac7 700f 79b1 +cd9 cda 568a 6cc4 +cd9 18ee 6cbe 6cbf +18f1 cd9 6cbe 6cc1 +18f4 cd9 6cc1 6cc4 +cda cdc 568c 6f54 +18f4 cda 6cc4 6cc9 +18f8 cda 6cc9 6f54 +cdc cdb 568d 6f55 +cdb cdd 568e 6f5a +1a64 cdb 6f55 6f57 +1a69 cdb 6f57 6f5a +cdc 18f8 6f4f 6f54 +1a5f cdc 6f4f 6f50 +1a64 cdc 6f50 6f55 +1a69 cdd 6f5a 6f5c +1a6b cdd 6f5c 6f62 +cde cdf 5696 569d +ce1 cde 5697 569e +cde ce4 569d 569e +cdf ce0 5695 569f +ce4 cdf 569d 569f +ce0 ce3 569a 56a1 +ce4 ce0 569f 8d02 +ce5 ce0 56a0 56a1 +ce0 ce6 56a0 8d02 +ce1 ce4 569e 58f9 +ce1 e37 58f9 7dce +ce1 2215 7dce 8cc7 +ce3 ce2 569b 58fb +e39 ce2 58fb 58fc +e3a ce2 58fc 58fd +e3b ce2 58fd 58fe +ce5 ce3 56a1 58fa +e39 ce3 58fa 58fb +ce6 ce4 58f8 8d02 +ce4 e37 58f8 58f9 +ce6 ce5 56a0 8d03 +ce5 e39 58fa 8140 +ce5 2211 813f 8d03 +23fc ce5 813f 8140 +ce6 e37 58f7 58f8 +e38 ce6 58f7 8c75 +2211 ce6 8c75 8d03 +ce8 ce7 56a2 56a6 +ce9 ce7 56a6 56a8 +cea ce7 56a8 56aa +ce7 ceb 56a9 56aa +ce8 ce9 56a6 56ac +cec ce8 56ab 56ac +ce9 cea 56a8 56b0 +cec ce9 56ac 56b1 +ce9 cef 56b0 56b2 +cf0 ce9 56b1 56b3 +ce9 cf1 56b2 56b3 +cea ceb 56aa 56b7 +cef cea 56b0 56b8 +cea cf4 56b7 56b8 +ceb cf2 56b4 56b9 +cf4 ceb 56b7 56ba +ceb cf5 56b9 56ba +ced cec 56ad 56bb +cec cf0 56b1 56bc +cf6 cec 56bb 56bd +cec cf7 56bc 56bd +cee ced 56ae 56be +ced cf6 56bb 56bf +cf8 ced 56be 56bf +cee cf8 56be 56c2 +cf9 cee 56c0 56c3 +cf1 cef 56b2 56c4 +cef cf4 56b8 56c5 +cfa cef 56c4 56c6 +cef cfb 56c5 56c6 +cf0 cf1 56b3 56c7 +cf7 cf0 56bc 56c8 +cf0 cfc 56c7 56c8 +cf1 cfa 56c4 56c9 +cfc cf1 56c7 56ca +cf1 cfd 56c9 56ca +cf2 cf3 56b5 56cb +cf5 cf2 56b9 56cc +cf2 cfe 56cb 56cc +cfe cf3 56cb 56ce +cff cf3 56ce 56d0 +cf3 d00 56cf 56d0 +cf4 cf5 56ba 56d1 +cfb cf4 56c5 56d2 +cf4 d01 56d1 56d3 +d02 cf4 56d2 56d3 +cf5 cfe 56cc 56d5 +d01 cf5 56d1 56d4 +d03 cf5 56d4 56d5 +cf6 cf7 56bd 56d6 +cf8 cf6 56bf 56d7 +cf6 d04 56d6 56d8 +d05 cf6 56d7 56d9 +cf6 d06 56d8 56d9 +cf7 cfc 56c8 56da +d04 cf7 56d6 56da +cf8 d05 56d7 56dc +cfa cfb 56c6 56e0 +cfd cfa 56c9 56e1 +cfa d07 56e0 56e2 +d08 cfa 56e1 56e3 +cfa d09 56e2 56e3 +cfb d02 56d2 56e4 +d07 cfb 56e0 56e5 +cfb d0a 56e4 56e5 +cfc cfd 56ca 56e6 +d04 cfc 56da 56e7 +cfc d0b 56e6 56e9 +d0c cfc 56e7 56e8 +d0d cfc 56e8 56e9 +cfd d08 56e1 56eb +d0b cfd 56e6 56ea +d0e cfd 56ea 56eb +cfe cff 56ce 56f1 +d03 cfe 56d5 56f0 +d11 cfe 56f0 56f1 +cff d00 56d0 56f6 +d11 cff 56f1 56f7 +cff d14 56f6 56f8 +d15 cff 56f7 56f8 +d00 d13 56f4 56f9 +d14 d00 56f6 56f9 +d02 d01 56d3 56ec +d01 d03 56d4 56ed +d0f d01 56ec 56ee +d01 d10 56ed 56ee +d0a d02 56e4 56ef +d02 d0f 56ec 56ef +d10 d03 56ed 56f3 +d03 d11 56f0 56f2 +d03 d12 56f2 56f3 +d06 d04 56d8 56fa +d04 d0c 56e7 56fb +d16 d04 56fa 56fb +d05 d06 56d9 56fc +d05 d17 56fc 5700 +d19 d05 56ff 5700 +d06 d16 56fa 56fe +d17 d06 56fc 56fd +d18 d06 56fd 56fe +d09 d07 56e2 5c1e +d07 d0a 56e5 5733 +d07 d37 5733 5c1d +d07 1005 5c1d 5c1e +d08 d09 56e3 6953 +d0e d08 56eb 68fe +1715 d08 68fe 6953 +d09 1005 5c1e 6958 +1715 d09 6953 6954 +1730 d09 6954 6958 +d0a d0f 56ef 5719 +d0a d28 5719 5731 +d0a d36 5731 5732 +d0a d37 5732 5733 +d0d d0b 56e9 68ed +d0b d0e 56ea 68ef +d54 d0b 68ed 68ef +d0c d0d 56e8 5778 +d16 d0c 56fb 5778 +d0d d16 5777 5778 +d50 d0d 5777 577a +d54 d0d 577a 68ed +d54 d0e 68ef 68f1 +1710 d0e 68f1 68fb +1715 d0e 68fb 68fe +d0f d10 56ee 5708 +d0f d1d 5708 5714 +d0f d26 5714 5718 +d0f d28 5718 5719 +d10 d12 56f3 5705 +d10 d1d 5705 5708 +d12 d11 56f2 5701 +d11 d15 56f7 5704 +d1a d11 5701 5702 +d1b d11 5702 5703 +d1c d11 5703 5704 +d12 d1a 5701 5706 +d1d d12 5705 5707 +d12 d1e 5706 5707 +d14 d13 56f9 571f +d2c d13 571f 5743 +d40 d13 5743 5744 +d15 d14 56f8 5710 +d24 d14 5710 571e +d2b d14 571e 5720 +d14 d2c 571f 5720 +d1c d15 5704 570f +d23 d15 570f 5711 +d15 d24 5710 5711 +d18 d16 56fe 576a +d4b d16 576a 576e +d50 d16 576e 5777 +d17 d18 56fd 5759 +d19 d17 5700 575a +d48 d18 5760 5763 +d4b d18 5763 576a +d1a d1b 5702 5709 +d1e d1a 5706 570a +d1a d1f 5709 570b +d20 d1a 570a 570b +d1b d1c 5703 570c +d1f d1b 5709 570d +d1b d21 570c 570e +d22 d1b 570d 570e +d21 d1c 570c 5712 +d1c d23 570f 5712 +d1d d1e 5707 5713 +d1d d25 5713 5715 +d26 d1d 5714 5715 +d1e d20 570a 5716 +d25 d1e 5713 5717 +d1e d27 5716 5717 +d20 d1f 570b 571a +d1f d22 570d 571b +d29 d1f 571a 571c +d1f d2a 571b 571c +d27 d20 5716 571d +d20 d29 571a 571d +d22 d21 570e 5721 +d21 d23 5712 5722 +d2d d21 5721 5723 +d21 d2e 5722 5724 +d2f d21 5723 5724 +d2a d22 571b 5725 +d22 d2d 5721 5726 +d30 d22 5725 5726 +d23 d24 5711 5727 +d2e d23 5722 5727 +d24 d2b 571e 5729 +d2e d24 5727 5728 +d31 d24 5728 5729 +d26 d25 5715 572a +d25 d27 5717 572b +d32 d25 572a 572c +d25 d33 572b 572c +d28 d26 5718 572d +d26 d32 572a 572e +d34 d26 572d 572e +d27 d29 571d 572f +d33 d27 572b 5730 +d27 d35 572f 5730 +d28 d34 572d 5734 +d36 d28 5731 5734 +d29 d2a 571c 5735 +d35 d29 572f 5736 +d29 d38 5735 5737 +d39 d29 5736 5737 +d2a d30 5725 5738 +d38 d2a 5735 5739 +d2a d3a 5738 5739 +d2b d2c 5720 5745 +d31 d2b 5729 5746 +d41 d2b 5746 5748 +d2c d40 5743 5749 +d2d d2f 5723 573a +d30 d2d 5726 573b +d2d d3b 573a 573c +d3c d2d 573b 573c +d2f d2e 5724 573d +d2e d31 5728 573e +d3d d2e 573d 573e +d3b d2f 573a 573f +d2f d3d 573d 5740 +d3e d2f 573f 5740 +d3a d30 5738 5741 +d30 d3c 573b 5742 +d3f d30 5741 5742 +d3d d31 573e 574a +d31 d41 5746 574a +d32 d33 572c 574b +d34 d32 572e 574c +d32 d42 574b 574c +d33 d35 5730 574d +d42 d33 574b 574f +d33 d43 574d 574e +d33 d44 574e 574f +d36 d34 5734 5750 +d34 d42 574c 5751 +d45 d34 5750 5752 +d34 d46 5751 5752 +d35 d39 5736 5753 +d43 d35 574d 5753 +d37 d36 5732 5c1c +d36 d45 5750 5c1c +d37 d45 5c1c 5c1f +1005 d37 5c1d 5c20 +d37 1006 5c1f 5c20 +d39 d38 5737 5af4 +d38 d3a 5739 5afc +f57 d38 5af4 5af5 +f5c d38 5af5 5afc +d43 d39 5753 5ac8 +f42 d39 5ac3 5ac5 +d39 f44 5ac3 5ac8 +f57 d39 5ac5 5af4 +d3a d3f 5741 5bd4 +f5c d3a 5afc 5afd +f71 d3a 5afd 5bd4 +d3c d3b 573c 5bda +d3b d3e 573f 5be2 +fe4 d3b 5bda 5be2 +d3f d3c 5742 5bd6 +fe3 d3c 5bd6 5bd9 +fe4 d3c 5bd9 5bda +d3e d3d 5740 5bf0 +d3d d41 574a 5819 +d3d db0 5819 5bf0 +d3e db0 5bf0 5bf2 +fe4 d3e 5be2 5be4 +fea d3e 5be4 5bf1 +ff0 d3e 5bf1 5bf2 +f71 d3f 5bd4 5bd5 +fe2 d3f 5bd5 5bd7 +d3f fe3 5bd6 5bd7 +d41 daf 5818 581a +db0 d41 5819 581a +d42 d44 574f 5c21 +d46 d42 5751 5c22 +d42 f6c 5c21 5c23 +1007 d42 5c22 5c23 +d44 d43 574e 5af2 +d43 f43 5ac6 5ac7 +f44 d43 5ac6 5ac8 +d43 f54 5ac7 5af2 +f54 d44 5af1 5af2 +d44 f55 5af1 5af3 +d44 f6c 5af3 5c21 +d45 d46 5752 5c24 +1006 d45 5c1f 5c26 +d45 1008 5c24 5c25 +d45 1009 5c25 5c26 +d46 1007 5c22 5c28 +1008 d46 5c24 5c27 +100a d46 5c27 5c28 +d47 d48 575d 5761 +d49 d47 575e 5762 +d47 d4a 5761 5762 +d4a d48 5761 5764 +d48 d4b 5763 5764 +d49 d4a 5762 5766 +d4c d49 5765 5767 +d49 d4d 5766 5767 +d4a d4b 5764 576b +d4d d4a 5766 576c +d4a d4f 576b 576c +d4f d4b 576b 576d +d50 d4b 576d 576e +d4c d4d 5767 5770 +d4e d4c 5769 5771 +d4c d51 5770 5772 +d52 d4c 5771 5772 +d4d d4f 576c 5773 +d51 d4d 5770 5774 +d4d d53 5773 5774 +d4e d52 5771 5775 +d4f d50 576d 5776 +d53 d4f 5773 5776 +d53 d50 5776 5779 +d54 d50 5779 577a +d52 d51 5772 68eb +d51 d53 5774 68e8 +d51 170c 68e8 68ea +d51 170d 68ea 68ec +170e d51 68eb 68ec +d52 170e 68eb 68f4 +d52 1712 68f4 68f5 +d53 d54 5779 68e9 +170c d53 68e8 68e9 +170c d54 68e9 68ee +170f d54 68ee 68f0 +1710 d54 68f0 68f1 +d56 d55 577d 577e +d55 d57 577d 577f +d58 d55 577e 8d92 +d55 d59 577f 8104 +d55 23c2 8104 8105 +d55 23c5 8105 8d92 +d57 d56 577d 5780 +d56 d58 577e 5782 +d5a d56 5780 5781 +d5b d56 5781 5782 +d59 d57 577f 5783 +d57 d5a 5780 5784 +d5c d57 5783 5785 +d57 d5d 5784 5786 +d5e d57 5785 5786 +d5b d58 5782 8de4 +d58 21be 8e0e 8e36 +21bf d58 8de4 8e36 +d58 23c5 8d92 8e0e +d59 d5c 5783 5787 +d59 d5f 5787 5788 +d59 d60 5788 8d32 +23c2 d59 8104 8d32 +d5a d5b 5781 5789 +d5d d5a 5784 578a +d5a d61 5789 578b +d62 d5a 578a 578b +d61 d5b 5789 8e92 +21bf d5b 7d73 8de4 +d5b 21c1 7d73 7d77 +d5b 21c2 7d77 8e92 +d5c d5e 5785 578c +d5f d5c 5787 578d +d5c d63 578c 578e +d64 d5c 578d 578e +d5e d5d 5786 578f +d5d d62 578a 5790 +d65 d5d 578f 5790 +d63 d5e 578c 5791 +d5e d65 578f 5791 +d60 d5f 5788 5792 +d5f d64 578d 5793 +d66 d5f 5792 5794 +d5f d67 5793 5794 +d60 d66 5792 8392 +23c2 d60 8d32 8d9a +d60 23c3 8103 8d9a +23c4 d60 8103 8390 +24fe d60 8390 8392 +d62 d61 578b 5795 +d68 d61 5795 8de3 +d61 d75 7d75 8de3 +21c2 d61 7d75 8e92 +d65 d62 5790 5797 +d62 d68 5795 5796 +d62 d69 5796 5798 +d6a d62 5797 5798 +d64 d63 578e 579a +d63 d65 5791 579b +d6c d63 579a 579d +d63 d6d 579b 579c +d63 d6e 579c 579d +d67 d64 5793 579e +d64 d6c 579a 579e +d65 d6a 5797 579f +d6d d65 579b 57a0 +d65 d6f 579f 57a0 +d66 d67 5794 57a1 +d66 d70 57a1 57a2 +d66 d71 57a2 8ca9 +24fe d66 8392 8ca9 +d67 d6c 579e 57a3 +d70 d67 57a1 57a4 +d67 d72 57a3 57a4 +d69 d68 5796 5799 +d6b d68 5799 57a8 +d75 d68 57a8 8de3 +d6a d69 5798 57a5 +d69 d6b 5799 8dd9 +d73 d69 57a5 8d38 +2293 d69 7ec9 8dd9 +d69 2294 7ec9 8d38 +d6f d6a 579f 57a7 +d6a d73 57a5 57a6 +d6a d74 57a6 57a7 +d6b d75 57a8 8e3b +21c4 d6b 8c57 8e3b +d6b 21c5 8c57 8e85 +2292 d6b 7ec8 8e85 +d6b 2293 7ec8 8dd9 +d6c d6e 579d 581d +d72 d6c 57a3 581f +d6c d94 581e 581f +d6c d95 581d 581e +d6e d6d 579c 581c +d6d d6f 57a0 7ecd +d97 d6d 581c 81e5 +d6d 2297 7ecd 81e5 +d95 d6e 581d 5820 +d6e d97 581c 5820 +d6f d74 57a7 8bd2 +d6f 20d6 8bd2 8c3f +2297 d6f 7ecd 8c3f +d71 d70 57a2 5824 +d70 d72 57a4 5822 +d70 db1 5822 5825 +db2 d70 5824 5825 +d71 db2 5824 838f +2415 d71 838d 838f +d71 24fe 838d 8ca9 +d72 d94 581f 5821 +d72 d96 5821 5823 +db1 d72 5822 5823 +d74 d73 57a6 8d26 +d73 2294 8d38 8e03 +2295 d73 8d26 8e03 +d74 20d6 81e4 8bd2 +d74 2291 7ecb 8dcc +2295 d74 7ecb 8d26 +2296 d74 81e4 8dcc +d75 21c2 7d75 7d76 +d75 21c3 7d76 7d78 +d75 21c4 7d78 8e3b +d77 d76 57a9 8ac1 +d76 d78 57a9 57aa +d76 d79 57aa 57ab +d76 d7a 57ab 57ac +d76 d7b 57ac 81e9 +d76 2427 81e9 8ac1 +d78 d77 57a9 57ad +d7c d77 57ad 89d4 +2427 d77 8475 8ac1 +256b d77 8472 8475 +d77 256c 8472 89d4 +d79 d78 57aa 57ae +d78 d7c 57ad 57af +d7d d78 57ae 57b0 +d78 d7e 57af 57b0 +d7a d79 57ab 57b1 +d79 d7d 57ae 57b2 +d7f d79 57b1 57b3 +d79 d80 57b2 57b3 +d7b d7a 57ac 57b7 +d7a d7f 57b1 57b5 +d81 d7a 57b4 57b5 +d7a d82 57b4 57b6 +d7a d83 57b6 57b7 +d7b d83 57b7 89df +2423 d7b 81e7 89df +d7b 2426 81e7 8978 +2427 d7b 81e9 8978 +d7e d7c 57af 57b8 +d84 d7c 57b8 57b9 +d85 d7c 57b9 57ba +d86 d7c 57ba 8918 +256c d7c 8918 89d4 +d7d d7e 57b0 57bb +d80 d7d 57b2 57bc +d7d d87 57bb 57bd +d88 d7d 57bc 57bd +d7e d84 57b8 57be +d87 d7e 57bb 57be +d7f d80 57b3 57c6 +d81 d7f 57b5 57c0 +d8a d7f 57c0 57c5 +d8d d7f 57c5 57c6 +d80 d88 57bc 57cf +d8d d80 57c6 57ce +d92 d80 57ce 57d0 +d80 d93 57cf 57d0 +d82 d81 57b4 57bf +d89 d81 57bf 57c1 +d81 d8a 57c0 57c1 +d83 d82 57b6 57c4 +d82 d89 57bf 57c2 +d82 d8b 57c2 57c3 +d82 d8c 57c3 57c4 +d83 d8c 57c4 8a60 +2422 d83 81df 8a60 +d83 2423 81df 89df +d84 d85 57b9 5b94 +d87 d84 57be 5b6e +fa1 d84 5b6e 5b6f +faa d84 5b6f 5b8d +fbb d84 5b8d 5b94 +d85 d86 57ba 6d94 +fbb d85 5b94 5bac +fbc d85 5bac 5bad +fcd d85 5bad 6d94 +fcd d86 6d94 6d95 +1972 d86 6d95 88d2 +d86 256c 8918 89b6 +256d d86 88d2 89b6 +d88 d87 57bd 5b5d +d87 f97 5b5c 5b5d +fa1 d87 5b5c 5b6e +d93 d88 57cf 5b59 +d88 f95 5b57 5b59 +f97 d88 5b57 5b5d +d89 d8a 57c1 57c8 +d8b d89 57c2 57c7 +d8e d89 57c7 57c9 +d89 d8f 57c8 57c9 +d8a d8d 57c5 57cc +d8f d8a 57c8 57cd +d8a d91 57cc 57cd +d8c d8b 57c3 57cb +d8b d8e 57c7 57ca +d8b d90 57ca 57cb +d8c d90 57cb 8baf +2422 d8c 8a60 8b1a +2425 d8c 8b1a 8baf +d91 d8d 57cc 57d1 +d8d d92 57ce 57d1 +d8e d8f 57c9 57d2 +d90 d8e 57ca 57d3 +d8e d94 57d2 57d4 +d95 d8e 57d3 57d4 +d8f d91 57cd 57d6 +d94 d8f 57d2 57d5 +d96 d8f 57d5 57d6 +d90 d95 57d3 57d7 +d90 d97 57d7 81e0 +d90 2424 81e0 8c29 +2425 d90 8baf 8c29 +d91 d92 57d1 5b9e +d96 d91 57d6 6f2e +d91 fc3 5b9e 6f36 +1a50 d91 6f2e 6f32 +1a53 d91 6f32 6f36 +d92 d93 57d0 5b79 +d92 fb0 5b79 5b9a +d92 fc3 5b9a 5b9e +d93 f95 5b59 5b5a +d93 fa0 5b5a 5b77 +d93 fb0 5b77 5b79 +d95 d94 57d4 581e +d94 d96 57d5 5821 +d97 d95 57d7 5820 +db1 d96 5823 6f2a +1a50 d96 6f2a 6f2e +2297 d97 81e2 81e5 +2424 d97 81e0 81e2 +d99 d98 57da 57dd +d9a d98 57dd 57de +d99 d9a 57dd 57e2 +d9b d99 57df 57e3 +d99 d9d 57e2 57e3 +d9d d9a 57e2 57e5 +d9c d9b 57e1 57e9 +d9b d9d 57e3 57ea +d9f d9b 57e9 57eb +d9b da0 57ea 57eb +d9e d9c 57e7 57ec +d9c d9f 57e9 57ed +da1 d9c 57ec 57ed +da0 d9d 57ea 57f3 +da4 d9d 57f3 57f4 +d9e da1 57ec 57f6 +da3 d9e 57f0 57f5 +da5 d9e 57f5 57f6 +d9f da0 57eb 57fe +da1 d9f 57ed 57fd +da9 d9f 57fd 57ff +d9f daa 57fe 57ff +da0 da4 57f3 5803 +daa da0 57fe 5803 +da5 da1 57f6 5802 +da1 da9 57fd 5800 +da1 dab 5800 5801 +da1 dac 5801 5802 +da2 da3 57f1 57f7 +da2 da6 57f7 57f9 +da7 da2 57f8 57f9 +da3 da5 57f5 57fa +da6 da3 57f7 57fb +da3 da8 57fa 57fb +daa da4 5803 8a9c +da4 23ff 83d2 8a9c +da8 da5 57fa 5a82 +da5 dac 5802 5a7f +da5 f29 5a7f 5a82 +da7 da6 57f9 6d61 +da6 da8 57fb 6d5c +da6 1954 6d5c 6d60 +da6 1956 6d60 6d61 +da7 1956 6d61 6d6b +da7 195c 6d6b 6d6e +da7 195e 6d6e 6d6f +da8 f29 5a82 6d5b +da8 1953 6d5b 6d5d +1954 da8 6d5c 6d5d +da9 daa 57ff 8616 +dab da9 5800 8619 +da9 2401 8616 8619 +daa 23ff 8a9c 8af8 +2401 daa 8616 8af8 +dac dab 5801 5a67 +f19 dab 5a67 5a68 +f1a dab 5a68 8615 +2401 dab 8618 8619 +2665 dab 8615 8618 +dac f19 5a67 5a80 +f29 dac 5a7f 5a81 +dac f2a 5a80 5a81 +dae dad 5812 5a61 +dad ee9 5a30 5a31 +eea dad 5a30 5a34 +dad eee 5a31 5a3d +dad f02 5a3d 5a61 +dae f02 5a61 6a46 +db0 daf 581a 69ec +daf 1773 69e7 69ec +ff0 db0 5bf2 69ee +db0 1773 69ec 69ee +db2 db1 5825 6f29 +1a4f db1 6f29 6f2b +db1 1a50 6f2a 6f2b +db2 1a4f 6f29 6f2c +db2 1a51 6f2c 6f2d +db2 1a52 6f2d 838c +db2 2415 838c 838f +db4 db3 5826 8465 +db3 db5 5826 5827 +db3 db6 5827 8706 +255f db3 8707 88da +db3 2560 8707 88cf +2562 db3 8465 88cf +db3 2680 8706 88da +db5 db4 5826 5828 +db7 db4 5828 5829 +db8 db4 5829 582a +db9 db4 582a 868c +db4 2562 8465 868c +db6 db5 5827 582b +db5 db7 5828 582c +dba db5 582b 582d +db5 dbb 582c 582d +db6 dba 582b 582e +db6 dbc 582e 582f +db6 dbd 582f 5830 +db6 dbe 5830 88db +2680 db6 8706 88db +db7 db8 5829 5831 +dbb db7 582c 5832 +db7 dbf 5831 5832 +db8 db9 582a 5833 +dbf db8 5831 5834 +db8 dc0 5833 5835 +dc1 db8 5834 5836 +db8 dc2 5835 5836 +dc0 db9 5833 5837 +dc3 db9 5837 88ce +db9 2562 868c 88ce +dba dbb 582d 5838 +dbc dba 582e 5839 +dba dc4 5838 583a +dc5 dba 5839 583a +dbb dbf 5832 583b +dc4 dbb 5838 583c +dbb dc6 583b 583c +dbd dbc 582f 583d +dbc dc5 5839 583e +dc7 dbc 583d 583f +dbc dc8 583e 5841 +dc9 dbc 583f 5840 +dca dbc 5840 5841 +dbe dbd 5830 5842 +dbd dc7 583d 5843 +dcb dbd 5842 5843 +dbe dcb 5842 8703 +dbe 25d0 8683 8688 +267a dbe 8683 899c +dbe 2680 8688 88db +dbe 26b5 8703 899c +dbf dc1 5834 5844 +dc6 dbf 583b 5845 +dbf dcc 5844 5845 +dc2 dc0 5835 5847 +dc0 dc3 5837 5846 +dc0 dcd 5846 5849 +dce dc0 5847 5848 +dcf dc0 5848 5849 +dc1 dc2 5836 584a +dcc dc1 5844 584f +dc1 dd0 584a 584d +dc1 dd2 584d 584e +dc1 dd3 584e 584f +dc2 dce 5847 584b +dd0 dc2 584a 584c +dc2 dd1 584b 584c +dcd dc3 5846 868e +2562 dc3 870a 88ce +dc3 25d2 868f 8950 +2681 dc3 868f 870a +2682 dc3 868e 8950 +dc5 dc4 583a 5850 +dc4 dc6 583c 5851 +dd4 dc4 5850 5852 +dc4 dd5 5851 5852 +dc8 dc5 583e 5853 +dc5 dd4 5850 5854 +dd6 dc5 5853 5854 +dc6 dcc 5845 5855 +dd5 dc6 5851 5856 +dc6 dd7 5855 5856 +dc7 dc9 583f 5859 +dcb dc7 5843 5857 +dd8 dc7 5857 5859 +dca dc8 5841 585b +dc8 dd6 5853 585b +dc9 dca 5840 585a +dd8 dc9 5859 585f +dc9 dda 585a 5860 +ddd dc9 585f 5860 +dca dd6 585b 585e +dda dca 585a 585c +ddb dca 585c 585d +ddc dca 585d 585e +dcb dd8 5857 5858 +dcb dd9 5858 899d +26b5 dcb 8703 899d +dcc dd3 584f 6afc +dd7 dcc 5855 6afe +dcc 17fe 6afc 6afe +dcf dcd 5849 6ac2 +17d6 dcd 6ac2 6ac6 +17dd dcd 6ac6 6ada +17eb dcd 6ada 870e +dcd 2682 868e 870e +dce dcf 5848 6ab4 +dd1 dce 584b 6aaf +dce 17d0 6aae 6aaf +17d1 dce 6aae 6ab4 +17d1 dcf 6ab4 6ab6 +17d6 dcf 6ab6 6ac2 +dd0 dd1 584c 6ab9 +dd2 dd0 584d 6ac7 +dd0 17d7 6ab9 6ac7 +dd1 17d0 6aaf 6ab1 +dd1 17d3 6ab1 6ab8 +dd1 17d7 6ab8 6ab9 +dd3 dd2 584e 6ae0 +dd2 17d7 6ac7 6ac9 +dd2 17e0 6ac9 6ae0 +dd3 17e0 6ae0 6ae3 +dd3 17f0 6ae3 6afd +17fe dd3 6afc 6afd +dd4 dd5 5852 767b +dd6 dd4 5854 58df +e28 dd4 58df 767b +dd5 dd7 5856 7680 +dd5 e28 767a 767b +1df5 dd5 767a 767f +1df6 dd5 767f 7680 +ddc dd6 585e 58db +e28 dd6 58db 58df +dd7 17fe 6afe 7686 +1df6 dd7 7680 7684 +1df7 dd7 7684 7686 +dd9 dd8 5858 5861 +dd8 ddd 585f 5862 +dde dd8 5861 5863 +dd8 ddf 5862 5863 +dd9 dde 5861 5864 +dd9 de0 5864 58ed +dd9 e30 58ed 899e +26b5 dd9 899d 899e +dda ddb 585c 58c5 +ddd dda 5860 58c4 +e15 dda 58c4 58c5 +ddb ddc 585d 58d0 +ddb e15 58c3 58c5 +e17 ddb 58c3 58c9 +e20 ddb 58c9 58cf +e24 ddb 58cf 58d0 +e24 ddc 58d0 58d9 +e27 ddc 58d9 58dc +ddc e28 58db 58dc +ddf ddd 5862 58b4 +ddd e10 58b3 58b4 +e15 ddd 58b3 58c4 +dde ddf 5863 58ca +de0 dde 5864 58d5 +dde e18 58ca 58cb +dde e22 58cb 58d5 +ddf e0f 58b0 58b2 +e10 ddf 58b0 58b4 +ddf e18 58b2 58ca +de0 df9 58e0 88d6 +de0 dfa 58d7 58e0 +de0 e22 58d5 58d7 +e30 de0 58ed 88d6 +de2 de1 5865 8cf4 +de1 de3 5865 5866 +de1 de4 5866 8d0c +de1 de8 5869 8da2 +de9 de1 5869 8d0c +20cf de1 8cf4 8da2 +de3 de2 5865 586f +de5 de2 5867 7b46 +de2 de6 5867 586b +de2 deb 586b 586f +20cf de2 7b46 8cf4 +de4 de3 5866 5875 +de3 deb 586f 5874 +de3 df2 5874 5876 +df3 de3 5875 5876 +de4 de9 7b44 8d0c +de4 df3 5875 5879 +de4 df5 5879 8d57 +20cb de4 7b44 8d57 +de6 de5 5867 5868 +de7 de5 5868 586a +dea de5 586a 8ca2 +de5 20cf 7b46 8d87 +2711 de5 8ca2 8d87 +de6 de7 5868 586c +deb de6 586b 586d +de6 dec 586c 586e +ded de6 586d 586e +de7 dea 586a 5870 +dec de7 586c 5871 +de7 dee 5870 8c54 +def de7 5871 5873 +df1 de7 5873 8c54 +de8 de9 5869 8da3 +20ce de8 7b45 8be1 +de8 20cf 7b45 8da2 +20d2 de8 8be1 8da3 +de9 20cb 7b44 8d0d +20d2 de9 8da3 8dff +de9 2726 8d0d 8dff +dee dea 5870 8b18 +dea 226d 8c84 8d6a +226e dea 8b18 8d6a +dea 2711 8ca2 8d86 +2723 dea 8c84 8d86 +deb ded 586d 5877 +df2 deb 5874 5878 +deb df4 5877 5878 +ded dec 586e 587a +dec def 5871 587b +df6 dec 587a 587b +df4 ded 5877 587c +ded df6 587a 587e +df7 ded 587c 587d +df8 ded 587d 587e +df0 dee 5872 8b9d +dee df1 5872 8c54 +dee 226e 8b18 8bd1 +2703 dee 8b9d 8bd1 +def df1 5873 587f +df6 def 587b 5880 +def df9 587f 5881 +dfa def 5880 5881 +df1 df0 5872 8c55 +df0 df9 899f 8c55 +267b df0 899f 89a2 +2703 df0 8932 8b9d +df0 2704 8932 89a2 +df9 df1 587f 8c55 +df3 df2 5876 5882 +df2 df4 5878 5883 +dfb df2 5882 5884 +df2 dfc 5883 5884 +df5 df3 5879 5885 +df3 dfb 5882 5886 +dfd df3 5885 5887 +df3 dfe 5886 5887 +df4 df7 587c 5888 +dfc df4 5883 5889 +df4 dff 5888 5889 +df5 dfd 5885 588a +df5 e00 588a 8c5c +20c9 df5 7b42 8c5c +df5 20cb 7b42 8d57 +df8 df6 587e 58d6 +df6 dfa 5880 58d8 +e22 df6 58d6 58d8 +df7 df8 587d 58b8 +dff df7 5888 58a2 +df7 e09 58a1 58a2 +e0f df7 58a1 58b1 +e18 df7 58b1 58b8 +e18 df8 58b8 58cc +e22 df8 58cc 58d6 +dfa df9 5881 58e0 +df9 e30 8684 88d6 +267b df9 8684 899f +dfa e22 58d7 58d8 +dfb dfc 5884 588d +dfe dfb 5886 588b +e01 dfb 588b 588c +e02 dfb 588c 588d +dfc dff 5889 58b7 +e02 dfc 588d 58b7 +dfd dfe 5887 588e +e00 dfd 588a 5892 +dfd e03 588e 5891 +dfd e05 5891 5892 +dfe e01 588b 588f +e03 dfe 588e 5890 +dfe e04 588f 5890 +dff e02 58a7 58b7 +e09 dff 58a0 58a2 +dff e0b 58a0 58a7 +e00 e05 5892 8c4d +e00 20c3 8c4d 8d0b +20c9 e00 8c5c 8d0b +e01 e02 588c 58aa +e04 e01 588f 58c2 +e01 e0d 58aa 58ab +e01 e14 58ab 58c0 +e01 e1f 58c0 58c2 +e0b e02 58a6 58a7 +e02 e0d 58a6 58aa +e03 e04 5890 58ef +e05 e03 5891 8b78 +e03 e31 58ef 7f60 +e03 2312 7f60 8b78 +e04 e1f 58c2 58ee +e04 e31 58ee 58ef +e05 20c3 7b3d 8c4d +20c4 e05 7b3d 7f5e +2312 e05 7f5e 8b78 +e07 e06 5893 5894 +e06 e08 5893 5895 +e09 e06 5894 5896 +e06 e0a 5895 5897 +e0b e06 5896 5898 +e06 e0c 5897 5899 +e0d e06 5898 5899 +e08 e07 5893 589a +e07 e09 5894 589b +e0e e07 589a 589c +e07 e0f 589b 589d +e10 e07 589c 589d +e0a e08 5895 589e +e08 e0e 589a 589f +e11 e08 589e 589f +e09 e0b 5896 58a0 +e0f e09 589b 58a1 +e0c e0a 5897 58a3 +e0a e11 589e 58a4 +e12 e0a 58a3 58a5 +e0a e13 58a4 58a5 +e0b e0d 5898 58a6 +e0d e0c 5899 58a8 +e0c e12 58a3 58a9 +e14 e0c 58a8 58a9 +e0d e14 58a8 58ab +e0e e10 589c 58ac +e11 e0e 589f 58ad +e0e e15 58ac 58ae +e16 e0e 58ad 58af +e0e e17 58ae 58af +e10 e0f 589d 58b0 +e0f e18 58b1 58b2 +e15 e10 58ac 58b3 +e13 e11 58a4 58b5 +e11 e16 58ad 58b6 +e19 e11 58b5 58b6 +e12 e13 58a5 58b9 +e14 e12 58a9 58ba +e12 e1a 58b9 58bb +e1b e12 58ba 58bc +e12 e1c 58bb 58bc +e13 e19 58b5 58bd +e1a e13 58b9 58bf +e13 e1d 58bd 58be +e13 e1e 58be 58bf +e14 e1b 58ba 58c1 +e1f e14 58c0 58c1 +e17 e15 58ae 58c3 +e16 e17 58af 58c6 +e19 e16 58b6 58c7 +e16 e20 58c6 58c8 +e21 e16 58c7 58c8 +e20 e17 58c6 58c9 +e22 e18 58cb 58cc +e1d e19 58bd 58ce +e19 e21 58c7 58cd +e19 e23 58cd 58ce +e1c e1a 58bb 58e5 +e1a e1e 58bf 58e4 +e1a e2c 58e4 58e6 +e2d e1a 58e5 58e6 +e1b e1c 58bc 58e9 +e1f e1b 58c1 58ea +e1b e2e 58e9 58eb +e2f e1b 58ea 58eb +e1c e2d 58e5 58ec +e2e e1c 58e9 58ec +e1e e1d 58be 58e1 +e1d e23 58ce 58e2 +e2a e1d 58e1 58e3 +e1d e2b 58e2 58e3 +e1e e2a 58e1 58e7 +e2c e1e 58e4 58e7 +e1f e2f 58ea 58f1 +e31 e1f 58ee 58f0 +e32 e1f 58f0 58f1 +e21 e20 58c8 58d1 +e20 e24 58cf 58d2 +e25 e20 58d1 58d2 +e23 e21 58cd 58d4 +e21 e25 58d1 58d3 +e21 e26 58d3 58d4 +e23 e26 58d4 58e8 +e2b e23 58e2 58e8 +e25 e24 58d2 58da +e24 e27 58d9 58da +e26 e25 58d3 58de +e25 e27 58da 58dd +e25 e29 58dd 58de +e26 e29 58de 595e +e2b e26 58e8 5958 +e26 e62 5957 5958 +e65 e26 5957 595e +e27 e28 58dc 7676 +e29 e27 58dd 7674 +1df4 e27 7674 7676 +1df4 e28 7676 7678 +1df5 e28 7678 767a +e29 e65 595d 595e +e66 e29 595d 5960 +e78 e29 5960 7675 +e29 1df4 7674 7675 +e2a e2b 58e3 767c +e2c e2a 58e7 58f6 +e36 e2a 58f6 7682 +e2a e76 767c 7681 +e2a e77 7681 7682 +e2b e62 5958 5959 +e2b e76 5959 767c +e2d e2c 58e6 58f3 +e34 e2c 58f3 58f4 +e35 e2c 58f4 58f5 +e36 e2c 58f5 58f6 +e2e e2d 58ec 8249 +e2d e34 58f3 8a6d +2476 e2d 8249 8a6d +e2f e2e 58eb 58f2 +e33 e2e 58f2 824a +e2e 2476 8249 824a +e32 e2f 58f1 8a04 +e2f e33 58f2 8a04 +e30 267a 8685 88dc +e30 267b 8684 8a8b +267c e30 8685 8a8b +e30 26b5 88dc 899e +e31 e32 58f0 7f5d +2311 e31 7f5c 7f5d +e31 2312 7f5c 7f60 +e32 e33 8a04 8ab7 +e32 2310 8ab7 8b40 +2311 e32 7f5d 8b40 +230f e33 7f59 8a05 +e33 2310 7f59 8ab7 +e33 2476 824a 8a6c +2477 e33 8a05 8a6c +e34 e35 58f4 899b +e34 2476 824b 8a6d +2477 e34 824b 897c +25cd e34 897c 899b +e35 e36 58f5 7116 +e35 1b49 7116 7117 +e35 1b4a 7117 84ef +e35 25cc 84ef 84f0 +e35 25cd 84f0 899b +e36 e77 7682 79b7 +1b49 e36 7116 79b7 +e37 e38 58f7 7dca +e37 2212 7dca 7dcc +e37 2214 7dcc 8cca +2215 e37 7dce 8cca +e38 2210 7dc8 8c9a +2211 e38 7dc8 8c75 +2212 e38 7dca 8c9a +e39 e3a 58fc 8143 +23fc e39 8140 8c49 +23fd e39 8c49 8c97 +e39 23fe 8143 8c97 +e3a e3b 58fd 6cae +18e9 e3a 6cad 6cae +e3a 18ea 6cad 8bda +23fe e3a 8143 8bda +18e9 e3b 6cae 6cb0 +18ec e3b 6cb0 6cb3 +e3d e3c 58ff 5900 +e3c e3e 58ff 5901 +e3f e3c 5900 5902 +e3c e40 5901 5903 +e41 e3c 5902 5904 +e3c e42 5903 5905 +e43 e3c 5904 5905 +e3e e3d 58ff 5906 +e3d e3f 5900 5907 +e44 e3d 5906 5908 +e3d e45 5907 5908 +e40 e3e 5901 5909 +e3e e44 5906 590a +e46 e3e 5909 590a +e3f e41 5902 590b +e45 e3f 5907 590c +e3f e47 590b 590d +e48 e3f 590c 590d +e42 e40 5903 590e +e40 e46 5909 590f +e49 e40 590e 5910 +e40 e4a 590f 5911 +e4b e40 5910 5911 +e41 e43 5904 5912 +e47 e41 590b 5913 +e41 e4c 5912 5914 +e4d e41 5913 5914 +e43 e42 5905 5915 +e42 e49 590e 5916 +e4e e42 5915 5916 +e4c e43 5912 5917 +e43 e4e 5915 5918 +e4f e43 5917 5919 +e43 e50 5918 5919 +e44 e45 5908 591a +e46 e44 590a 591b +e44 e51 591a 591c +e52 e44 591b 591d +e44 e53 591c 591d +e45 e48 590c 591e +e51 e45 591a 591f +e45 e54 591e 591f +e4a e46 590f 5920 +e46 e52 591b 5921 +e55 e46 5920 5921 +e48 e47 590d 890e +e47 e4d 5913 8881 +e47 1f1d 86ff 890e +26b3 e47 86ff 8881 +e54 e48 591e 5922 +e56 e48 5922 8701 +1f1d e48 8701 890e +e49 e4b 5910 5923 +e4e e49 5916 5924 +e49 e57 5923 5925 +e58 e49 5924 5925 +e4b e4a 5911 5926 +e4a e55 5920 5927 +e59 e4a 5926 5928 +e4a e5a 5927 5928 +e57 e4b 5923 5929 +e4b e59 5926 592a +e5b e4b 5929 592a +e4d e4c 5914 592b +e4c e4f 5917 592c +e5c e4c 592b 592c +e4d e5c 592b 592d +e4d e5d 592d 890b +26b3 e4d 8881 890b +e50 e4e 5918 592e +e4e e58 5924 592f +e5e e4e 592e 592f +e4f e50 5919 5930 +e5c e4f 592c 5933 +e4f e5f 5930 5934 +e61 e4f 5933 5934 +e50 e5e 592e 5931 +e5f e50 5930 5932 +e50 e60 5931 5932 +e53 e51 591c 5935 +e51 e54 591f 5936 +e62 e51 5935 5937 +e51 e63 5936 5937 +e52 e53 591d 5938 +e55 e52 5921 5939 +e52 e64 5938 5939 +e53 e62 5935 593a +e64 e53 5938 593b +e53 e65 593a 593c +e66 e53 593b 593c +e54 e56 5922 593d +e63 e54 5936 593e +e54 e67 593d 593e +e5a e55 5927 593f +e55 e64 5939 5940 +e68 e55 593f 5941 +e55 e69 5940 5941 +e67 e56 593d 5942 +e6a e56 5942 8702 +1f1c e56 8702 8947 +e56 1f1d 8701 8947 +e58 e57 5925 5943 +e57 e5b 5929 5944 +e6b e57 5943 5944 +e5e e58 592f 5945 +e58 e6b 5943 5946 +e6c e58 5945 5946 +e59 e5a 5928 5947 +e5b e59 592a 5948 +e59 e6d 5947 5949 +e6e e59 5948 5949 +e5a e68 593f 594a +e6d e5a 5947 594b +e5a e6f 594a 594b +e6b e5b 5944 594d +e5b e6e 5948 594c +e5b e70 594c 594d +e5d e5c 592d 885f +e5c e61 5933 86fb +e5c 26b0 86fb 885f +26af e5d 88b1 88e3 +e5d 26b0 885f 88e3 +e5d 26b1 88b1 88d8 +26b2 e5d 86fc 88d8 +e5d 26b3 86fc 890b +e60 e5e 5931 594e +e5e e6c 5945 594f +e71 e5e 594e 5950 +e5e e72 594f 5950 +e5f e60 5932 5951 +e61 e5f 5934 5952 +e5f e73 5951 5952 +e60 e71 594e 5954 +e73 e60 5951 5953 +e74 e60 5953 5954 +e61 e73 5952 5955 +e61 e75 5955 88e2 +26b0 e61 86fb 88e2 +e62 e63 5937 5956 +e65 e62 593a 5957 +e62 e76 5956 5959 +e63 e67 593e 595a +e76 e63 5956 595b +e63 e77 595a 595b +e64 e66 593b 595c +e69 e64 5940 595c +e66 e65 593c 595d +e69 e66 595c 595f +e78 e66 595f 5960 +e67 e6a 5942 5961 +e77 e67 595a 5961 +e68 e69 5941 5962 +e6f e68 594a 5963 +e68 e79 5962 5964 +e7a e68 5963 5964 +e69 e78 595f 5965 +e79 e69 5962 5966 +e69 e7b 5965 5966 +e77 e6a 5961 79b8 +1b49 e6a 79b8 79b9 +1b4a e6a 79b9 88c0 +e6a 1f1c 8702 88c0 +e6c e6b 5946 59af +e6b e70 594d 59a5 +e6b ea9 59a5 59ad +e6b eae 59ad 59ae +e6b eaf 59ae 59af +e72 e6c 594f 59c5 +e6c eaf 59af 59c2 +e6c eba 59c2 59c4 +e6c ebb 59c4 59c5 +e6e e6d 5949 59a3 +e6d e6f 594b 59ac +ea7 e6d 59a3 59a7 +eaa e6d 59a7 59ab +ead e6d 59ab 59ac +e70 e6e 594c 59a2 +ea7 e6e 59a2 59a3 +e6f e7a 5963 59be +ead e6f 59ac 59bb +eb6 e6f 59bb 59be +e70 ea7 59a2 59a4 +e70 ea8 59a4 59a6 +ea9 e70 59a5 59a6 +e71 e72 5950 59e1 +e74 e71 5954 5a6d +e71 ebb 59e1 59e2 +e71 ecb 59e2 5a70 +f1e e71 5a6d 5a70 +e72 ebb 59c5 59e1 +e73 e74 5953 5a6a +e75 e73 5955 5a69 +f1b e73 5a69 5a6a +f1b e74 5a6a 5a6b +f1c e74 5a6b 5a6c +f1d e74 5a6c 5a6e +e74 f1e 5a6d 5a6e +e75 f1b 5a69 8875 +26ad e75 86fa 8875 +e75 26ae 86fa 88b9 +26af e75 86f2 88b9 +e75 26b0 86f2 88e2 +e76 e77 595b 7681 +1b49 e77 79b7 79b8 +e7b e78 5965 7677 +e78 1df4 7675 7677 +e7a e79 5964 59da +e79 e7b 5966 767e +ec5 e79 59da 7685 +e79 1df6 767e 7683 +e79 1df7 7683 7685 +eb6 e7a 59be 59d5 +ec5 e7a 59d5 59da +e7b 1df4 7677 7679 +e7b 1df5 7679 767d +e7b 1df6 767d 767e +e7d e7c 5967 5968 +e7c e7e 5967 5969 +e7f e7c 5968 596a +e7c e80 5969 596b +e81 e7c 596a 596b +e7e e7d 5967 596c +e7d e7f 5968 596d +e82 e7d 596c 596e +e7d e83 596d 596f +e84 e7d 596e 5970 +e7d e85 596f 5970 +e80 e7e 5969 5971 +e7e e82 596c 5972 +e86 e7e 5971 88e6 +e7e e87 5972 5974 +e88 e7e 5973 5974 +e7e e89 5973 88e6 +e7f e81 596a 5975 +e83 e7f 596d 86dc +e7f e8a 5975 5976 +e7f e8b 5976 86d9 +e7f 25c0 86d9 86dc +e81 e80 596b 5977 +e80 e86 5971 5978 +e8c e80 5977 5979 +e80 e8d 5978 5979 +e8a e81 5975 597a +e81 e8c 5977 597b +e8e e81 597a 597b +e82 e84 596e 893d +e87 e82 5972 597c +e8f e82 597c 822f +2459 e82 822f 893d +e85 e83 596f 88cd +e83 2457 84d7 88cd +25c0 e83 84d7 86dc +e84 e85 5970 8229 +e84 2455 8229 8970 +2459 e84 893d 8970 +2452 e85 88df 88f1 +e85 2453 822b 88f1 +2455 e85 8229 88df +2457 e85 822b 88cd +e89 e86 597f 88e6 +e8d e86 5978 597e +e90 e86 597e 597f +e88 e87 5974 8866 +e87 e8f 597c 84de +e87 25c4 84de 8866 +e89 e88 5973 88e7 +e88 e9a 84dc 88e7 +25c2 e88 84dc 88f9 +e88 25c4 8866 88f9 +e89 e90 597d 597f +e91 e89 597d 88c8 +e9a e89 88c8 88e7 +e8b e8a 5976 5980 +e8a e8e 597a 5981 +e92 e8a 5980 5981 +e8b e92 5980 5982 +e8b e93 5982 887a +25c0 e8b 86d9 8884 +e8b 26a1 887a 8884 +e8c e8d 5979 5983 +e8e e8c 597b 5984 +e8c e94 5983 5985 +e95 e8c 5984 5985 +e8d e90 597e 5986 +e94 e8d 5983 5987 +e8d e96 5986 5988 +e97 e8d 5987 5988 +e92 e8e 5981 5989 +e8e e95 5984 598a +e98 e8e 5989 598a +22fd e8f 88b7 8907 +e8f 2456 88b7 8939 +e8f 2459 822f 8907 +25c3 e8f 88f8 8939 +25c4 e8f 84de 88f8 +e90 e91 597d 598b +e96 e90 5986 598e +e90 e99 598b 598e +e99 e91 598b 598d +e9a e91 598c 88c8 +e91 e9b 598c 598d +e93 e92 5982 598f +e92 e98 5989 5990 +e9c e92 598f 5991 +e92 e9d 5990 5991 +e93 e9c 598f 5992 +e93 e9e 5992 86db +e93 26a1 86db 887a +e95 e94 5985 5993 +e94 e97 5987 5994 +e9f e94 5993 5995 +e94 ea0 5994 5995 +e98 e95 598a 5996 +e95 e9f 5993 5997 +ea1 e95 5996 5997 +e97 e96 5988 5998 +e96 e99 598e 5999 +ea2 e96 5998 5999 +ea0 e97 5994 599a +e97 ea2 5998 599b +ea3 e97 599a 599b +e9d e98 5990 599c +e98 ea1 5996 599d +ea4 e98 599c 599d +e99 e9b 598d 599e +ea2 e99 5999 599f +e99 ea5 599e 59a0 +ea6 e99 599f 59a0 +e9b e9a 598c 84dd +e9a 25c2 84dc 88c9 +25c5 e9a 84dd 88c9 +ea5 e9b 599e 88a4 +e9b 25c5 84dd 8852 +e9b 26a3 86de 88a4 +26a4 e9b 86de 8852 +e9c e9d 5991 67e3 +e9e e9c 5992 67e5 +1671 e9c 67e1 67e3 +e9c 1672 67e1 67e5 +e9d ea4 599c 67fd +1671 e9d 67e3 67e4 +167a e9d 67e4 67fd +e9e 166b 67e6 8752 +e9e 1672 67e5 67e6 +e9e 25be 8752 8754 +e9e 25bf 8754 8885 +26a1 e9e 86db 8885 +e9f ea0 5995 680b +ea1 e9f 5997 6803 +168c e9f 6803 6805 +168d e9f 6805 680a +168f e9f 680a 680b +ea0 ea3 599a 6814 +168f ea0 680b 6812 +1691 ea0 6812 6814 +ea4 ea1 599d 6800 +168c ea1 6800 6803 +ea3 ea2 599b 70ed +ea2 ea6 599f 7115 +1b34 ea2 70ed 7115 +1691 ea3 6814 682a +1696 ea3 682a 70e2 +1b2e ea3 70e2 70ec +1b34 ea3 70ec 70ed +167a ea4 67fd 67fe +1686 ea4 67fe 67ff +168c ea4 67ff 6800 +ea6 ea5 59a0 7463 +ea5 1b41 7462 7463 +1ce2 ea5 7462 86df +26a3 ea5 86df 88a4 +ea6 1b34 7113 7115 +1b35 ea6 7113 7114 +1b41 ea6 7114 7463 +ea8 ea7 59a4 59a8 +ea7 eaa 59a7 59a9 +eab ea7 59a8 59aa +ea7 eac 59a9 59aa +ea9 ea8 59a6 59b0 +ea8 eab 59a8 59b1 +eb0 ea8 59b0 59b1 +eae ea9 59ad 59b2 +ea9 eb0 59b0 59b3 +eb1 ea9 59b2 59b3 +eac eaa 59a9 59b4 +eaa ead 59ab 59b5 +eb2 eaa 59b4 59b6 +eaa eb3 59b5 59b6 +eab eac 59aa 59b7 +eb0 eab 59b1 59b8 +eab eb4 59b7 59b8 +eac eb2 59b4 59b9 +eb4 eac 59b7 59ba +eac eb5 59b9 59ba +eb3 ead 59b5 59bc +ead eb6 59bb 59bd +eb7 ead 59bc 59bd +eaf eae 59ae 59bf +eae eb1 59b2 59c0 +eb8 eae 59bf 59c1 +eae eb9 59c0 59c1 +eaf eb8 59bf 59c3 +eba eaf 59c2 59c3 +eb1 eb0 59b3 59c6 +eb0 eb4 59b8 59c7 +ebc eb0 59c6 59c8 +eb0 ebd 59c7 59c8 +eb9 eb1 59c0 59c9 +eb1 ebc 59c6 59ca +ebe eb1 59c9 59ca +eb2 eb3 59b6 59cb +eb5 eb2 59b9 59cc +eb2 ebf 59cb 59ce +ec0 eb2 59cc 59cd +ec1 eb2 59cd 59ce +eb3 eb7 59bc 59cf +ebf eb3 59cb 59d0 +eb3 ec2 59cf 59d0 +eb4 eb5 59ba 59d1 +ebd eb4 59c7 59d2 +eb4 ec3 59d1 59d2 +eb5 ec0 59cc 59d3 +ec3 eb5 59d1 59d3 +eb7 eb6 59bd 59d4 +ec4 eb6 59d4 59d6 +eb6 ec5 59d5 59d6 +ec2 eb7 59cf 59d8 +eb7 ec4 59d4 59d9 +ec6 eb7 59d7 59d9 +eb7 ec7 59d7 59d8 +eb8 eb9 59c1 59db +eba eb8 59c3 59dc +eb8 ec8 59db 59de +ec9 eb8 59dc 59dd +eca eb8 59dd 59de +eb9 ebe 59c9 59df +ec8 eb9 59db 59df +ebb eba 59c4 59e0 +eba ec9 59dc 59e0 +ebb ec9 59e0 59e3 +ecb ebb 59e2 59e3 +ebc ebd 59c8 59e4 +ebe ebc 59ca 59e5 +ebc ecc 59e4 59e6 +ecd ebc 59e5 59e7 +ebc ece 59e6 59e7 +ebd ec3 59d2 59e8 +ecc ebd 59e4 59e9 +ebd ecf 59e8 59e9 +ec8 ebe 59df 59ea +ebe ecd 59e5 59ec +ed0 ebe 59ea 59eb +ed1 ebe 59eb 59ec +ec1 ebf 59ce 75f3 +ebf ec2 59d0 7605 +1d41 ebf 75f3 7605 +ec0 ec1 59cd 75e7 +ec3 ec0 59d3 75e5 +1dae ec0 75e5 75e7 +1d41 ec1 75f2 75f3 +1d42 ec1 75e6 75f2 +ec1 1dae 75e6 75e7 +ec2 ec7 59d8 7849 +1d3e ec2 7604 7849 +ec2 1d41 7604 7605 +ecf ec3 59e8 75eb +ec3 1dad 75e2 75e3 +1dae ec3 75e2 75e5 +ec3 1db0 75e3 75eb +ec4 ec5 59d6 784e +ec6 ec4 59d9 784a +1df8 ec4 784b 784e +1eac ec4 784a 784b +ec5 1df7 7685 7850 +1df8 ec5 784e 7850 +ec7 ec6 59d7 7846 +1eaa ec6 7846 7847 +1eac ec6 7847 784a +ec7 1d3d 7840 7842 +ec7 1d3e 7842 7849 +1d40 ec7 7840 7841 +1eaa ec7 7841 7846 +eca ec8 59de 76f6 +ec8 ed0 59ea 76f8 +ec8 1ce5 76f5 76f6 +1e1a ec8 76f5 76f8 +ec9 eca 59dd 746d +ecb ec9 59e3 5a77 +f23 ec9 5a77 746d +f23 eca 746d 746e +1ce5 eca 746e 76f6 +f1e ecb 5a70 5a74 +f22 ecb 5a74 5a76 +f23 ecb 5a76 5a77 +ece ecc 59e6 7877 +ecc ecf 59e9 7602 +ecc 1db9 7602 7877 +ecd ece 59e7 787b +ed1 ecd 59ec 787a +1eb5 ecd 787a 787b +1db9 ece 7876 7877 +ece 1eb5 7876 787b +ecf 1db0 75eb 75ec +ecf 1db2 75ec 75f7 +ecf 1db9 75f7 7602 +ed0 ed1 59eb 76fb +1cd5 ed0 76fa 76fb +1cd8 ed0 76f9 76fa +1e1a ed0 76f8 76f9 +1cd5 ed1 76fb 7879 +ed1 1cd6 7878 7879 +1eb5 ed1 7878 787a +ed3 ed2 59ed 59ee +ed2 ed4 59ed 59ef +ed5 ed2 59ee 59f0 +ed2 ed6 59ef 59f1 +ed7 ed2 59f0 59f2 +ed2 ed8 59f1 59f3 +ed9 ed2 59f2 59f3 +ed4 ed3 59ed 59f4 +ed3 ed5 59ee 59f5 +eda ed3 59f4 59f6 +ed3 edb 59f5 59f7 +edc ed3 59f6 59f7 +ed6 ed4 59ef 59f8 +ed4 eda 59f4 59f9 +edd ed4 59f8 59fa +ed4 ede 59f9 59fa +ed5 ed7 59f0 59fb +edb ed5 59f5 59fc +ed5 edf 59fb 59fc +ed8 ed6 59f1 59fd +ed6 edd 59f8 59fe +ee0 ed6 59fd 59ff +ed6 ee1 59fe 59ff +ed7 ed9 59f2 5a00 +edf ed7 59fb 5a01 +ed7 ee2 5a00 5a02 +ee3 ed7 5a01 5a02 +ed9 ed8 59f3 5a03 +ed8 ee0 59fd 5a04 +ee4 ed8 5a03 5a05 +ed8 ee5 5a04 5a05 +ee2 ed9 5a00 5a06 +ed9 ee4 5a03 5a06 +eda edc 59f6 5a07 +ede eda 59f9 5a08 +eda ee6 5a07 5a09 +ee7 eda 5a08 5a0a +eda ee8 5a09 5a0a +edc edb 59f7 5a0b +edb edf 59fc 5a0c +ee9 edb 5a0b 5a0c +ee6 edc 5a07 5a0d +edc ee9 5a0b 5a0e +edc eea 5a0e 5a10 +edd ede 59fa 5a11 +ee1 edd 59fe 5a12 +edd eeb 5a11 5a13 +eec edd 5a12 5a13 +ede ee7 5a08 5a14 +eeb ede 5a11 5a14 +edf ee3 5a01 5a15 +ee9 edf 5a0c 5a16 +edf eed 5a15 5a17 +eee edf 5a16 5a18 +edf eef 5a17 5a18 +ee0 ee1 59ff 5a19 +ee5 ee0 5a04 5a1a +ee0 ef0 5a19 5a1b +ef1 ee0 5a1a 5a1c +ee0 ef2 5a1b 5a1c +ee1 eec 5a12 5a1d +ef0 ee1 5a19 5a1e +ee1 ef3 5a1d 5a1f +ef4 ee1 5a1e 5a1f +ee3 ee2 5a02 5a20 +ee2 ee4 5a06 5a21 +ef5 ee2 5a20 5a23 +ee2 ef6 5a21 5a22 +ee2 ef7 5a22 5a23 +eed ee3 5a15 5a24 +ee3 ef5 5a20 5a25 +ef8 ee3 5a24 5a25 +ee4 ee5 5a05 5a26 +ef6 ee4 5a21 5a27 +ee4 ef9 5a26 5a28 +efa ee4 5a27 5a28 +ee5 ef1 5a1a 5a29 +ef9 ee5 5a26 5a29 +ee8 ee6 5a09 5a2a +efb ee6 5a2a 5a2b +ee7 ee8 5a0a 5a2c +eeb ee7 5a14 5a2d +ee7 efc 5a2c 5a2e +efd ee7 5a2d 5a2e +ee8 efb 5a2a 5a2f +efc ee8 5a2c 5a2f +eea ee9 5a0e 5a30 +ee9 eee 5a16 5a31 +eec eeb 5a13 5a35 +ef3 eeb 5a35 5a36 +eeb efd 5a2d 5a37 +efe eeb 5a36 5a38 +eeb eff 5a37 5a38 +ef3 eec 5a1d 5a35 +eef eed 5a17 5a39 +eed ef8 5a24 5a3a +f00 eed 5a39 5a3b +eed f01 5a3a 5a3b +eee eef 5a18 5a3c +eee f02 5a3c 5a3d +eef f00 5a39 5a3f +f02 eef 5a3c 5a3e +f03 eef 5a3e 5a3f +ef2 ef0 5a1b 5a40 +ef0 ef4 5a1e 5a41 +f04 ef0 5a40 5a41 +ef1 ef2 5a1c 5a42 +ef9 ef1 5a29 5a43 +ef1 f05 5a42 5a43 +ef2 f04 5a40 5a44 +f05 ef2 5a42 5a45 +ef2 f06 5a44 5a46 +f07 ef2 5a45 5a46 +ef4 ef3 5a1f 5a47 +ef3 efe 5a36 5a48 +f08 ef3 5a47 5a49 +ef3 f09 5a48 5a49 +f04 ef4 5a41 5a4a +ef4 f08 5a47 5a4a +ef5 ef7 5a23 5a4e +ef8 ef5 5a25 5a4f +ef5 f0c 5a4e 5a50 +f0d ef5 5a4f 5a50 +ef7 ef6 5a22 5a4b +ef6 efa 5a27 5a4c +f0a ef6 5a4b 5a4d +ef6 f0b 5a4c 5a4d +ef7 f0a 5a4b 5a51 +f0c ef7 5a4e 5a53 +ef7 f0e 5a51 5a52 +ef7 f0f 5a52 5a53 +f01 ef8 5a3a 5a58 +ef8 f0d 5a4f 5a58 +efa ef9 5a28 5a54 +ef9 f05 5a43 5a55 +f10 ef9 5a54 5a55 +f0b efa 5a4c 5a57 +efa f10 5a54 5a56 +efa f11 5a56 5a57 +efc efb 5a2f 5a59 +f12 efb 5a59 5a5b +efb f13 5a5a 5a5b +efd efc 5a2e 5a5c +efc f12 5a59 5a5d +f14 efc 5a5c 5a5d +eff efd 5a37 5a5e +efd f14 5a5c 5a60 +f15 efd 5a5e 5a5f +f16 efd 5a5f 5a60 +efe eff 5a38 5a63 +f09 efe 5a48 5a64 +efe f17 5a63 5a64 +eff f15 5a5e 5a65 +f17 eff 5a63 5a66 +eff f18 5a65 5a66 +f00 f01 5a3b 6a8c +f03 f00 5a3f 6a71 +17b0 f00 6a71 6a8b +17c1 f00 6a8b 6a8c +f01 f0d 5a58 6a92 +17c1 f01 6a8c 6a92 +f02 f03 5a3e 6a47 +17a0 f03 6a48 6a72 +f03 17b0 6a71 6a72 +f06 f04 5a44 6728 +f04 f08 5a4a 66bd +f04 15e6 66bd 6720 +f04 160b 6720 6728 +f05 f07 5a45 699f +f10 f05 5a55 69a2 +1748 f05 699d 699f +f05 1749 699d 69a2 +f07 f06 5a46 69bc +f06 160b 6728 672c +f06 1610 672c 69be +1753 f06 69bc 69be +1748 f07 699f 69a0 +1753 f07 69a0 69bc +f08 f09 5a49 66a9 +f08 15df 66a9 66b9 +f08 15e6 66b9 66bd +f09 f17 5a64 6698 +15d4 f09 6696 6698 +f09 15d9 6696 66a6 +f09 15df 66a6 66a9 +f0a f0b 5a4d 67a1 +f0e f0a 5a51 679e +1638 f0a 679e 67a1 +f0b f11 5a57 69c7 +f0b 1638 67a0 67a1 +163a f0b 67a0 67a7 +1653 f0b 67a7 69c7 +f0d f0c 5a50 6a93 +f0c f0f 5a53 6a94 +1650 f0c 6a93 6a94 +f0d 1650 6a93 6a95 +17c1 f0d 6a92 6a96 +f0d 17c4 6a95 6a97 +17c5 f0d 6a96 6a97 +f0f f0e 5a52 679f +1628 f0e 6776 6777 +f0e 162a 6776 677c +1638 f0e 6777 679e +f0e 163b 677c 679f +f0f 163b 679f 67a2 +f0f 1650 67a2 6a94 +f11 f10 5a56 69ab +1749 f10 69a1 69a2 +f10 174d 69a1 69ab +f11 1653 69ac 69c7 +f11 174d 69ab 69ac +f12 f13 5a5b 673f +f14 f12 5a5d 66b3 +f12 15dd 66b2 66b3 +15e4 f12 66b2 673e +160a f12 673e 673f +f13 160a 671d 673f +f16 f14 5a60 66b0 +15dd f14 66b0 66b3 +f15 f16 5a5f 669d +f18 f15 5a65 6695 +f15 15d3 6694 6695 +15d6 f15 6694 669d +15d6 f16 669d 669f +15dd f16 669f 66b0 +f17 f18 5a66 6697 +f17 15d4 6697 6698 +15d3 f18 6693 6695 +f18 15d4 6693 6697 +f19 f1a 5a68 5a83 +f2a f19 5a80 5a83 +f2a f1a 5a83 5a84 +f2b f1a 5a84 8614 +2664 f1a 8614 8aeb +f1a 2665 8615 8aeb +f1b f1c 5a6b 86f4 +f1b 26ac 86f4 86f6 +f1b 26ad 86f6 8875 +f1c f1d 5a6c 5a6f +f1c f1f 5a6f 886c +26ac f1c 86f4 886c +f1d f1e 5a6e 5a71 +f1f f1d 5a6f 5a72 +f1d f20 5a71 5a73 +f21 f1d 5a72 5a73 +f20 f1e 5a71 5a75 +f1e f22 5a74 5a75 +f1f f21 5a72 8886 +25da f1f 86f3 875a +26ab f1f 875a 8886 +f1f 26ac 86f3 886c +f21 f20 5a73 5a78 +f20 f22 5a75 5a79 +f24 f20 5a78 5a7a +f20 f25 5a79 5a7a +f21 f24 5a78 5a7c +f26 f21 5a7b 5a7c +f21 f27 5a7b 86ee +f21 26ab 86ee 8886 +f22 f23 5a76 5a7e +f25 f22 5a79 5a7d +f28 f22 5a7d 5a7e +f28 f23 5a7e 7469 +1ce3 f23 7469 746a +1ce5 f23 746a 746e +f24 f25 5a7a 6b63 +f26 f24 5a7c 6b5f +1825 f24 6b5f 6b63 +f25 f28 5a7d 6b66 +1825 f25 6b63 6b66 +f27 f26 5a7b 6b5e +1824 f26 6b5e 6b60 +f26 1825 6b5f 6b61 +1826 f26 6b60 6b62 +f26 1827 6b61 6b62 +f27 1824 6b5e 8756 +25c8 f27 86ef 8756 +f27 25d9 86ef 8887 +26ab f27 86ee 8887 +1825 f28 6b66 6b67 +1829 f28 6b67 7465 +1ce3 f28 7465 7469 +f29 f2a 5a81 5a85 +f29 f2c 5a85 6d5f +1953 f29 6d5b 6d5e +1955 f29 6d5e 6d5f +f2a f2b 5a84 5a87 +f2c f2a 5a85 5a86 +f2d f2a 5a86 5a87 +f2d f2b 5a87 6d74 +1961 f2b 6d74 6d76 +1962 f2b 6d76 8a89 +f2b 2664 8614 8a89 +f2c f2d 5a86 6d67 +1955 f2c 6d5f 6d64 +1958 f2c 6d64 6d68 +f2c 195a 6d67 6d68 +195a f2d 6d67 6d75 +f2d 1961 6d74 6d75 +f2f f2e 5a88 5a89 +f2e f30 5a88 5a8a +f31 f2e 5a89 5a8b +f2e f32 5a8a 5a8c +f33 f2e 5a8b 5a8d +f2e f34 5a8c 5a8d +f30 f2f 5a88 5a8e +f2f f31 5a89 5a8f +f35 f2f 5a8e 5a90 +f2f f36 5a8f 5a91 +f37 f2f 5a90 5a92 +f2f f38 5a91 5a92 +f32 f30 5a8a 5a93 +f30 f35 5a8e 5a94 +f39 f30 5a93 5a95 +f30 f3a 5a94 5a95 +f31 f33 5a8b 5a96 +f36 f31 5a8f 5a97 +f31 f3b 5a96 5a97 +f34 f32 5a8c 5a98 +f32 f39 5a93 5a99 +f3c f32 5a98 5a9a +f32 f3d 5a99 5a9a +f33 f34 5a8d 5a9b +f3b f33 5a96 5a9c +f33 f3e 5a9b 5a9d +f3f f33 5a9c 5a9e +f33 f40 5a9d 5a9e +f34 f3c 5a98 5a9f +f3e f34 5a9b 5a9f +f35 f37 5a90 5aa0 +f3a f35 5a94 5aa1 +f35 f41 5aa0 5aa1 +f38 f36 5a91 5aa2 +f36 f3b 5a97 5aa3 +f42 f36 5aa2 5aa4 +f36 f43 5aa3 5aa5 +f44 f36 5aa4 5aa5 +f37 f38 5a92 5aa6 +f41 f37 5aa0 5aa7 +f37 f45 5aa6 5aa8 +f46 f37 5aa7 5aa9 +f37 f47 5aa8 5aa9 +f38 f42 5aa2 5aaa +f45 f38 5aa6 5aab +f38 f48 5aaa 5aab +f39 f3a 5a95 5aac +f3d f39 5a99 5aad +f39 f49 5aac 5aae +f4a f39 5aad 5aae +f3a f41 5aa1 5aaf +f49 f3a 5aac 5ab0 +f3a f4b 5aaf 5ab1 +f4c f3a 5ab0 5ab1 +f3b f3f 5a9c 5ab2 +f43 f3b 5aa3 5ab2 +f3c f3d 5a9a 5ab3 +f3e f3c 5a9f 5ab4 +f3c f4d 5ab3 5ab5 +f4e f3c 5ab4 5ab6 +f3c f4f 5ab5 5ab6 +f3d f4a 5aad 5ab7 +f4d f3d 5ab3 5ab8 +f3d f50 5ab7 5ab9 +f51 f3d 5ab8 5ab9 +f40 f3e 5a9d 5aba +f3e f4e 5ab4 5abb +f52 f3e 5aba 5abb +f3f f40 5a9e 5abc +f43 f3f 5ab2 5abd +f3f f53 5abc 5abe +f54 f3f 5abd 5abf +f3f f55 5abe 5abf +f40 f52 5aba 5ac0 +f53 f40 5abc 5ac1 +f40 f56 5ac0 5ac1 +f41 f46 5aa7 5ac2 +f4b f41 5aaf 5ac2 +f42 f44 5aa4 5ac3 +f48 f42 5aaa 5ac4 +f57 f42 5ac4 5ac5 +f44 f43 5aa5 5ac6 +f43 f54 5abd 5ac7 +f47 f45 5aa8 5ac9 +f45 f48 5aab 5aca +f58 f45 5ac9 5acb +f45 f59 5aca 5acb +f46 f47 5aa9 5acc +f4b f46 5ac2 5acd +f46 f5a 5acc 5acd +f47 f58 5ac9 5ace +f5a f47 5acc 5acf +f47 f5b 5ace 5acf +f48 f57 5ac4 5ad0 +f59 f48 5aca 5ad1 +f48 f5c 5ad0 5ad1 +f4a f49 5aae 5ad2 +f49 f4c 5ab0 5ad3 +f5d f49 5ad2 5ad5 +f49 f5e 5ad3 5ad4 +f49 f5f 5ad4 5ad5 +f50 f4a 5ab7 5ad6 +f4a f5d 5ad2 5ad6 +f4c f4b 5ab1 5ad7 +f4b f5a 5acd 5ad8 +f60 f4b 5ad7 5ad9 +f4b f61 5ad8 5ad9 +f5e f4c 5ad3 5ada +f4c f60 5ad7 5adb +f62 f4c 5ada 5adb +f4f f4d 5ab5 5adc +f4d f51 5ab8 5add +f63 f4d 5adc 5ade +f4d f64 5add 5ade +f4e f4f 5ab6 5adf +f52 f4e 5abb 5ae0 +f4e f65 5adf 5ae1 +f66 f4e 5ae0 5ae1 +f4f f63 5adc 5ae2 +f65 f4f 5adf 5ae2 +f51 f50 5ab9 5ae3 +f50 f5d 5ad6 5ae4 +f67 f50 5ae3 5ae6 +f50 f68 5ae4 5ae5 +f50 f69 5ae5 5ae6 +f64 f51 5add 5ae7 +f51 f67 5ae3 5ae7 +f56 f52 5ac0 5ae8 +f52 f66 5ae0 5ae9 +f6a f52 5ae8 5ae9 +f55 f53 5abe 5aeb +f53 f56 5ac1 5aea +f53 f6b 5aea 5aec +f6c f53 5aeb 5aec +f54 f55 5abf 5af1 +f55 f6c 5aeb 5af3 +f56 f6a 5ae8 5aed +f6b f56 5aea 5af0 +f56 f6d 5aed 5aee +f56 f6e 5aee 5aef +f56 f6f 5aef 5af0 +f5c f57 5ad0 5af5 +f58 f59 5acb 5af6 +f5b f58 5ace 5afa +f58 f70 5af6 5afb +f73 f58 5afa 5afb +f59 f5c 5ad1 5af7 +f70 f59 5af6 5af9 +f59 f71 5af7 5af8 +f59 f72 5af8 5af9 +f5a f5b 5acf 5afe +f61 f5a 5ad8 5aff +f5a f74 5afe 5b01 +f75 f5a 5aff 5b00 +f76 f5a 5b00 5b01 +f5b f73 5afa 5b02 +f74 f5b 5afe 5b02 +f71 f5c 5af7 5afd +f5d f5f 5ad5 5b05 +f68 f5d 5ae4 5b05 +f5f f5e 5ad4 5b03 +f5e f62 5ada 5b04 +f77 f5e 5b03 5b04 +f68 f5f 5b05 5b08 +f5f f77 5b03 5b06 +f5f f78 5b06 5b07 +f5f f79 5b07 5b08 +f60 f61 5ad9 5b0a +f62 f60 5adb 5b09 +f7a f60 5b09 5b0b +f60 f7b 5b0a 5b0b +f61 f75 5aff 5b0e +f7b f61 5b0a 5b0e +f77 f62 5b04 5b0d +f62 f7a 5b09 5b0c +f62 f7c 5b0c 5b0d +f63 f64 5ade 5b37 +f65 f63 5ae2 5b28 +f86 f63 5b28 5b34 +f8c f63 5b34 5b37 +f64 f67 5ae7 5d25 +f8c f64 5b37 5d21 +108d f64 5d21 5d24 +108e f64 5d24 5d25 +f66 f65 5ae1 5b1a +f7e f65 5b1a 5b1b +f82 f65 5b1b 5b26 +f86 f65 5b26 5b28 +f6a f66 5ae9 5b1f +f7e f66 5b18 5b1a +f66 f80 5b18 5b1f +f67 f69 5ae6 5fbb +108e f67 5d25 62c2 +f67 1204 5fbb 62c2 +f69 f68 5ae5 5faa +f68 f79 5b08 5f3c +f68 11b1 5f3c 5faa +f69 11b1 5faa 5fab +f69 11fb 5fab 5fb7 +f69 1204 5fb7 5fbb +f6d f6a 5aed 5b20 +f6a f80 5b1f 5b20 +f6c f6b 5aec 5c41 +f6b f6f 5af0 5c34 +f90 f6b 5c33 5c34 +f6b 1007 5c40 5c41 +f6b 100a 5c33 5c40 +1007 f6c 5c23 5c41 +f6e f6d 5aee 5b29 +f6d f7f 5b1c 5b1e +f80 f6d 5b1c 5b20 +f6d f83 5b1e 5b29 +f6f f6e 5aef 5b38 +f6e f83 5b29 5b2b +f6e f88 5b2b 5b38 +f6f f88 5b38 5b3d +f6f f90 5b3d 5c34 +f70 f72 5af9 5be1 +f73 f70 5afb 5bed +f70 fe8 5be1 5bed +f72 f71 5af8 5bd8 +f71 fe2 5bd5 5bd8 +f72 fe2 5bd8 5bdc +f72 fe6 5bdc 5be0 +f72 fe8 5be0 5be1 +f74 f73 5b02 5ca2 +f73 fe8 5bed 5bef +f73 fef 5bef 5c82 +f73 102a 5c82 5c86 +f73 1038 5c86 5ca2 +f76 f74 5b01 5d39 +f74 1038 5ca2 5ca7 +f74 1047 5ca7 5d39 +f75 f76 5b00 5d34 +f7b f75 5b0e 5d3d +f75 1092 5d34 5d35 +f75 1094 5d35 5d3d +1047 f76 5d38 5d39 +1049 f76 5d2e 5d38 +1090 f76 5d2c 5d2e +f76 1092 5d2c 5d34 +f78 f77 5b06 5f0f +f77 f7c 5b0d 5d8d +f77 10c4 5d8d 5f0f +f79 f78 5b07 5f1f +10c4 f78 5f0e 5f0f +f78 1199 5f0e 5f1b +f78 11a2 5f1b 5f1e +f78 11a3 5f1e 5f1f +f79 11a3 5f1f 5f39 +f79 11b1 5f39 5f3c +f7a f7b 5b0b 5d4a +f7c f7a 5b0c 5d69 +f7a 1099 5d4a 5d4c +f7a 10a0 5d4c 5d66 +f7a 10b0 5d66 5d69 +f7b 1094 5d3d 5d3e +f7b 1099 5d3e 5d4a +f7c 10b0 5d69 5d83 +f7c 10bd 5d83 5d8c +f7c 10c4 5d8c 5d8d +f7e f7d 5b10 5b12 +f7d f7f 5b11 5b13 +f80 f7d 5b12 5b13 +f7e f80 5b12 5b18 +f82 f7e 5b19 5b1b +f80 f7f 5b13 5b1c +f7f f81 5b15 5b1d +f7f f83 5b1d 5b1e +f83 f81 5b1d 5b23 +f84 f81 5b23 5b25 +f81 f85 5b24 5b25 +f82 f86 5b26 5b27 +f83 f84 5b23 5b2a +f83 f87 5b2a 5b2c +f88 f83 5b2b 5b2c +f84 f85 5b25 5b30 +f87 f84 5b2a 5b31 +f84 f8a 5b30 5b31 +f8a f85 5b30 5b33 +f85 f8b 5b32 5b33 +f89 f86 5b2d 5b35 +f86 f8c 5b34 5b36 +f8d f86 5b35 5b36 +f88 f87 5b2c 5b39 +f87 f8a 5b31 5b3a +f8e f87 5b39 5b3b +f87 f8f 5b3a 5b3b +f88 f8e 5b39 5b3c +f88 f90 5b3c 5b3d +f89 f8d 5b35 5b40 +f8a f8b 5b33 5b42 +f8f f8a 5b3a 5b43 +f8d f8c 5b36 5d1f +108c f8c 5d1f 5d22 +f8c 108d 5d21 5d22 +f8d 108c 5d1f 5d20 +f8e f8f 5b3b 5c2f +f90 f8e 5b3c 5c2a +f8e 100b 5c29 5c2a +100c f8e 5c29 5c2f +1001 f8f 5c3e 5c3f +1002 f8f 5c31 5c3e +100c f8f 5c2f 5c31 +f90 100a 5c32 5c33 +f90 100b 5c2a 5c2c +f90 100e 5c2c 5c32 +f92 f91 5b46 5b47 +f91 f93 5b46 5b48 +f94 f91 5b47 5b49 +f91 f95 5b48 5b4a +f96 f91 5b49 5b4b +f91 f97 5b4a 5b4b +f93 f92 5b46 5b4c +f92 f94 5b47 5b4d +f98 f92 5b4c 5b4e +f92 f99 5b4d 5b50 +f9a f92 5b4e 5b4f +f9b f92 5b4f 5b50 +f95 f93 5b48 5b51 +f93 f98 5b4c 5b52 +f9c f93 5b51 5b53 +f93 f9d 5b52 5b53 +f94 f96 5b49 5b54 +f99 f94 5b4d 5b55 +f94 f9e 5b54 5b56 +f9f f94 5b55 5b56 +f97 f95 5b4a 5b57 +f95 f9c 5b51 5b58 +f95 fa0 5b58 5b5a +f96 f97 5b4b 5b5b +f9e f96 5b54 5b5e +f96 fa1 5b5b 5b5e +fa1 f97 5b5b 5b5c +f98 f9a 5b4e 5b5f +f9d f98 5b52 5b60 +f98 fa2 5b5f 5b60 +f9b f99 5b50 5b64 +f99 f9f 5b55 5b65 +fa5 f99 5b64 5b66 +f99 fa6 5b65 5b66 +f9a f9b 5b4f 5b61 +fa2 f9a 5b5f 5b62 +f9a fa3 5b61 5b63 +fa4 f9a 5b62 5b63 +fa3 f9b 5b61 5b67 +f9b fa5 5b64 5b67 +f9c f9d 5b53 5b68 +fa0 f9c 5b58 5b6b +f9c fa7 5b68 5b6c +fa9 f9c 5b6b 5b6c +f9d fa2 5b60 5b69 +fa7 f9d 5b68 5b6a +f9d fa8 5b69 5b6a +f9f f9e 5b56 5b70 +f9e fa1 5b5e 5b6d +f9e faa 5b6d 5b72 +fab f9e 5b70 5b71 +fac f9e 5b71 5b72 +fa6 f9f 5b65 5b81 +f9f fab 5b70 5b82 +fb5 f9f 5b81 5b82 +fa0 fa9 5b6b 5b78 +fb0 fa0 5b77 5b78 +faa fa1 5b6d 5b6f +fa2 fa4 5b62 5b74 +fa8 fa2 5b69 5b73 +fad fa2 5b73 5b75 +fa2 fae 5b74 5b76 +faf fa2 5b75 5b76 +fa4 fa3 5b63 5b90 +fa3 fa5 5b67 5b86 +fa3 fb8 5b86 5b91 +fbd fa3 5b90 5b92 +fa3 fbe 5b91 5b92 +fae fa4 5b74 5b93 +fa4 fbd 5b90 5b93 +fa5 fa6 5b66 5b83 +fa5 fb6 5b83 5b87 +fb8 fa5 5b86 5b87 +fa6 fb5 5b81 5b84 +fb6 fa6 5b83 5b85 +fa6 fb7 5b84 5b85 +fa7 fa8 5b6a 5b7a +fa9 fa7 5b6c 5b7b +fa7 fb1 5b7a 5b7d +fb2 fa7 5b7b 5b7c +fb3 fa7 5b7c 5b7d +fa8 fad 5b73 5b7e +fb1 fa8 5b7a 5b7e +fb0 fa9 5b78 5b7f +fa9 fb2 5b7b 5b80 +fb4 fa9 5b7f 5b80 +fac faa 5b72 5b8c +fbb faa 5b8c 5b8d +fab fac 5b71 5b89 +fb5 fab 5b82 5b88 +fb9 fab 5b88 5b8a +fab fba 5b89 5b8a +fba fac 5b89 5b8e +fac fbb 5b8c 5b8f +fbc fac 5b8e 5b8f +fad faf 5b75 87ad +fb1 fad 5b7e 87af +2674 fad 87af 8aa2 +fad 26d8 87ad 8aa2 +faf fae 5b76 5b95 +fae fbd 5b93 5b96 +fbf fae 5b95 5b97 +fae fc0 5b96 5b97 +faf fbf 5b95 5b98 +faf fc1 5b98 89f0 +26d8 faf 87ad 89f0 +fb0 fb4 5b7f 5b99 +fb0 fc2 5b99 5b9b +fc3 fb0 5b9a 5b9b +fb3 fb1 5b7d 8647 +2674 fb1 8647 87af +fb2 fb3 5b7c 85dd +fb4 fb2 5b80 5b9c +fc4 fb2 5b9c 85de +fb2 2640 85dd 85de +263e fb3 8a5c 8adb +fb3 263f 8a5c 8bac +2640 fb3 85dd 8bac +fb3 2674 8647 8adb +fc2 fb4 5b99 5b9d +fb4 fc4 5b9c 5b9d +fb7 fb5 5b84 5b8b +fb5 fb9 5b88 5b8b +fb6 fb7 5b85 5b9f +fb8 fb6 5b87 5ba0 +fb6 fc5 5b9f 5ba2 +fc6 fb6 5ba0 5ba1 +fc7 fb6 5ba1 5ba2 +fb7 fb9 5b8b 5ba3 +fc5 fb7 5b9f 5ba4 +fb7 fc8 5ba3 5ba4 +fbe fb8 5b91 5ba5 +fb8 fc6 5ba0 5ba6 +fc9 fb8 5ba5 5ba6 +fb9 fba 5b8a 5ba7 +fc8 fb9 5ba3 5ba8 +fb9 fca 5ba7 5ba8 +fba fbc 5b8e 5ba9 +fca fba 5ba7 5bab +fba fcb 5ba9 5baa +fba fcc 5baa 5bab +fbc fbb 5b8f 5bac +fcb fbc 5ba9 5bae +fbc fcd 5bad 5bae +fbd fbe 5b92 5baf +fc0 fbd 5b96 5baf +fc0 fbe 5baf 5bb1 +fbe fc9 5ba5 5bb0 +fbe fce 5bb0 5bb1 +fbf fc0 5b97 5d00 +fc1 fbf 5b98 5d1d +fbf 107b 5d00 5d1d +fc0 fce 5bb1 5ce7 +fc0 1066 5ce7 5cea +fc0 106f 5cea 5cff +fc0 107b 5cff 5d00 +fc1 107b 5d1d 89cc +26d5 fc1 87ac 8a3e +fc1 26d6 89cc 8a3e +fc1 26d8 87ac 89f0 +fc3 fc2 5b9b 6f37 +fc2 fc4 5b9d 6f39 +fc2 1a53 6f35 6f37 +1a54 fc2 6f35 6f38 +1a55 fc2 6f38 6f39 +1a53 fc3 6f36 6f37 +1a55 fc4 6f39 8b43 +fc4 24fd 85e0 8b43 +fc4 2640 85de 85e0 +fc7 fc5 5ba2 5cf8 +fc5 fc8 5ba4 5d14 +1076 fc5 5cf8 5d11 +1085 fc5 5d11 5d13 +1086 fc5 5d13 5d14 +fc6 fc7 5ba1 5ce1 +fc9 fc6 5ba6 5cdf +1062 fc6 5cdf 5ce1 +1062 fc7 5ce1 5ce2 +106b fc7 5ce2 5cf6 +1076 fc7 5cf6 5cf8 +fc8 fca 5ba8 70a8 +1086 fc8 5d14 5de5 +10f5 fc8 5de5 70a8 +fce fc9 5bb0 5cd9 +fc9 1060 5cd8 5cd9 +1062 fc9 5cd8 5cdf +fca fcc 5bab 709a +fca 10f5 709e 70a8 +fca 1b09 709a 709e +fcc fcb 5baa 7091 +fcb fcd 5bae 6d98 +fcb 1974 6d98 7091 +1974 fcc 7090 7091 +fcc 1b05 7090 7093 +fcc 1b09 7093 709a +fcd 1972 6d95 6d96 +fcd 1973 6d96 6d97 +fcd 1974 6d97 6d98 +fce 105f 5cd4 5cd6 +1060 fce 5cd4 5cd9 +fce 1066 5cd6 5ce7 +fcf fd0 5bb4 5bc1 +fd3 fcf 5bb8 5bc2 +fcf fd8 5bc1 5bc2 +fd8 fd0 5bc1 5bc3 +fd9 fd0 5bc3 8155 +240b fd0 8155 8b74 +fd2 fd1 5bb7 5bcc +fd1 fd3 5bb9 5bcd +fde fd1 5bcc 5bce +fd1 fdf 5bcd 5bce +fd7 fd2 5bc0 5bcf +fd2 fde 5bcc 5bd0 +fe0 fd2 5bcf 5bd0 +fd3 fd8 5bc2 5bd2 +fdf fd3 5bcd 5bd1 +fe1 fd3 5bd1 5bd2 +fd6 fd4 5bbd 5bc5 +fd4 fd7 5bbf 5bc6 +fda fd4 5bc5 5bc7 +fd4 fdb 5bc6 5bc7 +fd5 fd6 5bbe 5bc8 +fd5 fdc 5bc8 5bc9 +fd6 fda 5bc5 5bcb +fdc fd6 5bc8 5bca +fdd fd6 5bca 5bcb +fdb fd7 5bc6 5bd3 +fd7 fe0 5bcf 5bd3 +fd8 fd9 5bc3 7080 +fe1 fd8 5bd2 707f +fd8 1af8 707e 707f +1af9 fd8 707e 7080 +1af9 fd9 7080 8b4c +fd9 240b 8155 83e2 +fd9 2542 83e2 8c0f +2545 fd9 8b4c 8c0f +fda fdb 5bc7 7055 +fdd fda 5bcb 7056 +fda 1ae4 7055 7056 +fdb fe0 5bd3 7058 +1ae4 fdb 7055 7057 +1ae5 fdb 7057 7058 +fdc fdd 5bca 6a9b +17c8 fdc 6a9a 6a9b +17c8 fdd 6a9b 705a +fdd 1ae4 7056 7059 +fdd 1ae6 7059 705b +1ae7 fdd 705a 705b +fde fdf 5bce 706b +fe0 fde 5bd0 705f +1aea fde 705f 706c +fde 1af1 706b 706c +fdf fe1 5bd1 792c +1af1 fdf 706b 7923 +1afb fdf 7922 792c +fdf 1afc 7922 7923 +1ae5 fe0 7058 705e +1ae9 fe0 705e 7060 +fe0 1aea 705f 7060 +fe1 1af6 707a 707b +1af8 fe1 707a 707f +fe1 1afb 707b 792c +fe2 fe3 5bd7 5bdb +fe2 fe5 5bdb 5bdd +fe6 fe2 5bdc 5bdd +fe3 fe4 5bd9 5bde +fe5 fe3 5bdb 5bdf +fe3 fe7 5bde 5bdf +fe7 fe4 5bde 5be3 +fe9 fe4 5be3 5be5 +fe4 fea 5be4 5be5 +fe6 fe5 5bdd 5be6 +fe5 fe7 5bdf 5be7 +feb fe5 5be6 5be7 +fe8 fe6 5be0 5be8 +fe6 feb 5be6 5be9 +fec fe6 5be8 5be9 +fe7 fe9 5be3 5bea +feb fe7 5be7 5beb +fe7 fed 5bea 5bec +fee fe7 5beb 5bec +fe8 fec 5be8 5bee +fe8 fef 5bee 5bef +fe9 fea 5be5 5bf3 +fed fe9 5bea 5bf5 +fe9 ff1 5bf3 5bf6 +ff2 fe9 5bf5 5bf6 +fea ff0 5bf1 5bf4 +ff1 fea 5bf3 5bf4 +fec feb 5be9 5c7b +feb fee 5beb 5c7b +fee fec 5c68 5c7b +fef fec 5bee 5c6d +101f fec 5c67 5c68 +fec 1021 5c67 5c6d +fee fed 5bec 5c7c +fed ff2 5bf5 5c9b +1033 fed 5c7c 5c9b +101d fee 5c61 5c63 +fee 101f 5c61 5c68 +1026 fee 5c63 5c7a +1033 fee 5c7a 5c7c +fef 1020 5c69 5c6b +1021 fef 5c69 5c6d +fef 102a 5c6b 5c82 +ff1 ff0 5bf4 69ef +ff0 1773 69ee 69ef +ff2 ff1 5bf6 69f7 +1773 ff1 69ed 69ef +ff1 1775 69ed 69f5 +ff1 1779 69f5 69f7 +1033 ff2 5c9b 5c9c +103e ff2 5c9c 5cb8 +1050 ff2 5cb8 6a01 +ff2 1779 69f7 6a01 +ff3 ff4 5bf9 5c02 +ff7 ff3 5bfd 5c03 +ff3 ff8 5c02 5c04 +ff9 ff3 5c03 5c04 +ff8 ff4 5c02 5c06 +ff5 ff6 5bff 5c08 +ffa ff5 5c07 5c09 +ff5 ffb 5c08 5c0a +ffc ff5 5c09 5c0a +ff6 ff7 5bfe 5c0d +ffb ff6 5c08 5c0e +ff6 ffe 5c0d 5c0e +ff7 ff9 5c03 5c0f +ffe ff7 5c0d 5c11 +ff7 fff 5c0f 5c10 +ff7 1000 5c10 5c11 +ff9 ff8 5c04 5c18 +1003 ff8 5c18 5c19 +fff ff9 5c0f 5c1b +ff9 1003 5c18 5c1a +ff9 1004 5c1a 5c1b +ffa ffc 5c09 5c47 +ffd ffa 5c0c 5c45 +1011 ffa 5c45 5c47 +ffc ffb 5c0a 5c4d +ffb ffe 5c0e 6970 +1014 ffb 5c4d 5c4e +1017 ffb 5c4e 696f +1737 ffb 696f 6970 +ffc 1011 5c46 5c47 +1014 ffc 5c46 5c4d +1002 ffd 5c14 5c36 +100d ffd 5c36 5c38 +1011 ffd 5c38 5c45 +ffe 1000 5c11 696a +ffe 1737 696a 6970 +1000 fff 5c10 6964 +fff 1004 5c1b 694c +fff 172f 694c 6961 +fff 1734 6961 6964 +1000 1734 6964 6965 +1000 1735 6965 6967 +1000 1737 6967 696a +1001 1002 5c15 5c3e +1002 100c 5c30 5c31 +100d 1002 5c30 5c36 +1004 1003 5c1a 6915 +1003 171a 6914 6915 +1004 171a 6915 694a +1004 172a 694a 694b +1004 172f 694b 694c +1005 1006 5c20 6972 +1018 1005 6971 6972 +1730 1005 6958 6959 +1733 1005 6959 6971 +1006 1009 5c26 5c51 +1006 1018 5c51 6972 +100a 1007 5c28 5c40 +1009 1008 5c25 5c48 +1008 100a 5c27 5c3a +1008 100e 5c3a 5c3b +1008 1012 5c3b 5c48 +1009 1012 5c48 5c49 +1009 1013 5c49 5c4b +1009 1016 5c4b 5c50 +1009 1018 5c50 5c51 +100a 100e 5c32 5c3a +100b 100c 5c29 5c2b +100b 100d 5c2b 5c2d +100e 100b 5c2c 5c2e +100b 100f 5c2d 5c2e +100d 100c 5c2b 5c30 +100f 100d 5c2d 5c35 +1010 100d 5c35 5c37 +1011 100d 5c37 5c38 +100e 100f 5c2e 5c39 +100e 1012 5c39 5c3b +100f 1010 5c35 5c3c +1012 100f 5c39 5c3d +100f 1013 5c3c 5c3d +1010 1011 5c37 5c42 +1013 1010 5c3c 5c43 +1010 1014 5c42 5c44 +1015 1010 5c43 5c44 +1014 1011 5c42 5c46 +1012 1013 5c3d 5c49 +1013 1015 5c43 5c4a +1013 1016 5c4a 5c4b +1015 1014 5c44 5c4c +1017 1014 5c4c 5c4e +1016 1015 5c4a 5c4f +1015 1017 5c4c 5c4f +1016 1017 5c4f 5c53 +1018 1016 5c50 5c52 +1019 1016 5c52 5c53 +1019 1017 5c53 696d +1017 1736 696c 696d +1737 1017 696c 696f +1018 1019 5c52 6973 +1733 1018 6971 6973 +1019 1732 696b 696e +1019 1733 696e 6973 +1736 1019 696b 696d +101b 101a 5c54 5c55 +101a 101c 5c54 5c56 +101d 101a 5c55 5c57 +101a 101e 5c56 5c58 +101f 101a 5c57 5c59 +101a 1020 5c58 5c5a +1021 101a 5c59 5c5a +101c 101b 5c54 5c5b +101b 101d 5c55 5c5c +1022 101b 5c5b 5c5d +101b 1023 5c5c 5c5d +101e 101c 5c56 5c5e +101c 1022 5c5b 5c5f +1024 101c 5c5e 5c60 +101c 1025 5c5f 5c60 +101d 101f 5c57 5c61 +1023 101d 5c5c 5c62 +1026 101d 5c62 5c63 +1020 101e 5c58 5c64 +101e 1024 5c5e 5c65 +1027 101e 5c64 5c66 +101e 1028 5c65 5c66 +101f 1021 5c59 5c67 +1021 1020 5c5a 5c69 +1020 1027 5c64 5c6a +1020 1029 5c6a 5c6c +102a 1020 5c6b 5c6c +1022 1023 5c5d 5c6e +1025 1022 5c5f 5c6f +1022 102b 5c6e 5c70 +102c 1022 5c6f 5c70 +1023 1026 5c62 5c71 +102b 1023 5c6e 5c72 +1023 102d 5c71 5c73 +102e 1023 5c72 5c73 +1024 1025 5c60 5c74 +1028 1024 5c65 5c75 +1024 102f 5c74 5c76 +1030 1024 5c75 5c77 +1024 1031 5c76 5c77 +1025 102c 5c6f 5c78 +102f 1025 5c74 5c79 +1025 1032 5c78 5c79 +102d 1026 5c71 5c7d +1026 1033 5c7a 5c7d +1027 1028 5c66 5c7e +1029 1027 5c6a 5c7f +1027 1034 5c7e 5c7f +1028 1030 5c75 5c80 +1034 1028 5c7e 5c81 +1028 1035 5c80 5c81 +102a 1029 5c6c 5c83 +1029 1034 5c7f 5c84 +1036 1029 5c83 5c85 +1029 1037 5c84 5c85 +102a 1036 5c83 5c87 +1038 102a 5c86 5c87 +102c 102b 5c70 5c88 +102b 102e 5c72 5c89 +1039 102b 5c88 5c8a +102b 103a 5c89 5c8a +1032 102c 5c78 5c8b +102c 1039 5c88 5c8c +103b 102c 5c8b 5c8d +102c 103c 5c8c 5c8d +102e 102d 5c73 5c8e +102d 1033 5c7d 5c8f +103d 102d 5c8e 5c90 +102d 103e 5c8f 5c90 +103a 102e 5c89 5c91 +102e 103d 5c8e 5c92 +103f 102e 5c91 5c92 +1031 102f 5c76 5c93 +102f 1032 5c79 5c94 +1040 102f 5c93 5c94 +1030 1031 5c77 5c95 +1035 1030 5c80 5c96 +1030 1041 5c95 5c97 +1042 1030 5c96 5c97 +1031 1040 5c93 5c98 +1041 1031 5c95 5c98 +1032 103b 5c8b 5c99 +1040 1032 5c94 5c9a +1032 1043 5c99 5c9a +103e 1033 5c8f 5c9c +1034 1035 5c81 5c9d +1037 1034 5c84 5c9e +1034 1044 5c9d 5c9f +1045 1034 5c9e 5c9f +1035 1042 5c96 5ca0 +1044 1035 5c9d 5ca1 +1035 1046 5ca0 5ca1 +1036 1037 5c85 5ca4 +1038 1036 5c87 5ca3 +1047 1036 5ca3 5ca6 +1036 1048 5ca4 5ca5 +1036 1049 5ca5 5ca6 +1037 1045 5c9e 5ca8 +1048 1037 5ca4 5ca8 +1038 1047 5ca3 5ca7 +1039 103a 5c8a 5ca9 +103c 1039 5c8c 5caa +1039 104a 5ca9 5cab +104b 1039 5caa 5cab +103a 103f 5c91 5cac +104a 103a 5ca9 5cac +103b 103c 5c8d 5cad +1043 103b 5c99 5cae +103b 104c 5cad 5caf +104d 103b 5cae 5caf +103c 104b 5caa 5cb0 +104c 103c 5cad 5cb1 +103c 104e 5cb0 5cb1 +103d 103e 5c90 5cb3 +103f 103d 5c92 5cb2 +104f 103d 5cb2 5cb4 +103d 1050 5cb3 5cb4 +1050 103e 5cb3 5cb8 +104a 103f 5cac 5cb5 +103f 104f 5cb2 5cb6 +1051 103f 5cb5 5cb7 +103f 1052 5cb6 5cb7 +1041 1040 5c98 5cba +1040 1043 5c9a 5cb9 +1040 1053 5cb9 5cba +1042 1041 5c97 5cbf +1041 1053 5cba 5cc0 +1057 1041 5cbf 5cc1 +1041 1058 5cc0 5cc1 +1046 1042 5ca0 5cc2 +1042 1057 5cbf 5cc2 +1043 104d 5cae 5cbc +1053 1043 5cb9 5cbb +1054 1043 5cbb 5cbe +1043 1055 5cbc 5cbd +1043 1056 5cbd 5cbe +1045 1044 5c9f 5d47 +1044 1046 5ca1 5d71 +1098 1044 5d47 5d49 +109f 1044 5d49 5d61 +10ae 1044 5d61 5d71 +1048 1045 5ca8 5d3b +1098 1045 5d3b 5d47 +1046 1057 5cc2 5d78 +10ae 1046 5d71 5d73 +10b7 1046 5d73 5d77 +10b9 1046 5d77 5d78 +1047 1049 5ca6 5d38 +1049 1048 5ca5 5d2f +1048 1090 5d2d 5d2f +1093 1048 5d2d 5d36 +1097 1048 5d36 5d3a +1098 1048 5d3a 5d3b +1090 1049 5d2e 5d2f +104b 104a 5cab 5cc4 +104a 1051 5cb5 5cc7 +1059 104a 5cc4 5cc7 +104e 104b 5cb0 5cc5 +104b 1059 5cc4 5cc6 +105a 104b 5cc5 5cc6 +104d 104c 5caf 5cc9 +104c 104e 5cb1 5cc8 +104c 105b 5cc8 5cca +105c 104c 5cc9 5cca +1055 104d 5cbc 5ccd +104d 105c 5cc9 5ccd +104e 105a 5cc5 5ccb +105b 104e 5cc8 5ccc +104e 105d 5ccb 5ccc +104f 1050 5cb4 6a0a +1052 104f 5cb6 6a12 +104f 177c 6a0a 6a0b +104f 1782 6a0b 6a12 +1050 1777 69fd 69fe +1779 1050 69fd 6a01 +1050 177c 69fe 6a0a +1051 1052 5cb7 6a13 +1059 1051 5cc7 6a1d +1051 1784 6a13 6a17 +1051 1788 6a17 6a1d +1782 1052 6a0e 6a12 +1052 1783 6a0e 6a0f +1052 1784 6a0f 6a13 +1053 1054 5cbb 5cc3 +1058 1053 5cc0 5cc3 +1054 1056 5cbe 77e6 +1058 1054 5cc3 6ca1 +18df 1054 6ca1 6ca7 +18e6 1054 6ca7 77e7 +1054 1e88 77e6 77e7 +1056 1055 5cbd 72d5 +1055 105c 5ccd 72b8 +1055 1c06 72b8 72d4 +1055 1c15 72d4 72d5 +1056 1c15 72d5 77e1 +1056 1e88 77e1 77e6 +1057 1058 5cc1 6c97 +10b9 1057 5d78 6c97 +10b9 1058 6c97 6c99 +18df 1058 6c99 6ca1 +105a 1059 5cc6 6a2e +1059 1788 6a1d 6a25 +1059 1790 6a25 6a2e +105d 105a 5ccb 72aa +105a 1790 6a2e 6a36 +105a 1797 6a36 72ab +1bfe 105a 72aa 72ab +105c 105b 5cca 72af +105b 105d 5ccc 72ac +105b 1bff 72ac 72ae +105b 1c00 72ae 72af +105c 1c00 72af 72b7 +105c 1c05 72b7 72b9 +1c06 105c 72b8 72b9 +105d 1bfe 72aa 72ad +1bff 105d 72ac 72ad +105f 105e 5cce 5ccf +105e 1060 5cce 5cd0 +1061 105e 5ccf 5cd1 +105e 1062 5cd0 5cd2 +1063 105e 5cd1 5cd3 +105e 1064 5cd2 5cd3 +1060 105f 5cce 5cd4 +105f 1061 5ccf 5cd5 +105f 1065 5cd5 5cd7 +1066 105f 5cd6 5cd7 +1062 1060 5cd0 5cd8 +1061 1063 5cd1 5cda +1065 1061 5cd5 5cdb +1061 1067 5cda 5cdc +1068 1061 5cdb 5cdd +1061 1069 5cdc 5cdd +1064 1062 5cd2 5cde +106a 1062 5cde 5ce0 +106b 1062 5ce0 5ce2 +1063 1064 5cd3 5ce3 +1067 1063 5cda 5ce4 +1063 106c 5ce3 5ce5 +106d 1063 5ce4 5ce5 +1064 106a 5cde 5ce6 +106c 1064 5ce3 5ce6 +1066 1065 5cd7 5ce8 +1065 1068 5cdb 5ce9 +106e 1065 5ce8 5ce9 +1066 106e 5ce8 5ceb +106f 1066 5cea 5ceb +1069 1067 5cdc 5cec +1067 106d 5ce4 5ced +1070 1067 5cec 5ced +1068 1069 5cdd 5cee +106e 1068 5ce9 5cef +1068 1071 5cee 5cef +1069 1070 5cec 5cf0 +1071 1069 5cee 5cf1 +1069 1072 5cf0 5cf2 +1073 1069 5cf1 5cf2 +106a 106b 5ce0 5cf3 +106c 106a 5ce6 5cf4 +106a 1074 5cf3 5cf5 +1075 106a 5cf4 5cf5 +1074 106b 5cf3 5cf7 +106b 1076 5cf6 5cf7 +106d 106c 5ce5 5cf9 +106c 1075 5cf4 5cfa +1077 106c 5cf9 5cfb +106c 1078 5cfa 5cfb +1070 106d 5ced 5cfc +106d 1077 5cf9 5cfd +1079 106d 5cfc 5cfe +106d 107a 5cfd 5cfe +106f 106e 5ceb 5d01 +106e 1071 5cef 5d02 +107c 106e 5d01 5d03 +106e 107d 5d02 5d03 +107b 106f 5cff 882f +106f 107c 5d01 8991 +2673 106f 882f 8991 +1072 1070 5cf0 5d04 +1070 1079 5cfc 5d05 +107e 1070 5d04 5d05 +1071 1073 5cf1 5d06 +107d 1071 5d02 5d07 +1071 107f 5d06 5d07 +1073 1072 5cf2 5d08 +1072 107e 5d04 5d0a +1080 1072 5d08 5d09 +1081 1072 5d09 5d0a +107f 1073 5d06 5d0c +1073 1080 5d08 5d0b +1073 1082 5d0b 5d0c +1075 1074 5cf5 5d0d +1074 1076 5cf7 5d0e +1083 1074 5d0d 5d0f +1074 1084 5d0e 5d0f +1078 1075 5cfa 5d10 +1075 1083 5d0d 5d10 +1084 1076 5d0e 5d12 +1076 1085 5d11 5d12 +1077 1078 5cfb 5d15 +107a 1077 5cfd 5d16 +1077 1087 5d15 5d16 +1078 1083 5d10 5d17 +1087 1078 5d15 5d18 +1078 1088 5d17 5d18 +1079 107a 5cfe 5d19 +107e 1079 5d05 5d1c +1079 1089 5d19 5d1c +107a 1087 5d16 5d1a +1089 107a 5d19 5d1b +107a 108a 5d1a 5d1b +2673 107b 87a8 882f +107b 26d6 87a8 89cc +107c 107d 5d03 882b +107c 2671 882b 882c +2672 107c 8643 882c +107c 2673 8643 8991 +107d 107f 5d07 5d1e +107d 108b 5d1e 898c +2671 107d 882b 898c +1081 107e 5d0a 7803 +107e 1089 5d1c 7807 +1e92 107e 7803 7804 +1e95 107e 7804 7807 +107f 1082 5d0c 7806 +108b 107f 5d1e 894a +107f 1e97 7806 87a1 +107f 26d3 87a1 894a +1080 1081 5d09 7800 +1082 1080 5d0b 7802 +1080 1e91 7800 7802 +1081 1e91 77ff 7800 +1e92 1081 77ff 7803 +1e91 1082 7801 7802 +1082 1e97 7801 7806 +1083 1084 5d0f 5dac +1088 1083 5d17 5d9f +10c8 1083 5d98 5d9a +1083 10ca 5d98 5d9f +10ce 1083 5d9a 5dac +1084 1085 5d12 5dae +10ce 1084 5dac 5dae +1085 1086 5d13 5dc3 +1085 10ce 5dad 5dae +10d7 1085 5dad 5dc3 +10d7 1086 5dc3 5dc4 +10e4 1086 5dc4 5de2 +10f5 1086 5de2 5de5 +1087 1088 5d18 5db6 +108a 1087 5d1a 5dcf +1087 10dc 5db6 5dcf +1088 10ca 5d9f 5da0 +1088 10d1 5da0 5db3 +1088 10dc 5db3 5db6 +1089 108a 5d1b 780c +1e86 1089 7809 780c +1e95 1089 7807 7809 +108a 10dc 5dcf 5dd0 +108a 10ea 5dd0 77da +108a 1e86 77da 780c +2670 108b 8640 8829 +108b 2671 8640 898c +26d3 108b 8829 894a +108c 108d 5d22 5d26 +108d 108e 5d24 5d29 +108f 108d 5d28 5d29 +108f 108e 5d29 62c6 +108e 1204 62c2 62c3 +108e 13d4 62c3 62c6 +11b3 108f 5f3e 62cd +108f 13d4 62c6 62ca +108f 13d7 62ca 62cd +1091 1090 5d2a 5d2b +1090 1092 5d2a 5d2c +1093 1090 5d2b 5d2d +1092 1091 5d2a 5d30 +1091 1093 5d2b 5d31 +1094 1091 5d30 5d32 +1091 1095 5d31 5d33 +1096 1091 5d32 5d33 +1092 1094 5d30 5d35 +1095 1093 5d31 5d37 +1093 1097 5d36 5d37 +1094 1096 5d32 5d3c +1094 1099 5d3c 5d3e +1096 1095 5d33 5d3f +1095 1097 5d37 5d40 +109a 1095 5d3f 5d41 +1095 109b 5d40 5d42 +109c 1095 5d41 5d42 +1099 1096 5d3c 5d43 +1096 109a 5d3f 5d44 +109d 1096 5d43 5d45 +1096 109e 5d44 5d45 +1097 1098 5d3a 5d46 +109b 1097 5d40 5d46 +109b 1098 5d46 5d48 +109f 1098 5d48 5d49 +1099 109d 5d43 5d4b +1099 10a0 5d4b 5d4c +109a 109c 5d41 5d4d +109e 109a 5d44 5d4e +109a 10a1 5d4d 5d4e +109c 109b 5d42 5d4f +109b 109f 5d48 5d53 +10a2 109b 5d4f 5d52 +10a4 109b 5d52 5d53 +10a1 109c 5d4d 5d50 +109c 10a2 5d4f 5d51 +10a3 109c 5d50 5d51 +109d 109e 5d45 5d54 +10a0 109d 5d4b 5d57 +109d 10a5 5d54 5d58 +10a7 109d 5d57 5d58 +109e 10a1 5d4e 5d55 +10a5 109e 5d54 5d56 +109e 10a6 5d55 5d56 +10a4 109f 5d53 5d60 +10ad 109f 5d60 5d62 +109f 10ae 5d61 5d62 +10a0 10a7 5d57 5d67 +10b0 10a0 5d66 5d68 +10a0 10b1 5d67 5d68 +10a1 10a3 5d50 5d59 +10a6 10a1 5d55 5d5a +10a1 10a8 5d59 5d5a +10a3 10a2 5d51 5d5c +10a2 10a4 5d52 5d5b +10a2 10a9 5d5b 5d5d +10aa 10a2 5d5c 5d5f +10a2 10ab 5d5d 5d5e +10a2 10ac 5d5e 5d5f +10a8 10a3 5d59 5d65 +10a3 10aa 5d5c 5d64 +10a3 10af 5d64 5d65 +10a9 10a4 5d5b 5d63 +10a4 10ad 5d60 5d63 +10a5 10a6 5d56 5d6b +10a7 10a5 5d58 5d6a +10b2 10a5 5d6a 5d6b +10a6 10a8 5d5a 5d70 +10b2 10a6 5d6b 5d6f +10b5 10a6 5d6f 5d70 +10b1 10a7 5d67 5d6c +10a7 10b2 5d6a 5d6d +10b3 10a7 5d6c 5d6e +10a7 10b4 5d6d 5d6e +10a8 10af 5d65 5d8f +10b5 10a8 5d70 5d8e +10c5 10a8 5d8e 5d90 +10a8 10c6 5d8f 5d90 +10ab 10a9 5d5d 5d79 +10a9 10ad 5d63 5d75 +10a9 10b8 5d75 5d79 +10aa 10ac 5d5f 5d7c +10af 10aa 5d64 5d7f +10aa 10bb 5d7c 5d7f +10ac 10ab 5d5e 5d7a +10ab 10b8 5d79 5d7b +10ba 10ab 5d7a 5d7b +10ac 10ba 5d7a 5d7d +10bb 10ac 5d7c 5d7e +10ac 10bc 5d7d 5d7e +10ad 10ae 5d62 5d72 +10ad 10b6 5d72 5d76 +10b8 10ad 5d75 5d76 +10b6 10ae 5d72 5d74 +10ae 10b7 5d73 5d74 +10af 10bb 5d7f 5e9d +10c6 10af 5d8f 5e9e +10af 1157 5e9d 5e9e +10b0 10b1 5d68 5d80 +10b0 10bd 5d80 5d83 +10b1 10b3 5d6c 5d81 +10bd 10b1 5d80 5d82 +10b1 10be 5d81 5d82 +10b4 10b2 5d6d 5d84 +10b2 10b5 5d6f 5d85 +10bf 10b2 5d84 5d85 +10b3 10b4 5d6e 5d86 +10be 10b3 5d81 5d87 +10b3 10c0 5d86 5d88 +10c1 10b3 5d87 5d88 +10b4 10bf 5d84 5d8b +10c0 10b4 5d86 5d89 +10c2 10b4 5d89 5d8a +10c3 10b4 5d8a 5d8b +10bf 10b5 5d85 5d91 +10b5 10c5 5d8e 5d91 +10b6 10b7 5d74 6c96 +10b8 10b6 5d76 6c9d +116c 10b6 6c9d 6c9e +10b6 18dd 6c96 6c9c +10b6 18e1 6c9c 6c9e +10b7 10b9 5d77 6c95 +10b7 18dd 6c95 6c96 +10ba 10b8 5d7b 5eb3 +116c 10b8 5eb3 6c9d +18dd 10b9 6c95 6c98 +18de 10b9 6c98 6c9a +10b9 18df 6c99 6c9b +18e0 10b9 6c9a 6c9b +10bc 10ba 5d7d 5e98 +1156 10ba 5e98 5e99 +1162 10ba 5e99 5eb2 +116c 10ba 5eb2 5eb3 +10bb 10bc 5d7e 5e9b +10bb 1157 5e9b 5e9d +10bc 114e 5e83 5e84 +1156 10bc 5e83 5e98 +10bc 1157 5e84 5e9b +10bd 10be 5d82 5f00 +10c4 10bd 5d8c 5f04 +10bd 1193 5f00 5f03 +10bd 1195 5f03 5f04 +10be 10c1 5d87 5f02 +1193 10be 5f00 5f01 +1194 10be 5f01 5f02 +10c3 10bf 5d8b 5f2a +10bf 10c5 5d91 5f2c +116b 10bf 5f2b 5f2c +11aa 10bf 5f2a 5f2b +10c1 10c0 5d88 5f0a +10c0 10c2 5d89 5f14 +1197 10c0 5f0a 5f13 +119d 10c0 5f13 5f14 +1194 10c1 5f02 5f07 +1197 10c1 5f07 5f0a +10c2 10c3 5d8a 5f26 +119d 10c2 5f14 5f25 +11a7 10c2 5f25 5f26 +11a7 10c3 5f26 5f2d +10c3 11aa 5f2a 5f2e +11ab 10c3 5f2d 5f2e +10c4 1195 5f04 5f0b +10c4 1199 5f0b 5f0e +10c5 10c6 5d90 5eae +10c5 115d 5eae 5eaf +10c5 116b 5eaf 5f2c +1157 10c6 5e9c 5e9e +10c6 115d 5e9c 5eae +10c8 10c7 5d92 5d93 +10c7 10c9 5d92 5d94 +10ca 10c7 5d93 5d95 +10c7 10cb 5d94 5d96 +10cc 10c7 5d95 5d96 +10c9 10c8 5d92 5d97 +10c8 10ca 5d93 5d98 +10cd 10c8 5d97 5d99 +10ce 10c8 5d99 5d9a +10cb 10c9 5d94 5d9b +10c9 10cd 5d97 5d9c +10cf 10c9 5d9b 5d9d +10c9 10d0 5d9c 5d9d +10ca 10cc 5d95 5d9e +10ca 10d1 5d9e 5da0 +10cc 10cb 5d96 5da1 +10cb 10cf 5d9b 5da2 +10d2 10cb 5da1 5da3 +10cb 10d3 5da2 5da4 +10d4 10cb 5da3 5da4 +10d1 10cc 5d9e 5da5 +10cc 10d2 5da1 5da6 +10d5 10cc 5da5 5da7 +10cc 10d6 5da6 5da7 +10cd 10ce 5d99 5da8 +10d0 10cd 5d9c 5da9 +10cd 10d7 5da8 5daa +10d8 10cd 5da9 5dab +10cd 10d9 5daa 5dab +10d7 10ce 5da8 5dad +10cf 10d0 5d9d 5daf +10d3 10cf 5da2 5db0 +10cf 10d8 5daf 5db1 +10da 10cf 5db0 5db2 +10cf 10db 5db1 5db2 +10d0 10d8 5da9 5daf +10d1 10d5 5da5 5db4 +10dc 10d1 5db3 5db5 +10d1 10dd 5db4 5db5 +10d2 10d4 5da3 5db7 +10d6 10d2 5da6 5db8 +10d2 10de 5db7 5db9 +10df 10d2 5db8 5db9 +10d4 10d3 5da4 5dba +10d3 10da 5db0 5dbb +10e0 10d3 5dba 5dbc +10d3 10e1 5dbb 5dbc +10de 10d4 5db7 5dbd +10d4 10e0 5dba 5dbe +10e2 10d4 5dbd 5dbe +10d5 10d6 5da7 5dbf +10dd 10d5 5db4 5dc0 +10d5 10e3 5dbf 5dc0 +10d6 10df 5db8 5dc1 +10e3 10d6 5dbf 5dc1 +10d9 10d7 5daa 5dc2 +10e4 10d7 5dc2 5dc4 +10d8 10d9 5dab 5dc5 +10db 10d8 5db1 5dc6 +10d8 10e5 5dc5 5dc7 +10e6 10d8 5dc6 5dc7 +10d9 10e4 5dc2 5dc8 +10e5 10d9 5dc5 5dc8 +10da 10db 5db2 5dc9 +10e1 10da 5dbb 5dca +10da 10e7 5dc9 5dcb +10e8 10da 5dca 5dcb +10db 10e6 5dc6 5dcc +10e7 10db 5dc9 5dcd +10db 10e9 5dcc 5dcd +10dc 10dd 5db5 5dce +10dc 10ea 5dce 5dd0 +10dd 10e3 5dc0 5dd1 +10ea 10dd 5dce 5dd3 +10dd 10eb 5dd1 5dd2 +10dd 10ec 5dd2 5dd3 +10df 10de 5db9 5dd4 +10de 10e2 5dbd 5dd5 +10ed 10de 5dd4 5dd6 +10de 10ee 5dd5 5dd6 +10e3 10df 5dc1 5dd7 +10df 10ed 5dd4 5dd8 +10ef 10df 5dd7 5dd8 +10e0 10e1 5dbc 5dd9 +10e2 10e0 5dbe 5dda +10e0 10f0 5dd9 5dda +10e1 10e8 5dca 5ddb +10f0 10e1 5dd9 5ddc +10e1 10f1 5ddb 5ddc +10ee 10e2 5dd5 5ddf +10e2 10f0 5dda 5ddd +10e2 10f2 5ddd 5dde +10e2 10f3 5dde 5ddf +10eb 10e3 5dd1 5de1 +10e3 10ef 5dd7 5de0 +10e3 10f4 5de0 5de1 +10e5 10e4 5dc8 5de3 +10e4 10f5 5de2 5de4 +10f6 10e4 5de3 5de4 +10e6 10e5 5dc7 5de6 +10e5 10f6 5de3 5de7 +10f7 10e5 5de6 5de8 +10e5 10f8 5de7 5de8 +10e9 10e6 5dcc 5de9 +10e6 10f7 5de6 5de9 +10e8 10e7 5dcb 5deb +10e7 10e9 5dcd 5dea +10e7 10f9 5dea 5deb +10f1 10e8 5ddb 5df0 +10e8 10f9 5deb 5def +10e8 10fc 5def 5df1 +10fd 10e8 5df0 5df1 +10e9 10f7 5de9 5ded +10f9 10e9 5dea 5dec +10fa 10e9 5dec 5dee +10e9 10fb 5ded 5dee +10ea 10ec 5dd3 77d7 +10ea 1e84 77d7 77db +1e86 10ea 77da 77db +10ec 10eb 5dd2 77ca +10eb 10f4 5de1 77bd +10eb 1e7d 77bd 77ca +10ec 1e7d 77ca 77cc +10ec 1e80 77cc 77d6 +10ec 1e84 77d6 77d7 +10ed 10ee 5dd6 77bb +10ef 10ed 5dd8 77b2 +1e77 10ed 77b2 77b5 +1e7a 10ed 77b5 77bb +10ee 10f3 5ddf 77c9 +1e7a 10ee 77bb 77c1 +1e7f 10ee 77c1 77c9 +10f4 10ef 5de0 77b3 +1e77 10ef 77b1 77b2 +10ef 1e78 77b1 77b3 +10f0 10f1 5ddc 7378 +10f2 10f0 5ddd 737f +10f0 1c25 7378 737f +10f1 10fd 5df0 7377 +1c25 10f1 7378 7379 +10f1 1c6f 7377 7379 +10f3 10f2 5dde 738e +10f2 1c25 737f 7385 +10f2 1c73 7385 738e +10f3 1c73 738e 77d5 +1e7f 10f3 77c9 77d0 +1e82 10f3 77d0 77d5 +10f4 1e78 77b3 77b9 +10f4 1e7c 77b9 77bc +10f4 1e7d 77bc 77bd +10f6 10f5 5de4 70a0 +1b09 10f5 709d 709e +10f5 1b0a 709d 70a0 +10f8 10f6 5de7 70a9 +1b0a 10f6 709f 70a0 +10f6 1b0e 709f 70a9 +10f7 10f8 5de8 7373 +10fb 10f7 5ded 7372 +1b17 10f7 7372 7373 +10f8 1b0e 70a9 70aa +10f8 1b11 70aa 70b3 +10f8 1b17 70b3 7373 +10f9 10fa 5dec 7370 +10fc 10f9 5def 7371 +10f9 1c6e 7370 7371 +10fa 10fb 5dee 7374 +10fa 1b22 736e 736f +1b25 10fa 736e 7374 +10fa 1c6b 736f 7375 +1c6e 10fa 7370 7375 +10fb 1b17 7372 7376 +1b25 10fb 7374 7376 +10fd 10fc 5df1 737a +10fc 1c6e 7371 737b +1c70 10fc 737a 737c +10fc 1c71 737b 737d +1c72 10fc 737c 737d +1c6f 10fd 7377 737e +10fd 1c70 737a 737e +10ff 10fe 5df2 5df3 +10fe 1100 5df2 5df4 +1101 10fe 5df3 5df5 +10fe 1102 5df4 5df6 +1103 10fe 5df5 5df7 +10fe 1104 5df6 5df8 +1105 10fe 5df7 5df8 +1100 10ff 5df2 5df9 +10ff 1101 5df3 5dfa +1106 10ff 5df9 5dfb +10ff 1107 5dfa 5dfc +1108 10ff 5dfb 5dfc +1102 1100 5df4 5dfd +1100 1106 5df9 5dfe +1109 1100 5dfd 5dfe +1101 1103 5df5 5dff +1107 1101 5dfa 5e00 +1101 110a 5dff 5e01 +110b 1101 5e00 5e01 +1104 1102 5df6 5e02 +1102 1109 5dfd 5e03 +110c 1102 5e02 5e04 +1102 110d 5e03 5e05 +110e 1102 5e04 5e05 +1103 1105 5df7 5e06 +110a 1103 5dff 5e07 +1103 110f 5e06 5e07 +1105 1104 5df8 5e08 +1104 110c 5e02 5e09 +1110 1104 5e08 5e09 +110f 1105 5e06 5e0a +1105 1110 5e08 5e0b +1111 1105 5e0a 5e0c +1105 1112 5e0b 5e0c +1106 1108 5dfb 5e0d +1109 1106 5dfe 5e0e +1106 1113 5e0d 5e0f +1114 1106 5e0e 5e10 +1106 1115 5e0f 5e10 +1108 1107 5dfc 5e11 +1107 110b 5e00 5e12 +1116 1107 5e11 5e13 +1107 1117 5e12 5e14 +1118 1107 5e13 5e14 +1113 1108 5e0d 5e15 +1108 1116 5e11 5e15 +110d 1109 5e03 5e16 +1109 1114 5e0e 5e17 +1119 1109 5e16 5e18 +1109 111a 5e17 5e18 +110b 110a 5e01 5e19 +110a 110f 5e07 5e1a +111b 110a 5e19 5e1b +110a 111c 5e1a 5e1b +1117 110b 5e12 5e1c +110b 111b 5e19 5e1d +111d 110b 5e1c 5e1d +110c 110e 5e04 5e1e +1110 110c 5e09 5e1f +110c 111e 5e1e 5e20 +111f 110c 5e1f 5e21 +110c 1120 5e20 5e21 +110e 110d 5e05 5e22 +110d 1119 5e16 5e23 +1121 110d 5e22 5e23 +111e 110e 5e1e 5e24 +110e 1121 5e22 5e24 +110f 1111 5e0a 5e25 +111c 110f 5e1a 5e26 +110f 1122 5e25 5e26 +1112 1110 5e0b 5e27 +1110 111f 5e1f 5e27 +1111 1112 5e0c 5e28 +1122 1111 5e25 5e2a +1111 1123 5e28 5e2b +1124 1111 5e2a 5e2b +1112 111f 5e27 5e29 +1123 1112 5e28 5e29 +1115 1113 5e0f 5e2c +1113 1116 5e15 5e2d +1125 1113 5e2c 5e2e +1113 1126 5e2d 5e2e +1114 1115 5e10 5e2f +111a 1114 5e17 5e30 +1114 1127 5e2f 5e30 +1115 1125 5e2c 5e31 +1127 1115 5e2f 5e32 +1115 1128 5e31 5e32 +1116 1118 5e13 5e33 +1126 1116 5e2d 5e34 +1116 1129 5e33 5e34 +1118 1117 5e14 5e35 +1117 111d 5e1c 5e36 +112a 1117 5e35 5e37 +1117 112b 5e36 5e37 +1129 1118 5e33 5e38 +1118 112a 5e35 5e39 +112c 1118 5e38 5e39 +1119 111a 5e18 5e3a +1121 1119 5e23 5e3b +1119 112d 5e3a 5e3c +112e 1119 5e3b 5e3c +111a 1127 5e30 5e3d +112d 111a 5e3a 5e3e +111a 112f 5e3d 5e3e +111b 111c 5e1b 5e3f +111d 111b 5e1d 5e40 +111b 1130 5e3f 5e41 +1131 111b 5e40 5e42 +111b 1132 5e41 5e42 +111c 1122 5e26 5e43 +1130 111c 5e3f 5e44 +111c 1133 5e43 5e44 +112b 111d 5e36 5e45 +111d 1131 5e40 5e45 +1120 111e 5e20 5e46 +111e 1121 5e24 5e47 +1134 111e 5e46 5e48 +111e 1135 5e47 5e49 +1136 111e 5e48 5e49 +111f 1120 5e21 5e4a +1123 111f 5e29 5e4b +111f 1137 5e4a 5e4c +1138 111f 5e4b 5e4c +1120 1134 5e46 5e4d +1137 1120 5e4a 5e4d +1121 112e 5e3b 5e4e +1135 1121 5e47 5e4f +1121 1139 5e4e 5e4f +1122 1124 5e2a 5e50 +1133 1122 5e43 5e51 +1122 113a 5e50 5e51 +1124 1123 5e2b 5e52 +1123 1138 5e4b 8851 +113b 1123 5e52 86ba +2698 1123 86ba 8851 +113a 1124 5e50 5e54 +1124 113b 5e52 5e53 +1124 113c 5e53 5e54 +1125 1126 5e2e 5e55 +1128 1125 5e31 5e56 +1125 113d 5e55 5e57 +113e 1125 5e56 5e57 +1126 1129 5e34 5e58 +113d 1126 5e55 5e59 +1126 113f 5e58 5e59 +1127 1128 5e32 5e5a +112f 1127 5e3d 5e5b +1127 1140 5e5a 5e5b +1128 113e 5e56 5e5c +1140 1128 5e5a 5e5c +1129 112c 5e38 5e5d +113f 1129 5e58 5e5d +112a 112b 5e37 5e5f +112c 112a 5e39 5e5e +1141 112a 5e5e 5e5f +112b 1131 5e45 5e63 +1141 112b 5e5f 5e62 +1143 112b 5e62 5e64 +112b 1144 5e63 5e64 +113f 112c 5e5d 5e60 +112c 1141 5e5e 5e61 +1142 112c 5e60 5e61 +112e 112d 5e3c 5e65 +112d 112f 5e3e 5e66 +1145 112d 5e65 5e67 +112d 1146 5e66 5e67 +1139 112e 5e4e 5e68 +112e 1145 5e65 5e69 +1147 112e 5e68 5e69 +112f 1140 5e5b 5e6a +1146 112f 5e66 5e6b +112f 1148 5e6a 5e6b +1132 1130 5e41 5ed4 +1130 1133 5e44 5ecd +1130 1179 5ecd 5ed4 +1131 1132 5e42 5ed9 +1144 1131 5e63 5ee0 +1131 117f 5ed9 5ee0 +1132 1179 5ed4 5ed5 +1132 117d 5ed5 5ed8 +1132 117f 5ed8 5ed9 +1133 113a 5e51 5ec7 +1133 1176 5ec7 5ec9 +1133 1177 5ec9 5ecc +1133 1179 5ecc 5ecd +1134 1136 5e48 872e +1137 1134 5e4d 8730 +2583 1134 8518 872e +1134 2586 8518 8730 +1136 1135 5e49 872a +1135 1139 5e4f 5ebd +1135 1172 5ebd 884b +2694 1135 872a 884b +1136 2583 8516 872e +2584 1136 8516 872c +1136 2694 872a 872c +1138 1137 5e4c 8732 +2586 1137 851a 8730 +1137 2588 851a 8732 +1138 2588 8732 8733 +258a 1138 86b8 8733 +1138 2698 86b8 8851 +1139 1147 5e68 5ebe +1172 1139 5ebd 5ebf +1139 1173 5ebe 5ebf +113a 113c 5e54 5ec3 +113a 1175 5ec3 5ec5 +113a 1176 5ec5 5ec7 +113c 113b 5e53 5ec0 +1174 113b 5ec0 8738 +113b 2698 86ba 886f +26b6 113b 8738 886f +113c 1174 5ec0 5ec1 +113c 1175 5ec1 5ec3 +113e 113d 5e57 5e6e +113d 113f 5e59 5e6d +1149 113d 5e6c 5e6d +113d 114a 5e6c 5e6e +1140 113e 5e5c 5e78 +113e 114a 5e6e 5e72 +113e 114d 5e72 5e77 +113e 1150 5e77 5e78 +113f 1142 5e60 5e76 +1149 113f 5e6d 5e70 +114c 113f 5e70 5e76 +1148 1140 5e6a 5e8c +1140 1150 5e78 5e89 +1140 115a 5e89 5e8b +1140 115b 5e8b 5e8c +1142 1141 5e61 5e87 +1141 1143 5e62 5ea0 +1159 1141 5e87 5e9f +1163 1141 5e9f 5ea0 +114c 1142 5e76 5e7c +1153 1142 5e7c 5e86 +1158 1142 5e86 5e88 +1142 1159 5e87 5e88 +1143 1144 5e64 5eed +1163 1143 5ea0 5eff +1143 1189 5eed 5eff +1144 117f 5ee0 5ee2 +1144 1183 5ee2 5eec +1144 1189 5eec 5eed +1145 1146 5e67 76bd +1147 1145 5e69 76c4 +1145 1e0d 76bd 76c4 +1146 1148 5e6b 5eaa +1146 1167 5eaa 76b2 +1146 1e0b 76b2 76b9 +1146 1e0d 76b9 76bd +1173 1147 5ebe 76c5 +1e0d 1147 76c3 76c4 +1147 1e0f 76c3 76c5 +1148 115b 5e8c 5ea7 +1148 1167 5ea7 5eaa +114a 1149 5e6c 5e6f +114b 1149 5e6f 5e71 +1149 114c 5e70 5e71 +114a 114b 5e6f 5e73 +114d 114a 5e72 5e74 +114a 114e 5e73 5e75 +114f 114a 5e74 5e75 +114b 114c 5e71 5e79 +114e 114b 5e73 5e7a +114b 1151 5e79 5e7b +1152 114b 5e7a 5e7b +1151 114c 5e79 5e7d +114c 1153 5e7c 5e7d +114d 114f 5e74 5e7e +1150 114d 5e77 5e7f +114d 1154 5e7e 5e80 +1155 114d 5e7f 5e80 +114f 114e 5e75 5e81 +114e 1152 5e7a 5e82 +1156 114e 5e81 5e83 +114e 1157 5e82 5e84 +1154 114f 5e7e 5e85 +114f 1156 5e81 5e85 +1150 1155 5e7f 5e8a +115a 1150 5e89 5e8a +1152 1151 5e7b 5e8d +1151 1153 5e7d 5e8e +115c 1151 5e8d 5e8e +1157 1152 5e82 5e8f +1152 115c 5e8d 5e90 +115d 1152 5e8f 5e90 +1153 1158 5e86 5e91 +115c 1153 5e8e 5e92 +1153 115e 5e91 5e92 +1155 1154 5e80 5e93 +1154 1156 5e85 5e94 +115f 1154 5e93 5e94 +115a 1155 5e8a 5e95 +1155 115f 5e93 5e96 +1160 1155 5e95 5e97 +1155 1161 5e96 5e97 +115f 1156 5e94 5e9a +1156 1162 5e99 5e9a +1157 115d 5e8f 5e9c +1158 1159 5e88 5ea1 +115e 1158 5e91 5ea2 +1158 1164 5ea1 5ea3 +1165 1158 5ea2 5ea3 +1159 1163 5e9f 5ea4 +1164 1159 5ea1 5ea4 +115b 115a 5e8b 5ea5 +115a 1160 5e95 5ea6 +1166 115a 5ea5 5ea6 +115b 1166 5ea5 5ea8 +1167 115b 5ea7 5ea9 +115b 1168 5ea8 5ea9 +115d 115c 5e90 5eab +115c 115e 5e92 5eac +1169 115c 5eab 5ead +115c 116a 5eac 5ead +115d 1169 5eab 5eb0 +116b 115d 5eaf 5eb0 +115e 1165 5ea2 5eb1 +116a 115e 5eac 5eb1 +1161 115f 5e96 5eb5 +115f 1162 5e9a 5eb4 +115f 116d 5eb4 5eb5 +1160 1161 5e97 5eb8 +1166 1160 5ea6 5eb9 +1160 116f 5eb8 5eba +1170 1160 5eb9 5eba +1161 116d 5eb5 5ebb +116f 1161 5eb8 5ebc +1161 1171 5ebb 5ebc +1162 116c 5eb2 5eb6 +116d 1162 5eb4 5eb7 +1162 116e 5eb6 5eb7 +1164 1163 5ea4 6a56 +1163 1189 5eff 6a58 +17a3 1163 6a56 6a58 +1165 1164 5ea3 6a59 +1164 1284 6a50 6a59 +1164 17a1 6a4f 6a50 +17a3 1164 6a4f 6a56 +116a 1165 5eb1 6098 +1261 1165 6094 6096 +1165 1263 6094 6098 +1284 1165 6096 6a59 +1168 1166 5ea8 76a5 +1166 1170 5eb9 76a8 +1e07 1166 76a5 76a8 +1167 1168 5ea9 76a6 +1167 1e08 76a6 76ab +1167 1e0b 76ab 76b2 +1168 1e06 769f 76a0 +1e07 1168 769f 76a5 +1168 1e08 76a0 76a6 +1169 116a 5ead 6a6b +116b 1169 5eb0 6aa6 +1169 1285 6a6b 6aa6 +116a 1263 6098 6099 +116a 1285 6099 6a6b +11aa 116b 5f2b 6aa5 +1283 116b 6aa5 6aa7 +116b 1285 6aa6 6aa7 +116e 116c 5eb6 6caa +116c 18e1 6c9e 6ca9 +116c 18e7 6ca9 6caa +116d 116e 5eb7 72e3 +1171 116d 5ebb 72e3 +1171 116e 72e3 72e4 +116e 18e7 6caa 72e0 +116e 1c1c 72e0 72e2 +116e 1c1d 72e2 72e4 +1170 116f 5eba 76b3 +116f 1171 5ebc 72ee +116f 1c21 72ee 76b3 +1c21 1170 76a9 76b3 +1e07 1170 76a8 76a9 +1171 1c1d 72e4 72eb +1171 1c21 72eb 72ee +1172 1173 5ebf 76cb +1172 1e12 76cb 884d +1172 2694 86b0 884b +2695 1172 86b0 884d +1173 1e0f 76c5 76c6 +1173 1e10 76c6 76ca +1173 1e12 76ca 76cb +1175 1174 5ec1 5ec2 +258e 1174 8739 886e +2590 1174 86bb 8739 +1174 26b6 8738 886e +1176 1175 5ec5 5ec6 +1177 1176 5ec9 5ecb +1176 1178 5eca 5ecb +1177 1178 5ecb 5ed0 +1179 1177 5ecc 5ed1 +1177 117b 5ed0 5ed1 +1178 117a 5ece 5ed3 +117b 1178 5ed0 5ed2 +117c 1178 5ed2 5ed3 +1179 117b 5ed1 5ed7 +117d 1179 5ed5 5ed6 +117e 1179 5ed6 5ed7 +117c 117a 5ed3 5eea +1186 117a 5eea 5ef0 +117b 117c 5ed2 5edd +117e 117b 5ed7 5edc +1181 117b 5edc 5edd +1181 117c 5edd 5ee6 +1186 117c 5ee6 5eea +117d 117e 5ed6 5eda +117f 117d 5ed8 5edb +117d 1180 5eda 5edb +1180 117e 5eda 5ede +117e 1181 5edc 5edf +1182 117e 5ede 5edf +117f 1180 5edb 5ee1 +117f 1183 5ee1 5ee2 +1180 1182 5ede 5ee3 +1183 1180 5ee1 5ee4 +1180 1184 5ee3 5ee5 +1185 1180 5ee4 5ee5 +1182 1181 5edf 5ee7 +1181 1186 5ee6 5ee9 +1187 1181 5ee7 5ee8 +1188 1181 5ee8 5ee9 +1184 1182 5ee3 5eeb +1182 1187 5ee7 5eeb +1183 1185 5ee4 5eee +1189 1183 5eec 5eef +1183 118a 5eee 5eef +1185 1184 5ee5 5ef2 +1184 1187 5eeb 5ef3 +118b 1184 5ef2 5ef4 +1184 118c 5ef3 5ef6 +118d 1184 5ef4 5ef5 +118e 1184 5ef5 5ef6 +118a 1185 5eee 5ef7 +1185 118b 5ef2 5ef7 +1188 1186 5ee9 5efa +1190 1186 5efa 5efb +1191 1186 5efb 5efc +1187 1188 5ee8 5ef8 +118c 1187 5ef3 5ef9 +1187 118f 5ef8 5ef9 +118f 1188 5ef8 5efe +1188 1190 5efa 5efd +1188 1192 5efd 5efe +1189 118a 5eef 6a57 +1189 17a3 6a57 6a58 +118a 118b 5ef7 6a5c +17a2 118a 6a52 6a54 +118a 17a3 6a52 6a57 +17a5 118a 6a54 6a5c +118b 118d 5ef4 6a5e +17a5 118b 6a5c 6a5e +118e 118c 5ef6 6a70 +118c 118f 5ef9 6dce +17af 118c 6a70 6dcf +118c 1988 6dce 6dcf +118d 118e 5ef5 6a64 +118d 17a5 6a5d 6a5e +17a6 118d 6a5d 6a62 +17a9 118d 6a62 6a64 +17a9 118e 6a64 6a6c +17ad 118e 6a6c 6a6f +17af 118e 6a6f 6a70 +118f 1192 5efe 6dcc +118f 1988 6dcc 6dce +1190 1191 5efb 6dca +1192 1190 5efd 6db7 +1190 1980 6db6 6db7 +1986 1190 6db6 6dca +1986 1191 6dca 6dcb +1980 1192 6db5 6db7 +1192 1981 6db5 6db9 +1192 1988 6db9 6dcc +1193 1194 5f01 5f05 +1195 1193 5f03 5f06 +1193 1196 5f05 5f06 +1196 1194 5f05 5f08 +1194 1197 5f07 5f09 +1198 1194 5f08 5f09 +1195 1196 5f06 5f0c +1199 1195 5f0b 5f0d +1195 119a 5f0c 5f0d +1196 1198 5f08 5f10 +119a 1196 5f0c 5f11 +1196 119b 5f10 5f12 +119c 1196 5f11 5f12 +1198 1197 5f09 5f15 +1197 119d 5f13 5f16 +119e 1197 5f15 5f17 +1197 119f 5f16 5f17 +119b 1198 5f10 5f18 +1198 119e 5f15 5f19 +11a0 1198 5f18 5f19 +1199 119a 5f0d 5f1a +1199 11a1 5f1a 5f1c +11a2 1199 5f1b 5f1c +119a 119c 5f11 5f1d +11a1 119a 5f1a 5f1d +119c 119b 5f12 5f20 +119b 11a0 5f18 5f21 +11a4 119b 5f20 5f22 +119b 11a5 5f21 5f22 +11a1 119c 5f1d 5f23 +119c 11a4 5f20 5f24 +11a6 119c 5f23 5f24 +119f 119d 5f16 5f27 +119d 11a7 5f25 5f29 +11a8 119d 5f27 5f28 +11a9 119d 5f28 5f29 +119e 119f 5f17 5f2f +11a0 119e 5f19 5f30 +119e 11ac 5f2f 5f31 +11ad 119e 5f30 5f31 +119f 11a8 5f27 5f32 +11ac 119f 5f2f 5f32 +11a5 11a0 5f21 5f33 +11a0 11ad 5f30 5f34 +11ae 11a0 5f33 5f34 +11a2 11a1 5f1c 5f35 +11a1 11a6 5f23 5f37 +11af 11a1 5f35 5f36 +11b0 11a1 5f36 5f37 +11a3 11a2 5f1e 5f38 +11a2 11af 5f35 5f38 +11a3 11af 5f38 5f3a +11b1 11a3 5f39 5f3b +11a3 11b2 5f3a 5f3b +11a4 11a5 5f22 5fbf +11a6 11a4 5f24 5faf +11ff 11a4 5faf 5fbe +1207 11a4 5fbe 5fbf +11a5 11ae 5f33 60f9 +1207 11a5 5fbf 60fb +11a5 12b4 60f9 60fb +11b0 11a6 5f37 5fac +11fd 11a6 5fac 5fae +11fe 11a6 5fae 5fb0 +11a6 11ff 5faf 5fb0 +11a9 11a7 5f29 608a +11a7 11ab 5f2d 608c +1260 11a7 608a 608c +11a8 11a9 5f28 6062 +11ac 11a8 5f32 6089 +1258 11a8 6061 6062 +11a8 125b 6061 6067 +11a8 126d 6067 6089 +1258 11a9 6062 6063 +1260 11a9 6063 608a +11ab 11aa 5f2e 6aa4 +1283 11aa 6aa4 6aa5 +125f 11ab 608b 6093 +11ab 1260 608b 608c +1283 11ab 6093 6aa4 +11ad 11ac 5f31 608f +11ac 126d 6089 608d +11ac 126e 608d 608f +11ae 11ad 5f34 6100 +126e 11ad 608e 608f +11ad 127d 608e 6100 +127d 11ae 60ff 6100 +127f 11ae 60fe 60ff +11ae 12b4 60f8 60f9 +12b5 11ae 60f8 60fe +11af 11b0 5f36 5fa5 +11b2 11af 5f3a 5fa4 +11f9 11af 5fa4 5fa6 +11af 11fa 5fa5 5fa6 +11fa 11b0 5fa5 5fad +11b0 11fd 5fac 5fad +11b1 11b2 5f3b 5fa7 +11b1 11fb 5fa7 5fab +11b2 11f9 5fa4 5fa8 +11fb 11b2 5fa7 5fa9 +11b2 11fc 5fa8 5fa9 +11b4 11b3 5f3f 62d4 +11b3 13d7 62cd 62d4 +11b4 13d7 62d4 62d5 +11b4 13dc 62d5 62d7 +11b4 13dd 62d7 62da +11b6 11b5 5f41 5f42 +11b5 11b7 5f41 5f43 +11b8 11b5 5f42 5f44 +11b5 11b9 5f43 5f45 +11ba 11b5 5f44 5f45 +11b7 11b6 5f41 5f46 +11b6 11b8 5f42 5f47 +11bb 11b6 5f46 5f48 +11b6 11bc 5f47 5f49 +11bd 11b6 5f48 5f4a +11b6 11be 5f49 5f4a +11b9 11b7 5f43 5f4b +11b7 11bb 5f46 5f4c +11bf 11b7 5f4b 5f4d +11b7 11c0 5f4c 5f4d +11b8 11ba 5f44 88e9 +11bc 11b8 5f47 5f4e +11c1 11b8 5f4e 5f4f +11c2 11b8 5f4f 8877 +11cf 11b8 8877 88e9 +11ba 11b9 5f45 84b1 +11b9 11bf 5f4b 5f50 +11b9 11c3 5f50 84ac +11b9 25a0 84ac 88ae +25a1 11b9 84b1 88ae +11ce 11ba 5f61 84b4 +11ba 11cf 5f61 88e9 +11ba 25a1 84b1 84b4 +11bb 11bd 5f48 5f51 +11c0 11bb 5f4c 5f52 +11bb 11c4 5f51 5f52 +11be 11bc 5f49 5f53 +11bc 11c1 5f4e 5f54 +11c5 11bc 5f53 5f54 +11bd 11be 5f4a 5f55 +11c4 11bd 5f51 5f56 +11bd 11c6 5f55 5f57 +11c7 11bd 5f56 5f58 +11bd 11c8 5f57 5f58 +11be 11c5 5f53 5f59 +11c6 11be 5f55 5f59 +11bf 11c0 5f4d 5f5a +11c3 11bf 5f50 5f5b +11bf 11c9 5f5a 5f5b +11c0 11c4 5f52 5f5c +11c9 11c0 5f5a 5f5d +11c0 11ca 5f5c 5f5d +11c1 11c2 5f4f 5f5e +11c5 11c1 5f54 5f5f +11c1 11cb 5f5e 887d +11cc 11c1 5f5f 5f60 +11cd 11c1 5f60 887d +11cb 11c2 5f5e 88e4 +11c2 11cf 8877 88e8 +25a2 11c2 84b9 88e8 +11c2 25a3 84b9 88e4 +11c3 11c9 5f5b 5f6f +11c3 11d8 5f6f 88a9 +259f 11c3 88a7 88a9 +25a0 11c3 84ac 88a7 +11c4 11c7 5f56 5f62 +11ca 11c4 5f5c 5f63 +11c4 11d0 5f62 5f64 +11d1 11c4 5f63 5f64 +11c6 11c5 5f59 5f65 +11c5 11cc 5f5f 5f66 +11d2 11c5 5f65 5f66 +11c8 11c6 5f57 5f67 +11c6 11d2 5f65 5f68 +11d3 11c6 5f67 5f69 +11c6 11d4 5f68 5f69 +11c7 11c8 5f58 5f6a +11d0 11c7 5f62 5f6b +11c7 11d5 5f6a 5f6c +11d6 11c7 5f6b 5f6c +11c8 11d3 5f67 5f6d +11d5 11c8 5f6a 5f6d +11c9 11ca 5f5d 5f6e +11c9 11d7 5f6e 5f71 +11d8 11c9 5f6f 5f70 +11d9 11c9 5f70 5f71 +11ca 11d1 5f63 5f72 +11d7 11ca 5f6e 5f73 +11ca 11da 5f72 5f73 +11cb 11cd 84ba 887d +25a3 11cb 88ac 88e4 +11cb 25a5 88ac 88e5 +25a6 11cb 84ba 88e5 +11cc 11cd 5f60 5f75 +11d2 11cc 5f66 5f78 +11cc 11dc 5f75 5f78 +11dc 11cd 5f75 5f76 +11dd 11cd 5f76 5f77 +11de 11cd 5f77 891b +11cd 25a6 84ba 891b +11cf 11ce 5f61 88d0 +22cb 11ce 88af 88d1 +22cc 11ce 84b2 88af +11ce 25a1 84b4 88d1 +11ce 25a2 84b2 88d0 +11cf 25a2 88d0 88e8 +11d1 11d0 5f64 5f79 +11d0 11d6 5f6b 5f7a +11df 11d0 5f79 5f7a +11da 11d1 5f72 5f7b +11d1 11df 5f79 5f7c +11e0 11d1 5f7b 5f7c +11d4 11d2 5f68 5f7d +11d2 11dc 5f78 5f7e +11e1 11d2 5f7d 5f7e +11d3 11d4 5f69 5f7f +11d5 11d3 5f6d 5f80 +11d3 11e2 5f7f 5f80 +11d4 11e1 5f7d 5f81 +11e2 11d4 5f7f 5f82 +11d4 11e3 5f81 5f82 +11d6 11d5 5f6c 5f83 +11d5 11e2 5f80 5f84 +11e4 11d5 5f83 5f86 +11d5 11e5 5f84 5f85 +11d5 11e6 5f85 5f86 +11df 11d6 5f7a 5f88 +11d6 11e4 5f83 5f87 +11d6 11e7 5f87 5f88 +11d9 11d7 5f71 5f89 +11d7 11da 5f73 5f8a +11e8 11d7 5f89 5f8a +11d8 11d9 5f70 5f74 +11d8 11db 5f74 84ad +11d8 259e 84ad 88ab +259f 11d8 88a9 88ab +11db 11d9 5f74 5f8b +11d9 11e8 5f89 5f8c +11e9 11d9 5f8b 5f8d +11d9 11ea 5f8c 5f8d +11da 11e0 5f7b 5f8e +11e8 11da 5f8a 5f8f +11da 11eb 5f8e 5f90 +11ec 11da 5f8f 5f90 +11db 11e9 5f8b 84ab +11db 259e 84ab 84ad +11dc 11dd 5f76 5f91 +11e1 11dc 5f7e 5f92 +11dc 11ed 5f91 5f92 +11dd 11de 5f77 5f93 +11ed 11dd 5f91 5f94 +11dd 11ee 5f93 5f94 +11ee 11de 5f93 5f95 +11ef 11de 5f95 5f96 +11f0 11de 5f96 84bb +25a6 11de 84bb 891b +11e0 11df 5f7c 6b20 +11df 11e7 5f88 6b1d +11df 1809 6b1f 6b20 +11df 180b 6b1d 6b1f +11eb 11e0 5f8e 6b26 +11e0 1809 6b20 6b21 +11e0 180c 6b21 6b26 +11e3 11e1 5f81 5f9c +11e1 11ed 5f92 5f98 +11e1 11f3 5f98 5f9c +11e2 11e3 5f82 60c4 +11e5 11e2 5f84 60c6 +11e2 1294 60c4 60c6 +11e3 11f3 5f9c 6002 +11e3 122e 6002 60b3 +11e3 1294 60b3 60c4 +11e4 11e6 5f86 6b15 +11e7 11e4 5f87 6b14 +1806 11e4 6b14 6b15 +11e6 11e5 5f85 60df +1294 11e5 60c5 60c6 +11e5 1296 60c5 60c9 +11e5 12a0 60c9 60df +11e6 12a0 60df 60e2 +11e6 12a9 60e2 6b13 +11e6 1806 6b13 6b15 +1806 11e7 6b12 6b14 +11e7 1808 6b12 6b19 +11e7 180b 6b19 6b1d +11ea 11e8 5f8c 70d4 +11e8 11ec 5f8f 70d5 +1b28 11e8 70d4 70d5 +11e9 11ea 5f8d 70d6 +11e9 1b27 70d6 84a7 +11e9 2599 84a7 8898 +259d 11e9 84a9 8898 +11e9 259e 84a9 84ab +11ea 1993 70cc 70cd +11ea 1b27 70cd 70d6 +1b28 11ea 70cc 70d4 +11ec 11eb 5f90 70d1 +11eb 180c 6b26 6b27 +11eb 180e 6b27 6b2b +11eb 1810 6b2b 70d1 +1810 11ec 70d0 70d1 +11ec 1b28 70d0 70d5 +11ed 11ee 5f94 5f99 +11f3 11ed 5f98 5f9b +11ed 11f4 5f99 5f9a +11ed 11f5 5f9a 5f9b +11ee 11ef 5f95 5f9d +11f4 11ee 5f99 5f9f +11ee 11f6 5f9d 5f9e +11ee 11f7 5f9e 5f9f +11ef 11f0 5f96 5fa0 +11ef 11f1 5fa0 5fa2 +11f6 11ef 5f9d 5fa1 +11f8 11ef 5fa1 5fa2 +11f0 11f1 5f97 5fa0 +11f2 11f0 5f97 88c3 +11f0 25a6 84bb 88c3 +11f1 11f2 5f97 88fb +11f8 11f1 5fa2 5fcd +120f 11f1 5fcd 88fd +11f1 2445 8214 88fd +2446 11f1 8214 88fb +20e0 11f2 887c 891c +11f2 20e2 887c 88c2 +11f2 2446 88c2 88fb +11f2 25a4 84b7 891c +25a5 11f2 84b7 891a +11f2 25a6 88c3 891a +11f3 11f5 5f9b 5ffe +11f3 122b 5ffe 6001 +11f3 122e 6001 6002 +11f5 11f4 5f9a 5fec +11f4 11f7 5f9f 5fde +11f4 121a 5fde 5feb +11f4 1222 5feb 5fec +11f5 1222 5fec 5ffb +11f5 122b 5ffb 5ffe +11f7 11f6 5f9e 5fd3 +11f6 11f8 5fa1 5fcb +11f6 120e 5fcb 5fce +11f6 1210 5fce 5fd3 +11f7 1210 5fd3 5fd5 +11f7 1215 5fd5 5fdd +11f7 121a 5fdd 5fde +120e 11f8 5fcb 5fcc +120f 11f8 5fcc 5fcd +11f9 11fa 5fa6 5fb1 +11fc 11f9 5fa8 5fb2 +11f9 1200 5fb1 5fb2 +11fa 11fd 5fad 5fb3 +1200 11fa 5fb1 5fb4 +11fa 1201 5fb3 5fb5 +1202 11fa 5fb4 5fb5 +11fb 11fc 5fa9 5fb6 +11fb 1203 5fb6 5fb8 +1204 11fb 5fb7 5fb8 +11fc 1200 5fb2 5fb9 +1203 11fc 5fb6 5fba +11fc 1205 5fb9 5fba +11fd 11fe 5fae 5fbc +1201 11fd 5fb3 5fbd +11fd 1206 5fbc 5fbd +11fe 11ff 5fb0 5fc0 +1206 11fe 5fbc 5fc3 +11fe 1208 5fc0 5fc3 +11ff 1207 5fbe 5fc1 +1208 11ff 5fc0 5fc2 +11ff 1209 5fc1 5fc2 +1200 1202 5fb4 5fc4 +1205 1200 5fb9 5fc5 +1200 120a 5fc4 5fc5 +1202 1201 5fb5 5fc6 +1201 1206 5fbd 5fca +120b 1201 5fc6 5fca +120a 1202 5fc4 5fc7 +1202 120b 5fc6 5fc9 +120c 1202 5fc7 5fc8 +120d 1202 5fc8 5fc9 +1204 1203 5fb8 62c4 +1203 1205 5fba 62c8 +13d5 1203 62c4 62c7 +13d6 1203 62c7 62c8 +13d4 1204 62c3 62c5 +1204 13d5 62c4 62c5 +1205 120a 5fc5 62ce +13d6 1205 62c8 62ce +1206 1208 5fc3 6126 +120b 1206 5fca 65e2 +1206 12ca 6126 65e2 +1209 1207 5fc1 6106 +1207 12b4 60fb 60fd +1207 12b7 60fd 6106 +1208 1209 5fc2 6113 +1208 12c1 6113 6123 +1208 12c9 6123 6125 +1208 12ca 6125 6126 +1209 12b7 6106 6108 +1209 12bb 6108 6112 +1209 12c1 6112 6113 +120a 120c 5fc7 62dd +13d6 120a 62ce 62d1 +13db 120a 62d1 62dd +120d 120b 5fc9 65ab +12ca 120b 65ac 65e2 +155b 120b 65aa 65ac +120b 155c 65aa 65ab +120c 120d 5fc8 62f9 +13db 120c 62dd 62e1 +13e1 120c 62e1 62f8 +13ed 120c 62f8 62f9 +13ed 120d 62f9 65a9 +120d 155a 65a6 65a9 +155c 120d 65a6 65ab +120e 120f 5fcc 5fcf +1210 120e 5fce 5fd0 +120e 1211 5fcf 5fd1 +1212 120e 5fd0 5fd2 +120e 1213 5fd1 5fd2 +1211 120f 5fcf 8216 +2444 120f 8216 895a +120f 2445 88fd 895a +1210 1212 5fd0 5fd4 +1210 1214 5fd4 5fd6 +1215 1210 5fd5 5fd6 +1213 1211 5fd1 5fd7 +1216 1211 5fd7 8211 +2444 1211 8211 8216 +1212 1213 5fd2 5fd8 +1214 1212 5fd4 5fd9 +1212 1217 5fd8 5fda +1218 1212 5fd9 5fda +1213 1216 5fd7 5fdb +1217 1213 5fd8 5fdc +1213 1219 5fdb 5fdc +1215 1214 5fd6 5fdf +1214 1218 5fd9 5fe0 +121b 1214 5fdf 5fe1 +1214 121c 5fe0 5fe1 +121a 1215 5fdd 5fe2 +1215 121b 5fdf 5fe2 +1219 1216 5fdb 5fe3 +121d 1216 5fe3 7f0d +22d1 1216 7f0d 8976 +1216 2444 8211 8976 +1218 1217 5fda 5fe4 +1217 1219 5fdc 5fe5 +121e 1217 5fe4 5fe5 +121c 1218 5fe0 5fe6 +1218 121e 5fe4 5fe7 +121f 1218 5fe6 5fe8 +1218 1220 5fe7 5fe8 +1219 121d 5fe3 5fea +121e 1219 5fe5 5fe9 +1221 1219 5fe9 5fea +121a 121b 5fe2 5fed +1222 121a 5feb 5fee +121a 1223 5fed 5fee +121b 121c 5fe1 5fef +1223 121b 5fed 5ff0 +121b 1224 5fef 5ff0 +121c 121f 5fe6 5ff1 +1224 121c 5fef 5ff2 +121c 1225 5ff1 5ff2 +1221 121d 5fea 897e +20e4 121d 7bc3 8994 +121d 20e5 7bc3 7f12 +121d 22d1 7f0d 8994 +121d 22d2 7f12 897e +1220 121e 5fe7 5ff3 +121e 1221 5fe9 5ff4 +1226 121e 5ff3 5ff4 +121f 1220 5fe8 5ff5 +1225 121f 5ff1 5ff8 +121f 1227 5ff5 5ff9 +1229 121f 5ff8 5ffa +121f 122a 5ff9 5ffa +1220 1226 5ff3 5ff6 +1227 1220 5ff5 5ff7 +1220 1228 5ff6 5ff7 +1226 1221 5ff4 7f0f +22d2 1221 7f0f 897e +1222 1223 5fee 5ffc +122b 1222 5ffb 5ffd +1222 122c 5ffc 5ffd +1223 1224 5ff0 6000 +122c 1223 5ffc 5fff +122d 1223 5fff 6000 +1224 1225 5ff2 60d2 +122d 1224 6000 60bb +1297 1224 60bb 60cc +12a2 1224 60cc 60d2 +1225 1229 5ff8 60e6 +12a2 1225 60d2 60e4 +12aa 1225 60e4 60e6 +1228 1226 5ff6 6b2e +1811 1226 6b2e 7f13 +1226 22d2 7f0f 7f13 +1227 1228 5ff7 6b2f +122a 1227 5ff9 6b33 +1227 13cf 6b30 6b32 +1227 1812 6b2f 6b30 +1227 1816 6b32 6b33 +1811 1228 6b2c 6b2e +1228 1812 6b2c 6b2f +1229 122a 5ffa 6b38 +12aa 1229 60e6 6b3f +1229 12ac 6b3d 6b3f +1229 1817 6b38 6b3d +122a 1816 6b33 6b35 +122a 1817 6b35 6b38 +122b 122c 5ffd 60a6 +122e 122b 6001 60a8 +122b 128c 60a6 60a8 +122c 122d 5fff 60ac +122c 128c 60a5 60a6 +128d 122c 60a5 60ab +1290 122c 60ab 60ac +1290 122d 60ac 60b7 +1297 122d 60b7 60bb +122e 128c 60a8 60aa +122e 128f 60aa 60b2 +122e 1294 60b2 60b3 +1230 122f 6003 6004 +122f 1231 6003 6005 +1232 122f 6004 6006 +122f 1233 6005 6007 +1234 122f 6006 6008 +122f 1235 6007 6008 +1231 1230 6003 6009 +1230 1232 6004 600a +1236 1230 6009 600b +1230 1237 600a 600c +1238 1230 600b 600c +1233 1231 6005 600d +1231 1236 6009 600e +1239 1231 600d 600f +1231 123a 600e 600f +1232 1234 6006 6010 +1237 1232 600a 6011 +1232 123b 6010 6012 +123c 1232 6011 6013 +1232 123d 6012 6013 +1235 1233 6007 6014 +1233 1239 600d 6015 +123e 1233 6014 6016 +1233 123f 6015 6017 +1240 1233 6016 6017 +1234 1235 6008 6018 +123b 1234 6010 6019 +1234 1241 6018 6019 +1235 123e 6014 601a +1241 1235 6018 601b +1235 1242 601a 601b +1236 1238 600b 601c +123a 1236 600e 601d +1236 1243 601c 601e +1244 1236 601d 601e +1238 1237 600c 601f +1237 123c 6011 6020 +1245 1237 601f 6021 +1237 1246 6020 6022 +1247 1237 6021 6022 +1243 1238 601c 6023 +1238 1245 601f 6023 +1239 123a 600f 6024 +123f 1239 6015 6025 +1239 1248 6024 6025 +123a 1244 601d 6026 +1248 123a 6024 6027 +123a 1249 6026 6028 +124a 123a 6027 6028 +123d 123b 6012 6029 +123b 1241 6019 602a +124b 123b 6029 602b +123b 124c 602a 602b +123c 123d 6013 602c +1246 123c 6020 602d +123c 124d 602c 602e +124e 123c 602d 602e +123d 124b 6029 602f +124d 123d 602c 602f +123e 1240 6016 6030 +1242 123e 601a 6031 +123e 124f 6030 6032 +1250 123e 6031 6032 +1240 123f 6017 6033 +123f 1248 6025 6034 +1251 123f 6033 6035 +123f 1252 6034 6035 +124f 1240 6030 6037 +1240 1251 6033 6036 +1240 1253 6036 6037 +1241 1242 601b 6038 +124c 1241 602a 6039 +1241 1254 6038 603b +1255 1241 6039 603a +1256 1241 603a 603b +1242 1250 6031 603d +1254 1242 6038 603c +1257 1242 603c 603d +1244 1243 601e 603e +1243 1245 6023 603f +1258 1243 603e 6041 +1243 1259 603f 6040 +1243 125a 6040 6042 +125b 1243 6041 6042 +1249 1244 6026 6043 +1244 1258 603e 6043 +1245 1247 6021 6044 +1259 1245 603f 6045 +1245 125c 6044 6045 +1247 1246 6022 6046 +1246 124e 602d 6048 +125d 1246 6046 6049 +1246 125e 6048 6049 +125c 1247 6044 6047 +1247 125d 6046 6047 +1248 124a 6027 604a +1252 1248 6034 604a +124a 1249 6028 604b +1249 1258 6043 604c +125f 1249 604b 604d +1249 1260 604c 604d +1252 124a 604a 604e +124a 125f 604b 604f +1261 124a 604e 6050 +124a 1262 604f 6051 +1263 124a 6050 6051 +124b 124c 602b 6068 +124d 124b 602f 605b +126a 124b 605b 6069 +124b 126f 6068 606a +1270 124b 6069 606a +124c 1255 6039 606b +126f 124c 6068 606b +124e 124d 602e 6057 +1267 124d 6057 605c +124d 126a 605b 605c +125e 124e 6048 6058 +124e 1267 6057 6059 +1268 124e 6058 605a +124e 1269 6059 605a +1250 124f 6032 609f +124f 1253 6037 609e +124f 1288 609e 609f +1257 1250 603d 60a3 +1250 1288 609f 60a2 +1250 128a 60a2 60a4 +128b 1250 60a3 60a4 +1251 1252 6035 6091 +1253 1251 6036 609b +1251 1282 6091 609c +1286 1251 609b 609d +1251 1287 609c 609d +1252 1261 604e 6090 +1252 1282 6090 6091 +1253 1286 609b 60a0 +1288 1253 609e 60a1 +1253 1289 60a0 60a1 +1256 1254 603b 607d +1254 1257 603c 607e +127b 1254 607d 607e +1255 1256 603a 607b +126f 1255 606b 6077 +1278 1255 6077 607c +1255 127a 607b 607c +127a 1256 607b 607f +1256 127b 607d 6080 +127c 1256 607f 6080 +127b 1257 607e 6b0e +1257 128b 60a3 6b08 +1257 1805 6b08 6b0e +1258 125b 6041 6061 +1260 1258 604c 6063 +125a 1259 6040 6056 +1259 125c 6045 6052 +1259 1264 6052 6056 +125b 125a 6042 6064 +125a 1264 6056 6065 +126d 125a 6064 6066 +125a 126e 6065 6066 +125b 126d 6064 6067 +125c 125d 6047 6053 +1264 125c 6052 6054 +125c 1265 6053 6055 +1266 125c 6054 6055 +125d 125e 6049 605d +1265 125d 6053 605e +125d 126b 605d 605e +125e 1268 6058 605f +126b 125e 605d 6060 +125e 126c 605f 6060 +125f 1260 604d 608b +1262 125f 604f 6092 +1283 125f 6092 6093 +1261 1263 6050 6094 +1282 1261 6090 6095 +1284 1261 6095 6096 +1263 1262 6051 6097 +1262 1283 6092 609a +1285 1262 6097 609a +1263 1285 6097 6099 +1264 1266 6054 6081 +126e 1264 6065 6082 +1264 127d 6081 6082 +1266 1265 6055 6083 +1265 126b 605e 6088 +127e 1265 6083 6087 +1281 1265 6087 6088 +127d 1266 6081 6084 +1266 127e 6083 6086 +127f 1266 6084 6085 +1280 1266 6085 6086 +1269 1267 6059 606d +1267 126a 605c 606c +1267 1271 606c 606e +1272 1267 606d 606e +1268 1269 605a 6072 +126c 1268 605f 6075 +1268 1275 6072 6075 +1269 1272 606d 6073 +1275 1269 6072 6074 +1269 1276 6073 6074 +126a 1270 6069 606f +1271 126a 606c 6071 +126a 1273 606f 6070 +126a 1274 6070 6071 +126b 126c 6060 6447 +1281 126b 6088 612a +12cc 126b 612a 6447 +126c 1275 6075 643b +126c 12cc 6446 6447 +126c 149e 643b 6444 +126c 14a3 6444 6446 +126d 126e 6066 608d +126e 127d 6082 608e +1270 126f 606a 6076 +1277 126f 6076 6078 +126f 1278 6077 6078 +1273 1270 606f 607a +1270 1277 6076 6079 +1270 1279 6079 607a +1272 1271 606e 6434 +1271 1274 6071 619e +1271 130c 619e 619f +1271 1319 619f 6434 +1276 1272 6073 6433 +1319 1272 6433 6434 +1274 1273 6070 6187 +1273 1279 607a 6179 +1273 1300 6179 617b +1273 1304 617b 6187 +1274 1304 6187 6189 +1274 130c 6189 619e +1275 1276 6074 6436 +1275 149c 6436 643a +1275 149e 643a 643b +1276 1319 6433 6435 +1276 149b 6435 6437 +149c 1276 6436 6438 +1276 149d 6437 6438 +1277 1278 6078 60dd +1279 1277 6079 60f3 +1277 129d 60da 60db +129e 1277 60da 60dd +1277 12a6 60db 60f3 +1278 127a 607c 60de +129e 1278 60dd 60de +1279 12a5 60f0 60f2 +12a6 1279 60f0 60f3 +1279 12b1 60f2 6173 +1279 1300 6173 6179 +127a 127c 607f 60e1 +127a 129e 60dc 60de +129f 127a 60dc 60e1 +127c 127b 6080 6b1b +127b 12a9 6b10 6b1b +127b 1805 6b0e 6b10 +127c 129f 60e0 60e1 +12a0 127c 60e0 60e3 +12a9 127c 60e3 6b1b +127d 127f 6084 60ff +1280 127e 6086 611a +127e 1281 6087 611a +127f 1280 6085 610a +12b5 127f 60fe 6102 +12b9 127f 6102 6109 +12bc 127f 6109 610a +1281 1280 6116 611a +12bc 1280 610a 6116 +12bc 1281 6116 6118 +12c4 1281 6118 6129 +12cc 1281 6129 612a +1282 1284 6095 6a4e +1287 1282 609c 6a4b +17a1 1282 6a4b 6a4e +1285 1283 609a 6aa7 +17a1 1284 6a4e 6a50 +1286 1287 609d 6a4c +1289 1286 60a0 6a55 +1286 17a2 6a4c 6a51 +1286 17a4 6a51 6a55 +17a1 1287 6a4a 6a4b +1287 17a2 6a4a 6a4c +1288 1289 60a1 6a60 +128a 1288 60a2 6a65 +1288 17a8 6a60 6a65 +1289 17a4 6a55 6a5b +1289 17a6 6a5b 6a5f +1289 17a7 6a5f 6a61 +17a8 1289 6a60 6a61 +128b 128a 60a4 6b09 +128a 17a8 6a65 6a69 +128a 17ac 6a69 6b09 +17ac 128b 6b07 6b09 +1804 128b 6b06 6b07 +128b 1805 6b06 6b08 +128c 128d 60a5 60a7 +128c 128e 60a7 60a9 +128c 128f 60a9 60aa +128e 128d 60a7 60ad +128d 1290 60ab 60ae +1291 128d 60ad 60ae +128f 128e 60a9 60af +128e 1291 60ad 60b0 +1292 128e 60af 60b1 +128e 1293 60b0 60b1 +128f 1292 60af 60b4 +1294 128f 60b2 60b5 +128f 1295 60b4 60b6 +1296 128f 60b5 60b6 +1291 1290 60ae 60b8 +1290 1297 60b7 60b9 +1298 1290 60b8 60ba +1290 1299 60b9 60ba +1293 1291 60b0 60bc +1291 1298 60b8 60bd +129a 1291 60bc 60be +1291 129b 60bd 60bf +129c 1291 60be 60bf +1292 1293 60b1 60c0 +1295 1292 60b4 60c1 +1292 129d 60c0 60c2 +129e 1292 60c1 60c2 +1293 129a 60bc 60c3 +129d 1293 60c0 60c3 +1294 1296 60b5 60c5 +1296 1295 60b6 60c7 +1295 129e 60c1 60c8 +129f 1295 60c7 60c8 +1296 129f 60c7 60ca +12a0 1296 60c9 60ca +1299 1297 60b9 60cb +12a1 1297 60cb 60cd +1297 12a2 60cc 60cd +1298 1299 60ba 60ce +129b 1298 60bd 60cf +1298 12a3 60ce 60d0 +12a4 1298 60cf 60d0 +1299 12a1 60cb 60d1 +12a3 1299 60ce 60d1 +129a 129c 60be 60d3 +129d 129a 60c3 60d4 +129a 12a5 60d3 60d5 +12a6 129a 60d4 60d5 +129c 129b 60bf 60d6 +129b 12a4 60cf 60d7 +12a7 129b 60d6 60d7 +12a5 129c 60d3 60d8 +129c 12a7 60d6 60d9 +12a8 129c 60d8 60d9 +129e 129d 60c2 60da +129d 12a6 60d4 60db +129f 129e 60c8 60dc +12a0 129f 60ca 60e0 +12a9 12a0 60e2 60e3 +12a1 12a2 60cd 60e5 +12a3 12a1 60d1 60e7 +12a1 12aa 60e5 60e8 +12ab 12a1 60e7 60e9 +12a1 12ac 60e8 60e9 +12a2 12aa 60e4 60e5 +12a4 12a3 60d0 60ea +12a3 12ab 60e7 60ec +12ad 12a3 60ea 60eb +12ae 12a3 60eb 60ec +12a7 12a4 60d7 60ed +12a4 12ad 60ea 60ef +12af 12a4 60ed 60ee +12b0 12a4 60ee 60ef +12a6 12a5 60d5 60f0 +12a5 12a8 60d8 60f1 +12a5 12b1 60f1 60f2 +12a8 12a7 60d9 60f4 +12a7 12af 60ed 60f6 +12b2 12a7 60f4 60f5 +12b3 12a7 60f5 60f6 +12b1 12a8 60f1 60f7 +12a8 12b2 60f4 60f7 +1805 12a9 6b0f 6b10 +12a9 1806 6b0f 6b13 +12ac 12aa 60e8 6b3f +12ab 12ac 60e9 6b4e +12ae 12ab 60ec 6b4d +181b 12ab 6b4d 6b4e +12ac 1817 6b3d 6b3e +12ac 1819 6b3e 6b46 +12ac 181b 6b46 6b4e +12ad 12ae 60eb 61a3 +12b0 12ad 60ef 61a1 +131a 12ad 61a1 61a3 +131a 12ae 61a3 6b4a +181b 12ae 6b4c 6b4d +181c 12ae 6b4a 6b4c +12af 12b0 60ee 618a +12b3 12af 60f6 617f +1307 12af 617f 618a +1307 12b0 618a 6190 +1310 12b0 6190 61a2 +12b0 131a 61a1 61a2 +12b1 12b2 60f7 6171 +12b1 12ff 6171 6172 +12b1 1300 6172 6173 +12b2 12b3 60f5 6175 +12ff 12b2 6171 6174 +1301 12b2 6174 6175 +1301 12b3 6175 617c +1305 12b3 617c 6180 +12b3 1307 617f 6180 +12b4 12b5 60f8 60fa +12b4 12b6 60fa 60fc +12b4 12b7 60fc 60fd +12b6 12b5 60fa 6101 +12b8 12b5 6101 6103 +12b5 12b9 6102 6103 +12b7 12b6 60fc 6104 +12b6 12b8 6101 6105 +12ba 12b6 6104 6105 +12b7 12ba 6104 6107 +12b7 12bb 6107 6108 +12b8 12b9 6103 610b +12ba 12b8 6105 610c +12b8 12bd 610b 610d +12be 12b8 610c 610e +12b8 12bf 610d 610e +12b9 12bc 6109 610f +12bd 12b9 610b 610f +12bb 12ba 6107 6110 +12ba 12be 610c 6111 +12c0 12ba 6110 6111 +12bb 12c0 6110 6114 +12c1 12bb 6112 6115 +12bb 12c2 6114 6115 +12bd 12bc 610f 6117 +12c3 12bc 6117 6119 +12bc 12c4 6118 6119 +12bf 12bd 610d 611b +12bd 12c3 6117 611c +12c5 12bd 611b 611c +12be 12bf 610e 611d +12c0 12be 6111 611e +12be 12c5 611d 611f +12c6 12be 611e 611f +12bf 12c5 611b 611d +12c2 12c0 6114 6120 +12c0 12c6 611e 6121 +12c7 12c0 6120 6122 +12c0 12c8 6121 6122 +12c1 12c2 6115 6124 +12c9 12c1 6123 6124 +12c2 12c7 6120 6127 +12c9 12c2 6124 6128 +12c2 12cb 6127 6128 +12c3 12c4 6119 612b +12c5 12c3 611c 612c +12c3 12cd 612b 612c +12c4 12cc 6129 612d +12cd 12c4 612b 612e +12c4 12ce 612d 612e +12c6 12c5 611f 612f +12c5 12cd 612c 6130 +12cf 12c5 612f 6131 +12c5 12d0 6130 6131 +12c8 12c6 6121 6132 +12c6 12cf 612f 6133 +12d1 12c6 6132 6133 +12c7 12c8 6122 6588 +12cb 12c7 6127 6562 +153e 12c7 6562 6563 +1549 12c7 6563 6585 +155e 12c7 6585 6588 +12c8 12d1 6132 65af +155e 12c8 6588 65af +12ca 12c9 6125 6590 +12c9 12cb 6128 6575 +12c9 154b 6575 6576 +12c9 1550 6576 6590 +12ca 1550 6590 6591 +12ca 155b 6591 65ac +12cb 153d 655f 6561 +153e 12cb 655f 6562 +12cb 154b 6561 6575 +12ce 12cc 612d 6456 +12cc 14a3 6446 6454 +12cc 14ab 6454 6456 +12cd 12ce 612e 65be +12d0 12cd 6130 65bd +1579 12cd 65bd 65be +12ce 14ab 6456 65c5 +14ae 12ce 65c4 65c5 +1579 12ce 65be 65c4 +12cf 12d0 6131 65bf +12d1 12cf 6133 65c2 +12cf 157a 65bf 65c1 +12cf 157b 65c1 65c3 +157c 12cf 65c2 65c3 +12d0 1579 65bd 65c0 +157a 12d0 65bf 65c0 +12d1 155e 65ae 65af +155f 12d1 65ae 65b1 +1571 12d1 65b1 65cb +12d1 157c 65c2 65cb +12d3 12d2 6134 6135 +12d2 12d4 6134 6136 +12d5 12d2 6135 6137 +12d2 12d6 6136 6138 +12d7 12d2 6137 6139 +12d2 12d8 6138 6139 +12d4 12d3 6134 613a +12d3 12d5 6135 613b +12d9 12d3 613a 613c +12d3 12da 613b 613d +12db 12d3 613c 613d +12d6 12d4 6136 613e +12d4 12d9 613a 6140 +12dc 12d4 613e 613f +12dd 12d4 613f 6141 +12d4 12de 6140 6141 +12d5 12d7 6137 6142 +12da 12d5 613b 6143 +12d5 12df 6142 6144 +12e0 12d5 6143 6144 +12d8 12d6 6138 6149 +12d6 12dc 613e 6145 +12d6 12e1 6145 6148 +12d6 12e3 6148 6149 +12d7 12d8 6139 614a +12df 12d7 6142 614b +12d7 12e4 614a 614c +12e5 12d7 614b 614c +12d8 12e3 6149 8afb +12e4 12d8 614a 8b31 +12d8 24c2 85b2 8b31 +2621 12d8 85b5 8afb +2626 12d8 85b2 85b5 +12d9 12db 613c 7ac9 +12de 12d9 6140 6151 +12e9 12d9 6151 8e54 +12d9 203d 7ac9 8e54 +12db 12da 613d 8d95 +12da 12e0 6143 7ac1 +12da 2031 7ac1 8e80 +2745 12da 8d95 8e80 +203d 12db 7ac9 8e7a +12db 2739 8d13 8e7a +2745 12db 8d13 8d95 +12dc 12dd 613f 6147 +12e1 12dc 6145 6146 +12e2 12dc 6146 6147 +12dd 12de 6141 6152 +12e2 12dd 6147 6153 +12dd 12ea 6152 6153 +12de 12e9 6151 6154 +12ea 12de 6152 6155 +12de 12eb 6154 6155 +12e0 12df 6144 6156 +12df 12e5 614b 6157 +12ec 12df 6156 6158 +12df 12ed 6157 6158 +12e0 12ec 6156 8e81 +2031 12e0 7ac1 8e81 +12e1 12e2 6146 614e +12e3 12e1 6148 614d +12e6 12e1 614d 614f +12e1 12e7 614e 6150 +12e8 12e1 614f 6150 +12e7 12e2 614e 615a +12e2 12ea 6153 6159 +12e2 12ee 6159 615a +12e3 12e6 614d 8ba2 +2621 12e3 8afb 8ba2 +12e5 12e4 614c 8314 +24c1 12e4 8314 8cef +12e4 24c2 8b31 8cef +12ed 12e5 6157 615b +12ef 12e5 615b 8d59 +12e5 24c1 8314 8315 +12e5 24c9 8315 8d59 +12e6 12e8 614f 615c +12e6 12f0 615c 615d +12e6 12f1 615d 85ad +12e6 2621 85ad 8ba2 +12e8 12e7 6150 6162 +12e7 12ee 615a 6163 +12f5 12e7 6162 6164 +12e7 12f6 6163 6164 +12f0 12e8 615c 6165 +12e8 12f5 6162 6166 +12f7 12e8 6165 6166 +12eb 12e9 6154 8df9 +203c 12e9 8df9 8e7b +12e9 203d 8e54 8e7b +12ea 12eb 6155 615e +12ee 12ea 6159 615f +12ea 12f2 615e 6160 +12f3 12ea 615f 6160 +12f2 12eb 615e 8e6a +203c 12eb 8cdf 8df9 +12eb 2049 8d10 8e6a +12eb 2738 8cdf 8d10 +12ec 12ed 6158 8c9c +202f 12ec 7abd 8c9c +12ec 2030 7abd 7abf +12ec 2031 7abf 8e81 +12ed 12ef 615b 6161 +12ed 12f4 6161 8e47 +202f 12ed 8c9c 8e47 +12ee 12f3 615f 6167 +12f6 12ee 6163 6168 +12ee 12f8 6167 6168 +12f4 12ef 6161 6169 +12f9 12ef 6169 8c7d +24c9 12ef 8c7d 8d59 +12f1 12f0 615d 616a +12f0 12f7 6165 616b +12fa 12f0 616a 616c +12f0 12fb 616b 616d +12fc 12f0 616c 616d +12f1 12fa 616a 8a72 +2621 12f1 85ad 85b6 +12f1 2623 8a72 8b6c +2624 12f1 85b6 8b6c +12f3 12f2 6160 616e +12fd 12f2 616e 8eaf +12f2 2048 8cdd 8eaf +2049 12f2 8cdd 8e6a +12f8 12f3 6167 616f +12f3 12fd 616e 6170 +12fe 12f3 616f 6170 +12f4 12f9 6169 8ddb +201a 12f4 7ab7 8ddb +12f4 2020 7ab7 8eca +202f 12f4 8e47 8eca +12f5 12f6 6164 61b9 +12f7 12f5 6166 61b0 +1321 12f5 61b0 61b8 +1327 12f5 61b8 61ba +12f5 1328 61b9 61ba +12f6 12f8 6168 61c9 +1328 12f6 61b9 61c8 +1331 12f6 61c8 61c9 +12fb 12f7 616b 61af +1321 12f7 61af 61b0 +12f8 12fe 616f 61e3 +1331 12f8 61c9 61e0 +133f 12f8 61e0 61e3 +12f9 201a 8c77 8ddb +12f9 24c3 8b38 8cec +24c9 12f9 8b38 8c7d +271e 12f9 8c77 8cec +12fa 12fc 616c 61b1 +12fa 1322 61b1 61b2 +12fa 1323 61b2 8b6d +2622 12fa 85ae 8b6d +12fa 2623 85ae 8a72 +12fc 12fb 616d 61b3 +12fb 1321 61af 61b4 +1324 12fb 61b3 61b5 +12fb 1325 61b4 61b6 +1326 12fb 61b5 61b6 +1322 12fc 61b1 61b7 +12fc 1324 61b3 61b7 +12fe 12fd 6170 7ad1 +2047 12fd 7acf 8e16 +2048 12fd 8e16 8eaf +12fd 204c 7acf 7ad1 +133f 12fe 61e3 621c +1360 12fe 621c 8e5a +12fe 204c 7ad1 8e5a +1300 12ff 6172 6176 +12ff 1301 6174 6177 +1302 12ff 6176 6178 +12ff 1303 6177 6178 +1300 1302 6176 617a +1300 1304 617a 617b +1303 1301 6177 617d +1301 1305 617c 617e +1306 1301 617d 617e +1302 1303 6178 6181 +1304 1302 617a 6182 +1302 1308 6181 6183 +1309 1302 6182 6184 +1302 130a 6183 6184 +1303 1306 617d 6185 +1308 1303 6181 6186 +1303 130b 6185 6186 +1304 1309 6182 6188 +1304 130c 6188 6189 +1306 1305 617e 618b +1305 1307 6180 618c +130d 1305 618b 618e +1305 130e 618c 618d +1305 130f 618d 618e +130b 1306 6185 618f +1306 130d 618b 618f +130e 1307 618c 6191 +1307 1310 6190 6192 +1311 1307 6191 6192 +130a 1308 6183 6193 +1308 130b 6186 6194 +1312 1308 6193 6194 +1309 130a 6184 6195 +130c 1309 6188 6196 +1309 1313 6195 6199 +1314 1309 6196 6197 +1315 1309 6197 6198 +1316 1309 6198 6199 +130a 1312 6193 619a +1313 130a 6195 619a +130b 130d 618f 619b +1312 130b 6194 619d +130b 1317 619b 619c +130b 1318 619c 619d +130c 1314 6196 61a0 +1319 130c 619f 61a0 +130d 130f 618e 61a6 +1317 130d 619b 61a7 +130d 131c 61a6 61a7 +130f 130e 618d 61a4 +130e 1311 6191 61a5 +131b 130e 61a4 61a5 +130f 131b 61a4 61a9 +131c 130f 61a6 61a8 +131d 130f 61a8 61a9 +1311 1310 6192 61aa +1310 131a 61a2 61ab +131e 1310 61aa 61ab +131b 1311 61a5 61ac +1311 131e 61aa 61ae +131f 1311 61ac 61ad +1320 1311 61ad 61ae +1313 1312 619a 64e9 +1312 1318 619d 63df +1312 146e 63df 64eb +14b6 1312 64e9 64eb +1316 1313 6199 6468 +14b6 1313 6468 64e9 +1314 1315 6197 643d +1319 1314 61a0 6439 +149b 1314 6439 643d +1315 1316 6198 644c +149b 1315 643d 643e +149f 1315 643e 6448 +14a4 1315 6448 644c +14a4 1316 644c 6460 +14b2 1316 6460 6469 +1316 14b6 6468 6469 +1318 1317 619c 63c5 +1317 131c 61a7 63c3 +1317 1459 63c3 63c5 +1459 1318 63c4 63c5 +1318 1462 63c4 63dc +1318 146e 63dc 63df +149b 1319 6435 6439 +131e 131a 61ab 63ff +1477 131a 63ff 6401 +1480 131a 6401 6b49 +181c 131a 6b49 6b4a +131d 131b 61a9 63bb +131b 131f 61ac 63ce +1457 131b 63bb 63bc +145d 131b 63bc 63ce +131c 131d 61a8 63b4 +1454 131c 63b2 63b4 +131c 1455 63b2 63b5 +131c 1459 63b5 63c3 +131d 1454 63b3 63b4 +1457 131d 63b3 63bb +1320 131e 61ae 63f0 +1477 131e 63f0 63ff +131f 1320 61ad 63e5 +145d 131f 63ce 63cf +1466 131f 63cf 63e5 +1320 1466 63e4 63e5 +1468 1320 63e4 63ea +1475 1320 63ea 63ef +1477 1320 63ef 63f0 +1325 1321 61b4 61bb +1321 1327 61b8 61bb +1323 1322 61b2 61bc +1322 1324 61b7 61bd +1329 1322 61bc 61be +1322 132a 61bd 61be +1323 1329 61bc 61bf +1323 132b 61bf 8b7e +2622 1323 8b6d 8b7e +1324 1326 61b5 61c0 +132a 1324 61bd 61c1 +1324 132c 61c0 61c1 +1326 1325 61b6 61c2 +1325 1327 61bb 61c3 +132d 1325 61c2 61c4 +1325 132e 61c3 61c5 +132f 1325 61c4 61c5 +132c 1326 61c0 61c6 +1326 132d 61c2 61c7 +1330 1326 61c6 61c7 +1327 1328 61ba 61ca +132e 1327 61c3 61cb +1327 1332 61ca 61cb +1328 1331 61c8 61cc +1332 1328 61ca 61cd +1328 1333 61cc 61cd +1329 132a 61be 61ce +132b 1329 61bf 61d1 +1329 1334 61ce 61d2 +1336 1329 61d1 61d2 +132a 132c 61c1 61cf +1334 132a 61ce 61d0 +132a 1335 61cf 61d0 +132b 1336 61d1 61d6 +132b 1339 61d6 85aa +132b 261e 85aa 8a9f +132b 2622 8a9f 8b7e +132c 1330 61c6 61d3 +1335 132c 61cf 61d4 +132c 1337 61d3 61d5 +1338 132c 61d4 61d5 +132d 132f 61c4 61d8 +1330 132d 61c7 61d7 +133a 132d 61d7 61d9 +132d 133b 61d8 61d9 +132f 132e 61c5 61dc +132e 1332 61cb 61dd +133d 132e 61dc 61dd +133b 132f 61d8 61de +132f 133d 61dc 61df +133e 132f 61de 61df +1337 1330 61d3 61da +1330 133a 61d7 61db +133c 1330 61da 61db +1333 1331 61cc 61e1 +1331 133f 61e0 61e2 +1340 1331 61e1 61e2 +1332 1333 61cd 61e4 +133d 1332 61dd 61e4 +133d 1333 61e4 61e6 +1333 1340 61e1 61e7 +1341 1333 61e5 61e7 +1333 1342 61e5 61e6 +1334 1335 61d0 61e8 +1336 1334 61d2 61ea +1334 1343 61e8 61eb +1344 1334 61ea 61eb +1335 1338 61d4 61e9 +1343 1335 61e8 61e9 +1339 1336 61d6 61f5 +1336 1344 61ea 61f3 +1336 134a 61f3 61f4 +1336 134b 61f4 61f5 +1338 1337 61d5 61ec +1337 133c 61da 61f1 +1345 1337 61ec 61f2 +1337 1349 61f1 61f2 +1343 1338 61e9 61ed +1338 1345 61ec 61ee +1346 1338 61ed 61ef +1338 1347 61ee 61f0 +1348 1338 61ef 61f0 +1339 134b 61f5 85a6 +1339 261a 85a6 8aa0 +261c 1339 85a9 8aa0 +1339 261e 85a9 85aa +133a 133b 61d9 61fd +133c 133a 61db 61f9 +134d 133a 61f9 61fd +133b 133e 61de 6209 +134d 133b 61fd 620a +133b 1356 6209 620a +1349 133c 61f1 61fa +133c 134d 61f9 61fb +134e 133c 61fa 61fc +133c 134f 61fb 61fc +133e 133d 61df 6215 +133d 1342 61e6 6212 +133d 135c 6212 6215 +1356 133e 6209 622d +133e 135c 6215 6217 +133e 135f 6217 622d +1340 133f 61e2 6218 +1360 133f 6218 621c +1341 1340 61e7 7ad7 +1340 1360 6218 8dbf +2053 1340 7ad7 8e00 +1340 272f 8dbf 8e00 +1342 1341 61e5 620f +135a 1341 620f 8d85 +1341 2053 7ad7 8d85 +1342 135a 620f 6210 +1342 135b 6210 6211 +1342 135c 6211 6212 +1344 1343 61eb 61f6 +1343 1346 61ed 61f6 +1344 1346 61f6 61f7 +134a 1344 61f3 61f8 +1344 134c 61f7 61f8 +1347 1345 61ee 61fe +1345 1349 61f2 61ff +1350 1345 61fe 61ff +1346 1348 61ef 6200 +134c 1346 61f7 6201 +1346 1351 6200 6201 +1348 1347 61f0 6202 +1347 1350 61fe 6203 +1352 1347 6202 6203 +1351 1348 6200 6205 +1348 1352 6202 6204 +1348 1353 6204 6205 +1349 134e 61fa 6206 +1350 1349 61ff 6208 +1349 1354 6206 6207 +1349 1355 6207 6208 +134b 134a 61f4 8a3d +134a 134c 61f8 620b +134a 1357 620b 8aec +26bd 134a 8a3d 8aec +261a 134b 85a6 8a6f +134b 261b 8773 8a6f +26bd 134b 8773 8a3d +134c 1351 6201 620d +1357 134c 620b 620c +1358 134c 620c 620d +134f 134d 61fb 6232 +134d 1356 620a 622e +134d 136d 622e 6232 +134e 134f 61fc 623b +1354 134e 6206 623a +1374 134e 623a 623b +136d 134f 6231 6232 +134f 136f 6231 6237 +134f 1374 6237 623b +1352 1350 6203 6252 +1350 1355 6208 624a +1350 137f 624a 6252 +1351 1353 6205 6aac +1358 1351 620d 6aa9 +17cc 1351 6aa9 6aad +1351 17cf 6aac 6aad +1353 1352 6204 6258 +1352 137f 6252 6253 +1352 1381 6253 6258 +1353 1381 6258 6259 +1353 1385 6259 72a9 +17cf 1353 6aac 72a9 +1355 1354 6207 623f +1374 1354 6238 623a +1354 1375 6238 623c +1354 1376 623c 623f +1355 1376 623f 6243 +1355 137a 6243 6249 +1355 137f 6249 624a +135f 1356 6224 622d +1362 1356 6223 6224 +1356 1369 6223 6228 +1356 136d 6228 622e +1357 1358 620c 620e +1357 1359 620e 8985 +1357 1364 8985 8a58 +26bc 1357 876d 8a58 +1357 26bd 876d 8aec +1359 1358 620e 6aa8 +17cc 1358 6aa8 6aa9 +1359 1364 8771 8985 +1359 17cc 6aa8 6aab +17cd 1359 6aaa 6aab +1359 17ce 6aaa 8771 +135b 135a 6210 8dc2 +135a 2053 8d85 8dbe +135a 2056 7ad9 8e58 +2058 135a 7ad9 8dbe +205b 135a 8dc2 8e58 +135c 135b 6211 6213 +135d 135b 6213 6214 +135e 135b 6214 7adc +205b 135b 7adc 8dc2 +135c 135d 6213 6216 +135c 135f 6216 6217 +135d 135e 6214 6219 +135f 135d 6216 621b +135d 1361 6219 621a +135d 1362 621a 621b +1361 135e 6219 7ae2 +2055 135e 8c32 8d81 +135e 205b 7adc 8d81 +2060 135e 7ae2 8c32 +135f 1362 621b 6224 +204c 1360 8e01 8e5a +272f 1360 8dbf 8e01 +1362 1361 621a 7ade +205d 1361 7ade 8dae +1361 2060 7ae2 8dae +1366 1362 621e 8d1d +1362 1367 621e 6220 +1362 1369 6220 6223 +1362 205d 7ade 8d1d +1364 1363 621d 8a63 +1363 1365 621d 8770 +1363 1a41 8770 89da +24ba 1363 8982 8a62 +1363 2619 89da 8a62 +1363 26bc 8982 8a63 +1365 1364 621d 8983 +1364 17ce 8771 8a59 +26bb 1364 8983 8a59 +26bc 1364 8a58 8a63 +1365 1a41 6f15 8770 +1a42 1365 6f15 8a67 +1365 26bb 8983 8a67 +1367 1366 621e 621f +1368 1366 621f 8d91 +1366 205d 8d1d 8d5c +2061 1366 7ae5 8d5c +1366 2064 7ae5 8d91 +1367 1368 621f 6221 +1369 1367 6220 6222 +1367 136a 6221 6222 +136a 1368 6221 6225 +136b 1368 6225 6226 +136c 1368 6226 8cad +2064 1368 8cad 8d91 +1369 136a 6222 6227 +1369 136d 6227 6228 +136a 136b 6225 6229 +136d 136a 6227 622a +136a 136e 6229 622b +136f 136a 622a 622c +136a 1370 622b 622c +136b 136c 6226 622f +136e 136b 6229 6230 +136b 1371 622f 6230 +1371 136c 622f 8bf4 +2063 136c 8c59 8d90 +136c 2064 8cad 8d90 +136c 2066 8c59 8d40 +2068 136c 8bf4 8d40 +136d 136f 622a 6231 +1370 136e 622b 6233 +136e 1371 6230 6246 +1372 136e 6233 8c17 +136e 137d 6246 8c17 +136f 1370 622c 6234 +136f 1373 6234 6236 +136f 1374 6236 6237 +1370 1372 6233 6235 +1373 1370 6234 6235 +137d 1371 6246 7f24 +1371 2068 8bf4 8ccf +22de 1371 7f24 8ccf +1373 1372 6235 6240 +1377 1372 6240 8b97 +137d 1372 8b97 8c17 +1374 1373 6236 6239 +1375 1373 6239 623d +1377 1373 623d 6240 +1375 1374 6238 6239 +1376 1375 623c 623e +1375 1377 623d 8219 +1378 1375 623e 821a +1375 2449 8219 821a +1376 1378 623e 6241 +1376 1379 6241 6242 +1376 137a 6242 6243 +137d 1377 821b 8b97 +1377 22e0 821b 8ae9 +2449 1377 8219 8ae9 +1379 1378 6241 6244 +137b 1378 6244 6245 +137c 1378 6245 8ae8 +1378 2449 821a 8ae8 +137a 1379 6242 6247 +1379 137b 6244 6248 +137e 1379 6247 6248 +137a 137e 6247 624b +137f 137a 6249 624c +137a 1380 624b 624d +1381 137a 624c 624d +137b 137c 6245 8a06 +137e 137b 6248 624e +1382 137b 624e 624f +1383 137b 624f 892a +25a8 137b 892a 8a06 +22e2 137c 8934 89b1 +137c 2448 8934 8a36 +2449 137c 89b1 8ae8 +25a7 137c 84bc 8a36 +137c 25a8 84bc 8a06 +206b 137d 7f26 8cce +137d 22de 7f24 8cce +137d 22df 7f26 8c16 +22e0 137d 821b 8c16 +1380 137e 624b 6250 +137e 1382 624e 6251 +1384 137e 6250 6251 +137f 1381 624c 6253 +1381 1380 624d 6254 +1380 1384 6250 6255 +1385 1380 6254 6257 +1380 1386 6255 6256 +1380 1387 6256 6257 +1381 1385 6254 6259 +1382 1383 624f 625a +1384 1382 6251 625b +1382 1388 625a 625b +1388 1383 625a 625c +1389 1383 625c 86c5 +25a8 1383 84c0 892a +25aa 1383 86c5 86c7 +1383 25ab 84c0 86c7 +1386 1384 6255 625d +1384 1388 625b 625d +1385 1387 6257 7711 +17cf 1385 72a9 7711 +1387 1386 6256 7709 +1386 1388 625d 6b5b +1386 1821 6b5b 7707 +1386 1e1d 7707 7709 +1387 17cf 7710 7711 +1e1d 1387 7708 7709 +1387 1e1e 7708 770b +1387 1e20 770b 7710 +1388 1389 625c 6b5a +1388 1821 6b5a 6b5b +1821 1389 6b5a 6b5d +1822 1389 6b5c 8975 +1389 1823 6b5c 6b5d +1389 25aa 86c5 8975 +138b 138a 625e 625f +138a 138c 625e 6260 +138d 138a 625f 6261 +138a 138e 6260 6263 +138f 138a 6261 6262 +1390 138a 6262 6263 +138c 138b 625e 6264 +138b 138d 625f 6265 +1391 138b 6264 8d2a +138b 1392 6265 6267 +138b 1394 6267 6269 +138b 1395 6269 8d2a +138e 138c 6260 8d48 +138c 1391 6264 6266 +138c 1393 6266 7cbc +138c 217f 7cbc 8d48 +138d 138f 6261 626a +1392 138d 6265 626b +138d 1397 626a 626c +1398 138d 626b 626c +1390 138e 6263 8d82 +20ed 138e 8cae 8cb7 +217f 138e 8cb7 8d48 +138e 2181 8cae 8d82 +138f 1390 6262 626d +1397 138f 626a 626e +138f 1399 626d 626f +139a 138f 626e 626f +1399 1390 626d 6270 +139b 1390 6270 7cbe +2181 1390 7cbe 8d82 +1393 1391 6266 8d2b +1395 1391 6268 8d2a +1391 1396 6268 8d2b +1394 1392 6267 6271 +1392 1398 626b 6272 +139c 1392 6271 6273 +1392 139d 6272 6273 +1396 1393 7cb8 8d2b +1393 217c 7cb8 8d31 +217d 1393 7cbb 8d31 +1393 217f 7cbb 7cbc +1395 1394 6269 6274 +1394 139c 6271 6274 +1396 1395 6268 8cb8 +1395 139c 6274 6275 +1395 139e 6275 8082 +1395 23a2 8082 8cb8 +217c 1396 7cb8 8c90 +23a2 1396 8c90 8cb8 +1398 1397 626c 6276 +1397 139a 626e 6277 +139f 1397 6276 6278 +1397 13a0 6277 6278 +139d 1398 6272 6279 +1398 139f 6276 627a +13a1 1398 6279 627a +139a 1399 626f 627b +1399 139b 6270 7fff +13a2 1399 627b 8000 +1399 2326 7fff 8000 +13a0 139a 6277 627c +139a 13a2 627b 627c +20eb 139b 8c61 8d69 +139b 20ec 8003 8d69 +139b 2181 7cbe 7cc0 +139b 2182 7cc0 8003 +2326 139b 7fff 8c61 +139c 139d 6273 627d +139e 139c 6275 627e +139c 13a3 627d 627f +13a4 139c 627e 627f +139d 13a1 6279 6280 +13a3 139d 627d 6281 +139d 13a5 6280 6281 +139e 13a4 627e 6282 +139e 13a6 6282 8325 +23a0 139e 8084 8b9a +139e 23a1 8325 8b9a +23a2 139e 8082 8084 +139f 13a0 6278 6283 +13a1 139f 627a 6284 +139f 13a7 6283 6285 +13a8 139f 6284 6285 +13a0 13a2 627c 6286 +13a7 13a0 6283 6287 +13a0 13a9 6286 6287 +13a5 13a1 6280 6288 +13a1 13a8 6284 6289 +13aa 13a1 6288 628a +13a1 13ab 6289 628a +13a9 13a2 6286 628b +13ac 13a2 628b 8bd7 +13a2 2326 8000 8bd7 +13a4 13a3 627f 628c +13a3 13a5 6281 628f +13ad 13a3 628c 628f +13a6 13a4 6282 628d +13a4 13ad 628c 628e +13ae 13a4 628d 628e +13a5 13aa 6288 6291 +13ad 13a5 628f 6290 +13af 13a5 6290 6291 +13a6 13ae 628d 877c +13a6 173e 877c 8a83 +23a1 13a6 8325 8b2e +13a6 23a3 8a83 8b2e +13a8 13a7 6285 6324 +13a7 13a9 6287 6315 +13a7 13f9 6315 6317 +13a7 1405 6317 6324 +13ab 13a8 6289 632c +13a8 1405 6324 6325 +13a8 140a 6325 632c +13a9 13ac 628b 6318 +13f7 13a9 630e 630f +13a9 13f9 630e 6315 +13fb 13a9 630f 6318 +13aa 13ab 628a 636b +13af 13aa 6291 697a +13aa 1429 636b 636d +13aa 1434 636d 697a +13ab 140a 632c 632e +13ab 1411 632e 635a +13ab 1429 635a 636b +13fb 13ac 6318 8c45 +13ac 2326 8bd7 8cd3 +2328 13ac 8c45 8cd3 +13ae 13ad 628e 6974 +13ad 13af 6290 6975 +1738 13ad 6974 6975 +13ae 1738 6974 6976 +13ae 1739 6976 697e +13ae 173e 697e 877c +13af 1434 697a 697c +147e 13af 697b 697c +1738 13af 6975 6977 +173a 13af 6977 697b +13b1 13b0 6292 6293 +13b0 13b2 6292 6294 +13b3 13b0 6293 89e6 +13b0 13b4 6294 7f1e +13b0 22d8 7f1e 8a0a +22d9 13b0 89e6 8adc +13b0 22da 8a0a 8adc +13b2 13b1 6292 6295 +13b1 13b3 6293 6296 +13b5 13b1 6295 6297 +13b1 13b6 6296 6298 +13b7 13b1 6297 6298 +13b4 13b2 6294 629b +13b2 13b5 6295 6299 +13b2 13b8 6299 629a +13b2 13b9 629a 629b +13b6 13b3 6296 8777 +22d9 13b3 7f21 89e6 +13b3 22db 7f21 8b4f +22dc 13b3 8959 8b4f +26be 13b3 8777 8959 +13b4 13b9 629b 62a3 +13b4 13bf 62a3 8a1c +22d8 13b4 7f1e 8a1c +13b5 13b7 6297 629d +13b8 13b5 6299 629c +13ba 13b5 629c 8a24 +13b5 13bb 629d 8a24 +13b7 13b6 6298 8775 +13b6 26be 8777 8997 +26bf 13b6 8775 8997 +13bb 13b7 629d 8a25 +13b7 13c2 8785 8a25 +13b7 26bf 8775 8785 +13b9 13b8 629a 629e +13b8 13ba 629c 62a0 +13bc 13b8 629e 629f +13bd 13b8 629f 62a0 +13b9 13bc 629e 62a1 +13b9 13be 62a1 62a2 +13b9 13bf 62a2 62a3 +13bb 13ba 62ad 8a24 +13bd 13ba 62a0 62ac +13ba 13c0 62ad 62af +13c7 13ba 62ac 62ae +13c8 13ba 62ae 62af +13bb 13c0 62a4 62ad +13c1 13bb 62a4 62a5 +13c2 13bb 62a5 8a25 +13bc 13bd 629f 62a7 +13be 13bc 62a1 62a6 +13c3 13bc 62a6 62a8 +13bc 13c4 62a7 62a8 +13c4 13bd 62a7 62b0 +13bd 13c7 62ac 62b0 +13bf 13be 62a2 62a9 +13be 13c3 62a6 62aa +13c5 13be 62a9 62ab +13be 13c6 62aa 62ab +13bf 13c5 62a9 7f16 +13bf 22d5 7f16 8a1b +22d6 13bf 7f1d 8a1b +13bf 22d8 7f1d 8a1c +13c0 13c1 62a4 62b2 +13c8 13c0 62af 62be +13c0 13ca 62b2 62c1 +13d2 13c0 62be 62c0 +13d3 13c0 62c0 62c1 +13c1 13c2 62a5 62b1 +13c1 13c9 62b1 62b3 +13ca 13c1 62b2 62b3 +13c9 13c2 62b1 877b +181f 13c2 877b 8989 +13c2 26bf 8785 8989 +13c3 13c4 62a8 62b4 +13c6 13c3 62aa 62b5 +13c3 13cb 62b4 62b6 +13cc 13c3 62b5 62b6 +13c4 13c7 62b0 62b7 +13cb 13c4 62b4 62b8 +13c4 13cd 62b7 62b9 +13ce 13c4 62b8 62b9 +13c5 13c6 62ab 8a0e +1813 13c5 89bf 8a0e +22d5 13c5 7f16 89bf +13c6 13cc 62b5 62bb +13cf 13c6 62ba 62bb +13c6 13d0 62ba 7f15 +13c6 1813 7f15 8a0e +13c7 13c8 62ae 62bc +13cd 13c7 62b7 62bd +13c7 13d1 62bc 62bd +13d1 13c8 62bc 62bf +13c8 13d2 62be 62bf +13ca 13c9 62b3 6b51 +173d 13c9 6b51 877a +181f 13c9 877a 877b +13d3 13ca 62c1 6b53 +1487 13ca 6b53 6b54 +13ca 173d 6b51 6b54 +13cc 13cb 62b6 6b39 +13cb 13ce 62b8 6b3b +1818 13cb 6b39 6b3b +13cf 13cc 62bb 6b34 +1816 13cc 6b34 6b36 +1818 13cc 6b36 6b39 +13ce 13cd 62b9 6b40 +13cd 13d1 62bd 6b43 +1485 13cd 6b40 6b43 +13ce 1485 6b40 6b41 +1818 13ce 6b3b 6b3c +1819 13ce 6b3c 6b42 +13ce 181a 6b41 6b42 +13d0 13cf 62ba 6b31 +13cf 1812 6b30 6b31 +1816 13cf 6b32 6b34 +13d0 1812 6b31 8a1e +1813 13d0 7f15 8a0f +1814 13d0 8a0f 8a1e +13d1 13d2 62bf 640c +1481 13d1 6409 640c +13d1 1482 6409 640a +13d1 1485 640a 6b43 +13d2 13d3 62c0 6b4f +1481 13d2 640c 640d +1483 13d2 640d 6b4f +1483 13d3 6b4f 6b50 +1487 13d3 6b50 6b53 +13d4 13d5 62c5 62c9 +13d4 13d7 62c9 62ca +13d5 13d6 62c7 62cb +13d7 13d5 62c9 62cc +13d5 13d8 62cb 62cc +13d8 13d6 62cb 62cf +13d9 13d6 62cf 62d0 +13da 13d6 62d0 62d2 +13d6 13db 62d1 62d2 +13d7 13d8 62cc 62d3 +13d7 13dc 62d3 62d5 +13d8 13d9 62cf 62d6 +13dc 13d8 62d3 62d6 +13d9 13da 62d0 62db +13dc 13d9 62d6 62d8 +13de 13d9 62d8 62dc +13d9 13df 62db 62dc +13da 13db 62d2 62de +13df 13da 62db 62df +13da 13e0 62de 62df +13e0 13db 62de 62e0 +13e1 13db 62e0 62e1 +13dd 13dc 62d7 62d9 +13dc 13de 62d8 62d9 +13dd 13de 62d9 62e2 +13dd 13e2 62e2 62e5 +13de 13df 62dc 62e3 +13e2 13de 62e2 62e3 +13df 13e0 62df 62e7 +13e2 13df 62e3 62e6 +13e3 13df 62e6 62e8 +13df 13e4 62e7 62e9 +13e5 13df 62e8 62ea +13df 13e6 62e9 62ea +13e0 13e1 62e0 62ef +13e4 13e0 62e7 62ee +13e8 13e0 62ee 62ef +13e8 13e1 62ef 62fa +13e1 13ed 62f8 62fa +13e2 13e3 62e6 62ec +13e2 13e7 62ec 62ed +13e3 13e5 62e8 62f0 +13e7 13e3 62ec 62f1 +13e3 13e9 62f0 62f1 +13e6 13e4 62e9 62f2 +13e4 13e8 62ee 62f3 +13ea 13e4 62f2 62f3 +13e5 13e6 62ea 62f4 +13e9 13e5 62f0 62f7 +13e5 13eb 62f4 62f7 +13e6 13ea 62f2 62f5 +13eb 13e6 62f4 62f6 +13e6 13ec 62f5 62f6 +13e7 13e9 62f1 62ff +13ee 13e7 62fb 62fd +13ef 13e7 62fd 62fe +13f0 13e7 62fe 62ff +13ea 13e8 62f3 6669 +13e8 13ed 62fa 665c +1570 13e8 665b 665c +13e8 15bd 665b 6669 +13e9 13eb 62f7 661c +13f0 13e9 62ff 68e6 +13e9 1595 661c 661d +13e9 15a1 661d 68e6 +13ec 13ea 62f5 6681 +13ea 15a5 666b 6681 +15bd 13ea 6668 6669 +13ea 15be 6668 666b +13eb 13ec 62f6 661e +1595 13eb 661c 661e +1594 13ec 661a 661b +13ec 1595 661a 661e +15a5 13ec 661b 6681 +155a 13ed 65a8 65a9 +13ed 1570 65a8 665c +13ee 13ef 62fd 6502 +1506 13ee 64ff 6502 +13ef 13f0 62fe 68e4 +13ef 1506 6501 6502 +1507 13ef 6501 65e0 +1587 13ef 65e0 68e4 +1586 13f0 68e5 68e7 +1587 13f0 68e4 68e5 +13f0 15a1 68e6 68e7 +13f2 13f1 6300 6301 +13f1 13f3 6300 8c4b +13f4 13f1 6301 6302 +13f5 13f1 6302 6303 +13f6 13f1 6303 8bef +232c 13f1 8bef 8c4b +13f3 13f2 6300 6304 +13f2 13f4 6301 6305 +13f7 13f2 6304 6306 +13f2 13f8 6305 6307 +13f9 13f2 6306 6308 +13f2 13fa 6307 6308 +13f3 13f7 6304 8bec +13fc 13f3 8007 8bec +13f3 232c 8007 8c4b +13f4 13f5 6302 630a +13f8 13f4 6305 630b +13f4 13fd 630a 630b +13f5 13f6 6303 8bab +13fd 13f5 630a 630c +13fe 13f5 630c 8ba9 +13f5 232e 82c2 8ba9 +232f 13f5 82c2 8bab +1400 13f6 82c1 8c8f +13f6 1401 8bd8 8c8f +232a 13f6 8bd8 8c4a +13f6 232c 8bef 8c4a +13f6 232f 82c1 8bab +13f7 13f9 6306 630e +13fb 13f7 6309 630f +13f7 13fc 6309 8bec +13fa 13f8 6307 6310 +13f8 13fd 630b 6311 +1402 13f8 6310 6312 +13f8 1403 6311 6313 +1404 13f8 6312 6313 +13f9 13fa 6308 6314 +13f9 1402 6314 6316 +13f9 1405 6316 6317 +13fa 1402 6310 6314 +13fc 13fb 6309 8caa +2327 13fb 8caa 8cd2 +13fb 2328 8c45 8cd2 +2327 13fc 8005 8caa +13fc 2329 8005 8cab +232c 13fc 8007 8cab +13fd 13fe 630c 6319 +1403 13fd 6311 631a +13fd 1406 6319 631b +1407 13fd 631a 631b +1406 13fe 6319 631c +1408 13fe 631c 8c2c +13fe 232e 8ba9 8c2c +1400 13ff 630d 8bd9 +13ff 1401 630d 8c8e +20f1 13ff 7c25 8c8e +13ff 20f2 7c26 8bd9 +1401 1400 630d 8c8f +20f2 1400 800b 8bd9 +1400 20f4 800b 800c +1400 232f 800c 82c1 +1401 20f0 8009 8bee +1401 20f1 8bee 8c8e +232a 1401 8009 8bd8 +1402 1404 6312 631d +1405 1402 6316 631e +1402 1409 631d 631f +140a 1402 631e 631f +1404 1403 6313 6320 +1403 1407 631a 6321 +140b 1403 6320 6321 +1409 1404 631d 6322 +1404 140b 6320 6323 +140c 1404 6322 6323 +1405 140a 631e 6325 +1407 1406 631b 6326 +1406 1408 631c 632a +140d 1406 6326 6329 +140f 1406 6329 632a +140b 1407 6321 6327 +1407 140d 6326 6328 +140e 1407 6327 6328 +140f 1408 632a 6360 +142d 1408 6360 82c4 +1408 232d 800a 82c4 +232e 1408 800a 8c2c +140a 1409 631f 632b +1409 140c 6322 632f +1410 1409 632b 632f +140a 1410 632b 632d +140a 1411 632d 632e +140c 140b 6323 6330 +140b 140e 6327 6331 +1412 140b 6330 6331 +1410 140c 632f 6333 +140c 1412 6330 6332 +140c 1413 6332 6333 +140e 140d 6328 6338 +140d 140f 6329 6345 +1416 140d 6338 6344 +141e 140d 6344 6345 +1412 140e 6331 6334 +1414 140e 6334 6337 +1416 140e 6337 6338 +141e 140f 6345 635c +142c 140f 635c 635f +142d 140f 635f 6360 +1411 1410 632d 6343 +1410 1413 6333 633a +1410 1418 633a 6342 +1410 141d 6342 6343 +1411 141d 6343 6357 +1411 1429 6357 635a +1413 1412 6332 6335 +1412 1414 6334 6336 +1415 1412 6335 6336 +1413 1415 6335 6339 +1413 1417 6339 633b +1418 1413 633a 633b +1415 1414 6336 633c +1414 1416 6337 633d +1419 1414 633c 633e +1414 141a 633d 633f +141b 1414 633e 633f +1417 1415 6339 6340 +1415 1419 633c 6341 +141c 1415 6340 6341 +141a 1416 633d 6346 +1416 141e 6344 6347 +141f 1416 6346 6347 +1418 1417 633b 6348 +1417 141c 6340 6349 +1420 1417 6348 634a +1417 1421 6349 634b +1422 1417 634a 634b +141d 1418 6342 634c +1418 1420 6348 634d +1423 1418 634c 634d +1419 141b 633e 634e +141c 1419 6341 634f +1419 1424 634e 6350 +1425 1419 634f 6350 +141b 141a 633f 6351 +141a 141f 6346 6352 +1426 141a 6351 6353 +141a 1427 6352 6353 +1424 141b 634e 6354 +141b 1426 6351 6355 +1428 141b 6354 6355 +1421 141c 6349 6356 +141c 1425 634f 6356 +141d 1423 634c 6358 +1429 141d 6357 6359 +141d 142a 6358 6359 +141f 141e 6347 635b +142b 141e 635b 635d +141e 142c 635c 635d +1427 141f 6352 635e +141f 142b 635b 635e +1420 1422 634a 6362 +1423 1420 634d 6361 +142e 1420 6361 6362 +1422 1421 634b 6365 +1421 1425 6356 6366 +1430 1421 6365 6368 +1421 1431 6366 6367 +1421 1432 6367 6368 +142e 1422 6362 636a +1422 1430 6365 6369 +1422 1433 6369 636a +142a 1423 6358 6363 +1423 142e 6361 6364 +142f 1423 6363 6364 +1425 1424 6350 6370 +1424 1428 6354 6371 +1436 1424 6370 6372 +1424 1437 6371 6372 +1431 1425 6366 6373 +1425 1436 6370 6373 +1426 1427 6353 6374 +1428 1426 6355 6375 +1426 1438 6374 6376 +1439 1426 6375 6376 +1427 142b 635e 6377 +1438 1427 6374 6379 +1427 143a 6377 6378 +1427 143b 6378 6379 +1437 1428 6371 637a +1428 1439 6375 637b +143c 1428 637a 637c +1428 143d 637b 637c +1429 142a 6359 636c +1429 1434 636c 636d +142a 142f 6363 636e +1434 142a 636c 636f +142a 1435 636e 636f +142b 142c 635d 637d +143a 142b 6377 6380 +142b 143e 637d 6380 +142c 142d 635f 637e +143e 142c 637d 637f +142c 143f 637e 637f +143f 142d 637e 8c2f +142d 232d 82c4 82c6 +142d 2331 8ba1 8c2f +142d 2480 82c6 8c3b +2481 142d 8ba1 8c3b +142f 142e 6364 638b +142e 1433 636a 638a +142e 1445 638a 638b +1435 142f 636e 63ec +142f 1445 638b 63d5 +142f 1469 63d5 63ec +1430 1432 6368 6384 +1433 1430 6369 6385 +1430 1442 6384 6385 +1432 1431 6367 6381 +1431 1436 6373 6382 +1440 1431 6381 6383 +1431 1441 6382 6383 +1432 1440 6381 6386 +1442 1432 6384 6387 +1432 1443 6386 6387 +1433 1442 6385 638c +1445 1433 638a 638d +1433 1446 638c 638d +1434 1435 636f 63fc +1434 147e 63fc 697c +1435 1469 63ec 63ee +1435 1476 63ee 63fa +1435 147d 63fa 63fb +1435 147e 63fb 63fc +1436 1437 6372 6388 +1441 1436 6382 6389 +1436 1444 6388 6389 +1437 143c 637a 638f +1444 1437 6388 638e +1447 1437 638e 638f +1439 1438 6376 641a +1438 143b 6379 6415 +1438 148a 6415 6419 +1438 148d 6419 641a +143d 1439 637b 6425 +1439 148d 641a 6425 +143b 143a 6378 6413 +143a 143e 6380 6412 +143a 1488 6412 6413 +143b 1488 6413 6416 +148a 143b 6415 6417 +143b 148b 6416 6418 +148c 143b 6417 6418 +143c 143d 637c 6430 +1447 143c 638f 6432 +143c 149a 6430 6432 +143d 148d 6425 6426 +143d 1490 6426 642b +143d 1497 642b 6431 +149a 143d 6430 6431 +143e 143f 637f 800e +1488 143e 6412 6414 +1489 143e 6414 8c2a +143e 2331 800e 8c2e +2483 143e 8ae1 8c2e +143e 2484 8ae1 8c2a +2331 143f 800e 8c2f +1440 1441 6383 6390 +1443 1440 6386 6392 +1440 1444 6390 6391 +1440 1448 6391 6394 +1449 1440 6392 6393 +144a 1440 6393 6394 +1441 1444 6389 6390 +1442 1443 6387 63a8 +1446 1442 638c 63aa +1442 1450 63a8 63aa +1443 1449 6392 639a +1443 144c 639a 639c +1443 1450 639c 63a8 +1444 1447 638e 6396 +1448 1444 6391 6395 +144b 1444 6395 6396 +1445 1446 638d 63be +1445 145f 63be 63d1 +1445 1467 63d1 63d4 +1445 1469 63d4 63d5 +1450 1446 63a9 63aa +1446 1456 63a9 63b9 +1446 145e 63b9 63bd +1446 145f 63bd 63be +144b 1447 6396 6df1 +1447 149a 6432 6df3 +199f 1447 6df1 6df3 +144a 1448 6394 63b7 +1448 144b 6395 63ca +145c 1448 63b7 63ca +1449 144a 6393 63a4 +1449 144c 6398 639a +144d 1449 6398 639e +1452 1449 639e 63a4 +1452 144a 63a4 63b0 +145b 144a 63b0 63b6 +145c 144a 63b6 63b7 +145c 144b 63ca 63cc +1465 144b 63cc 6df0 +199f 144b 6df0 6df1 +144d 144c 6397 6398 +144c 144e 6397 6399 +144c 144f 6399 639b +144c 1450 639b 639c +144e 144d 6397 639d +1451 144d 639d 639f +144d 1452 639e 63a0 +1453 144d 639f 63a0 +144f 144e 6399 63a1 +144e 1451 639d 63a2 +1454 144e 63a1 63a3 +144e 1455 63a2 63a3 +1450 144f 639b 63a5 +144f 1454 63a1 63a6 +1456 144f 63a5 63a7 +144f 1457 63a6 63a7 +1450 1456 63a5 63a9 +1451 1453 639f 63ab +1455 1451 63a2 63ac +1451 1458 63ab 63ad +1459 1451 63ac 63ae +1451 145a 63ad 63ae +1453 1452 63a0 63af +145b 1452 63af 63b0 +1458 1453 63ab 63b1 +1453 145b 63af 63b1 +1454 1455 63a3 63b2 +1457 1454 63a6 63b3 +1455 1459 63ac 63b5 +1456 1457 63a7 63b8 +1456 145d 63b8 63ba +145e 1456 63b9 63ba +145d 1457 63b8 63bc +145a 1458 63ad 63bf +1458 145b 63b1 63c0 +1460 1458 63bf 63c1 +1458 1461 63c0 63c1 +1459 145a 63ae 63c2 +1459 1462 63c2 63c4 +145a 1460 63bf 63c6 +1462 145a 63c2 63c6 +145b 145c 63b6 63c7 +1461 145b 63c0 63c8 +145b 1463 63c7 63c9 +1464 145b 63c8 63c9 +1463 145c 63c7 63cb +1465 145c 63cb 63cc +145e 145d 63ba 63cd +1466 145d 63cd 63cf +145f 145e 63bd 63d0 +145e 1466 63cd 63d0 +145f 1466 63d0 63d2 +1467 145f 63d1 63d3 +145f 1468 63d2 63d3 +1460 1461 63c1 63d6 +1462 1460 63c6 63d7 +1460 146a 63d6 63da +146b 1460 63d7 63d9 +146c 1460 63d8 63da +1460 146d 63d8 63d9 +1461 1464 63c8 63db +146a 1461 63d6 63db +1462 146b 63d7 63dd +146e 1462 63dc 63de +1462 146f 63dd 63de +1464 1463 63c9 63e0 +1463 1465 63cb 63e3 +1470 1463 63e0 63e2 +1471 1463 63e2 63e3 +146a 1464 63db 63e1 +1464 1470 63e0 63e1 +1471 1465 63e3 64c5 +14e1 1465 64c5 64cf +14f3 1465 64cf 6df2 +1465 199f 6df0 6df2 +1468 1466 63d2 63e4 +1467 1468 63d3 63e6 +1469 1467 63d4 63e7 +1467 1472 63e6 63e8 +1473 1467 63e7 63e9 +1467 1474 63e8 63e9 +1472 1468 63e6 63eb +1468 1475 63ea 63eb +1469 1473 63e7 63ed +1469 1476 63ed 63ee +146c 146a 63da 6488 +146a 1470 63e1 649e +146a 14c3 6486 6488 +14c5 146a 6486 648c +14cd 146a 648c 649e +146b 146d 63d9 6497 +146f 146b 63dd 64b3 +146b 14d4 6497 64b3 +146d 146c 63d8 6487 +14c3 146c 6487 6488 +146d 14c2 6481 6483 +14c3 146d 6481 6487 +146d 14ca 6483 6496 +146d 14d4 6496 6497 +146e 146f 63de 64da +14b6 146e 64eb 64ec +146e 14f8 64da 64ec +146f 14d4 64b3 64b5 +146f 14e4 64b5 64d9 +146f 14f8 64d9 64da +1470 1471 63e2 64a3 +14cd 1470 649e 64a3 +1471 14cd 64a2 64a3 +14d1 1471 64a2 64ae +14e1 1471 64ae 64c5 +1474 1472 63e8 63f1 +1472 1475 63eb 63f2 +1478 1472 63f1 63f3 +1472 1479 63f2 63f3 +1473 1474 63e9 63f4 +1476 1473 63ed 63f5 +1473 147a 63f4 63f5 +1474 1478 63f1 63f6 +147a 1474 63f4 63f7 +1474 147b 63f6 63f7 +1475 1477 63ef 63f8 +1479 1475 63f2 63f9 +1475 147c 63f8 63f9 +1476 147a 63f5 63fd +147d 1476 63fa 63fe +1476 147f 63fd 63fe +147c 1477 63f8 6400 +1480 1477 6400 6401 +1478 1479 63f3 6402 +147b 1478 63f6 6406 +1478 1481 6402 6405 +1478 1483 6405 6406 +1479 147c 63f9 6403 +1481 1479 6402 6404 +1479 1482 6403 6404 +147a 147b 63f7 640e +147f 147a 63fd 640f +147a 1486 640e 640f +147b 1483 6406 6410 +1486 147b 640e 6411 +147b 1487 6410 6411 +147c 1480 6400 6408 +1482 147c 6403 6407 +1484 147c 6407 6408 +147e 147d 63fb 79af +147d 147f 63fe 6f28 +147d 173a 79ae 79af +147d 1820 6f28 79ae +173a 147e 697b 79af +147f 1486 640f 6b59 +147f 1820 6b59 6f28 +1484 1480 6408 6b4b +1480 181c 6b49 6b4b +1481 1482 6404 6409 +1483 1481 6405 640d +1482 1484 6407 640b +1485 1482 640a 640b +1487 1483 6410 6b50 +1485 1484 640b 6b44 +181a 1484 6b44 6b47 +181c 1484 6b47 6b4b +181a 1485 6b41 6b44 +1486 1487 6411 6b56 +1486 173c 6b56 6b57 +1486 1820 6b57 6b59 +1487 173c 6b55 6b56 +1487 173d 6b54 6b55 +1488 1489 6414 641b +148b 1488 6416 641c +1488 148e 641b 641c +148e 1489 641b 82c8 +2484 1489 82c8 8c2a +148a 148c 6417 641d +148d 148a 6419 641e +148a 148f 641d 641f +1490 148a 641e 641f +148c 148b 6418 6420 +148b 148e 641c 6421 +1491 148b 6420 6422 +148b 1492 6421 6423 +1493 148b 6422 6423 +148f 148c 641d 6424 +148c 1491 6420 6424 +148d 1490 641e 6426 +1492 148e 6421 8bb0 +148e 2484 82c8 8b70 +2486 148e 82cd 8b70 +2487 148e 82cb 82cd +148e 2488 82cb 8bb0 +1490 148f 641f 6427 +148f 1491 6424 6428 +1494 148f 6427 642a +148f 1495 6428 6429 +148f 1496 6429 642a +1490 1494 6427 642c +1497 1490 642b 642c +1491 1493 6422 642d +1495 1491 6428 642e +1491 1498 642d 642e +1493 1492 6423 8b0e +2336 1492 8b0e 8bf9 +1492 23a5 82d0 8bf9 +2488 1492 82d0 8bb0 +1498 1493 642d 642f +1499 1493 642f 82cf +2336 1493 82cf 8b0e +1494 1496 642a 646f +1497 1494 642c 6473 +1494 14ba 646f 6472 +1494 14bc 6472 6473 +1496 1495 6429 646c +1495 1498 642e 646b +1495 14b7 646b 646d +14b8 1495 646c 646d +1496 14b8 646c 646e +1496 14b9 646e 6470 +14ba 1496 646f 6470 +149a 1497 6431 6de0 +1497 14bc 6473 6ddf +1497 1996 6ddf 6de0 +1498 1499 642f 646a +1498 14b7 646a 646b +14b7 1499 646a 8b81 +1499 2336 82cf 8ba5 +2337 1499 8ae5 8ba5 +248a 1499 8550 8ae5 +1499 25de 8550 8b81 +149a 1996 6de0 6df5 +199f 149a 6df3 6df5 +149d 149b 6437 643c +149f 149b 643c 643e +149c 149d 6438 643f +149e 149c 643a 6440 +149c 14a0 643f 6441 +14a1 149c 6440 6441 +149d 149f 643c 6442 +14a0 149d 643f 6443 +149d 14a2 6442 6443 +149e 14a1 6440 6445 +14a3 149e 6444 6445 +14a2 149f 6442 6449 +149f 14a4 6448 644b +14a5 149f 6449 644a +14a6 149f 644a 644b +14a1 14a0 6441 644d +14a0 14a2 6443 644e +14a7 14a0 644d 644e +14a3 14a1 6445 644f +14a1 14a7 644d 6450 +14a8 14a1 644f 6450 +14a2 14a5 6449 6452 +14a7 14a2 644e 6451 +14a9 14a2 6451 6453 +14a2 14aa 6452 6453 +14a3 14a8 644f 6455 +14ab 14a3 6454 6455 +14a6 14a4 644b 645f +14b1 14a4 645f 6461 +14a4 14b2 6460 6461 +14a5 14a6 644a 645d +14aa 14a5 6452 645e +14a5 14b0 645d 645e +14b0 14a6 645d 6462 +14a6 14b1 645f 6462 +14a8 14a7 6450 6457 +14a7 14a9 6451 6458 +14ac 14a7 6457 6459 +14a7 14ad 6458 6459 +14ab 14a8 6455 645a +14a8 14ac 6457 645c +14ae 14a8 645a 645b +14af 14a8 645b 645c +14a9 14aa 6453 6463 +14ad 14a9 6458 6466 +14a9 14b3 6463 6467 +14b5 14a9 6466 6467 +14aa 14b0 645e 6464 +14b3 14aa 6463 6465 +14aa 14b4 6464 6465 +14ab 14ae 645a 65c5 +14ac 14ad 6459 6dde +14af 14ac 645c 65d3 +1582 14ac 65d3 6dde +14ad 14b5 6466 716e +1582 14ad 6dde 7163 +1b6c 14ad 7163 716e +14ae 14af 645b 65d0 +1579 14ae 65c4 65c7 +157d 14ae 65c7 65d0 +157d 14af 65d0 65d1 +1581 14af 65d1 65d4 +14af 1582 65d3 65d5 +1583 14af 65d4 65d5 +14b0 14b1 6462 64f0 +14b4 14b0 6464 64f5 +14b0 1500 64f0 64f3 +14b0 1502 64f3 64f5 +14b1 14b2 6461 64ee +14b1 1500 64ee 64f0 +14b2 14b6 6469 64ea +14b2 14f8 64ea 64ed +14b2 14f9 64ed 64ef +1500 14b2 64ee 64ef +14b3 14b4 6465 715a +14b5 14b3 6467 78cd +14b3 1505 715a 715c +14b3 1b69 715c 78d0 +1b95 14b3 78cd 78d0 +14b4 1502 64f5 64fb +14b4 1505 64fb 715a +1b6c 14b5 716e 716f +1b70 14b5 716f 78cf +14b5 1b72 78ce 78cf +14b5 1b95 78cd 78ce +14f8 14b6 64ea 64ec +14b8 14b7 646d 8a90 +25de 14b7 8a90 8b81 +14b9 14b8 646e 6471 +14bb 14b8 6471 8b76 +25dd 14b8 8554 8b80 +14b8 25de 8a90 8b80 +14b8 25df 8554 8b76 +14ba 14b9 6470 6474 +14b9 14bb 6471 6475 +14bd 14b9 6474 6476 +14b9 14be 6475 6476 +14bc 14ba 6472 6477 +14ba 14bd 6474 6478 +14bf 14ba 6477 6478 +14be 14bb 6475 6479 +14c0 14bb 6479 8a8f +25df 14bb 8a8f 8b76 +14bc 14bf 6477 6de1 +1996 14bc 6ddf 6de2 +14bc 1997 6de1 6de2 +14bd 14be 6476 6de4 +14bf 14bd 6478 6de7 +14bd 1999 6de4 6de7 +14be 14c0 6479 6de3 +14be 1998 6de3 6de5 +1999 14be 6de4 6de5 +14f2 14bf 6dee 6def +1997 14bf 6de1 6dee +14bf 1999 6de7 6deb +14bf 199d 6deb 6def +1998 14c0 6de3 6de6 +199a 14c0 6de6 854d +25dc 14c0 854d 8b5b +25df 14c0 8551 8a8f +14c0 25e0 8551 8b5b +14c2 14c1 647a 647b +14c1 14c3 647a 647c +14c4 14c1 647b 647d +14c1 14c5 647c 647e +14c6 14c1 647d 647f +14c1 14c7 647e 6480 +14c8 14c1 647f 6480 +14c3 14c2 647a 6481 +14c2 14c4 647b 6482 +14c2 14c9 6482 6484 +14ca 14c2 6483 6485 +14c2 14cb 6484 6485 +14c5 14c3 647c 6486 +14c4 14c6 647d 6489 +14c9 14c4 6482 648a +14c4 14cc 6489 648a +14c7 14c5 647e 648b +14cd 14c5 648b 648c +14c6 14c8 647f 648d +14cc 14c6 6489 648e +14c6 14ce 648d 648f +14cf 14c6 648e 648f +14c8 14c7 6480 6490 +14c7 14cd 648b 6491 +14d0 14c7 6490 6492 +14c7 14d1 6491 6493 +14d2 14c7 6492 6493 +14ce 14c8 648d 6494 +14c8 14d0 6490 6495 +14d3 14c8 6494 6495 +14cb 14c9 6484 6498 +14c9 14cc 648a 6499 +14d5 14c9 6498 649a +14c9 14d6 6499 649a +14ca 14cb 6485 649b +14d4 14ca 6496 649c +14ca 14d7 649b 649c +14cb 14d5 6498 649d +14d7 14cb 649b 649d +14cc 14cf 648e 649f +14d6 14cc 6499 64a0 +14cc 14d8 649f 64a1 +14d9 14cc 64a0 64a1 +14d1 14cd 6491 64a2 +14cf 14ce 648f 64a4 +14ce 14d3 6494 64a5 +14da 14ce 64a4 64a7 +14ce 14db 64a5 64a6 +14ce 14dc 64a6 64a7 +14d8 14cf 649f 64a8 +14cf 14da 64a4 64a8 +14d0 14d2 6492 64a9 +14d3 14d0 6495 64aa +14d0 14dd 64a9 64ab +14de 14d0 64aa 64ac +14d0 14df 64ab 64ac +14d2 14d1 6493 64ad +14e0 14d1 64ad 64af +14d1 14e1 64ae 64af +14dd 14d2 64a9 64b0 +14d2 14e0 64ad 64b1 +14e2 14d2 64b0 64b1 +14db 14d3 64a5 64b2 +14d3 14de 64aa 64b2 +14d4 14d7 649c 64b4 +14d4 14e3 64b4 64b6 +14e4 14d4 64b5 64b6 +14d5 14d6 649a 64b7 +14d7 14d5 649d 64b8 +14d5 14e5 64b7 64ba +14e6 14d5 64b8 64b9 +14e7 14d5 64b9 64bb +14d5 14e8 64ba 64bc +14e9 14d5 64bb 64bc +14d6 14d9 64a0 64bd +14e5 14d6 64b7 64bd +14e3 14d7 64b4 64be +14d7 14e6 64b8 64be +14d9 14d8 64a1 64bf +14d8 14da 64a8 64c0 +14ea 14d8 64bf 64c2 +14d8 14eb 64c0 64c1 +14d8 14ec 64c1 64c2 +14e5 14d9 64bd 64c3 +14d9 14ea 64bf 64c4 +14ed 14d9 64c3 64c4 +14da 14dc 64a7 64d5 +14eb 14da 64c0 64d6 +14da 14f6 64d5 64d6 +14dc 14db 64a6 64d3 +14db 14de 64b2 64ca +14db 14f1 64ca 64d4 +14f5 14db 64d3 64d4 +14dc 14f5 64d3 64d7 +14f6 14dc 64d5 64d8 +14dc 14f7 64d7 64d8 +14df 14dd 64ab 64c6 +14dd 14e2 64b0 64c7 +14ee 14dd 64c6 64c8 +14dd 14ef 64c7 64c8 +14de 14df 64ac 64c9 +14de 14f0 64c9 64cb +14f1 14de 64ca 64cb +14df 14ee 64c6 64cc +14f0 14df 64c9 64cc +14e0 14e1 64af 64cd +14e2 14e0 64b1 64ce +14e0 14f2 64cd 64ce +14f2 14e1 64cd 64d0 +14e1 14f3 64cf 64d0 +14ef 14e2 64c7 64d2 +14e2 14f2 64ce 64d1 +14e2 14f4 64d1 64d2 +14e4 14e3 64b6 64db +14e3 14e6 64be 64dc +14f9 14e3 64db 64dd +14e3 14fa 64dc 64dd +14f8 14e4 64d9 64de +14e4 14f9 64db 64de +14e8 14e5 64ba 64e1 +14e5 14ed 64c3 64e1 +14e6 14e7 64b9 64df +14fa 14e6 64dc 64e0 +14e6 14fb 64df 64e0 +14e7 14e9 64bb 64e2 +14fb 14e7 64df 64e3 +14e7 14fc 64e2 64e3 +14e9 14e8 64bc 64e4 +14e8 14ed 64e1 64e8 +14fd 14e8 64e4 64e6 +14fe 14e8 64e6 64e7 +14ff 14e8 64e7 64e8 +14fc 14e9 64e2 64e5 +14e9 14fd 64e4 64e5 +14ea 14ec 64c2 6bc5 +14ed 14ea 64c4 6bc3 +1850 14ea 6bc3 6bc5 +14ec 14eb 64c1 794d +14eb 14f6 64d6 794a +14eb 1efc 794a 794b +14eb 1efd 794b 794d +1850 14ec 6bc5 6bc6 +1861 14ec 6bc6 794f +14ec 1efd 794d 794f +14ff 14ed 64e8 6ba6 +1850 14ed 6ba6 6bc3 +14ee 14ef 64c8 712d +14f0 14ee 64cc 7134 +14ee 1b4f 7126 7127 +1b52 14ee 7126 712d +14ee 1b54 7127 7134 +14ef 14f4 64d2 712f +14ef 1b52 712c 712d +1b53 14ef 712c 712f +14f1 14f0 64cb 713c +14f0 1b54 7134 7135 +14f0 1b5a 7135 713c +14f5 14f1 64d4 713d +14f1 1b5a 713c 713f +1b5b 14f1 713e 713f +1b5f 14f1 713d 713e +14f2 14f3 64d0 6df7 +14f4 14f2 64d1 6df8 +1997 14f2 6dee 6df7 +14f2 199d 6def 6df8 +14f3 1996 6df4 6df6 +14f3 1997 6df6 6df7 +14f3 199f 6df2 6df4 +14f4 199d 6df8 712e +14f4 1b53 712e 712f +14f7 14f5 64d7 7945 +14f5 1b5f 713d 7944 +14f5 1b67 7944 7945 +14f6 14f7 64d8 7948 +14f6 1efc 7948 794a +14f7 1533 7943 7946 +1b67 14f7 7943 7945 +14f7 1efc 7946 7948 +14f8 14f9 64de 64ed +14f9 14fa 64dd 64f2 +1500 14f9 64ef 64f1 +1501 14f9 64f1 64f2 +14fa 14fb 64e0 64f8 +1501 14fa 64f2 64f6 +1503 14fa 64f6 64f8 +14fb 14fc 64e3 6bdd +1503 14fb 64f8 7155 +14fb 1869 6bdd 7155 +14fc 14fd 64e5 6b92 +14fc 1839 6b92 6b94 +14fc 1847 6b94 6bdc +14fc 1869 6bdc 6bdd +14fd 14fe 64e6 6b7d +1831 14fd 6b7c 6b7d +14fd 1839 6b7c 6b92 +14fe 14ff 64e7 6b89 +14fe 1831 6b7b 6b7d +1835 14fe 6b87 6b89 +1836 14fe 6b7b 6b87 +1835 14ff 6b89 6b8b +1841 14ff 6b8b 6ba5 +1850 14ff 6ba5 6ba6 +1500 1501 64f1 64f4 +1502 1500 64f3 64f4 +1502 1501 64f4 64f7 +1501 1503 64f6 64f7 +1502 1503 64f7 64f9 +1502 1504 64f9 64fa +1502 1505 64fa 64fb +1504 1503 64f9 7156 +1503 1869 7155 7156 +1505 1504 64fa 7158 +1504 1869 7156 7157 +1504 186a 7157 7159 +1b68 1504 7158 7159 +1505 1b68 7158 715b +1505 1b69 715b 715c +1507 1506 6500 6501 +1584 1507 65da 65dc +1585 1507 65dc 65df +1587 1507 65df 65e0 +1509 1508 6503 6504 +1508 150a 6503 8b26 +150b 1508 6504 6505 +150c 1508 6505 8a15 +25fa 1508 8a15 8b26 +150a 1509 6503 6506 +1509 150b 6504 6509 +150d 1509 6506 650a +1509 1510 6509 650a +150a 150d 6506 6507 +150a 150e 6507 6508 +150a 150f 6508 8a2a +150a 25f7 8a2a 8b16 +25f9 150a 8573 8b16 +150a 25fa 8573 8b26 +150b 150c 6505 650b +1510 150b 6509 650c +150b 1511 650b 650d +1512 150b 650c 650d +1511 150c 650b 650e +1513 150c 650e 8b23 +25fa 150c 8576 8a15 +150c 25fb 8576 89f5 +150c 25fd 89f5 8b6a +2601 150c 8b23 8b6a +150e 150d 6507 650f +150d 1510 650a 6510 +1514 150d 650f 6511 +150d 1515 6510 6511 +150f 150e 6508 6512 +150e 1514 650f 6513 +1516 150e 6512 6514 +150e 1517 6513 6514 +150f 1516 6512 6515 +150f 1518 6515 8a5a +150f 25f5 8a5a 8b17 +25f7 150f 8a2a 8b17 +1510 1512 650c 6516 +1515 1510 6510 6517 +1510 1519 6516 6517 +1512 1511 650d 6518 +1511 1513 650e 6519 +151a 1511 6518 651a +1511 151b 6519 651a +1519 1512 6516 651b +1512 151a 6518 651b +151b 1513 6519 651c +151c 1513 651c 651d +151d 1513 651d 857a +2601 1513 857a 8b23 +1514 1515 6511 651e +1517 1514 6513 651f +1514 151e 651e 6520 +151f 1514 651f 6520 +1515 1519 6517 6521 +151e 1515 651e 6522 +1515 1520 6521 6522 +1516 1517 6514 6527 +1518 1516 6515 6523 +1521 1516 6523 6524 +1522 1516 6524 6527 +1517 151f 651f 6529 +1522 1517 6527 6528 +1525 1517 6528 652a +1517 1526 6529 652a +1518 1521 6523 856c +1518 25f3 856c 856f +1518 25f4 856f 8b11 +25f5 1518 8a5a 8b11 +1519 151a 651b 652b +1520 1519 6521 652c +1519 1527 652b 652d +1528 1519 652c 652e +1519 1529 652d 652e +151a 151b 651a 652f +1527 151a 652b 6530 +151a 152a 652f 6530 +151b 151c 651c 6531 +152a 151b 652f 6533 +151b 152b 6531 6532 +151b 152c 6532 6533 +151c 151d 651d 6534 +152b 151c 6531 6536 +151c 152d 6534 6535 +151c 152e 6535 6536 +152d 151d 6534 8a49 +151d 1f6d 7a0f 8a49 +1f6e 151d 7a0f 8ac4 +25fc 151d 8ac4 8b22 +151d 2601 857a 8b22 +151f 151e 6520 6539 +151e 1520 6522 653b +1530 151e 6539 653c +151e 1531 653b 653c +1526 151f 6529 653a +151f 1530 6539 653a +1520 1528 652c 6542 +1531 1520 653b 6542 +1521 1522 6524 6525 +1521 1523 6525 6526 +1521 1524 6526 8ad2 +25f3 1521 856c 8ad2 +1523 1522 6525 6538 +1522 1525 6528 6537 +1522 152f 6537 6538 +1524 1523 6526 7140 +1523 152f 6538 7142 +1b60 1523 7140 7142 +1524 1b60 7140 7141 +1524 1b61 7141 8568 +1524 25f1 8568 856b +1524 25f2 856b 8af4 +25f3 1524 8ad2 8af4 +1525 1526 652a 653d +152f 1525 6537 6540 +1525 1532 653d 6541 +1534 1525 6540 6541 +1526 1530 653a 653f +1532 1526 653d 653e +1533 1526 653e 653f +1529 1527 652d 7182 +1527 152a 6530 6a81 +1527 17ba 6a81 7182 +1528 1529 652e 6be5 +1531 1528 6542 7951 +1528 1857 6be5 6be6 +1528 1860 6be6 7951 +17ba 1529 6bd7 7182 +1853 1529 6bd5 6bd7 +1529 1857 6bd5 6be5 +152a 152c 6533 6a7d +152a 17b8 6a7d 6a80 +152a 17ba 6a80 6a81 +152c 152b 6532 6a78 +152b 152e 6536 6a75 +152b 17b3 6a75 6a78 +152c 17b3 6a78 6a7e +17b8 152c 6a7d 6a7f +152c 17b9 6a7e 6a7f +152e 152d 6535 6a73 +17b1 152d 6a73 6a74 +17b2 152d 6a74 857c +1f6d 152d 857c 8a49 +152e 17b1 6a73 6a76 +17b3 152e 6a75 6a77 +152e 17b4 6a76 6a77 +152f 1534 6540 7146 +1b60 152f 7142 7143 +1b62 152f 7143 7146 +1530 1531 653c 794c +1533 1530 653f 7947 +1efc 1530 7947 7949 +1efd 1530 7949 794c +1860 1531 7950 7951 +1861 1531 794e 7950 +1efd 1531 794c 794e +1532 1533 653e 7942 +1534 1532 6541 7150 +1b67 1532 7150 7942 +1b67 1533 7942 7943 +1efc 1533 7946 7947 +1b62 1534 7146 7149 +1b65 1534 7149 714f +1b67 1534 714f 7150 +1536 1535 6543 6544 +1535 1537 6543 6545 +1538 1535 6544 6546 +1535 1539 6545 6547 +153a 1535 6546 6548 +1535 153b 6547 6548 +1537 1536 6543 6549 +1536 1538 6544 654a +153c 1536 6549 654b +1536 153d 654a 654c +153e 1536 654b 654c +1539 1537 6545 654d +1537 153c 6549 654e +153f 1537 654d 654f +1537 1540 654e 654f +1538 153a 6546 6550 +153d 1538 654a 6551 +1538 1541 6550 6552 +1542 1538 6551 6552 +153b 1539 6547 6553 +1539 153f 654d 6554 +1543 1539 6553 6555 +1539 1544 6554 6556 +1545 1539 6555 6556 +153a 153b 6548 6557 +1541 153a 6550 6558 +153a 1546 6557 6559 +1547 153a 6558 6559 +153b 1543 6553 655a +1546 153b 6557 655b +153b 1548 655a 655b +153c 153e 654b 655c +1540 153c 654e 655d +153c 1549 655c 655e +154a 153c 655d 655e +153e 153d 654c 655f +153d 1542 6551 6560 +153d 154b 6560 6561 +1549 153e 655c 6563 +153f 1540 654f 6564 +1544 153f 6554 6565 +153f 154c 6564 6565 +1540 154a 655d 6566 +154c 1540 6564 6567 +1540 154d 6566 6568 +154e 1540 6567 6568 +1542 1541 6552 6569 +1541 1547 6558 656c +154f 1541 6569 656d +1541 1551 656c 656d +154b 1542 6560 656a +1542 154f 6569 656b +1550 1542 656a 656b +1543 1545 6555 656e +1548 1543 655a 656f +1543 1552 656e 656f +1545 1544 6556 6570 +1544 154c 6565 6571 +1553 1544 6570 6572 +1544 1554 6571 6572 +1552 1545 656e 6573 +1545 1553 6570 6574 +1555 1545 6573 6574 +1547 1546 6559 6578 +1546 1548 655b 6577 +1546 1556 6577 6579 +1557 1546 6578 6579 +1551 1547 656c 657c +1547 1557 6578 657d +1559 1547 657c 657d +1548 1552 656f 657a +1556 1548 6577 657b +1548 1558 657a 657b +154a 1549 655e 6584 +155e 1549 6584 6585 +154d 154a 6566 6586 +154a 155e 6584 6587 +155f 154a 6586 6587 +154b 1550 656a 6576 +154c 154e 6567 6589 +1554 154c 6571 658a +154c 1560 6589 658b +1561 154c 658a 658b +154e 154d 6568 658c +154d 155f 6586 658d +1562 154d 658c 658d +1560 154e 6589 658e +154e 1562 658c 658f +1563 154e 658e 658f +1550 154f 656b 657f +154f 1551 656d 657e +154f 155a 657e 6580 +155b 154f 657f 6581 +154f 155c 6580 6581 +1550 155b 657f 6591 +1551 1559 657c 6582 +155a 1551 657e 6583 +1551 155d 6582 6583 +1552 1555 6573 6592 +1558 1552 657a 6593 +1552 1564 6592 6594 +1565 1552 6593 6594 +1553 1554 6572 6595 +1555 1553 6574 6596 +1553 1566 6595 6598 +1567 1553 6596 6597 +1568 1553 6597 6598 +1554 1561 658a 6599 +1566 1554 6595 6599 +1564 1555 6592 659b +1555 1567 6596 659a +1555 1569 659a 659b +1557 1556 6579 659c +1556 1558 657b 659d +156a 1556 659c 659e +1556 156b 659d 659f +156c 1556 659e 659f +1559 1557 657d 65a0 +1557 156a 659c 65a1 +156d 1557 65a0 65a1 +1558 1565 6593 65a3 +156b 1558 659d 65a2 +156e 1558 65a2 65a3 +155d 1559 6582 65a4 +1559 156d 65a0 65a5 +156f 1559 65a4 65a5 +155c 155a 6580 65a6 +155a 155d 6583 65a7 +155a 1570 65a7 65a8 +155b 155c 6581 65aa +155d 156f 65a4 65ad +1570 155d 65a7 65ad +155f 155e 6587 65ae +1562 155f 658d 65b0 +1571 155f 65b0 65b1 +1561 1560 658b 65b2 +1560 1563 658e 65b3 +1572 1560 65b2 65b4 +1560 1573 65b3 65b5 +1574 1560 65b4 65b5 +1566 1561 6599 65b6 +1561 1572 65b2 65b7 +1575 1561 65b6 65b7 +1563 1562 658f 65b8 +1562 1571 65b0 65ba +1576 1562 65b8 65b9 +1577 1562 65b9 65ba +1573 1563 65b3 65bb +1563 1576 65b8 65bc +1578 1563 65bb 65bc +1565 1564 6594 668f +1564 1569 659b 6685 +1564 15d2 6685 668e +1564 15d8 668e 668f +156e 1565 65a3 66a1 +1565 15d8 668f 66a1 +1568 1566 6598 6692 +1566 1575 65b6 66a5 +15d9 1566 6692 66a4 +15de 1566 66a4 66a5 +1567 1568 6597 6686 +1569 1567 659a 6682 +15d0 1567 6682 6686 +15d0 1568 6686 6688 +15d4 1568 6688 6691 +15d9 1568 6691 6692 +1569 15d0 6682 6683 +1569 15d1 6683 6684 +1569 15d2 6684 6685 +156a 156c 659e 6648 +156d 156a 65a1 6646 +15b2 156a 6646 6648 +156c 156b 659f 665a +156b 156e 65a2 666c +15bf 156b 665a 666c +156c 15b2 6647 6648 +15b4 156c 6647 664e +15bb 156c 664e 6659 +15bf 156c 6659 665a +156f 156d 65a5 663d +156d 15af 663c 663d +15b2 156d 663c 6646 +15bf 156e 666c 666e +15c7 156e 666e 66a3 +156e 15d8 66a1 66a3 +1570 156f 65ad 6649 +15af 156f 663b 663d +156f 15b1 663b 6642 +156f 15b6 6642 6649 +1570 15b6 6649 6653 +1570 15bd 6653 665b +1577 1571 65ba 65cd +1571 157c 65cb 65cd +1572 1574 65b4 6722 +1575 1572 65b7 66b7 +15e5 1572 66b7 6722 +1574 1573 65b5 672a +1573 1578 65bb 68da +160f 1573 672a 68d9 +1707 1573 68d9 68da +1574 15e5 6721 6722 +15e8 1574 6721 6724 +160d 1574 6724 6729 +160f 1574 6729 672a +15de 1575 66a5 66b5 +15e5 1575 66b5 66b7 +1576 1577 65b9 68e1 +1578 1576 65bc 68dc +1580 1576 68dc 68e1 +1577 157b 65cc 65ce +157c 1577 65cc 65cd +1577 1580 65ce 68e1 +1578 1580 68dc 68de +1707 1578 68da 68dd +1708 1578 68dd 68e0 +1578 1709 68de 68df +1578 170a 68df 68e0 +157a 1579 65c0 65c6 +157d 1579 65c6 65c7 +157b 157a 65c1 65c8 +157a 157d 65c6 65c9 +157e 157a 65c8 65ca +157a 157f 65c9 65ca +157c 157b 65c3 65cc +157b 157e 65c8 65cf +1580 157b 65ce 65cf +157f 157d 65c9 65d2 +157d 1581 65d1 65d2 +157e 157f 65ca 6a9e +1580 157e 65cf 6a9d +1709 157e 6a9d 6a9f +157e 17c9 6a9e 6aa0 +17ca 157e 6a9f 6aa0 +157f 1581 65d2 6aa1 +17c9 157f 6a9e 6aa1 +1709 1580 68de 6a9d +1581 1583 65d4 715d +17c9 1581 6aa1 715e +1581 1b6a 715d 715f +1b6b 1581 715e 715f +1583 1582 65d5 7160 +1b6c 1582 7160 7163 +1b6a 1583 715d 7161 +1583 1b6c 7160 7162 +1b6d 1583 7161 7162 +1585 1584 65db 65dc +1586 1585 65dd 65e1 +1585 1587 65df 65e1 +1586 1587 65e1 68e5 +1593 1586 660d 660f +15a1 1586 660f 68e7 +1589 1588 65e5 65ea +1588 158a 65e6 65eb +158c 1588 65ea 65ec +1588 158d 65eb 65ec +158b 1589 65e8 65ee +1589 158c 65ea 65ed +1589 158e 65ed 65ee +158d 158a 65eb 65f4 +158a 158f 65ef 65f3 +158a 1592 65f3 65f4 +158b 158e 65ee 6607 +159b 158b 6603 6608 +158b 159d 6607 6608 +158c 158d 65ec 65fd +158e 158c 65ed 65fe +158c 1597 65fd 65fe +158d 1592 65f4 65ff +1597 158d 65fd 6600 +158d 1598 65ff 6601 +1599 158d 6600 6601 +158e 1597 65fe 6609 +159d 158e 6607 660a +158e 159e 6609 660c +159f 158e 660a 660b +15a0 158e 660b 660c +158f 1591 65f2 65fa +1592 158f 65f3 65fb +158f 1596 65fa 65fb +1591 1590 65f1 65f7 +1590 1593 65f5 65f8 +1594 1590 65f7 65f9 +1590 1595 65f8 65f9 +1591 1594 65f7 65fc +1596 1591 65fa 65fc +1592 1596 65fb 6611 +1598 1592 65ff 6610 +15a2 1592 6610 6611 +1595 1593 65f8 660e +15a1 1593 660e 660f +1594 1595 65f9 661a +1596 1594 65fc 6617 +15a5 1594 6617 661b +1595 15a1 660e 661d +15a2 1596 6611 6618 +1596 15a5 6617 6619 +15a6 1596 6618 6619 +1597 1599 6600 6612 +159e 1597 6609 6612 +1599 1598 6601 6613 +1598 15a2 6610 6614 +15a3 1598 6613 6615 +1598 15a4 6614 6615 +159e 1599 6612 6616 +1599 15a3 6613 6616 +159a 159b 6604 661f +159c 159a 6605 6620 +159a 15a7 661f 6620 +159b 159d 6608 6621 +15a7 159b 661f 6622 +159b 15a8 6621 6622 +159c 15a7 6620 6624 +159d 159f 660a 6628 +15a8 159d 6621 6629 +159d 15a9 6628 662a +15aa 159d 6629 662a +15a0 159e 660c 662d +159e 15a3 6616 662e +15ac 159e 662d 662f +159e 15ad 662e 662f +159f 15a0 660b 662b +15a9 159f 6628 662c +159f 15ab 662b 662c +15ab 15a0 662b 6630 +15a0 15ac 662d 6630 +15a4 15a2 6614 6655 +15a2 15a6 6618 6656 +15b7 15a2 6655 6656 +15a3 15a4 6615 6660 +15ad 15a3 662e 6672 +15a3 15c0 6660 6672 +15a4 15b3 664b 664c +15b7 15a4 664b 6655 +15a4 15b9 664c 665d +15a4 15c0 665d 6660 +15a6 15a5 6619 666a +15be 15a5 666a 666b +15a6 15b7 6654 6656 +15b8 15a6 6654 6658 +15be 15a6 6658 666a +15a7 15a8 6622 6631 +15a8 15aa 6629 6632 +15aa 15a9 662a 6634 +15a9 15ab 662c 6638 +15ae 15a9 6637 6638 +15ab 15ac 6630 694f +15ae 15ab 6638 66d0 +15ef 15ab 66d0 66da +15f4 15ab 66da 694f +15ac 15ad 662f 6676 +15ac 15ca 6676 694e +15ac 15f4 694e 694f +15c0 15ad 6671 6672 +15ad 15c1 6671 6673 +15ad 15c9 6673 6675 +15ad 15ca 6675 6676 +15ed 15ae 66ce 66cf +15ef 15ae 66cf 66d0 +15b0 15af 6639 663a +15af 15b1 6639 663b +15b2 15af 663a 663c +15b1 15b0 6639 663e +15b0 15b2 663a 663f +15b3 15b0 663e 6640 +15b0 15b4 663f 6641 +15b5 15b0 6640 6641 +15b1 15b3 663e 6643 +15b6 15b1 6642 6644 +15b1 15b7 6643 6645 +15b8 15b1 6644 6645 +15b4 15b2 663f 6647 +15b3 15b5 6640 664a +15b7 15b3 6643 664b +15b3 15b9 664a 664c +15b5 15b4 6641 664d +15ba 15b4 664d 664f +15b4 15bb 664e 664f +15b9 15b5 664a 6650 +15b5 15ba 664d 6651 +15bc 15b5 6650 6651 +15b6 15b8 6644 6652 +15b6 15bd 6652 6653 +15b8 15b7 6645 6654 +15bd 15b8 6652 6657 +15be 15b8 6657 6658 +15b9 15bc 6650 665e +15c0 15b9 665d 665f +15b9 15c1 665e 665f +15ba 15bb 664f 6661 +15bc 15ba 6651 6662 +15ba 15c2 6661 6664 +15c3 15ba 6662 6663 +15c4 15ba 6663 6664 +15bb 15bf 6659 6665 +15c2 15bb 6661 6665 +15c1 15bc 665e 6666 +15bc 15c3 6662 6667 +15c5 15bc 6666 6667 +15bd 15be 6657 6668 +15c2 15bf 6665 666d +15c6 15bf 666d 6670 +15bf 15c7 666e 666f +15bf 15c8 666f 6670 +15c0 15c1 665f 6671 +15c1 15c5 6666 6674 +15c9 15c1 6673 6674 +15c4 15c2 6664 667e +15c2 15c6 666d 667f +15cf 15c2 667e 667f +15c3 15c4 6663 667a +15c5 15c3 6667 6677 +15cb 15c3 6677 667b +15c3 15cd 667a 667b +15cd 15c4 667a 6680 +15c4 15cf 667e 6680 +15c9 15c5 6674 6678 +15c5 15cb 6677 6679 +15cc 15c5 6678 6679 +15c6 15c8 6670 6743 +15cf 15c6 667f 6745 +15c6 1617 6743 6745 +15c8 15c7 666f 66b4 +15d8 15c7 66a2 66a3 +15c7 15db 66a2 66ac +15c7 15e2 66ac 66b4 +15c8 15e2 66b4 673d +15c8 1617 673d 6743 +15ca 15c9 6675 667d +15c9 15cc 6678 667c +15c9 15ce 667c 667d +15ca 15ce 667d 66fe +15ca 15f4 66fe 694e +15cc 15cb 6679 6700 +15cb 15cd 667b 6702 +15cb 15fe 66ff 6700 +15ff 15cb 66ff 6702 +15ce 15cc 667c 66f4 +15fb 15cc 66f4 66f5 +15fe 15cc 66f5 6700 +15cd 15cf 6680 670d +15cd 15ff 6701 6702 +1602 15cd 6701 670b +1604 15cd 670b 670d +15ce 15f2 66f0 66fd +15ce 15f4 66fd 66fe +15ce 15f9 66ef 66f0 +15fb 15ce 66ef 66f4 +1604 15cf 670d 670f +1605 15cf 670f 6744 +1617 15cf 6744 6745 +15d1 15d0 6683 6687 +15d3 15d0 6687 6689 +15d0 15d4 6688 6689 +15d2 15d1 6684 668a +15d1 15d3 6687 668b +15d5 15d1 668a 668c +15d1 15d6 668b 668d +15d7 15d1 668c 668d +15d2 15d5 668a 6690 +15d8 15d2 668e 6690 +15d3 15d4 6689 6693 +15d6 15d3 668b 6694 +15d4 15d9 6691 6696 +15d5 15d7 668c 6699 +15d8 15d5 6690 669a +15d5 15da 6699 669b +15db 15d5 669a 669b +15d7 15d6 668d 669c +15dc 15d6 669c 669e +15dd 15d6 669e 669f +15da 15d7 6699 66a0 +15d7 15dc 669c 66a0 +15d8 15db 669a 66a2 +15d9 15de 66a4 66a7 +15df 15d9 66a6 66a8 +15d9 15e0 66a7 66a8 +15db 15da 669b 66aa +15da 15dc 66a0 66ab +15e1 15da 66aa 66ab +15db 15e1 66aa 66ad +15e2 15db 66ac 66ad +15dc 15dd 669e 66ae +15e1 15dc 66ab 66af +15dc 15e3 66ae 66af +15e3 15dd 66ae 66b1 +15e4 15dd 66b1 66b2 +15e0 15de 66a7 66b6 +15de 15e5 66b5 66b6 +15df 15e0 66a8 66b8 +15df 15e6 66b8 66b9 +15e0 15e5 66b6 66bb +15e6 15e0 66b8 66ba +15e7 15e0 66ba 66bc +15e0 15e8 66bb 66bc +15e2 15e1 66ad 6735 +15e1 15e3 66af 6734 +15e1 1615 6734 6735 +15e2 1615 6735 6739 +15e2 1616 6739 673c +15e2 1617 673c 673d +15e3 15e4 66b1 6737 +15e3 1607 6737 6738 +1608 15e3 6736 6738 +1615 15e3 6734 6736 +15e4 1607 671b 6737 +160a 15e4 671c 673e +15e8 15e5 66bb 6721 +15e6 15e7 66ba 671f +15e6 160b 671f 6720 +15e7 15e8 66bc 6723 +160b 15e7 671f 6726 +15e7 160c 6723 6727 +160e 15e7 6726 6727 +160c 15e8 6723 6725 +15e8 160d 6724 6725 +15ea 15e9 66c2 66c6 +15e9 15eb 66c5 66c6 +15ea 15eb 66c6 66fb +15ea 1603 66fb 6703 +15eb 15ec 66c8 66ed +15eb 15fc 66ed 66f7 +15eb 1601 66f7 66fc +1603 15eb 66fb 66fc +15ec 15f6 66e3 66e4 +15ec 15f8 66e4 66ea +15ec 15fc 66ea 66ed +15ee 15ed 66cc 66d3 +15ed 15ef 66cf 66d4 +15f1 15ed 66d3 66d4 +15f0 15ee 66d1 66d5 +15ee 15f1 66d3 66d5 +15f1 15ef 66d4 66d6 +15f2 15ef 66d6 66d9 +15f4 15ef 66d9 66da +15f0 15f1 66d5 66d7 +15f0 15f3 66d7 66dd +15f5 15f0 66db 66dd +15f1 15f2 66d6 66d8 +15f3 15f1 66d7 66d8 +15f3 15f2 66d8 66ee +15f2 15f4 66d9 66fd +15f9 15f2 66ee 66f0 +15f5 15f3 66dd 66e6 +15f9 15f3 66e6 66ee +15f7 15f5 66e0 66e5 +15f9 15f5 66e5 66e6 +15f6 15f7 66df 66e2 +15f6 15f8 66e2 66e4 +15f8 15f7 66e2 66e7 +15f7 15f9 66e5 66e8 +15fa 15f7 66e7 66e9 +15f7 15fb 66e8 66e9 +15f8 15fa 66e7 66eb +15fc 15f8 66ea 66ec +15f8 15fd 66eb 66ec +15fb 15f9 66e8 66ef +15fa 15fb 66e9 66f1 +15fd 15fa 66eb 66f2 +15fa 15fe 66f1 66f3 +15ff 15fa 66f2 66f3 +15fe 15fb 66f1 66f5 +15fc 15fd 66ec 66f6 +15fc 1600 66f6 66f8 +1601 15fc 66f7 66f8 +15fd 15ff 66f2 66f9 +1600 15fd 66f6 66fa +15fd 1602 66f9 66fa +15ff 15fe 66f3 66ff +1602 15ff 66f9 6701 +1601 1600 66f8 6706 +1600 1602 66fa 6708 +1603 1601 66fc 6705 +1604 1602 670a 670b +1605 1604 670e 670f +1606 1605 6711 6742 +1605 1616 6741 6742 +1617 1605 6741 6744 +1609 1606 6719 6740 +1616 1606 6740 6742 +1607 1608 6716 6738 +1608 1609 671a 673a +1615 1608 6736 673a +1615 1609 673a 673b +1616 1609 673b 6740 +160b 160e 6726 672b +160b 1610 672b 672c +160c 160d 6725 672e +160e 160c 6727 672d +1611 160c 672d 672f +160c 1612 672e 672f +160d 160f 6729 6731 +1612 160d 672e 6733 +160d 1613 6731 6732 +160d 1614 6732 6733 +1610 160e 672b 6730 +160e 1611 672d 6730 +1613 160f 6731 68db +160f 1707 68d9 68db +1610 1611 6730 69c3 +1610 1753 69bd 69be +1755 1610 69bd 69c1 +1757 1610 69c1 69c3 +1611 1612 672f 69e4 +1757 1611 69c3 69c4 +1762 1611 69c4 69e0 +1770 1611 69e0 69e4 +1612 1614 6733 71e1 +1770 1612 69e4 71e1 +1614 1613 6732 71d6 +1613 1707 68db 68e2 +1613 170b 68e2 71d4 +1613 1ba0 71d4 71d6 +1614 1770 71e0 71e1 +1614 1ba0 71d6 71d8 +1614 1ba3 71d8 71e0 +1616 1615 6739 673b +1617 1616 673c 6741 +1619 1618 6747 6748 +1618 161a 6747 6749 +161b 1618 6748 674a +1618 161c 6749 674b +161d 1618 674a 674c +1618 161e 674b 674c +161a 1619 6747 674d +1619 161b 6748 674e +161f 1619 674d 674f +1619 1620 674e 6750 +1621 1619 674f 6750 +161c 161a 6749 6751 +161a 161f 674d 6752 +1622 161a 6751 6752 +161b 161d 674a 6753 +1620 161b 674e 6754 +161b 1623 6753 6755 +1624 161b 6754 6756 +161b 1625 6755 6756 +161e 161c 674b 6757 +161c 1622 6751 6758 +1626 161c 6757 6759 +161c 1627 6758 6759 +161d 161e 674c 675a +1623 161d 6753 675b +161d 1628 675a 675c +1629 161d 675b 675c +161e 1626 6757 675d +1628 161e 675a 675e +161e 162a 675d 675e +161f 1621 674f 675f +1622 161f 6752 6760 +161f 162b 675f 6761 +162c 161f 6760 6761 +1621 1620 6750 6762 +1620 1624 6754 6763 +162d 1620 6762 6764 +1620 162e 6763 6765 +162f 1620 6764 6765 +162b 1621 675f 6766 +1621 162d 6762 6766 +1627 1622 6758 6767 +1622 162c 6760 6768 +1630 1622 6767 6769 +1622 1631 6768 6769 +1625 1623 6755 676a +1623 1629 675b 676b +1632 1623 676a 676b +1624 1625 6756 676c +162e 1624 6763 676d +1624 1633 676c 676d +1625 1632 676a 676e +1633 1625 676c 676f +1625 1634 676e 6770 +1635 1625 676f 6770 +1626 1627 6759 6771 +162a 1626 675d 6772 +1626 1636 6771 6773 +1637 1626 6772 6773 +1627 1630 6767 6774 +1636 1627 6771 6774 +1629 1628 675c 6775 +1628 162a 675e 6776 +1638 1628 6775 6777 +1632 1629 676b 6778 +1629 1638 6775 6779 +1639 1629 6778 677a +1629 163a 6779 677a +162a 1637 6772 677b +162a 163b 677b 677c +162c 162b 6761 677d +162b 162d 6766 677e +163c 162b 677d 677f +162b 163d 677e 6780 +163e 162b 677f 6781 +162b 163f 6780 6781 +1631 162c 6768 6782 +162c 163c 677d 6783 +1640 162c 6782 6783 +162d 162f 6764 6784 +163d 162d 677e 6785 +162d 1641 6784 6785 +162f 162e 6765 6786 +162e 1633 676d 6787 +1642 162e 6786 6788 +162e 1643 6787 6788 +1641 162f 6784 6789 +162f 1642 6786 678a +1644 162f 6789 678b +162f 1645 678a 678b +1630 1631 6769 678c +1636 1630 6774 678d +1630 1646 678c 678e +1647 1630 678d 678f +1630 1648 678e 678f +1631 1640 6782 6790 +1646 1631 678c 6790 +1634 1632 676e 6791 +1632 1639 6778 6792 +1649 1632 6791 6792 +1633 1635 676f 6793 +1643 1633 6787 6794 +1633 164a 6793 6794 +1635 1634 6770 6795 +1634 1649 6791 6796 +164b 1634 6795 6796 +164a 1635 6793 6799 +1635 164b 6795 6798 +164c 1635 6797 6798 +1635 164d 6797 6799 +1637 1636 6773 679a +1636 1647 678d 679b +164e 1636 679a 679b +163b 1637 677b 679c +1637 164e 679a 679d +164f 1637 679c 679d +163a 1638 6779 67a0 +1639 163a 677a 67a5 +1649 1639 6792 67a9 +1639 1652 67a5 67a8 +1639 1654 67a8 67a9 +1652 163a 67a5 67a6 +1653 163a 67a6 67a7 +163b 164f 679c 67a4 +1650 163b 67a2 67a3 +1651 163b 67a3 67a4 +163c 163e 677f 67aa +1640 163c 6783 67ab +163c 1655 67aa 67ab +163f 163d 6780 67ac +163d 1641 6785 67ad +1656 163d 67ac 67ae +163d 1657 67ad 67ae +163e 163f 6781 67af +1655 163e 67aa 67b1 +163e 1658 67af 67b0 +163e 1659 67b0 67b1 +163f 1656 67ac 67b3 +1658 163f 67af 67b2 +165a 163f 67b2 67b3 +1646 1640 6790 67b4 +1640 1655 67ab 67b5 +165b 1640 67b4 67b6 +1640 165c 67b5 67b6 +1641 1644 6789 67b7 +1657 1641 67ad 67b7 +1642 1643 6788 67b9 +1645 1642 678a 67b8 +165d 1642 67b8 67b9 +1643 164a 6794 67be +165d 1643 67b9 67c0 +1643 1660 67be 67bf +1643 1661 67bf 67c0 +1644 1645 678b 67ba +1657 1644 67b7 67bb +1644 165e 67ba 67bb +1645 165d 67b8 67bd +165e 1645 67ba 67bc +165f 1645 67bc 67bd +1648 1646 678e 67c1 +1646 165b 67b4 67c2 +1662 1646 67c1 67c2 +1647 1648 678f 67c3 +164e 1647 679b 67c6 +1647 1663 67c3 67c7 +1665 1647 67c6 67c7 +1648 1662 67c1 67c4 +1663 1648 67c3 67c5 +1648 1664 67c4 67c5 +164b 1649 6796 69cf +1649 1654 67a9 69b1 +1649 1750 69b1 69b5 +1649 175d 69b5 69cf +164a 164d 6799 6ef0 +1660 164a 67be 6ef2 +164a 1a26 6ef0 6ef2 +164c 164b 6798 69d3 +164b 175d 69cf 69d3 +164d 164c 6797 6edf +175d 164c 69d2 69d3 +164c 1768 69d2 6edb +1a1e 164c 6eda 6edb +164c 1a20 6eda 6edf +164d 1a20 6edf 6ee1 +164d 1a26 6ee1 6ef0 +164f 164e 679d 70d9 +164e 1665 67c6 70dd +1b2a 164e 70d9 70dd +1651 164f 67a4 70d8 +1b29 164f 70d8 70da +164f 1b2a 70d9 70da +1650 1651 67a3 70d7 +17c4 1650 6a95 70d7 +17c4 1651 70d7 70dc +1651 1b29 70d8 70db +1651 1b2b 70db 70dc +1652 1653 67a6 69aa +1654 1652 67a8 6995 +1652 1744 6994 6995 +174d 1652 6994 69aa +174d 1653 69aa 69ac +1744 1654 6993 6995 +1654 1746 6993 6999 +1654 1750 6999 69b1 +1655 1659 67b1 6816 +165c 1655 67b5 681d +1655 1692 6816 681d +1656 1657 67ae 6810 +165a 1656 67b3 6807 +1687 1656 6807 6809 +168e 1656 6809 6810 +1657 165e 67bb 681a +1688 1657 6811 681a +168e 1657 6810 6811 +1659 1658 67b0 680c +1658 165a 67b2 6804 +1658 168c 6804 6806 +1658 168d 6806 680c +1659 168d 680c 680e +1659 1690 680e 6815 +1659 1692 6815 6816 +1686 165a 6801 6802 +1687 165a 6802 6807 +165a 168c 6801 6804 +165b 165c 67b6 6820 +1662 165b 67c2 6822 +165b 1695 6820 6822 +165c 1692 681d 681e +165c 1694 681e 6821 +1695 165c 6820 6821 +165f 165d 67bd 76e7 +165d 1661 67c0 76e4 +165d 1e16 76e4 76e7 +165e 165f 67bc 681b +1681 165e 6819 681b +165e 1688 6819 681a +1680 165f 681c 76ee +1681 165f 681b 681c +1e16 165f 76e6 76e7 +165f 1e19 76e6 76ee +1661 1660 67bf 6f05 +1a26 1660 6ef1 6ef2 +1660 1a2a 6ef1 6f00 +1660 1a33 6f00 6f05 +1661 1a33 6f05 76d8 +1661 1e16 76d8 76e4 +1664 1662 67c4 682d +1662 1695 6822 6827 +1662 1698 6827 682b +1662 169a 682b 682c +1662 169b 682c 682d +1663 1664 67c5 70f7 +1665 1663 67c7 742e +1663 1b3b 70f7 742f +1cca 1663 742e 742f +1664 169b 682d 70f6 +1664 1b3a 70f6 70f8 +1b3b 1664 70f7 70f8 +1b2a 1665 70dd 7431 +1665 1cca 742e 7430 +1665 1ccb 7430 7431 +1667 1666 67c8 67c9 +1666 1668 67c8 874e +1669 1666 67c9 67ca +166a 1666 67ca 67cb +166b 1666 67cb 8750 +1666 25bc 8533 8750 +25bd 1666 8533 8854 +1666 25d6 874e 8854 +1668 1667 67c8 67cc +1667 1669 67c9 67cd +166c 1667 67cc 67ce +1667 166d 67cd 67ce +1668 166c 67cc 67cf +1668 166e 67cf 67d0 +1668 166f 67d0 8855 +25d6 1668 874e 8855 +1669 166a 67ca 67d1 +166d 1669 67cd 67d2 +1669 1670 67d1 67d2 +166a 166b 67cb 67d5 +1670 166a 67d1 67d3 +1671 166a 67d3 67d4 +1672 166a 67d4 67d5 +1672 166b 67d5 67e6 +25bc 166b 8535 8750 +166b 25be 8535 8752 +166c 166d 67ce 67d6 +166e 166c 67cf 67d7 +166c 1673 67d6 67d9 +1674 166c 67d7 67d8 +1675 166c 67d8 67d9 +166d 1670 67d2 67da +1673 166d 67d6 67db +166d 1676 67da 67dc +1677 166d 67db 67dc +166f 166e 67d0 67dd +166e 1674 67d7 67df +1678 166e 67dd 67de +1679 166e 67de 67df +166f 1678 67dd 874a +166f 1684 874a 8879 +25b7 166f 8530 874b +25b8 166f 874b 8879 +166f 25d6 8530 8855 +1670 1671 67d3 67e0 +1676 1670 67da 67e0 +1671 1672 67d4 67e1 +1676 1671 67e0 67e2 +167a 1671 67e2 67e4 +1675 1673 67d9 67ed +1673 1677 67db 67ee +1680 1673 67ed 67ef +1673 1681 67ee 67ef +1674 1675 67d8 67e9 +1679 1674 67df 67ea +1674 167d 67e9 67ec +167e 1674 67ea 67eb +167f 1674 67eb 67ec +167d 1675 67e9 67f0 +1675 1680 67ed 67f0 +1677 1676 67dc 67f6 +1676 167a 67e2 67f7 +1685 1676 67f6 67f9 +1676 1686 67f7 67f8 +1676 1687 67f8 67f9 +1681 1677 67ee 67fb +1677 1685 67f6 67fa +1677 1688 67fa 67fb +1678 1679 67de 67e7 +1678 167b 67e7 67e8 +1678 167c 67e8 67f5 +1678 1684 67f5 874a +167b 1679 67e7 67f1 +1679 167e 67ea 67f1 +1686 167a 67f7 67fe +167c 167b 67e8 67f2 +167b 167e 67f1 67f4 +1682 167b 67f2 67f3 +1683 167b 67f3 67f4 +167c 1682 67f2 8746 +1684 167c 67f5 8878 +167c 25d5 8746 8878 +167f 167d 67ec 76ed +167d 1680 67f0 76ec +167d 1e18 76eb 76ed +1e19 167d 76eb 76ec +167e 167f 67eb 76e8 +1683 167e 67f4 742b +1cc8 167e 742b 76e8 +1cc8 167f 76e8 76e9 +1e17 167f 76e9 76ef +167f 1e18 76ed 76ef +1680 1681 67ef 681c +1e19 1680 76ec 76ee +1681 1688 67fb 6819 +1682 1683 67f3 7425 +1cc2 1682 7424 7425 +1682 1cc3 7424 8872 +25d5 1682 8746 8872 +1cc1 1683 7421 7423 +1683 1cc2 7421 7425 +1cc5 1683 7423 742a +1cc8 1683 742a 742b +1684 25b8 8748 8879 +25d5 1684 86d2 8878 +1684 26a0 86d2 8748 +1685 1687 67f9 6808 +1688 1685 67fa 680f +1685 168e 6808 680f +1687 1686 67f8 6802 +1686 168c 67ff 6801 +168e 1687 6808 6809 +1688 168e 680f 6811 +168a 1689 67fc 8536 +1689 168b 67fc 8534 +2089 1689 8224 82a0 +1689 20e8 8223 82a0 +22f9 1689 8223 8534 +1689 231f 8224 8536 +168b 168a 67fc 8753 +231f 168a 7fd7 8536 +168a 2320 7fd7 86d7 +168a 25bf 86d8 8753 +168a 26a1 86d7 86d8 +168b 22f9 84d3 8534 +25bb 168b 84d3 8751 +25bf 168b 8751 8753 +168c 168d 6805 6806 +168d 168f 680a 680d +168d 1690 680d 680e +1690 168f 680d 6813 +168f 1691 6812 6813 +1690 1691 6813 6818 +1692 1690 6815 6817 +1693 1690 6817 6818 +1693 1691 6818 6826 +1696 1691 6826 682a +1692 1693 6817 681f +1694 1692 681e 681f +1694 1693 681f 6823 +1696 1693 6823 6826 +1695 1694 6821 6824 +1694 1696 6823 6825 +1697 1694 6824 6825 +1695 1697 6824 6828 +1698 1695 6827 6829 +1695 1699 6828 6829 +1697 1696 6825 70de +1b2c 1696 70de 70e1 +1b2e 1696 70e1 70e2 +1699 1697 6828 70df +1697 1b2c 70de 70e0 +1b2d 1697 70df 70e0 +1698 1699 6829 70e3 +169a 1698 682b 70e5 +1698 1b2f 70e3 70e5 +1699 1b2d 70df 70e4 +1b2f 1699 70e3 70e4 +169b 169a 682c 70f4 +169a 1b2f 70e5 70f0 +169a 1b36 70f0 70f5 +1b39 169a 70f4 70f5 +169b 1b39 70f4 70f9 +1b3a 169b 70f6 70f9 +169d 169c 682e 89b2 +169c 169e 682e 682f +169c 169f 682f 8b45 +249d 169c 8a65 8b45 +260f 169c 859a 875b +169c 2610 859a 89b2 +26b7 169c 875b 8a65 +169e 169d 682e 6830 +16a0 169d 6830 6831 +16a1 169d 6831 6832 +16a2 169d 6832 8ab2 +169d 2610 89b2 8ab2 +169f 169e 682f 6833 +169e 16a0 6830 6834 +16a3 169e 6833 6835 +169e 16a4 6834 6835 +169f 16a3 6833 6836 +169f 16a5 6836 6837 +169f 16a6 6837 8bb5 +249d 169f 8b45 8bb5 +16a0 16a1 6831 6838 +16a4 16a0 6834 6839 +16a0 16a7 6838 683a +16a8 16a0 6839 683a +16a1 16a2 6832 683b +16a7 16a1 6838 683c +16a1 16a9 683b 683c +16a9 16a2 683b 683d +16aa 16a2 683d 875d +2610 16a2 875d 8ab2 +16a3 16a4 6835 683e +16a5 16a3 6836 683f +16a3 16ab 683e 683f +16a4 16a8 6839 6840 +16ab 16a4 683e 6841 +16a4 16ac 6840 6842 +16ad 16a4 6841 6842 +16a6 16a5 6837 6843 +16a5 16ab 683f 6844 +16ae 16a5 6843 6845 +16a5 16af 6844 6845 +16a6 16ae 6843 6846 +16a6 16b0 6846 6847 +16a6 16b1 6847 8ce8 +16a6 249d 82f0 8bb5 +249e 16a6 82f0 8ce8 +16a8 16a7 683a 6848 +16a7 16a9 683c 6849 +16b2 16a7 6848 684b +16a7 16b3 6849 684a +16a7 16b4 684a 684b +16ac 16a8 6840 684c +16a8 16b2 6848 684d +16b5 16a8 684c 684d +16a9 16aa 683d 684e +16b3 16a9 6849 6850 +16a9 16b6 684e 684f +16a9 16b7 684f 6850 +16b6 16aa 684e 6851 +16b8 16aa 6851 6852 +16b9 16aa 6852 875f +16aa 2610 875d 875f +16ab 16ad 6841 6853 +16af 16ab 6844 6854 +16ab 16ba 6853 6854 +16ad 16ac 6842 6855 +16ac 16b5 684c 6856 +16bb 16ac 6855 6856 +16ba 16ad 6853 6857 +16ad 16bb 6855 6858 +16bc 16ad 6857 6858 +16ae 16af 6845 6859 +16b0 16ae 6846 685a +16ae 16bd 6859 685c +16be 16ae 685a 685b +16bf 16ae 685b 685c +16af 16ba 6854 685e +16bd 16af 6859 685d +16c0 16af 685d 685e +16b1 16b0 6847 8ce9 +16b0 16be 685a 7c71 +16b0 2134 7c71 8cfe +2136 16b0 8ce9 8cfe +2136 16b1 7c73 8ce9 +16b1 2137 7c73 8c03 +16b1 249e 8c03 8ce8 +16b2 16b4 684b 686b +16b5 16b2 684d 686c +16b2 16c9 686b 686c +16b4 16b3 684a 6863 +16b3 16b7 6850 6862 +16b3 16c3 6862 6864 +16c4 16b3 6863 6864 +16b4 16c4 6863 686d +16c9 16b4 686b 686e +16b4 16ca 686d 686e +16bb 16b5 6856 686f +16b5 16c9 686c 6871 +16cb 16b5 686f 6870 +16cc 16b5 6870 6871 +16b7 16b6 684f 685f +16b6 16b8 6851 6860 +16c1 16b6 685f 6861 +16b6 16c2 6860 6861 +16b7 16c1 685f 6865 +16c3 16b7 6862 6866 +16b7 16c5 6865 6866 +16b8 16b9 6852 6867 +16c2 16b8 6860 6868 +16b8 16c6 6867 6869 +16c7 16b8 6868 6869 +16c6 16b9 6867 686a +16c8 16b9 686a 8986 +2610 16b9 875c 875f +16b9 26b8 875c 8986 +16ba 16bc 6857 68d8 +16c0 16ba 685e 68d5 +1705 16ba 68d5 68d8 +16bc 16bb 6858 6c12 +16bb 16cb 686f 6c13 +1883 16bb 6c12 6c13 +1705 16bc 68d8 6c0a +1880 16bc 6c0a 6c0b +1883 16bc 6c0b 6c12 +16bf 16bd 685c 68d2 +16bd 16c0 685d 68d4 +1703 16bd 68d2 68d3 +1704 16bd 68d3 68d4 +16be 16bf 685b 8c82 +2134 16be 7c71 8c82 +16bf 1703 68d2 8c7f +16bf 2132 8c7f 8cff +2134 16bf 8c82 8cff +1704 16c0 68d4 68d6 +16c0 1705 68d5 68d7 +1706 16c0 68d6 68d7 +16c1 16c2 6861 6880 +16c5 16c1 6865 6874 +16cd 16c1 6874 6876 +16d1 16c1 6876 687e +16d5 16c1 687e 687f +16d6 16c1 687f 6880 +16c2 16c7 6868 6892 +16d6 16c2 6880 6892 +16c4 16c3 6864 688a +16c3 16c5 6866 6878 +16c3 16ce 6878 687a +16c3 16d3 687a 688a +16ca 16c4 686d 68a4 +16c4 16d3 688a 688f +16c4 16dd 688f 68a4 +16cd 16c5 6872 6874 +16c5 16ce 6872 6878 +16c7 16c6 6869 68af +16c6 16c8 686a 6f0e +16e8 16c6 68af 68c2 +16fb 16c6 68c2 6f0e +16d6 16c7 6892 6893 +16db 16c7 6893 689f +16e8 16c7 689f 68af +16fb 16c8 6f0e 85ba +2628 16c8 85ba 877f +2629 16c8 877f 89ef +16c8 26b8 8986 89ef +16c9 16ca 686e 68c5 +16cc 16c9 6871 68c5 +16cc 16ca 68c5 68c6 +16ca 16dd 68a4 68a6 +16ca 16ea 68a6 68c4 +16ca 16fc 68c4 68c6 +16cb 16cc 6870 6c17 +1882 16cb 6c10 6c11 +16cb 1883 6c10 6c13 +1884 16cb 6c11 6c14 +188b 16cb 6c14 6c17 +16cc 16fc 68c6 6c18 +188b 16cc 6c17 6c18 +16ce 16cd 6872 6873 +16cf 16cd 6873 6875 +16d0 16cd 6875 6877 +16cd 16d1 6876 6877 +16ce 16cf 6873 6879 +16ce 16d2 6879 687b +16d3 16ce 687a 687b +16cf 16d0 6875 687c +16d2 16cf 6879 687d +16cf 16d4 687c 687d +16d0 16d1 6877 6881 +16d4 16d0 687c 6882 +16d0 16d7 6881 6883 +16d8 16d0 6882 6884 +16d0 16d9 6883 6884 +16d1 16d5 687e 6885 +16d7 16d1 6881 6889 +16d1 16da 6885 6889 +16d3 16d2 687b 688b +16d2 16d4 687d 688c +16dd 16d2 688b 688d +16d2 16de 688c 688e +16df 16d2 688d 688e +16d3 16dd 688b 688f +16d4 16d8 6882 6890 +16de 16d4 688c 6891 +16d4 16e0 6890 6891 +16d5 16d6 687f 6886 +16da 16d5 6885 6887 +16d5 16db 6886 6888 +16dc 16d5 6887 6888 +16db 16d6 6886 6893 +16d9 16d7 6883 6894 +16d7 16da 6889 6895 +16e1 16d7 6894 6895 +16d8 16d9 6884 6896 +16e0 16d8 6890 6899 +16d8 16e2 6896 689a +16e4 16d8 6899 689a +16d9 16e1 6894 6897 +16e2 16d9 6896 6898 +16d9 16e3 6897 6898 +16da 16dc 6887 689b +16e1 16da 6895 689c +16da 16e5 689b 689d +16e6 16da 689c 689d +16dc 16db 6888 689e +16e7 16db 689e 68a0 +16db 16e8 689f 68a0 +16e5 16dc 689b 68a1 +16dc 16e7 689e 68a1 +16dd 16df 688d 68a5 +16dd 16ea 68a5 68a6 +16df 16de 688e 68a7 +16de 16e0 6891 68a8 +16eb 16de 68a7 68a9 +16de 16ec 68a8 68aa +16ed 16de 68a9 68aa +16ea 16df 68a5 68ab +16df 16eb 68a7 68ac +16ee 16df 68ab 68ac +16e0 16e4 6899 68ad +16ec 16e0 68a8 68ae +16e0 16ef 68ad 68ae +16e3 16e1 6897 68a2 +16e1 16e6 689c 68a3 +16e9 16e1 68a2 68a3 +16e2 16e3 6898 68b0 +16e4 16e2 689a 68b3 +16e2 16f0 68b0 68b4 +16f2 16e2 68b3 68b4 +16e3 16e9 68a2 68b1 +16f0 16e3 68b0 68b2 +16e3 16f1 68b1 68b2 +16ef 16e4 68ad 68bc +16e4 16f2 68b3 68be +16f7 16e4 68bc 68bd +16f8 16e4 68bd 68be +16e6 16e5 689d 68b5 +16e5 16e7 68a1 68b8 +16f3 16e5 68b5 68b9 +16e5 16f5 68b8 68b9 +16e9 16e6 68a3 68b6 +16e6 16f3 68b5 68b7 +16f4 16e6 68b6 68b7 +16e7 16e8 68a0 68bf +16f5 16e7 68b8 68c0 +16e7 16f9 68bf 68c1 +16fa 16e7 68c0 68c1 +16f9 16e8 68bf 68c3 +16e8 16fb 68c2 68c3 +16f1 16e9 68b1 68bb +16e9 16f4 68b6 68ba +16e9 16f6 68ba 68bb +16ea 16ee 68ab 68c7 +16fc 16ea 68c4 68c8 +16ea 16fd 68c7 68c9 +16fe 16ea 68c8 68c9 +16eb 16ed 68a9 68ca +16ee 16eb 68ac 68cb +16eb 16ff 68ca 68cc +1700 16eb 68cb 68cc +16ed 16ec 68aa 68cd +16ec 16ef 68ae 68cf +1701 16ec 68cd 68ce +1702 16ec 68ce 68cf +16ff 16ed 68ca 68d0 +16ed 1701 68cd 68d0 +16fd 16ee 68c7 68d1 +16ee 1700 68cb 68d1 +16ef 16f7 68bc 6e90 +1702 16ef 68cf 6e82 +19f6 16ef 6e82 6e90 +16f0 16f1 68b2 76de +16f2 16f0 68b4 76dd +1a31 16f0 76dd 76de +16f1 16f6 68bb 740d +16f1 1a31 76da 76de +16f1 1cb0 740d 7410 +16f1 1cba 7410 76da +16f8 16f2 68be 6efc +1a29 16f2 6efc 6efe +1a31 16f2 6efe 76dd +16f4 16f3 68b7 73e2 +16f3 16f5 68b9 73ea +16f3 1ca0 73e0 73e2 +1ca4 16f3 73e0 73ea +16f6 16f4 68ba 73f5 +1ca0 16f4 73e1 73e2 +16f4 1ca7 73e1 73f5 +16f5 16fa 68c0 73eb +1ca4 16f5 73ea 73eb +16f6 1ca7 73f5 73f7 +16f6 1cb0 73f7 740d +16f7 16f8 68bd 6eaa +19f6 16f7 6e90 6e95 +1a01 16f7 6e95 6ea9 +1a0b 16f7 6ea9 6eaa +1a0b 16f8 6eaa 6ee9 +1a23 16f8 6ee9 6eeb +1a29 16f8 6eeb 6efc +16fa 16f9 68c1 73fd +16f9 16fb 68c3 6f0f +16f9 1a39 6f0f 73fd +1a39 16fa 73fc 73fd +1ca3 16fa 73e7 73e9 +16fa 1ca4 73e7 73eb +1caa 16fa 73e9 73fc +1a39 16fb 6f0f 6f10 +1a3a 16fb 6f10 6f11 +1a3b 16fb 6f11 892d +16fb 2628 85ba 892d +16fc 16fe 68c8 6c1a +188b 16fc 6c18 6c19 +188c 16fc 6c19 6c1a +16fe 16fd 68c9 6c1e +16fd 1700 68d1 6e8d +188d 16fd 6c1e 6ea4 +16fd 19fd 6e8d 6ea4 +188c 16fe 6c1a 6c1b +188d 16fe 6c1b 6c1e +1700 16ff 68cc 6e7e +16ff 1701 68d0 6e78 +16ff 19f0 6e78 6e7d +16ff 19f4 6e7d 6e7e +1700 19f4 6e7e 6e8b +1700 19fc 6e8b 6e8c +1700 19fd 6e8c 6e8d +1701 1702 68ce 6e7a +19f0 1701 6e78 6e79 +19f1 1701 6e79 6e7b +1701 19f2 6e7a 6e7c +19f3 1701 6e7b 6e7c +19f2 1702 6e7a 6e81 +19f6 1702 6e81 6e82 +1703 1704 68d3 8c6b +1703 2131 7c6d 8d17 +2132 1703 8c7f 8d17 +2133 1703 7c6d 8c6d +1703 2378 8c6b 8c6d +1704 1706 68d6 8057 +1881 1704 8054 8057 +1704 2378 8054 8c6b +1706 1705 68d7 6bff +187a 1705 6bfb 6bfd +1705 187e 6bfb 6bff +1880 1705 6bfd 6c0a +1706 187e 6bff 8bbd +1881 1706 8057 8bbd +1707 1708 68dd 68e3 +170b 1707 68e2 68e3 +1708 170a 68e0 71e5 +170b 1708 68e3 71da +1b75 1708 71da 71e5 +170a 1709 68df 6aa3 +1709 17ca 6a9f 6aa2 +1709 17cb 6aa2 6aa3 +170a 17cb 6aa3 7176 +170a 1b75 7176 71e5 +1b75 170b 71d9 71da +170b 1ba0 71d3 71d4 +1ba1 170b 71d3 71d9 +170d 170c 68ea 68f2 +170c 170f 68ee 68f3 +1711 170c 68f2 68f3 +170e 170d 68ec 68f6 +170d 1711 68f2 68f7 +1713 170d 68f6 68f8 +170d 1714 68f7 68f8 +1712 170e 68f4 68f9 +170e 1713 68f6 68f9 +170f 1710 68f0 68fa +1711 170f 68f3 68fa +1711 1710 68fa 68fc +1710 1715 68fb 68fd +1716 1710 68fc 68fd +1714 1711 68f7 68ff +1711 1716 68fc 6901 +1717 1711 68ff 6900 +1718 1711 6900 6901 +1712 1713 68f9 6918 +171b 1712 6916 6918 +1713 1714 68f8 6920 +171b 1713 6918 691a +171d 1713 691a 6920 +1714 1717 68ff 6922 +171d 1714 6920 6922 +1716 1715 68fd 6950 +1730 1715 6950 6954 +1718 1716 6901 693d +172c 1716 693d 6951 +1716 1730 6950 6952 +1731 1716 6951 6952 +1717 1718 6900 692e +171d 1717 6922 6923 +171f 1717 6923 692a +1724 1717 692a 692d +1726 1717 692d 692e +1726 1718 692e 693c +172c 1718 693c 693d +171a 1729 6946 6949 +171a 172a 6949 694a +171c 171b 6917 6919 +171d 171b 6919 691a +171c 171d 6919 691e +171c 171e 691e 691f +171e 171d 691e 6921 +171f 171d 6921 6923 +171e 171f 6921 6926 +1720 171e 6924 6927 +171e 1721 6926 6928 +1722 171e 6927 6929 +171e 1723 6928 6929 +1721 171f 6926 692b +171f 1724 692a 692c +1725 171f 692b 692c +1720 1722 6927 6930 +1723 1721 6928 6932 +1721 1725 692b 6933 +1727 1721 6932 6933 +1722 1723 6929 6934 +1722 1728 6934 6935 +1723 1727 6932 6938 +1728 1723 6934 6936 +1729 1723 6936 6937 +172a 1723 6937 6938 +1725 1724 692c 6939 +1724 1726 692d 693a +172b 1724 6939 693a +1727 1725 6933 693b +1725 172b 6939 693b +172b 1726 693a 693f +1726 172c 693c 693e +1726 172d 693e 693f +172a 1727 6938 694d +1727 172b 693b 695f +172f 1727 694d 695f +1728 1729 6936 6948 +172e 1728 6947 6948 +1729 172a 6937 6949 +1729 172e 6945 6948 +172f 172a 694b 694d +172b 172d 693f 6963 +172f 172b 695f 6960 +1734 172b 6960 6962 +1735 172b 6962 6963 +172d 172c 693e 6956 +172c 1731 6951 6955 +172c 1732 6955 6956 +172d 1732 6956 6969 +1735 172d 6963 6966 +1736 172d 6966 6969 +172f 1734 6960 6961 +1731 1730 6952 6957 +1733 1730 6957 6959 +1732 1731 6955 695a +1731 1733 6957 695a +1732 1733 695a 696e +1736 1732 6969 696b +1734 1735 6962 6965 +1735 1736 6966 6968 +1737 1735 6967 6968 +1737 1736 6968 696c +1739 1738 6976 6978 +1738 173a 6977 6979 +173b 1738 6978 6979 +1739 173b 6978 697f +173c 1739 697d 697f +1739 173d 697d 89c1 +173e 1739 697e 89c1 +173b 173a 6979 79ad +1820 173a 79ad 79ae +173c 173b 697f 6b58 +1820 173b 6b58 79ad +173d 173c 697d 6b55 +1820 173c 6b57 6b58 +173d 173e 877d 89c1 +173d 181f 877a 877d +173e 181e 8988 89c0 +173e 181f 877d 8988 +173e 23a3 89c0 8a83 +1740 173f 6980 6981 +173f 1741 6980 6982 +1742 173f 6981 6983 +173f 1743 6982 6984 +1744 173f 6983 6985 +173f 1745 6984 6986 +1746 173f 6985 6987 +173f 1747 6986 6987 +1741 1740 6980 6988 +1740 1742 6981 6989 +1748 1740 6988 698a +1740 1749 6989 698a +1743 1741 6982 698b +1741 1748 6988 698c +174a 1741 698b 698d +1741 174b 698c 698e +174c 1741 698d 698e +1742 1744 6983 698f +1749 1742 6989 6990 +1742 174d 698f 6990 +1745 1743 6984 6991 +1743 174a 698b 6992 +174e 1743 6991 6992 +1744 1746 6985 6993 +174d 1744 698f 6994 +1747 1745 6986 6996 +1745 174e 6991 6997 +174f 1745 6996 6997 +1746 1747 6987 6998 +1746 1750 6998 6999 +1747 174f 6996 699a +1750 1747 6998 699b +1747 1751 699a 699c +1752 1747 699b 699c +1748 1749 698a 699d +174b 1748 698c 699e +1753 1748 699e 69a0 +1749 174d 6990 69a1 +174a 174c 698d 69a3 +174e 174a 6992 69a4 +174a 1754 69a3 69a4 +174c 174b 698e 69a5 +174b 1753 699e 69a6 +1755 174b 69a5 69a6 +1754 174c 69a3 69a7 +174c 1755 69a5 69a8 +1756 174c 69a7 69a9 +174c 1757 69a8 69a9 +174f 174e 6997 69ad +174e 1754 69a4 69ae +1758 174e 69ad 69af +174e 1759 69ae 69b0 +175a 174e 69af 69b0 +1751 174f 699a 69b2 +174f 1758 69ad 69b3 +175b 174f 69b2 69b3 +1750 1752 699b 69b4 +1750 175c 69b4 69b6 +175d 1750 69b5 69b6 +1752 1751 699c 69b7 +1751 175b 69b2 69ba +175e 1751 69b7 69bb +1751 1760 69ba 69bb +175c 1752 69b4 69b8 +1752 175e 69b7 69b9 +175f 1752 69b8 69b9 +1755 1753 69a6 69bd +1754 1756 69a7 69bf +1759 1754 69ae 69c0 +1754 1761 69bf 69c0 +1757 1755 69a8 69c1 +1756 1757 69a9 69c2 +1761 1756 69bf 69c5 +1756 1762 69c2 69c6 +1763 1756 69c5 69c6 +1762 1757 69c2 69c4 +1758 175a 69af 69c8 +175b 1758 69b3 69c9 +1758 1764 69c8 69c9 +175a 1759 69b0 69ca +1759 1761 69c0 69cb +1765 1759 69ca 69cb +1764 175a 69c8 69ce +175a 1765 69ca 69cc +175a 1766 69cc 69cd +175a 1767 69cd 69ce +1760 175b 69ba 69d4 +175b 1764 69c9 69d6 +1769 175b 69d4 69d5 +176a 175b 69d5 69d6 +175d 175c 69b6 69d0 +175c 175f 69b8 69d1 +1768 175c 69d0 69d1 +175d 1768 69d0 69d2 +175f 175e 69b9 69d7 +175e 1760 69bb 69d8 +176b 175e 69d7 69d9 +175e 176c 69d8 69d9 +1768 175f 69d1 69db +175f 176b 69d7 69da +175f 176d 69da 69db +1760 1769 69d4 69dc +176c 1760 69d8 69dc +1761 1763 69c5 69dd +1765 1761 69cb 69de +1761 176e 69dd 69de +1763 1762 69c6 69df +176f 1762 69df 69e1 +1762 1770 69e0 69e1 +176e 1763 69dd 69e3 +1763 176f 69df 69e2 +1763 1771 69e2 69e3 +1764 1767 69ce 7294 +176a 1764 69d6 7297 +1764 1bf4 7294 7297 +1766 1765 69cc 7281 +1765 176e 69de 727e +1765 1beb 727e 7281 +1767 1766 69cd 7289 +1766 1beb 7281 7283 +1766 1bed 7283 7288 +1766 1bf0 7288 7289 +1767 1bf0 7289 7295 +1bf4 1767 7294 7296 +1767 1bf5 7295 7296 +1768 176d 69db 6ed6 +1768 1a1e 6ed6 6edb +1769 176a 69d5 6f09 +176c 1769 69dc 6ef4 +1a2c 1769 6ef4 6f06 +1a36 1769 6f06 6f09 +1a36 176a 6f09 729e +176a 1bf4 7297 729a +176a 1bf6 729a 729e +176b 176c 69d9 6ee2 +176d 176b 69da 6ed0 +1a1b 176b 6ed0 6ed1 +1a21 176b 6ed1 6ee2 +1a21 176c 6ee2 6ee4 +1a27 176c 6ee4 6ef3 +1a2c 176c 6ef3 6ef4 +176d 1a1a 6ec9 6ecb +1a1b 176d 6ec9 6ed0 +176d 1a1e 6ecb 6ed6 +176e 1771 69e3 71f8 +176e 1bae 71f8 727d +176e 1beb 727d 727e +176f 1770 69e1 71e3 +1771 176f 69e2 71ec +176f 1ba3 71e3 71e4 +176f 1ba6 71e4 71ec +1770 1ba3 71e0 71e3 +1771 1ba6 71ec 71ee +1771 1baa 71ee 71f7 +1771 1bae 71f7 71f8 +1773 1772 69e6 69ea +1772 1774 69e8 69eb +1775 1772 69ea 69eb +1773 1775 69ea 69ed +1775 1774 69eb 69f2 +1774 1776 69f0 69f3 +1777 1774 69f2 69f4 +1774 1778 69f3 69f4 +1775 1777 69f2 69f6 +1779 1775 69f5 69f6 +1778 1776 69f3 69fa +1776 177a 69f8 69fb +177b 1776 69fa 69fb +1777 1778 69f4 69fc +1779 1777 69f6 69fd +1777 177c 69fc 69fe +1778 177b 69fa 69ff +177c 1778 69fc 6a00 +1778 177d 69ff 6a00 +177b 177a 69fb 6a03 +177a 177e 6a02 6a05 +177f 177a 6a03 6a04 +1780 177a 6a04 6a05 +177d 177b 69ff 6a07 +177b 177f 6a03 6a08 +1781 177b 6a07 6a08 +177c 177d 6a00 6a09 +177c 1782 6a09 6a0b +177d 1781 6a07 6a0d +1782 177d 6a09 6a0c +1783 177d 6a0c 6a0d +1780 177e 6a05 6a38 +178d 177e 6a38 6a3c +179c 177e 6a3c 6a44 +177f 1780 6a04 6a1e +1781 177f 6a08 6a15 +1786 177f 6a15 6a1e +1786 1780 6a1e 6a20 +178d 1780 6a20 6a38 +1783 1781 6a0d 6a10 +1785 1781 6a10 6a14 +1786 1781 6a14 6a15 +1782 1783 6a0c 6a0e +1784 1783 6a0f 6a11 +1783 1785 6a10 6a11 +1784 1785 6a11 6a16 +1784 1787 6a16 6a18 +1788 1784 6a17 6a19 +1784 1789 6a18 6a19 +1785 1786 6a14 6a1a +1787 1785 6a16 6a1b +1785 178a 6a1a 6a1c +178b 1785 6a1b 6a1c +178a 1786 6a1a 6a1f +178c 1786 6a1f 6a21 +1786 178d 6a20 6a21 +1789 1787 6a18 6a22 +1787 178b 6a1b 6a23 +178e 1787 6a22 6a23 +1788 1789 6a19 6a24 +1788 178f 6a24 6a26 +1790 1788 6a25 6a26 +1789 178e 6a22 6a27 +178f 1789 6a24 6a28 +1789 1791 6a27 6a28 +178b 178a 6a1c 6a29 +178a 178c 6a1f 6a2c +1792 178a 6a29 6a2d +178a 1794 6a2c 6a2d +178e 178b 6a23 6a2a +178b 1792 6a29 6a2b +1793 178b 6a2a 6a2b +178c 178d 6a21 6a39 +1794 178c 6a2c 6a3a +178c 179a 6a39 6a3b +179b 178c 6a3a 6a3b +179a 178d 6a39 6a3d +178d 179c 6a3c 6a3d +1791 178e 6a27 6a2f +178e 1793 6a2a 6a30 +1795 178e 6a2f 6a31 +178e 1796 6a30 6a31 +1790 178f 6a26 6a32 +178f 1791 6a28 6a33 +1797 178f 6a32 6a34 +178f 1798 6a33 6a35 +1799 178f 6a34 6a35 +1790 1797 6a32 6a36 +1791 1795 6a2f 6a37 +1798 1791 6a33 6a37 +1793 1792 6a2b 6a3f +1792 1794 6a2d 6a3e +1792 179d 6a3e 6a40 +179e 1792 6a3f 6a40 +1796 1793 6a30 6a42 +1793 179e 6a3f 6a43 +179f 1793 6a42 6a43 +1794 179b 6a3a 6a41 +179d 1794 6a3e 6a41 +1795 1796 6a31 78d8 +1798 1795 6a37 72cf +1c12 1795 72cf 7670 +1ded 1795 7670 7672 +1df3 1795 7672 78d8 +1796 179f 6a42 78d9 +1df3 1796 78d8 78d9 +1797 1799 6a34 72b4 +1bfe 1797 72ab 72b0 +1c01 1797 72b0 72b4 +1799 1798 6a35 72c4 +1c0c 1798 72c4 72ce +1c12 1798 72ce 72cf +1c01 1799 72b4 72bd +1c08 1799 72bd 72c3 +1c0c 1799 72c3 72c4 +179b 179a 6a3b 78a1 +179a 179c 6a3d 789c +179a 1ec4 789c 78a0 +179a 1ec6 78a0 78a1 +179d 179b 6a41 78a7 +179b 1ec6 78a1 78a6 +179b 1ec8 78a6 78a7 +1ec4 179c 789c 789e +1ec5 179c 789e 789f +179e 179d 6a40 78b1 +179d 1ec8 78a7 78af +179d 1ecd 78af 78b2 +1ece 179d 78b1 78b2 +179f 179e 6a43 78db +179e 1ece 78b1 78de +1edc 179e 78db 78de +1df3 179f 78d9 78da +1edb 179f 78da 78dc +179f 1edc 78db 78dc +17a0 17b0 6a72 6a8e +17c2 17a0 6a8d 6a8e +17a2 17a1 6a4a 6a4d +17a3 17a1 6a4d 6a4f +17a2 17a3 6a4d 6a52 +17a4 17a2 6a51 6a53 +17a5 17a2 6a53 6a54 +17a4 17a5 6a53 6a5a +17a4 17a6 6a5a 6a5b +17a6 17a5 6a5a 6a5d +17a7 17a6 6a5f 6a63 +17a6 17a9 6a62 6a63 +17a8 17a7 6a61 6a66 +17a7 17a9 6a63 6a67 +17aa 17a7 6a66 6a68 +17a7 17ab 6a67 6a68 +17a8 17aa 6a66 6a6a +17ac 17a8 6a69 6a6a +17ab 17a9 6a67 6a6d +17a9 17ad 6a6c 6a6e +17ae 17a9 6a6d 6a6e +17aa 17ab 6a68 6b1c +17ac 17aa 6a6a 6b11 +1807 17aa 6b11 6b17 +180a 17aa 6b17 6b1c +17ab 17ae 6a6d 6b25 +180a 17ab 6b1c 6b22 +180d 17ab 6b22 6b25 +1804 17ac 6b07 6b0b +1807 17ac 6b0b 6b11 +17ae 17ad 6a6e 70d2 +17ad 17af 6a6f 70d3 +1995 17ad 70d2 70d3 +180d 17ae 6b25 6b29 +180f 17ae 6b29 70cf +1995 17ae 70cf 70d2 +1988 17af 6dcd 6dcf +17af 198e 6dcd 6ddb +17af 1995 6ddb 70d3 +17b0 17c1 6a8b 6a91 +17c2 17b0 6a8e 6a90 +17c3 17b0 6a90 6a91 +17b1 17b2 6a74 6a7c +17b4 17b1 6a76 6a79 +17b5 17b1 6a79 6a7a +17b6 17b1 6a7a 6a7b +17b7 17b1 6a7b 6a7c +17b7 17b2 6a7c 8abd +17b2 1f6d 857c 857e +17b2 1f70 857e 8abd +17b3 17b4 6a77 6a82 +17b9 17b3 6a7e 6a83 +17b3 17bb 6a82 6a83 +17b4 17b5 6a79 6a84 +17bb 17b4 6a82 6a84 +17b5 17b6 6a7a 6a85 +17bb 17b5 6a84 6a88 +17b5 17bc 6a85 6a86 +17b5 17bd 6a86 6a87 +17b5 17be 6a87 6a88 +17b6 17b7 6a7b 6a8a +17bc 17b6 6a85 6a89 +17bf 17b6 6a89 8b07 +17b6 17c0 6a8a 8b07 +17c0 17b7 6a8a 896c +1f6f 17b7 896c 89cb +1f70 17b7 89cb 8abd +17b8 17b9 6a7f 6bda +17ba 17b8 6a80 6bd6 +1852 17b8 6bd3 6bd4 +17b8 1853 6bd3 6bd6 +1856 17b8 6bd4 6bda +17b9 17bb 6a83 7179 +17b9 1856 6bd9 6bda +1868 17b9 6bd9 7179 +17ba 1853 6bd6 6bd7 +17bb 17be 6a88 7177 +17bb 1868 7178 7179 +17bb 1b77 7177 7178 +17bd 17bc 6a86 6e18 +17bc 17bf 6a89 6e17 +17bc 19ac 6e17 6e18 +17be 17bd 6a87 6e2a +17bd 19aa 6e12 6e14 +19ac 17bd 6e12 6e18 +17bd 19b8 6e14 6e29 +17bd 19c3 6e29 6e2a +17be 19c3 6e2a 717a +1b77 17be 7177 717a +17c0 17bf 8340 8b07 +17bf 19ac 6e07 6e17 +19ad 17bf 6e07 8340 +19ad 17c0 8340 89ca +17c0 1f6f 896c 8b06 +2602 17c0 89ca 8b06 +17c3 17c1 6a91 7875 +17c1 17c5 6a96 7874 +17c1 1eb4 7874 7875 +17c2 17c3 6a90 7352 +1c5b 17c2 734f 7351 +1c5c 17c2 7351 7352 +1c5c 17c3 7352 7873 +1eb4 17c3 7873 7875 +17c5 17c4 6a97 7872 +17c4 1b2b 70dc 7872 +1b2b 17c5 7866 7872 +17c5 1eb0 7866 7867 +17c5 1eb4 7867 7874 +17c7 17c6 6a99 8c20 +17c6 2406 8b1e 8c20 +17c6 253d 83dd 8b1e +224d 17c7 8b83 8bc6 +2406 17c7 8bc6 8c20 +17c8 1ae7 705a 7063 +17c8 1aec 7063 7064 +17ca 17c9 6aa0 7164 +17c9 1b6b 715e 7164 +17cb 17ca 6aa2 7167 +17ca 1b6b 7164 7167 +17cb 1b6b 7167 7169 +17cb 1b6f 7169 7173 +17cb 1b75 7173 7176 +17cd 17cc 6aab 6f26 +17cc 17cf 6aad 79f7 +1a4e 17cc 6f26 79f7 +17ce 17cd 6aaa 6f1f +17cd 1a45 6f1e 6f1f +1a49 17cd 6f1e 6f25 +1a4e 17cd 6f25 6f26 +17ce 1a45 6f1f 8a84 +26bb 17ce 8a59 8a84 +17cf 1a4e 79f6 79f7 +17cf 1e20 7710 79f6 +17d0 17d1 6aae 6ab0 +17d0 17d2 6ab0 6ab2 +17d3 17d0 6ab1 6ab3 +17d0 17d4 6ab2 6ab3 +17d2 17d1 6ab0 6ab5 +17d5 17d1 6ab5 6ab7 +17d1 17d6 6ab6 6ab7 +17d4 17d2 6ab2 6aba +17d2 17d5 6ab5 6abb +17d8 17d2 6aba 6abc +17d2 17d9 6abb 6abc +17d3 17d4 6ab3 6abd +17d7 17d3 6ab8 6abe +17d3 17da 6abd 6abf +17db 17d3 6abe 6ac0 +17d3 17dc 6abf 6ac0 +17d4 17d8 6aba 6ac1 +17da 17d4 6abd 6ac1 +17d5 17d6 6ab7 6ac3 +17d9 17d5 6abb 6ac4 +17d5 17dd 6ac3 6ac5 +17de 17d5 6ac4 6ac5 +17dd 17d6 6ac3 6ac6 +17d7 17db 6abe 6ac8 +17d7 17df 6ac8 6aca +17e0 17d7 6ac9 6aca +17d8 17d9 6abc 6acb +17da 17d8 6ac1 6acc +17d8 17e1 6acb 6acd +17e2 17d8 6acc 6ace +17d8 17e3 6acd 6ace +17d9 17de 6ac4 6acf +17e1 17d9 6acb 6ad0 +17d9 17e4 6acf 6ad0 +17dc 17da 6abf 6ad1 +17da 17e2 6acc 6ad2 +17e5 17da 6ad1 6ad2 +17db 17dc 6ac0 6ad3 +17df 17db 6ac8 6ad4 +17db 17e6 6ad3 6ad5 +17e7 17db 6ad4 6ad6 +17db 17e8 6ad5 6ad6 +17dc 17e5 6ad1 6ad7 +17e6 17dc 6ad3 6ad8 +17dc 17e9 6ad7 6ad9 +17ea 17dc 6ad8 6ad9 +17de 17dd 6ac5 6adb +17dd 17eb 6ada 6adc +17ec 17dd 6adb 6add +17dd 17ed 6adc 6add +17e4 17de 6acf 6ade +17de 17ec 6adb 6adf +17ee 17de 6ade 6adf +17e0 17df 6aca 6ae1 +17df 17e7 6ad4 6ae2 +17ef 17df 6ae1 6ae2 +17e0 17ef 6ae1 6ae5 +17f0 17e0 6ae3 6ae4 +17f1 17e0 6ae4 6ae5 +17e3 17e1 6acd 6ae6 +17e1 17e4 6ad0 6ae7 +17f2 17e1 6ae6 6ae9 +17e1 17f3 6ae7 6ae8 +17e1 17f4 6ae8 6ae9 +17e2 17e3 6ace 6aea +17e5 17e2 6ad2 6aeb +17e2 17f5 6aea 6aeb +17e3 17f2 6ae6 6aec +17f5 17e3 6aea 6aed +17e3 17f6 6aec 6aed +17e4 17ee 6ade 6aee +17f3 17e4 6ae7 6aef +17e4 17f7 6aee 6af0 +17f8 17e4 6aef 6af0 +17e9 17e5 6ad7 6af1 +17e5 17f5 6aeb 6af2 +17f9 17e5 6af1 6af2 +17e8 17e6 6ad5 6af4 +17e6 17ea 6ad8 6af3 +17e6 17fa 6af3 6af4 +17e7 17e8 6ad6 6af9 +17ef 17e7 6ae2 6afb +17e7 17fd 6af9 6afb +17e8 17fa 6af4 6afa +17fd 17e8 6af9 6afa +17ea 17e9 6ad9 6af5 +17e9 17f9 6af1 6af6 +17fb 17e9 6af5 6af6 +17fa 17ea 6af3 6af8 +17ea 17fb 6af5 6af7 +17ea 17fc 6af7 6af8 +17ed 17eb 6adc 8255 +2478 17eb 8255 8691 +25d1 17eb 8691 8951 +17eb 2682 870e 8951 +17ec 17ed 6add 6aff +17ee 17ec 6adf 8693 +17ec 17ff 6aff 8696 +241e 17ec 8693 8696 +17ff 17ed 6aff 8992 +17ed 2478 8255 8992 +17f7 17ee 6aee 8697 +17ee 241e 8693 8697 +17f1 17ef 6ae5 7829 +17ef 17fd 6afb 7821 +17ef 1e02 7821 7823 +17ef 1ea1 7823 7829 +17f0 17f1 6ae4 768a +17fe 17f0 6afd 7687 +1df8 17f0 7687 768b +1df9 17f0 7689 768a +17f0 1dfa 7689 768b +1df9 17f1 768a 784f +17f1 1ea1 7829 782e +17f1 1ea6 782e 784f +17f2 17f4 6ae9 87b4 +17f6 17f2 6aec 8836 +17f2 26db 87b4 89fa +26dc 17f2 8836 89fa +17f4 17f3 6ae8 7081 +17f3 17f8 6aef 7082 +1afd 17f3 7081 7082 +17f4 1afd 7081 89e9 +26db 17f4 87b4 89e9 +17f5 17f6 6aed 7083 +17f9 17f5 6af2 7086 +17f5 1afe 7083 7086 +1afe 17f6 7083 7084 +1aff 17f6 7084 7085 +1b00 17f6 7085 8839 +17f6 26dc 8836 8839 +17f8 17f7 6af0 8710 +241e 17f7 8695 8697 +17f7 2683 8695 8710 +1afd 17f8 7082 89ce +17f8 2683 8710 89fc +2686 17f8 89ce 89fc +17fb 17f9 6af6 708b +17f9 1afe 7086 7088 +17f9 1b02 7088 708b +17fa 17fc 6af8 7694 +17fd 17fa 6afa 7699 +17fa 1dff 7694 7697 +17fa 1e01 7697 7698 +17fa 1e02 7698 7699 +17fc 17fb 6af7 768d +17fb 1b02 708b 7477 +17fb 1ced 7477 768c +17fb 1dfb 768c 768d +17fc 1dfb 768d 7693 +17fc 1dff 7693 7694 +17fd 1e02 7699 7821 +1df7 17fe 7686 7688 +17fe 1df8 7687 7688 +241c 17ff 8960 89ea +241e 17ff 8696 8960 +2478 17ff 8692 8992 +17ff 2566 8692 89ea +1801 1800 6b01 6db2 +1800 1802 6b04 6db1 +1800 197d 6db1 6db2 +1801 197c 6dae 6db0 +197d 1801 6dae 6db2 +1801 1986 6db0 6dc9 +1802 1803 6b05 88ec +197b 1802 6dad 8865 +1802 197d 6dad 6db1 +2591 1802 8865 88ec +1803 2438 8895 8903 +2439 1803 849b 8903 +1803 243b 849b 88b5 +1803 2591 8498 88ec +2592 1803 8498 88b5 +1805 1804 6b06 6b0a +1806 1804 6b0a 6b0c +1804 1807 6b0b 6b0d +1808 1804 6b0c 6b0d +1805 1806 6b0a 6b0f +1806 1808 6b0c 6b12 +1808 1807 6b0d 6b16 +1809 1807 6b16 6b18 +1807 180a 6b17 6b18 +1808 1809 6b16 6b1a +180b 1808 6b19 6b1a +1809 180a 6b18 6b1e +180b 1809 6b1a 6b1f +1809 180c 6b1e 6b21 +180c 180a 6b1e 6b23 +180a 180d 6b22 6b24 +180e 180a 6b23 6b24 +180c 180e 6b23 6b27 +180e 180d 6b24 6b28 +180f 180d 6b28 6b29 +180e 180f 6b28 6b2a +180e 1810 6b2a 6b2b +1810 180f 6b2a 6dda +1990 180f 6dd6 6dd8 +180f 1991 6dd6 6dda +1995 180f 6dd8 70cf +1991 1810 6dd9 6dda +1810 1994 6dd9 70ce +1810 1b28 70ce 70d0 +1812 1811 6b2c 8954 +1811 1814 7f18 8954 +1811 22d2 7f13 895e +22d3 1811 7f18 89a0 +1811 22d4 895e 89a0 +1812 1814 8954 8a1e +1814 1813 6b2d 8a0f +1813 1815 6b2d 7f1b +1813 22d5 7f1b 89bf +1815 1814 6b2d 8a39 +1814 22d3 7f18 8a1f +1814 22d7 8a1f 8a39 +1815 2007 7f19 7f1a +1815 22d5 7f1a 7f1b +22d7 1815 7f19 8a39 +1817 1816 6b35 6b37 +1816 1818 6b36 6b37 +1817 1818 6b37 6b3a +1817 1819 6b3a 6b3e +1819 1818 6b3a 6b3c +1819 181a 6b42 6b45 +1819 181b 6b45 6b46 +181b 181a 6b45 6b48 +181a 181c 6b47 6b48 +181b 181c 6b48 6b4c +181e 181d 6b52 8784 +181d 181f 6b52 8996 +181d 1f42 8774 8776 +181d 20e6 8776 8783 +181d 262b 8783 8784 +26be 181d 8774 8958 +26bf 181d 8958 8996 +181f 181e 6b52 8988 +23a3 181e 89c0 8a82 +181e 23a4 8324 8a82 +24d7 181e 8324 85c5 +262b 181e 85c5 8784 +181f 26bf 8989 8996 +1821 1823 6b5d 73cb +1821 1c9a 73cb 7700 +1821 1e1d 7700 7707 +1823 1822 6b5c 73c1 +1c8a 1822 73b9 73ba +1c8c 1822 73ba 890d +1822 1c90 73b9 73c1 +1822 25a9 84bd 890d +25aa 1822 84bd 8975 +1823 1c90 73c1 73c2 +1823 1c93 73c2 73ca +1823 1c9a 73ca 73cb +1824 1826 6b60 6b64 +1824 1828 6b64 86e8 +1824 25c8 86e9 8756 +1824 26aa 86e8 86e9 +1827 1825 6b61 6b65 +1829 1825 6b65 6b67 +1826 1827 6b62 6b68 +1828 1826 6b64 6b69 +1826 182a 6b68 6b69 +1827 1829 6b65 6b6b +182a 1827 6b68 6b6a +182b 1827 6b6a 6b6b +1828 182a 6b69 6b6c +1828 182c 6b6c 6b6d +1828 182d 6b6d 8861 +1828 26a9 8861 8870 +26aa 1828 86e8 8870 +182b 1829 6b6b 745a +1cdf 1829 745a 7464 +1ce3 1829 7464 7465 +182a 182b 6b6a 7456 +182c 182a 6b6c 7455 +1b46 182a 7455 7456 +1b3d 182b 710d 710e +1b43 182b 710e 745b +182b 1b46 710d 7456 +182b 1cdf 745a 745b +182d 182c 6b6d 7459 +182c 1b46 7455 7457 +182c 1b48 7457 7458 +182c 1cde 7458 7459 +182d 1cde 7459 885d +26a7 182d 86ea 885d +182d 26a9 86ea 8861 +182f 182e 6b6e 6b6f +182e 1830 6b6e 6b70 +1831 182e 6b6f 6b71 +182e 1832 6b70 6b72 +1833 182e 6b71 6b73 +182e 1834 6b72 6b73 +1830 182f 6b6e 6b74 +182f 1831 6b6f 6b75 +1835 182f 6b74 6b76 +182f 1836 6b75 6b76 +1832 1830 6b70 6b77 +1830 1835 6b74 6b78 +1837 1830 6b77 6b79 +1830 1838 6b78 6b79 +1831 1833 6b71 6b7a +1836 1831 6b75 6b7b +1831 1839 6b7a 6b7c +1834 1832 6b72 6b7e +1832 1837 6b77 6b7f +183a 1832 6b7e 6b80 +1832 183b 6b7f 6b81 +183c 1832 6b80 6b81 +1833 1834 6b73 6b82 +1839 1833 6b7a 6b83 +1833 183d 6b82 6b84 +183e 1833 6b83 6b84 +1834 183a 6b7e 6b85 +183d 1834 6b82 6b86 +1834 183f 6b85 6b86 +1835 1836 6b76 6b87 +1838 1835 6b78 6b88 +1840 1835 6b88 6b8a +1841 1835 6b8a 6b8b +1837 1838 6b79 6b8c +183b 1837 6b7f 6b8d +1837 1842 6b8c 6b8e +1843 1837 6b8d 6b8f +1837 1844 6b8e 6b8f +1838 1840 6b88 6b90 +1842 1838 6b8c 6b91 +1838 1845 6b90 6b91 +1839 183e 6b83 6b93 +1839 1846 6b93 6b95 +1847 1839 6b94 6b95 +183a 183c 6b80 6b96 +183f 183a 6b85 6b97 +183a 1848 6b96 6b97 +183c 183b 6b81 6b98 +183b 1843 6b8d 6b99 +1849 183b 6b98 6b99 +1848 183c 6b96 6b9a +183c 1849 6b98 6b9b +184a 183c 6b9a 6b9b +183e 183d 6b84 6b9d +183d 183f 6b86 6b9c +183d 184b 6b9c 6b9d +1846 183e 6b93 6ba2 +183e 184b 6b9d 6ba1 +183e 184e 6ba1 6ba2 +183f 1848 6b97 6b9e +184b 183f 6b9c 6b9f +183f 184c 6b9e 6ba0 +184d 183f 6b9f 6ba0 +1840 1841 6b8a 6ba3 +1845 1840 6b90 6ba4 +1840 184f 6ba3 6ba4 +184f 1841 6ba3 6ba7 +1841 1850 6ba5 6ba8 +1851 1841 6ba7 6ba8 +1844 1842 6b8e 6ba9 +1842 1845 6b91 6baa +1852 1842 6ba9 6bab +1842 1853 6baa 6bab +1843 1844 6b8f 6bac +1849 1843 6b99 6bad +1843 1854 6bac 6bad +1844 1852 6ba9 6baf +1854 1844 6bac 6bae +1855 1844 6bae 6bb0 +1844 1856 6baf 6bb0 +1845 184f 6ba4 6bb1 +1853 1845 6baa 6bb2 +1845 1857 6bb1 6bb2 +1847 1846 6b95 6bde +1846 184e 6ba2 6bdf +186a 1846 6bde 6be0 +1846 186b 6bdf 6be0 +1869 1847 6bdc 6be1 +1847 186a 6bde 6be1 +1848 184a 6b9a 6bb3 +184c 1848 6b9e 6bb4 +1848 1858 6bb3 6bb4 +184a 1849 6b9b 6bb5 +1849 1854 6bad 6bb7 +1859 1849 6bb5 6bb6 +185a 1849 6bb6 6bb7 +1858 184a 6bb3 6bb8 +184a 1859 6bb5 6bb9 +185b 184a 6bb8 6bb9 +184b 184d 6b9f 6bba +184e 184b 6ba1 6bbb +184b 185c 6bba 6bbb +184d 184c 6ba0 6bbc +184c 1858 6bb4 6bbd +185d 184c 6bbc 6bbe +184c 185e 6bbd 6bbf +185f 184c 6bbe 6bbf +185c 184d 6bba 6bc0 +184d 185d 6bbc 6bc0 +184e 185c 6bbb 6be2 +186b 184e 6bdf 6be4 +184e 186c 6be2 6be3 +184e 186d 6be3 6be4 +184f 1851 6ba7 6bc1 +1857 184f 6bb1 6bc2 +184f 1860 6bc1 6bc2 +1851 1850 6ba8 6bc4 +1861 1850 6bc4 6bc6 +1860 1851 6bc1 6bc7 +1851 1861 6bc4 6bc7 +1852 1853 6bab 6bd3 +1856 1852 6baf 6bd4 +1853 1857 6bb2 6bd5 +1854 1855 6bae 6bce +185a 1854 6bb7 6bcd +1865 1854 6bcd 6bcf +1854 1866 6bce 6bcf +1855 1856 6bb0 6bd8 +1866 1855 6bce 6bdb +1855 1868 6bd8 6bdb +1868 1856 6bd8 6bd9 +1857 1860 6bc2 6be6 +1858 185b 6bb8 6bc8 +185e 1858 6bbd 6bc9 +1858 1862 6bc8 6bc9 +1859 185a 6bb6 6bca +185b 1859 6bb9 6bcb +1859 1863 6bca 6bcc +1864 1859 6bcb 6bcc +1863 185a 6bca 6bd1 +185a 1865 6bcd 6bd0 +185a 1867 6bd0 6bd1 +1862 185b 6bc8 6bd2 +185b 1864 6bcb 6bd2 +185c 185d 6bc0 7184 +186c 185c 6be2 7185 +185c 1b78 7184 7186 +1b79 185c 7185 7186 +185d 185f 6bbe 7188 +1b78 185d 7184 7187 +1b7a 185d 7187 7188 +185f 185e 6bbf 7197 +185e 1862 6bc9 71a6 +1b80 185e 7197 71a5 +1b8a 185e 71a5 71a6 +1b7a 185f 7188 7194 +1b80 185f 7194 7197 +1860 1861 6bc7 7950 +1efd 1861 794e 794f +1862 1864 6bd2 71bf +1b8a 1862 71a6 71be +1b96 1862 71be 71c0 +1862 1b97 71bf 71c0 +1864 1863 6bcc 71c4 +1863 1867 6bd1 7183 +1863 19c5 7183 71c3 +1863 1b99 71c3 71c5 +1b9a 1863 71c4 71c5 +1b97 1864 71bf 71c7 +1864 1b9a 71c4 71c7 +1865 1866 6bcf 717e +1867 1865 6bd0 7180 +1865 19c4 717e 7180 +1866 1868 6bdb 717b +1866 19c4 717d 717e +1866 1b77 717b 717d +1867 19c2 717f 7181 +19c4 1867 717f 7180 +1867 19c5 7181 7183 +1868 1b77 7178 717b +1869 186a 6be1 7157 +186a 186b 6be0 7193 +1b68 186a 7159 7193 +186b 186d 6be4 7191 +186b 1b68 7191 7193 +186d 186c 6be3 718a +186c 1b79 7185 7189 +186c 1b7b 7189 718b +1b7c 186c 718a 718b +1b68 186d 7191 7192 +186d 1b7c 718a 7192 +186f 186e 6be7 6be8 +186e 1870 6be7 6be9 +1871 186e 6be8 6bea +186e 1872 6be9 6beb +1873 186e 6bea 6bed +186e 1874 6beb 6bec +186e 1875 6bec 6bed +1870 186f 6be7 804a +186f 1871 6be8 8b8c +2371 186f 804a 8bde +186f 249c 8b8c 8bde +1872 1870 6be9 804e +1870 2371 804a 8c35 +2372 1870 8b2a 8c35 +2373 1870 804e 8052 +2375 1870 8052 8b2a +1871 1873 6bea 6bee +1871 1876 6bee 6bef +1871 1877 6bef 82ef +1871 249c 82ef 8b8c +1874 1872 6beb 6bf0 +1878 1872 6bf0 8c79 +1872 2373 804e 8c79 +1873 1875 6bed 6bf5 +1876 1873 6bee 6bf8 +1873 187c 6bf5 6bf8 +1875 1874 6bec 6bf1 +1874 1878 6bf0 6bf2 +1879 1874 6bf1 6bf4 +1874 187a 6bf2 6bf3 +1874 187b 6bf3 6bf4 +1875 1879 6bf1 6bf6 +187c 1875 6bf5 6bf7 +1875 187d 6bf6 6bf7 +1877 1876 6bef 6c05 +1876 187c 6bf8 6c06 +1885 1876 6c05 6c07 +1876 1886 6c06 6c08 +1887 1876 6c07 6c08 +1877 1885 6c05 6c09 +1877 1888 6c09 8b8b +249b 1877 82ed 8b8b +1877 249c 82ed 82ef +187a 1878 6bf2 6bf9 +187e 1878 6bf9 6bfa +187f 1878 6bfa 8051 +2373 1878 8051 8c79 +1879 187b 6bf4 6c00 +187d 1879 6bf6 6c03 +1879 1882 6c00 6c04 +1884 1879 6c03 6c04 +187b 187a 6bf3 6bfc +187a 187e 6bf9 6bfb +1880 187a 6bfc 6bfd +187b 1880 6bfc 6c01 +1882 187b 6c00 6c02 +187b 1883 6c01 6c02 +187c 187d 6bf7 6c0c +1886 187c 6c06 6c0f +187c 1889 6c0c 6c0f +187d 1884 6c03 6c0d +1889 187d 6c0c 6c0e +187d 188a 6c0d 6c0e +187e 187f 6bfa 6bfe +187e 1881 6bfe 8bbd +1881 187f 6bfe 8056 +187f 2373 8051 8c78 +2375 187f 8c27 8c78 +2377 187f 8056 8c27 +1883 1880 6c01 6c0b +2376 1881 8c6c 8ce7 +1881 2377 8056 8ce7 +2378 1881 8054 8c6c +1882 1883 6c02 6c10 +1884 1882 6c04 6c11 +188a 1884 6c0d 6c16 +1884 188b 6c14 6c15 +1884 188c 6c15 6c16 +1885 1887 6c07 6e5a +1888 1885 6c09 6e59 +19dd 1885 6e59 6e5a +1887 1886 6c08 6e6a +1886 1889 6c0f 6e6f +188f 1886 6e6b 6e6f +19e2 1886 6e6a 6e6b +19dc 1887 6e58 6e5c +1887 19dd 6e58 6e5a +19e2 1887 6e5c 6e6a +1888 19db 6e57 8b0c +19dd 1888 6e57 6e59 +1888 23a8 82ec 8bea +2499 1888 82ec 8bf2 +1888 249a 8b0c 8bf2 +249b 1888 8b8b 8bea +1889 188a 6c0e 6c1f +1889 188f 6c1f 6e6f +188a 188c 6c16 6c1c +188a 188e 6c1c 6c20 +188f 188a 6c1f 6c20 +188c 188b 6c15 6c19 +188c 188d 6c1b 6c1d +188e 188c 6c1c 6c1d +188e 188d 6c1d 6e77 +19ed 188d 6e77 6ea6 +188d 19fd 6ea4 6ea6 +188f 188e 6c20 6e70 +19eb 188e 6e70 6e72 +19ed 188e 6e72 6e77 +19e2 188f 6e6b 6e6c +19eb 188f 6e6c 6e70 +1891 1890 6c21 6c22 +1890 1892 6c21 6c23 +1893 1890 6c22 6c24 +1890 1894 6c23 6c25 +1895 1890 6c24 6c25 +1892 1891 6c21 6c26 +1891 1893 6c22 6c27 +1896 1891 6c26 6c28 +1891 1897 6c27 6c29 +1898 1891 6c28 6c2a +1891 1899 6c29 6c2a +1894 1892 6c23 6c2b +1892 1896 6c26 6c2c +189a 1892 6c2b 6c2d +1892 189b 6c2c 6c2e +189c 1892 6c2d 6c2e +1893 1895 6c24 6c2f +1897 1893 6c27 6c30 +1893 189d 6c2f 6c31 +189e 1893 6c30 6c31 +1895 1894 6c25 6c32 +1894 189a 6c2b 6c33 +189f 1894 6c32 6c34 +1894 18a0 6c33 6c34 +189d 1895 6c2f 6c35 +1895 189f 6c32 6c36 +18a1 1895 6c35 6c37 +1895 18a2 6c36 6c37 +1896 1898 6c28 6c38 +189b 1896 6c2c 6c39 +1896 18a3 6c38 6c39 +1899 1897 6c29 6c3a +1897 189e 6c30 6c3b +18a4 1897 6c3a 6c3b +1898 1899 6c2a 6c3c +18a3 1898 6c38 6c3d +1898 18a5 6c3c 6c3e +18a6 1898 6c3d 6c3e +1899 18a4 6c3a 6c3f +18a5 1899 6c3c 6c40 +1899 18a7 6c3f 6c40 +189a 189c 6c2d 6c41 +18a0 189a 6c33 6c42 +189a 18a8 6c41 6c42 +189c 189b 6c2e 6c43 +189b 18a3 6c39 6c44 +18a9 189b 6c43 6c45 +189b 18aa 6c44 6c46 +18ab 189b 6c45 6c47 +189b 18ac 6c46 6c47 +18a8 189c 6c41 6c48 +189c 18a9 6c43 6c49 +18ad 189c 6c48 6c49 +189e 189d 6c31 6c4a +189d 18a1 6c35 6c4b +18ae 189d 6c4a 6c4c +189d 18af 6c4b 6c4c +18a4 189e 6c3b 6c4d +189e 18ae 6c4a 6c4e +18b0 189e 6c4d 6c4e +189f 18a0 6c34 6c4f +18a2 189f 6c36 6c50 +189f 18b1 6c4f 6c51 +18b2 189f 6c50 89a5 +189f 18b3 6c51 89a5 +18a0 18a8 6c42 6c52 +18b1 18a0 6c4f 6c53 +18a0 18b4 6c52 6c53 +18a1 18a2 6c37 6c54 +18af 18a1 6c4b 6c55 +18a1 18b5 6c54 6c55 +18a2 18b2 6c50 6c56 +18b5 18a2 6c54 6c57 +18a2 18b6 6c56 6c57 +18a3 18a6 6c3d 6c58 +18aa 18a3 6c44 6c59 +18a3 18b7 6c58 6c59 +18a7 18a4 6c3f 6c5a +18a4 18b0 6c4d 6c5b +18b8 18a4 6c5a 6c5c +18a4 18b9 6c5b 6c5c +18a6 18a5 6c3e 6c5d +18a5 18a7 6c40 6c5e +18ba 18a5 6c5d 6c5f +18a5 18bb 6c5e 6c5f +18b7 18a6 6c58 6c60 +18a6 18ba 6c5d 6c61 +18bc 18a6 6c60 6c61 +18a7 18b8 6c5a 6c63 +18bb 18a7 6c5e 6c62 +18bd 18a7 6c62 6c63 +18a8 18ad 6c48 6c64 +18b4 18a8 6c52 6c65 +18a8 18be 6c64 6c65 +18a9 18ab 6c45 87fb +18ad 18a9 6c49 87fc +266a 18a9 87fc 89c3 +18a9 2701 87fb 89c3 +18ac 18aa 6c46 6c66 +18aa 18b7 6c59 6c67 +18bf 18aa 6c66 6c67 +18ab 18ac 6c47 6c68 +18ab 18c0 6c68 6c69 +18ab 18c1 6c69 87fa +18ab 2701 87fa 87fb +18ac 18bf 6c66 6c6a +18c0 18ac 6c68 6c6a +18be 18ad 6c64 89a7 +18ad 18da 87f9 89a7 +266a 18ad 87f9 87fc +18ae 18af 6c4c 6c6b +18b0 18ae 6c4e 6c6c +18ae 18c2 6c6b 6c6d +18c3 18ae 6c6c 6c6d +18af 18b5 6c55 6c6e +18c2 18af 6c6b 6c6f +18af 18c4 6c6e 6c6f +18b9 18b0 6c5b 6c70 +18b0 18c3 6c6c 6c70 +18b3 18b1 6c51 6c71 +18b1 18b4 6c53 6c72 +18c5 18b1 6c71 6c74 +18b1 18c6 6c72 6c74 +18b3 18b2 6c76 89a5 +18b6 18b2 6c56 6c75 +18c8 18b2 6c75 6c76 +18b3 18c5 6c71 6c73 +18b3 18c7 6c73 89a4 +18c8 18b3 6c76 89a4 +18b4 18be 6c65 6c77 +18c6 18b4 6c72 6c77 +18b5 18b6 6c57 6c78 +18c4 18b5 6c6e 6c79 +18b5 18c9 6c78 6c7b +18ca 18b5 6c79 6c7a +18cb 18b5 6c7a 6c7b +18b6 18c8 6c75 6c7d +18c9 18b6 6c78 6c7c +18cc 18b6 6c7c 6c7d +18b7 18bc 6c60 6c7e +18bf 18b7 6c67 6c7f +18b7 18cd 6c7e 6c7f +18b8 18b9 6c5c 6c88 +18bd 18b8 6c63 6c89 +18b8 18d3 6c88 6c8a +18d4 18b8 6c89 6c8b +18b8 18d5 6c8a 6c8b +18b9 18c3 6c70 6c8c +18d3 18b9 6c88 6c8c +18ba 18bb 6c5f 6c80 +18bc 18ba 6c61 6c81 +18ba 18ce 6c80 6c82 +18cf 18ba 6c81 6c82 +18bb 18bd 6c62 6c83 +18ce 18bb 6c80 6c84 +18bb 18d0 6c83 6c84 +18cd 18bc 6c7e 6c85 +18bc 18cf 6c81 6c87 +18d1 18bc 6c85 6c86 +18d2 18bc 6c86 6c87 +18d0 18bd 6c83 6c8e +18bd 18d4 6c89 6c8d +18bd 18d6 6c8d 6c8e +18c6 18be 6c77 87fe +18d9 18be 87fe 8846 +18da 18be 8846 89a7 +18c0 18bf 6c6a 6c8f +18bf 18cd 6c7f 6c90 +18d7 18bf 6c8f 6c90 +18c1 18c0 6c69 896b +18c0 18d7 6c8f 6c91 +18c0 18d8 6c91 8a97 +1af3 18c0 896b 8a97 +18c1 1af3 896b 8a96 +18c1 2667 8a96 8aaa +2701 18c1 87fa 8aaa +18c3 18c2 6c6d 760c +18c2 18c4 6c6f 761b +1dbf 18c2 760c 7611 +1dc5 18c2 7611 7619 +1dc9 18c2 7619 761a +1dca 18c2 761a 761b +18d3 18c3 6c8c 7607 +1dbf 18c3 7607 760c +18c4 18ca 6c79 7635 +1dca 18c4 761b 7635 +18c5 18c6 6c74 85c8 +18c7 18c5 6c73 773d +1e38 18c5 773d 8801 +18c5 262e 85c8 8625 +18c5 2630 8625 8801 +18d9 18c6 8622 87fe +262e 18c6 85c8 8622 +18c7 18c8 7727 89a4 +1e2c 18c7 7727 773b +1e37 18c7 773b 773c +1e38 18c7 773c 773d +18cc 18c8 6c7d 7724 +1e2b 18c8 7724 7726 +1e2c 18c8 7726 7727 +18cb 18c9 6c7b 7714 +18c9 18cc 6c7c 7717 +1e22 18c9 7714 7717 +18ca 18cb 6c7a 7712 +1dca 18ca 7635 7636 +1dda 18ca 7636 7713 +18ca 1e21 7712 7713 +1e21 18cb 7712 7715 +18cb 1e22 7714 7716 +1e23 18cb 7715 7716 +1e22 18cc 7717 771f +1e28 18cc 771f 7725 +18cc 1e2b 7724 7725 +18cd 18d1 6c85 6c94 +18d7 18cd 6c90 6c93 +18dc 18cd 6c93 6c94 +18cf 18ce 6c82 7648 +18ce 18d0 6c84 762e +18ce 1dd6 762e 7647 +18ce 1de0 7647 7648 +18d2 18cf 6c87 792b +18cf 1de0 7648 792b +18d0 18d6 6c8e 7629 +18d0 1dd3 7629 762f +1dd6 18d0 762e 762f +18d1 18d2 6c86 7920 +18dc 18d1 6c94 7078 +1afa 18d1 7078 7920 +18d2 1afa 791f 7920 +1de0 18d2 792a 792b +1ef1 18d2 791f 7928 +1ef4 18d2 7928 792a +18d5 18d3 6c8a 7606 +1dbe 18d3 7606 7608 +18d3 1dbf 7607 7609 +1dc0 18d3 7608 7609 +18d4 18d5 6c8b 760b +18d6 18d4 6c8d 7616 +18d4 1dc1 760b 7615 +18d4 1dc7 7615 7616 +18d5 1dbe 7606 760a +18d5 1dc1 760a 760b +18d6 1dc7 7616 7628 +18d6 1dd2 7628 762a +1dd3 18d6 7629 762b +18d6 1dd4 762a 762b +18d8 18d7 6c91 706f +18d7 18dc 6c93 7071 +1af4 18d7 706f 7071 +1af2 18d8 706d 706e +18d8 1af3 706d 8a97 +1af4 18d8 706e 706f +18da 18d9 6c92 8846 +18d9 18db 6c92 87f8 +18d9 262c 87f8 8847 +262e 18d9 8622 8847 +18db 18da 6c92 89a6 +18da 2549 8937 89a6 +18da 266a 87f9 8937 +18db 24dd 867d 867f +2549 18db 83ea 89a6 +18db 254a 83ea 867d +18db 262c 867f 87f8 +1af4 18dc 7071 7073 +1af7 18dc 7073 7077 +1afa 18dc 7077 7078 +18dd 18de 6c98 6c9f +18e1 18dd 6c9c 6ca0 +18dd 18e2 6c9f 6ca0 +18de 18e0 6c9a 6ca2 +18e2 18de 6c9f 6ca3 +18de 18e3 6ca2 6ca4 +18e4 18de 6ca3 6ca4 +18e0 18df 6c9b 6ca5 +18e5 18df 6ca5 6ca8 +18df 18e6 6ca7 6ca8 +18e3 18e0 6ca2 6ca6 +18e0 18e5 6ca5 6ca6 +18e1 18e2 6ca0 6cac +18e7 18e1 6ca9 6cab +18e8 18e1 6cab 6cac +18e2 18e4 6ca3 72e6 +18e8 18e2 6cac 72e5 +1c1e 18e2 72e5 72e6 +18e4 18e3 6ca4 72f0 +18e3 18e5 6ca6 72f4 +1c24 18e3 72f0 72f5 +18e3 1c26 72f4 72f5 +1c1e 18e4 72e6 72ef +1c23 18e4 72ef 72f2 +18e4 1c24 72f0 72f1 +18e4 1c25 72f1 72f2 +18e5 18e6 6ca8 77e9 +1c26 18e5 72f4 77ea +18e5 1e87 77e9 77ea +18e6 1e87 77e8 77e9 +18e6 1e88 77e7 77e8 +18e7 18e8 6cab 72e1 +1c1c 18e7 72e0 72e1 +1c1c 18e8 72e1 72e7 +18e8 1c1e 72e5 72e8 +1c1f 18e8 72e7 72e9 +18e8 1c20 72e8 72e9 +18ea 18e9 6cad 6caf +18eb 18e9 6caf 6cb1 +18e9 18ec 6cb0 6cb1 +18ea 18eb 6caf 6cb2 +18ea 18ed 6cb2 8c15 +23fa 18ea 813e 8c15 +18ea 23fb 813e 8c96 +23fe 18ea 8bda 8c96 +18eb 18ec 6cb1 6cb6 +18ed 18eb 6cb2 6cba +18eb 18ef 6cb6 6cb9 +18eb 18f0 6cb9 6cba +18ec 18ee 6cb5 6cb7 +18ef 18ec 6cb6 6cb7 +18ed 18f0 6cba 83d0 +23f8 18ed 813c 8be5 +18ed 23f9 813c 8c7a +23fa 18ed 8c15 8c7a +18ed 2539 83d0 8be5 +18ef 18ee 6cb7 6cbb +18f1 18ee 6cbb 6cbe +18f0 18ef 6cb9 6cbc +18ef 18f1 6cbb 6cbd +18f2 18ef 6cbc 6cbd +18f0 18f2 6cbc 83d1 +2539 18f0 83d0 83d1 +18f2 18f1 6cbd 6cc0 +18f3 18f1 6cc0 6cc2 +18f1 18f4 6cc1 6cc2 +18f2 18f3 6cc0 6cc3 +18f2 18f5 6cc3 83ce +18f2 2539 83ce 83d1 +18f3 18f4 6cc2 6cc5 +18f5 18f3 6cc3 6cc6 +18f3 18f6 6cc5 6cc7 +18f7 18f3 6cc6 6cc7 +18f6 18f4 6cc5 6cc8 +18f8 18f4 6cc8 6cc9 +18f5 18f7 6cc6 6cca +18f5 18f9 6cca 8b24 +18f5 2538 8b24 8bd4 +2539 18f5 83ce 8bd4 +18f7 18f6 6cc7 6f44 +18f6 18f8 6cc8 6f4e +1a59 18f6 6f44 6f46 +1a5f 18f6 6f46 6f4e +18f9 18f7 6cca 6f3d +18f7 1a56 6f3c 6f3d +1a59 18f7 6f3c 6f44 +1a5f 18f8 6f4e 6f4f +18f9 1a56 6f3d 8bfb +2535 18f9 83cd 8b73 +2537 18f9 8b73 8bfb +18f9 2538 83cd 8b24 +18fb 18fa 6ccb 6ccc +18fa 18fc 6ccb 6ccd +18fd 18fa 6ccc 6cce +18fa 18fe 6ccd 6ccf +18ff 18fa 6cce 6cd0 +18fa 1900 6ccf 6cd0 +18fc 18fb 6ccb 6cd1 +18fb 18fd 6ccc 6cd2 +1901 18fb 6cd1 6cd3 +18fb 1902 6cd2 6cd4 +1903 18fb 6cd3 6cd4 +18fe 18fc 6ccd 6cd5 +18fc 1901 6cd1 6cd6 +1904 18fc 6cd5 6cd7 +18fc 1905 6cd6 6cd7 +18fd 18ff 6cce 6cd8 +1902 18fd 6cd2 6cd9 +18fd 1906 6cd8 6cd9 +1900 18fe 6ccf 6cda +18fe 1904 6cd5 6cdb +1907 18fe 6cda 6cdc +18fe 1908 6cdb 6cdd +1909 18fe 6cdc 6cdd +18ff 1900 6cd0 6cde +1906 18ff 6cd8 6cdf +18ff 190a 6cde 6ce0 +190b 18ff 6cdf 6ce1 +18ff 190c 6ce0 6ce1 +1900 1907 6cda 6ce2 +190a 1900 6cde 6ce2 +1901 1903 6cd3 6ce3 +1905 1901 6cd6 6ce4 +1901 190d 6ce3 6ce4 +1903 1902 6cd4 6ce5 +1902 1906 6cd9 6ce6 +190e 1902 6ce5 6ce7 +1902 190f 6ce6 6ce8 +1910 1902 6ce7 6ce8 +190d 1903 6ce3 6ce9 +1903 190e 6ce5 6cea +1911 1903 6ce9 6cea +1904 1905 6cd7 6ceb +1908 1904 6cdb 6cec +1904 1912 6ceb 6ced +1913 1904 6cec 6ced +1905 190d 6ce4 6cee +1912 1905 6ceb 6cef +1905 1914 6cee 6cf0 +1915 1905 6cef 6cf0 +1906 190b 6cdf 6cf1 +190f 1906 6ce6 6cf2 +1906 1916 6cf1 6cf2 +1907 1909 6cdc 6cf3 +190a 1907 6ce2 6cf4 +1907 1917 6cf3 6cf5 +1918 1907 6cf4 6cf5 +1909 1908 6cdd 6cf6 +1908 1913 6cec 6cf7 +1919 1908 6cf6 6cf8 +1908 191a 6cf7 6cf8 +1917 1909 6cf3 6cf9 +1909 1919 6cf6 6cfa +191b 1909 6cf9 6cfa +190c 190a 6ce0 6cfb +190a 1918 6cf4 6cfc +191c 190a 6cfb 6cfd +190a 191d 6cfc 6cfd +190b 190c 6ce1 6cfe +1916 190b 6cf1 6cff +190b 191e 6cfe 6d00 +191f 190b 6cff 6d00 +190c 191c 6cfb 6d01 +191e 190c 6cfe 6d01 +190d 1911 6ce9 6d02 +1914 190d 6cee 6d03 +190d 1920 6d02 6d03 +190e 1910 6ce7 6d04 +1911 190e 6cea 6d05 +190e 1921 6d04 6d06 +1922 190e 6d05 6d07 +190e 1923 6d06 6d07 +1910 190f 6ce8 6d08 +190f 1916 6cf2 6d09 +1924 190f 6d08 6d0a +190f 1925 6d09 6d0a +1921 1910 6d04 6d0b +1910 1924 6d08 6d0b +1920 1911 6d02 6d0c +1911 1922 6d05 6d0d +1926 1911 6d0c 6d0d +1913 1912 6ced 6d0e +1912 1915 6cef 6d0f +1927 1912 6d0e 6d10 +1912 1928 6d0f 6d10 +191a 1913 6cf7 6d11 +1913 1927 6d0e 6d11 +1915 1914 6cf0 6d12 +1914 1920 6d03 6d13 +1929 1914 6d12 6d14 +1914 192a 6d13 6d15 +192b 1914 6d14 6d15 +1928 1915 6d0f 6d16 +1915 1929 6d12 6d17 +192c 1915 6d16 6d17 +1916 191f 6cff 6d18 +1925 1916 6d09 6d19 +1916 192d 6d18 6d1a +192e 1916 6d19 6d1a +1918 1917 6cf5 6d1b +1917 191b 6cf9 6d1c +192f 1917 6d1b 6d1d +1917 1930 6d1c 6d1e +1931 1917 6d1d 6d1e +191d 1918 6cfc 6d1f +1918 192f 6d1b 6d1f +1919 191a 6cf8 6d20 +191b 1919 6cfa 6d21 +1919 1932 6d20 6d21 +191a 1927 6d11 6d22 +1932 191a 6d20 6d23 +191a 1933 6d22 6d24 +1934 191a 6d23 6d24 +1930 191b 6d1c 6d25 +191b 1932 6d21 6d26 +1935 191b 6d25 6d26 +191c 191d 6cfd 6d27 +191e 191c 6d01 6d28 +191c 1936 6d27 6d28 +191d 192f 6d1f 6d29 +1936 191d 6d27 6d2a +191d 1937 6d29 6d2b +1938 191d 6d2a 6d2b +191f 191e 6d00 6d2d +191e 1936 6d28 6d2c +191e 1939 6d2c 6d2e +193a 191e 6d2d 6d2e +192d 191f 6d18 6d3a +191f 193a 6d2d 6d39 +191f 1941 6d39 6d3a +1920 1926 6d0c 6d3f +192a 1920 6d13 6d40 +1920 1944 6d3f 6d40 +1923 1921 6d06 6d41 +1921 1924 6d0b 6d42 +1945 1921 6d41 6d43 +1921 1946 6d42 6d43 +1922 1923 6d07 6d44 +1926 1922 6d0d 6d45 +1922 1947 6d44 6d46 +1948 1922 6d45 6d46 +1923 1945 6d41 6d48 +1947 1923 6d44 6d47 +1949 1923 6d47 6d48 +1924 1925 6d0a 6d49 +1946 1924 6d42 6d4a +1924 194a 6d49 6d4a +1925 192e 6d19 6d4b +194a 1925 6d49 6d4c +1925 194b 6d4b 6d4c +1944 1926 6d3f 6d4d +1926 1948 6d45 6d4d +1927 1928 6d10 6d4e +1933 1927 6d22 6d50 +1927 194c 6d4e 6d51 +194d 1927 6d50 6d51 +1928 192c 6d16 6d4f +194c 1928 6d4e 6d4f +1929 192b 6d14 6d52 +192c 1929 6d17 6d53 +1929 194e 6d52 6d53 +192b 192a 6d15 6d54 +192a 1944 6d40 6d58 +194f 192a 6d54 6d57 +1951 192a 6d57 6d58 +194e 192b 6d52 6d55 +192b 194f 6d54 6d56 +1950 192b 6d55 6d56 +194c 192c 6d4f 6d5a +192c 194e 6d53 6d59 +192c 1952 6d59 6d5a +192e 192d 6d1a 6fde +192d 1941 6d3a 6fdf +1aad 192d 6fde 6fdf +194b 192e 6d4b 6fdb +192e 1a97 6fda 6fdb +1aad 192e 6fda 6fde +192f 1931 6d1d 6d30 +1937 192f 6d29 6d2f +193b 192f 6d2f 6d31 +192f 193c 6d30 6d31 +1931 1930 6d1e 7002 +1930 1935 6d25 7005 +1ac5 1930 7002 7004 +1ac6 1930 7004 7005 +193c 1931 6d30 7003 +1931 1ac5 7002 7003 +1932 1934 6d23 75ad +1935 1932 6d26 75ab +1932 1c56 75aa 75ab +1d9e 1932 75aa 75ad +1934 1933 6d24 75b7 +1933 194d 6d50 75c0 +1d38 1933 75b8 75c0 +1d3c 1933 75b7 75b8 +1d3c 1934 75ae 75b7 +1d9e 1934 75ad 75ae +1ac6 1935 7005 7343 +1935 1c50 7342 7343 +1c56 1935 7342 75ab +1936 1938 6d2a 6d32 +1939 1936 6d2c 6d33 +1936 193d 6d32 6d33 +1938 1937 6d2b 6d34 +1937 193b 6d2f 6d35 +193e 1937 6d34 6d36 +1937 193f 6d35 6d36 +193d 1938 6d32 6d37 +1938 193e 6d34 6d38 +1940 1938 6d37 6d38 +193a 1939 6d2e 6d3b +1939 193d 6d33 6d3c +1942 1939 6d3b 6d3d +1939 1943 6d3c 6d3d +1941 193a 6d39 6d3e +193a 1942 6d3b 6d3e +193b 193c 6d31 7006 +193f 193b 6d35 7007 +1ac7 193b 7007 7008 +193c 1ac5 7003 7009 +193c 1ac8 7009 700a +193d 1940 6d37 700b +1943 193d 6d3c 700c +193d 1ac9 700b 700c +193e 193f 6d36 700d +1940 193e 6d38 700e +193e 1968 700d 700e +193f 195e 6d85 6d86 +193f 1968 6d86 700d +193f 1ac7 7007 700f +1940 1967 7011 7012 +1940 1968 700e 7011 +196a 1940 7010 7012 +1ac9 1940 700b 7010 +1941 1942 6d3e 6fcb +1aa6 1941 6fc8 6fcb +1941 1aa7 6fc8 6fc9 +1941 1aad 6fc9 6fdf +1942 1943 6d3d 79a5 +1942 1aa6 6fca 6fcb +1aac 1942 6fca 6ff3 +1abb 1942 6ff3 79a5 +1abb 1943 79a5 79a6 +1943 1ac9 700c 79a6 +1944 1948 6d4d 7603 +1951 1944 6d58 75fd +1dbd 1944 75fd 7603 +1945 1946 6d43 78fe +1949 1945 6d48 78d3 +1ec1 1945 78d3 78d6 +1ed9 1945 78d6 78fe +1946 194a 6d4a 78f5 +1946 1ed9 78f3 78fe +1ee4 1946 78f3 78f5 +1948 1947 6d46 7892 +1947 1949 6d47 7894 +1947 1ebb 7890 7892 +1ebd 1947 7890 7894 +1dbd 1948 7603 7880 +1eb8 1948 7880 7891 +1ebb 1948 7891 7892 +1ebc 1949 7893 7895 +1949 1ebd 7893 7894 +1ec1 1949 7895 78d3 +194a 194b 6d4c 6fe1 +194a 1ab5 6fe1 78f4 +194a 1ee4 78f4 78f5 +194b 1a96 6fd7 6fd9 +1a97 194b 6fd7 6fdb +194b 1ab3 6fd9 6fe0 +194b 1ab5 6fe0 6fe1 +194d 194c 6d51 75dc +194c 1952 6d5a 75d2 +194c 1dac 75d2 75dc +1d38 194d 75c0 75c1 +1d39 194d 75c1 75e0 +194d 1dac 75dc 75e0 +194e 1950 6d55 75d0 +1952 194e 6d59 75ce +1da9 194e 75ce 75cf +1daa 194e 75cf 75d0 +1950 194f 6d56 75db +194f 1951 6d57 75ef +1db1 194f 75db 75ed +1db4 194f 75ed 75ee +1db5 194f 75ee 75ef +1daa 1950 75d0 75d7 +1daf 1950 75d7 75da +1db1 1950 75da 75db +1db5 1951 75ef 75fc +1dbc 1951 75fc 75fe +1951 1dbd 75fd 75fe +1952 1da9 75ce 75d1 +1952 1dab 75d1 75d3 +1dac 1952 75d2 75d3 +1954 1953 6d5d 6d63 +1953 1955 6d5e 6d62 +1953 1957 6d62 6d63 +1956 1954 6d60 6d69 +1954 1957 6d63 6d6a +195b 1954 6d69 6d6a +1957 1955 6d62 6d65 +1955 1958 6d64 6d66 +1959 1955 6d65 6d66 +1956 195b 6d69 6d6c +195c 1956 6d6b 6d6d +1956 195d 6d6c 6d6d +1957 1959 6d65 6d71 +195b 1957 6d6a 6d70 +195f 1957 6d70 6d72 +1957 1960 6d71 6d72 +1959 1958 6d66 6d77 +1958 195a 6d68 6d78 +1963 1958 6d77 6d79 +1958 1964 6d78 6d79 +1960 1959 6d71 6d7a +1959 1963 6d77 6d7b +1965 1959 6d7a 6d7b +195a 1961 6d75 6d7c +1964 195a 6d78 6d7d +195a 1966 6d7c 6d7d +195d 195b 6d6c 6d73 +195b 195f 6d70 6d73 +195c 195d 6d6d 6d7e +195e 195c 6d6e 6d7f +195c 1967 6d7e 6d80 +1968 195c 6d7f 6d80 +195d 195f 6d73 6d81 +1967 195d 6d7e 6d82 +195d 1969 6d81 6d83 +196a 195d 6d82 6d83 +195e 1968 6d7f 6d86 +195f 1960 6d72 6d87 +1969 195f 6d81 6d87 +1960 1965 6d7a 6d89 +1969 1960 6d87 6d88 +196b 1960 6d88 6d89 +1961 1962 6d76 6d8a +1966 1961 6d7c 6d8b +1961 196c 6d8a 6d8b +196c 1962 6d8a 6d8c +196d 1962 6d8c 8612 +2664 1962 8612 8a89 +1963 1964 6d79 6d8e +1965 1963 6d7b 6d92 +1963 196f 6d8e 6d93 +1971 1963 6d92 6d93 +1964 1966 6d7d 6d8d +1964 196e 6d8d 6d8f +196f 1964 6d8e 6d90 +1964 1970 6d8f 6d90 +196b 1965 6d89 6fee +1965 1971 6d92 6fed +1965 1ab1 6fed 6fee +1966 196c 6d8b 6d91 +196e 1966 6d8d 6d91 +1968 1967 6d80 7011 +1967 196a 6d82 7012 +196a 1969 6d83 79aa +1969 196b 6d88 79a9 +1969 1abc 79a9 79aa +1abc 196a 79a8 79aa +1ac9 196a 7010 79a8 +1ab1 196b 6fec 6fee +196b 1ab2 6fec 6ff1 +196b 1abc 6ff1 79a9 +196c 196d 6d8c 7043 +196e 196c 6d91 7050 +196c 1ad5 703c 703e +1ad7 196c 703c 7043 +196c 1adc 703e 7050 +1ad6 196d 703f 7041 +196d 1ad7 703f 7043 +1add 196d 7041 8613 +196d 2664 8612 8613 +1970 196e 6d8f 7052 +196e 1adc 7050 7052 +196f 1970 6d90 7053 +1971 196f 6d93 6ff2 +1ab7 196f 6ff2 7053 +1970 1ab7 7051 7053 +1adc 1970 7051 7052 +1971 1aaa 6fd4 6fd5 +1aaf 1971 6fd4 6fe9 +1971 1ab1 6fd5 6fed +1ab7 1971 6fe9 6ff2 +1973 1972 6d96 889a +1972 256d 88d2 8965 +268d 1972 889a 8965 +1974 1973 6d97 708c +1b04 1973 708c 8924 +268d 1973 86a1 889a +1973 268e 86a1 8924 +1974 1b04 708c 708d +1974 1b05 708d 7090 +1976 1975 6d99 6d9a +1975 1977 6d99 6d9b +1978 1975 6d9a 6d9c +1975 1979 6d9b 6d9d +197a 1975 6d9c 6d9d +1977 1976 6d99 6d9e +1976 1978 6d9a 6d9f +197b 1976 6d9e 6da0 +1976 197c 6d9f 6da1 +197d 1976 6da0 6da1 +1979 1977 6d9b 6da2 +1977 197b 6d9e 849c +197e 1977 6da2 888c +1977 2594 849c 888c +1978 197a 6d9c 6da3 +197c 1978 6d9f 6da4 +1978 197f 6da3 6da5 +1980 1978 6da4 6da6 +1978 1981 6da5 6da6 +197a 1979 6d9d 6da7 +1979 197e 6da2 6da8 +1982 1979 6da7 6da9 +1979 1983 6da8 6da9 +197f 197a 6da3 6daa +197a 1982 6da7 6dab +1984 197a 6daa 6dac +197a 1985 6dab 6dac +197b 197d 6da0 6dad +197b 2591 8865 88be +2594 197b 849c 88be +197d 197c 6da1 6dae +197c 1980 6da4 6daf +197c 1986 6daf 6db0 +1983 197e 6da8 6db3 +1987 197e 6db3 8893 +197e 2594 888c 88f3 +2597 197e 8893 88f3 +1981 197f 6da5 6db4 +197f 1984 6daa 6db4 +1980 1981 6da6 6db5 +1986 1980 6daf 6db6 +1981 1984 6db4 6db8 +1981 1988 6db8 6db9 +1982 1983 6da9 6dba +1985 1982 6dab 6dbe +1982 1989 6dba 6dbf +198c 1982 6dbe 6dbf +1983 1987 6db3 6dbd +1989 1983 6dba 6dbb +198a 1983 6dbb 6dbc +198b 1983 6dbc 6dbd +1984 1985 6dac 6dc0 +1988 1984 6db8 6dc2 +1984 198d 6dc0 6dc3 +198e 1984 6dc2 6dc3 +1985 198c 6dbe 6dc1 +198d 1985 6dc0 6dc1 +198b 1987 6dbd 888e +2595 1987 84a2 88f2 +1987 2597 8893 88f2 +1987 259b 84a2 888e +1988 198e 6dc2 6dcd +1989 198a 6dbb 6dc5 +198c 1989 6dbf 6dc4 +198f 1989 6dc4 6dc5 +198a 198b 6dbc 6dd0 +198f 198a 6dc5 6dd1 +198a 1992 6dd0 6dd2 +1993 198a 6dd1 6dd2 +1992 198b 6dd0 84a4 +259a 198b 84a4 88c4 +198b 259b 888e 88c4 +198d 198c 6dc1 6dc6 +198c 198f 6dc4 6dc7 +1990 198c 6dc6 6dc8 +198c 1991 6dc7 6dc8 +198e 198d 6dc3 6dd3 +198d 1990 6dc6 6dd3 +198e 1990 6dd3 6dd7 +198e 1995 6dd7 6ddb +1991 198f 6dc7 6dd4 +198f 1993 6dd1 6dd5 +1994 198f 6dd4 6dd5 +1990 1991 6dc8 6dd6 +1995 1990 6dd7 6dd8 +1991 1994 6dd4 6dd9 +1993 1992 6dd2 70ca +1b27 1992 70ca 888b +1992 2599 84a0 888b +259a 1992 84a0 84a4 +1994 1993 6dd5 70cb +1993 1b27 70ca 70cd +1b28 1993 70cb 70cc +1994 1b28 70cb 70ce +1996 1997 6de2 6df6 +1996 199f 6df4 6df5 +1999 1998 6de5 6de8 +1998 199a 6de6 6de9 +199b 1998 6de8 6dea +1998 199c 6de9 6dea +1999 199b 6de8 6dec +199d 1999 6deb 6dec +199c 199a 6de9 6ded +199e 199a 6ded 8a93 +199a 25dc 854d 8a93 +199b 199c 6dea 711b +199d 199b 6dec 7123 +199b 1b4d 711b 7121 +199b 1b52 7121 7122 +199b 1b53 7122 7123 +199c 199e 6ded 7118 +199c 1b4b 7118 7119 +199c 1b4c 7119 711a +199c 1b4d 711a 711b +199d 1b53 7123 712e +1b4b 199e 7118 855a +199e 25dc 8a93 8b5a +25e3 199e 8559 8b53 +199e 25e4 8a7c 8b53 +25e5 199e 8a7c 8b5a +199e 25e6 8559 855a +19a1 19a0 6df9 6dfa +19a0 19a2 6df9 6dfb +19a3 19a0 6dfa 6dfc +19a0 19a4 6dfb 6dfd +19a5 19a0 6dfc 6dfd +19a2 19a1 6df9 6dfe +19a1 19a3 6dfa 8585 +19a6 19a1 6dfe 6dff +19a7 19a1 6dff 6e00 +19a8 19a1 6e00 8585 +19a4 19a2 6dfb 6e01 +19a2 19a6 6dfe 6e02 +19a9 19a2 6e01 6e02 +19a3 19a5 6dfc 8582 +19a8 19a3 8585 89e3 +19a3 19ad 8582 8a7a +2602 19a3 8584 8a7a +19a3 2603 8584 8a53 +2604 19a3 89e3 8a53 +19a5 19a4 6dfd 6e03 +19a4 19a9 6e01 6e04 +19aa 19a4 6e03 6e05 +19a4 19ab 6e04 6e05 +19a5 19aa 6e03 6e06 +19a5 19ac 6e06 8a7b +19ad 19a5 8582 8a7b +19a6 19a7 6dff 6e08 +19a9 19a6 6e02 6e09 +19a6 19ae 6e08 6e0a +19af 19a6 6e09 6e0b +19a6 19b0 6e0a 6e0b +19a7 19a8 6e00 8ad9 +19ae 19a7 6e08 6e0d +19b1 19a7 6e0c 8ad9 +19a7 19b2 6e0c 8afe +19b3 19a7 6e0d 8afe +19a8 19b1 8a12 8ad9 +19a8 2604 89e3 8ad8 +2606 19a8 8a12 8ad8 +19ab 19a9 6e04 6e0f +19a9 19af 6e09 6e10 +19b6 19a9 6e0f 6e10 +19aa 19ab 6e05 6e11 +19ac 19aa 6e06 6e12 +19aa 19b7 6e11 6e13 +19aa 19b8 6e13 6e14 +19ab 19b6 6e0f 6e15 +19b7 19ab 6e11 6e16 +19ab 19b9 6e15 6e16 +19ac 19ad 6e07 8a7b +19ad 2602 89ca 8a7a +19b0 19ae 6e0a 6e19 +19ae 19b3 6e0d 6e1a +19ba 19ae 6e19 6e1b +19ae 19bb 6e1a 6e1b +19af 19b0 6e0b 6e1c +19b6 19af 6e10 6e1d +19af 19ba 6e1c 6e1e +19bc 19af 6e1d 6e1f +19af 19bd 6e1e 6e1f +19b0 19ba 6e19 6e1c +19b2 19b1 6e0c 8aff +19b1 2605 8a5e 8aff +19b1 2606 8a12 8a5e +19b2 19b3 6e20 8afe +19b2 19b4 6e0e 6e20 +19b5 19b2 6e0e 8588 +2605 19b2 8588 8aff +19b3 19b4 6e20 6e22 +19bb 19b3 6e1a 6e21 +19be 19b3 6e21 6e22 +19b4 19b5 6e0e 6e23 +19be 19b4 6e22 6e38 +19b4 19bf 6e23 6e39 +19cb 19b4 6e38 6e3a +19b4 19cc 6e39 6e3a +19bf 19b5 6e23 858a +19b5 2605 8588 8a4a +2607 19b5 858a 8a4a +19b9 19b6 6e15 6e24 +19b6 19bc 6e1d 6e25 +19c0 19b6 6e24 6e26 +19b6 19c1 6e25 6e26 +19b8 19b7 6e13 6e27 +19b7 19b9 6e16 6e28 +19c2 19b7 6e27 6e28 +19b8 19c2 6e27 6e2c +19c3 19b8 6e29 6e2b +19c4 19b8 6e2b 6e2c +19b9 19c0 6e24 6e2d +19c2 19b9 6e28 6e2e +19b9 19c5 6e2d 6e2e +19ba 19bb 6e1b 6e2f +19bd 19ba 6e1e 6e30 +19ba 19c6 6e2f 6e30 +19bb 19be 6e21 6e31 +19c6 19bb 6e2f 6e32 +19bb 19c7 6e31 6e32 +19bc 19bd 6e1f 6e33 +19c1 19bc 6e25 6e34 +19bc 19c8 6e33 6e35 +19c9 19bc 6e34 6e35 +19bd 19c6 6e30 6e37 +19c8 19bd 6e33 6e36 +19ca 19bd 6e36 6e37 +19c7 19be 6e31 6e3b +19be 19cb 6e38 6e3b +19cc 19bf 6e39 6e3c +19cd 19bf 6e3c 858c +19bf 2607 858a 8a74 +2608 19bf 858c 8a74 +19c0 19c1 6e26 6e3d +19c5 19c0 6e2d 6e3e +19c0 19c9 6e3d 6e3f +19ce 19c0 6e3e 6e3f +19c1 19c9 6e34 6e3d +19c4 19c2 6e2c 717f +19c2 19c5 6e2e 7181 +19c3 19c4 6e2b 717c +1b77 19c3 717a 717c +1b77 19c4 717c 717d +19c5 19ce 6e3e 71c6 +1b99 19c5 71c3 71c6 +19c6 19c7 6e32 7268 +19ca 19c6 6e37 722f +1bc7 19c6 722f 798a +19c6 1be4 7268 798a +19c7 19cb 6e3b 7256 +19c7 1bd7 7256 7257 +19c7 1bdb 7257 7262 +19c7 1be4 7262 7268 +19c9 19c8 6e35 720f +19c8 19ca 6e36 721b +1b9f 19c8 720f 7210 +1bb7 19c8 7210 721b +19ce 19c9 6e3f 71cc +1b9c 19c9 71cc 71d2 +1b9f 19c9 71d2 720f +1bb7 19ca 721b 721c +1bbe 19ca 721c 722c +1bc7 19ca 722c 722f +19cb 19cc 6e3a 7251 +19cb 1bd7 7251 7256 +19cc 19cd 6e3c 7245 +1bce 19cc 7244 7245 +19cc 1bd3 7244 724f +19cc 1bd7 724f 7251 +19cd 1bce 7243 7245 +1bcf 19cd 7243 8a77 +19cd 2608 858c 858e +19cd 260a 858e 8a77 +1b99 19ce 71c6 71c9 +1b9c 19ce 71c9 71cc +19d0 19cf 6e40 6e41 +19cf 19d1 6e40 6e42 +19d2 19cf 6e41 6e43 +19cf 19d3 6e42 6e44 +19d4 19cf 6e43 6e45 +19cf 19d5 6e44 6e45 +19d1 19d0 6e40 6e46 +19d0 19d2 6e41 6e47 +19d6 19d0 6e46 6e48 +19d0 19d7 6e47 6e49 +19d8 19d0 6e48 6e49 +19d3 19d1 6e42 8b0a +19d1 19d6 6e46 82e6 +19d1 2494 82e6 8b0a +19d2 19d4 6e43 6e4a +19d7 19d2 6e47 6e4b +19d2 19d9 6e4a 6e4c +19da 19d2 6e4b 6e4c +19d5 19d3 6e44 6e4d +19db 19d3 6e4d 82ea +19d3 2494 8b0a 8bf3 +249a 19d3 82ea 8bf3 +19d4 19d5 6e45 6e4e +19d9 19d4 6e4a 6e52 +19d4 19dc 6e4e 6e51 +19d4 19de 6e51 6e52 +19d5 19db 6e4d 6e4f +19dc 19d5 6e4e 6e50 +19d5 19dd 6e4f 6e50 +19d6 19d8 6e48 8a80 +19d6 1bd5 8a80 8b08 +2494 19d6 82e6 8bc3 +19d6 2497 8b08 8bc3 +19d8 19d7 6e49 6e53 +19d7 19da 6e4b 6e54 +19df 19d7 6e53 6e55 +19d7 19e0 6e54 6e55 +19d8 19df 6e53 6e56 +19d8 19e1 6e56 8594 +19d8 1bd5 8594 8a80 +19da 19d9 6e4c 6e5d +19d9 19de 6e52 6e5e +19e3 19d9 6e5d 6e60 +19d9 19e4 6e5e 6e5f +19d9 19e5 6e5f 6e60 +19e0 19da 6e54 6e61 +19da 19e3 6e5d 6e62 +19e6 19da 6e61 6e62 +19dd 19db 6e4f 6e57 +19db 249a 82ea 8b0c +19dc 19dd 6e50 6e58 +19de 19dc 6e51 6e5b +19e2 19dc 6e5b 6e5c +19de 19e2 6e5b 6e63 +19e4 19de 6e5e 6e63 +19df 19e0 6e55 6e64 +19e1 19df 6e56 6e65 +19df 19e7 6e64 6e66 +19e8 19df 6e65 6e66 +19e0 19e6 6e61 6e68 +19e7 19e0 6e64 6e67 +19e9 19e0 6e67 6e68 +19e1 19e8 6e65 6e69 +19e1 19ea 6e69 8a79 +1bd4 19e1 7246 8b5e +19e1 1bd5 7246 8594 +19e1 260b 8a79 8b5e +19e4 19e2 6e63 6e6e +19e2 19eb 6e6c 6e6d +19e2 19ec 6e6d 6e6e +19e3 19e5 6e60 7276 +19e6 19e3 6e62 7272 +1a19 19e3 7273 7276 +1be2 19e3 7272 7273 +19e5 19e4 6e5f 6e76 +19e4 19ec 6e6e 6e73 +19e4 19ee 6e73 6e75 +19e4 19ef 6e75 6e76 +19e5 19ef 6e76 6ec7 +1a0a 19e5 6ec6 6ec7 +19e5 1a19 6ec6 7276 +19e9 19e6 6e68 7260 +1be2 19e6 7260 7272 +19e8 19e7 6e66 7241 +19e7 19e9 6e67 7250 +1bcd 19e7 7241 7242 +1bd1 19e7 7242 724b +1bd9 19e7 724b 7250 +19ea 19e8 6e69 7239 +19e8 1bca 7237 7239 +1bcd 19e8 7237 7241 +1bd9 19e9 7250 725a +1bdf 19e9 725a 725f +1be2 19e9 725f 7260 +19ea 1bca 7239 723a +19ea 1bcf 723a 8591 +19ea 260b 8591 8a79 +19ec 19eb 6e6d 6e71 +19ed 19eb 6e71 6e72 +19ec 19ed 6e71 6e74 +19ee 19ec 6e73 6e74 +19ee 19ed 6e74 6ec2 +19fd 19ed 6ea5 6ea6 +19ed 1a09 6ea5 6ec2 +19ef 19ee 6e75 6ec4 +19ee 1a09 6ec2 6ec4 +1a09 19ef 6ec3 6ec4 +19ef 1a0a 6ec3 6ec7 +19f0 19f1 6e79 6e7f +19f4 19f0 6e7d 6e80 +19f0 19f5 6e7f 6e80 +19f1 19f3 6e7b 6e83 +19f5 19f1 6e7f 6e84 +19f1 19f7 6e83 6e85 +19f8 19f1 6e84 6e85 +19f3 19f2 6e7c 6e86 +19f2 19f6 6e81 6e87 +19f9 19f2 6e86 6e88 +19f2 19fa 6e87 6e88 +19f7 19f3 6e83 6e89 +19f3 19f9 6e86 6e8a +19fb 19f3 6e89 6e8a +19f4 19f5 6e80 6e8e +19fc 19f4 6e8b 6e8f +19f4 19fe 6e8e 6e8f +19f5 19f8 6e84 6e91 +19fe 19f5 6e8e 6e92 +19f5 19ff 6e91 6e93 +1a00 19f5 6e92 6e93 +19fa 19f6 6e87 6e94 +1a01 19f6 6e94 6e95 +19f8 19f7 6e85 6e96 +19f7 19fb 6e89 6e96 +19f8 19fb 6e96 6e97 +19ff 19f8 6e91 6e98 +19f8 1a02 6e97 6e99 +1a03 19f8 6e98 6e99 +19f9 19fa 6e88 6e9a +19fb 19f9 6e8a 6e9b +19f9 1a04 6e9a 6e9c +1a05 19f9 6e9b 6e9d +19f9 1a06 6e9c 6e9d +19fa 1a01 6e94 6e9f +1a04 19fa 6e9a 6e9e +1a07 19fa 6e9e 6e9f +1a02 19fb 6e97 6ea1 +19fb 1a05 6e9b 6ea0 +19fb 1a08 6ea0 6ea1 +19fd 19fc 6e8c 6ea2 +19fc 19fe 6e8f 6ea3 +1a09 19fc 6ea2 6ea3 +19fd 1a09 6ea2 6ea5 +19fe 1a00 6e92 6ea7 +1a09 19fe 6ea3 6ea8 +19fe 1a0a 6ea7 6ea8 +1a00 19ff 6e93 6eab +19ff 1a03 6e98 6eac +1a0c 19ff 6eab 6eac +1a0a 1a00 6ea7 6ead +1a00 1a0c 6eab 6eae +1a0d 1a00 6ead 6eae +1a07 1a01 6e9f 6eb6 +1a01 1a0b 6ea9 6eb8 +1a12 1a01 6eb6 6eb7 +1a13 1a01 6eb7 6eb8 +1a03 1a02 6e99 6ebd +1a02 1a08 6ea1 6ebc +1a02 1a16 6ebc 6ebd +1a0c 1a03 6eac 6ec0 +1a03 1a16 6ebd 6ec1 +1a18 1a03 6ec0 6ec1 +1a06 1a04 6e9c 6eaf +1a04 1a07 6e9e 6eb0 +1a0e 1a04 6eaf 6eb0 +1a05 1a06 6e9d 6eb1 +1a08 1a05 6ea0 6eb2 +1a05 1a0f 6eb1 6eb3 +1a10 1a05 6eb2 6eb3 +1a06 1a0e 6eaf 6eb4 +1a0f 1a06 6eb1 6eb5 +1a06 1a11 6eb4 6eb5 +1a0e 1a07 6eb0 6ebb +1a07 1a12 6eb6 6eb9 +1a07 1a14 6eb9 6eba +1a07 1a15 6eba 6ebb +1a08 1a10 6eb2 6ebf +1a16 1a08 6ebc 6ebe +1a17 1a08 6ebe 6ebf +1a09 1a0a 6ea8 6ec3 +1a0a 1a0d 6ead 6ec5 +1a0a 1a19 6ec5 6ec6 +1a13 1a0b 6eb8 6ee5 +1a23 1a0b 6ee5 6ee9 +1a0d 1a0c 6eae 7277 +1a0c 1a18 6ec0 727a +1be7 1a0c 7278 727a +1bea 1a0c 7277 7278 +1a19 1a0d 6ec5 7275 +1a0d 1be2 7274 7275 +1bea 1a0d 7274 7277 +1a11 1a0e 6eb4 6f0b +1a0e 1a15 6ebb 6ef8 +1a0e 1a2e 6ef8 6f0b +1a10 1a0f 6eb3 7989 +1a0f 1a11 6eb5 7976 +1a38 1a0f 796e 7976 +1a0f 1f07 796e 796f +1a0f 1f0b 796f 7989 +1a17 1a10 6ebf 7988 +1f0b 1a10 7988 7989 +1a11 1a2e 6f0b 6f0d +1a11 1a38 6f0d 7976 +1a12 1a13 6eb7 6ed4 +1a14 1a12 6eb9 6ed5 +1a12 1a1c 6ed4 6ed5 +1a13 1a1c 6ed2 6ed4 +1a1d 1a13 6ed2 6ed8 +1a23 1a13 6ed8 6ee5 +1a15 1a14 6eba 6ee6 +1a1c 1a14 6ed3 6ed5 +1a14 1a21 6ed3 6ee3 +1a14 1a27 6ee3 6ee6 +1a15 1a27 6ee6 6ef5 +1a15 1a2d 6ef5 6ef7 +1a15 1a2e 6ef7 6ef8 +1a16 1a17 6ebe 7986 +1a18 1a16 6ec1 727c +1be9 1a16 727c 7982 +1f10 1a16 7982 7986 +1f0b 1a17 7987 7988 +1f0e 1a17 7985 7987 +1a17 1f10 7985 7986 +1be6 1a18 7279 727b +1a18 1be7 7279 727a +1be9 1a18 727b 727c +1be2 1a19 7273 7275 +1a1b 1a1a 6ec8 6ec9 +1a1a 1a1c 6ec8 6eca +1a1a 1a1d 6eca 6ecc +1a1e 1a1a 6ecb 6ecd +1a1a 1a1f 6ecc 6ece +1a20 1a1a 6ecd 6ece +1a1c 1a1b 6ec8 6ecf +1a21 1a1b 6ecf 6ed1 +1a1d 1a1c 6eca 6ed2 +1a1c 1a21 6ecf 6ed3 +1a1f 1a1d 6ecc 6ed7 +1a22 1a1d 6ed7 6ed9 +1a1d 1a23 6ed8 6ed9 +1a1e 1a20 6ecd 6eda +1a20 1a1f 6ece 6edc +1a1f 1a22 6ed7 6edd +1a24 1a1f 6edc 6ede +1a1f 1a25 6edd 6ede +1a20 1a24 6edc 6ee0 +1a20 1a26 6ee0 6ee1 +1a27 1a21 6ee3 6ee4 +1a22 1a23 6ed9 6ee7 +1a25 1a22 6edd 6ee8 +1a22 1a28 6ee7 6ee8 +1a28 1a23 6ee7 6eea +1a29 1a23 6eea 6eeb +1a24 1a25 6ede 6eec +1a26 1a24 6ee0 6eed +1a24 1a2a 6eec 6eed +1a25 1a28 6ee8 6eee +1a2a 1a25 6eec 6eef +1a25 1a2b 6eee 6eef +1a26 1a2a 6eed 6ef1 +1a27 1a2c 6ef3 6ef6 +1a2d 1a27 6ef5 6ef6 +1a28 1a29 6eea 6ef9 +1a2b 1a28 6eee 6efa +1a28 1a2f 6ef9 6efb +1a30 1a28 6efa 6efb +1a2f 1a29 6ef9 6efd +1a31 1a29 6efd 6efe +1a2a 1a2b 6eef 6eff +1a2a 1a32 6eff 6f01 +1a33 1a2a 6f00 6f02 +1a2a 1a34 6f01 6f02 +1a2b 1a30 6efa 6f03 +1a32 1a2b 6eff 6f04 +1a2b 1a35 6f03 6f04 +1a2d 1a2c 6ef6 6f07 +1a2c 1a36 6f06 6f08 +1a37 1a2c 6f07 6f08 +1a2e 1a2d 6ef7 6f0a +1a2d 1a37 6f07 6f0a +1a2e 1a37 6f0a 6f0c +1a2e 1a38 6f0c 6f0d +1a30 1a2f 6efb 76cd +1a2f 1a31 6efd 76d3 +1cba 1a2f 76cd 76d3 +1a35 1a30 6f03 76cc +1cb9 1a30 76cc 76ce +1a30 1cba 76cd 76ce +1cba 1a31 76d3 76da +1a34 1a32 6f01 76d0 +1a32 1a35 6f04 76cf +1a32 1e13 76cf 76d0 +1a33 1a34 6f02 76d4 +1a33 1e14 76d4 76d7 +1a33 1e16 76d7 76d8 +1a34 1e13 76d0 76d5 +1e14 1a34 76d4 76d6 +1a34 1e15 76d5 76d6 +1a35 1cb9 76cc 76d1 +1a35 1cc7 76d1 76d2 +1e13 1a35 76cf 76d2 +1a37 1a36 6f08 72a8 +1a36 1bf6 729e 72a2 +1a36 1bfa 72a2 72a8 +1a38 1a37 6f0c 7941 +1a37 1bfa 72a8 7940 +1a37 1ed7 7940 7941 +1a38 1ed7 7941 7966 +1a38 1f07 7966 796e +1a39 1a3a 6f10 7409 +1caa 1a39 73fc 73fe +1cae 1a39 73fe 7409 +1a3a 1a3b 6f11 746f +1cae 1a3a 7409 740a +1cb8 1a3a 740a 746f +1cb8 1a3b 746f 7470 +1ce7 1a3b 7470 892e +2628 1a3b 8763 892d +1a3b 26ba 8763 892e +1a3d 1a3c 6f12 6f13 +1a3c 1a3e 6f12 6f14 +1a3f 1a3c 6f13 876f +1a3c 1a40 6f14 6f16 +1a3c 1a42 876e 876f +1a3c 1a43 6f16 876e +1a3e 1a3d 6f12 6f17 +1a3d 1a3f 6f13 6f18 +1a44 1a3d 6f17 6f19 +1a3d 1a45 6f18 6f19 +1a40 1a3e 6f14 6f1a +1a3e 1a44 6f17 8768 +1a46 1a3e 6f1a 8767 +1a4d 1a3e 8767 8768 +1a3f 1a42 876f 8a85 +1a45 1a3f 6f18 876c +26bb 1a3f 876c 8a85 +1a43 1a40 6f16 8a57 +1a40 1a46 6f1a 8b57 +2616 1a40 8a57 8b57 +1a41 1a42 6f15 8a66 +1a41 1a43 8a66 8a86 +1a41 24b5 8769 876b +24b6 1a41 876a 876b +2618 1a41 8769 8a86 +1a41 2619 876a 89da +1a42 1a43 876e 8a66 +1a42 26bb 8a67 8a85 +1a43 2616 8a57 8b56 +2617 1a43 89db 8b56 +1a43 2618 89db 8a86 +1a44 1a45 6f19 6f1b +1a44 1a47 6f1b 6f1c +1a44 1a48 6f1c 6f24 +1a44 1a4d 6f24 8768 +1a47 1a45 6f1b 6f1d +1a49 1a45 6f1d 6f1e +1a45 26bb 876c 8a84 +1a46 1a4d 8767 89d3 +2613 1a46 8a46 8af3 +1a46 2614 89d3 8af3 +2615 1a46 859d 8a46 +1a46 2616 859d 8b57 +1a48 1a47 6f1c 6f20 +1a47 1a49 6f1d 6f21 +1a4a 1a47 6f20 6f22 +1a47 1a4b 6f21 6f22 +1a48 1a4a 6f20 6f23 +1a48 1a4c 6f23 8944 +1a4d 1a48 6f24 8944 +1a4b 1a49 6f21 6f27 +1a49 1a4e 6f25 6f27 +1a4a 1a4b 6f22 770f +1a4c 1a4a 6f23 770e +1a4a 1ce9 770d 770e +1e1f 1a4a 770d 770f +1a4b 1a4e 6f27 79f5 +1e1e 1a4b 770a 770c +1a4b 1e1f 770a 770f +1e20 1a4b 770c 79f5 +1a4c 1a4d 8764 8944 +1a4c 1ce9 770e 8781 +26ba 1a4c 8764 8781 +237a 1a4d 8766 892f +1a4d 2614 8766 89d3 +1a4d 26b9 8765 892f +1a4d 26ba 8764 8765 +1e20 1a4e 79f5 79f6 +1a4f 1a50 6f2b 6f2f +1a51 1a4f 6f2c 6f30 +1a4f 1a53 6f2f 6f31 +1a54 1a4f 6f30 6f31 +1a53 1a50 6f2f 6f32 +1a52 1a51 6f2d 6f33 +1a51 1a54 6f30 6f34 +1a55 1a51 6f33 6f34 +1a52 1a55 6f33 817d +1a52 2414 817d 8bfe +2415 1a52 838c 8c52 +1a52 2416 8bfe 8c52 +1a54 1a53 6f31 6f35 +1a55 1a54 6f34 6f38 +2414 1a55 817d 838b +24fd 1a55 838b 8b43 +1a57 1a56 6f3a 6f3b +1a56 1a58 6f3a 83ca +1a59 1a56 6f3b 6f3c +1a56 2537 83ca 8bfb +1a58 1a57 6f3a 6f3e +1a57 1a59 6f3b 6f3f +1a5a 1a57 6f3e 6f40 +1a57 1a5b 6f3f 6f41 +1a5c 1a57 6f40 6f42 +1a57 1a5d 6f41 6f42 +1a58 1a5a 6f3e 6f43 +1a58 1a5e 6f43 83c8 +1a58 2534 83c8 8b13 +2537 1a58 83ca 8b13 +1a5b 1a59 6f3f 6f45 +1a5f 1a59 6f45 6f46 +1a5a 1a5c 6f40 6f47 +1a5e 1a5a 6f43 8ae2 +1a5a 1a60 6f47 860e +1a5a 1a67 860e 8ae2 +1a5d 1a5b 6f41 6f48 +1a5b 1a5f 6f45 6f49 +1a61 1a5b 6f48 6f49 +1a5c 1a5d 6f42 6f4a +1a60 1a5c 6f47 6f4b +1a5c 1a62 6f4a 6f4b +1a5d 1a61 6f48 6f4c +1a62 1a5d 6f4a 6f4d +1a5d 1a63 6f4c 6f4d +1a5e 1a67 8ae2 8b5d +1a5e 1c3e 8b5d 8b87 +2533 1a5e 83c7 8b87 +1a5e 2534 83c7 83c8 +1a61 1a5f 6f49 6f51 +1a5f 1a64 6f50 6f51 +1a60 1a62 6f4b 6f52 +1a60 1a65 6f52 89dd +1a66 1a60 6f53 8b1c +1a60 1a67 6f53 860e +1a60 2663 89dd 8b1c +1a63 1a61 6f4c 6f59 +1a61 1a64 6f51 6f56 +1a61 1a68 6f56 6f59 +1a62 1a63 6f4d 6f63 +1a65 1a62 6f52 6f66 +1a62 1a6e 6f63 6f66 +1a63 1a68 6f59 6f5f +1a63 1a6d 6f5f 6f64 +1a6e 1a63 6f63 6f65 +1a63 1a6f 6f64 6f65 +1a68 1a64 6f56 6f58 +1a64 1a69 6f57 6f58 +1a65 1a6e 6f66 6f74 +1a65 1a77 6f74 8b1d +2663 1a65 89dd 8b1d +1a67 1a66 6f53 8ae3 +1a66 1c37 8610 8ab0 +1a66 1c3f 89dc 8ae3 +1a66 2418 860d 89dc +2662 1a66 860d 8ab0 +2663 1a66 8610 8b1c +1a67 1c3e 83c4 8b5d +1c3f 1a67 83c4 8ae3 +1a68 1a69 6f58 6f5b +1a68 1a6a 6f5b 6f60 +1a6d 1a68 6f5f 6f60 +1a6a 1a69 6f5b 6f5d +1a69 1a6b 6f5c 6f5e +1a6c 1a69 6f5d 6f5e +1a6a 1a6c 6f5d 6f68 +1a6d 1a6a 6f60 6f67 +1a70 1a6a 6f67 6f69 +1a6a 1a71 6f68 6f6a +1a72 1a6a 6f69 6f6a +1a6c 1a6b 6f5e 6f6c +1a73 1a6b 6f6c 6f6d +1a71 1a6c 6f68 6f6f +1a6c 1a73 6f6c 6f6e +1a6c 1a74 6f6e 6f6f +1a6f 1a6d 6f64 6f6b +1a6d 1a70 6f67 6f6b +1a6e 1a6f 6f65 6f70 +1a6e 1a75 6f70 6f73 +1a6e 1a77 6f73 6f74 +1a6f 1a70 6f6b 6f72 +1a75 1a6f 6f70 6f71 +1a76 1a6f 6f71 6f72 +1a70 1a72 6f69 7320 +1a76 1a70 6f72 7314 +1c36 1a70 7314 7316 +1c3d 1a70 7316 7320 +1a72 1a71 6f6a 7330 +1a71 1a74 6f6f 7328 +1a71 1c48 732f 7330 +1a71 1c4c 7328 732f +1c3d 1a72 7320 7321 +1c48 1a72 7321 7330 +1a74 1a73 6f6e 7325 +1c4a 1a73 7325 7326 +1a74 1c4a 7325 7327 +1a74 1c4b 7327 7329 +1c4c 1a74 7328 732a +1a74 1c4d 7329 732a +1a75 1a76 6f71 7313 +1a77 1a75 6f73 730b +1a75 1c2f 730a 730b +1c35 1a75 730a 7313 +1a76 1c35 7312 7313 +1c36 1a76 7312 7314 +1c2f 1a77 7309 730b +1a77 1c32 7309 730c +1a77 1c37 730c 860f +1a77 2663 860f 8b1d +1a79 1a78 6f75 6f76 +1a78 1a7a 6f75 6f77 +1a7b 1a78 6f76 6f78 +1a78 1a7c 6f77 6f79 +1a7d 1a78 6f78 6f7a +1a78 1a7e 6f79 6f7b +1a7f 1a78 6f7a 6f7b +1a7a 1a79 6f75 6f7c +1a79 1a7b 6f76 6f7d +1a80 1a79 6f7c 6f7e +1a79 1a81 6f7d 6f7f +1a82 1a79 6f7e 6f7f +1a7c 1a7a 6f77 6f80 +1a7a 1a80 6f7c 6f81 +1a83 1a7a 6f80 6f81 +1a7b 1a7d 6f78 6f82 +1a81 1a7b 6f7d 6f83 +1a7b 1a84 6f82 6f84 +1a85 1a7b 6f83 6f84 +1a7e 1a7c 6f79 6f85 +1a7c 1a83 6f80 6f86 +1a86 1a7c 6f85 6f87 +1a7c 1a87 6f86 6f88 +1a88 1a7c 6f87 6f88 +1a7d 1a7f 6f7a 6f89 +1a84 1a7d 6f82 6f8a +1a7d 1a89 6f89 6f8a +1a7f 1a7e 6f7b 6f8b +1a7e 1a86 6f85 6f8c +1a8a 1a7e 6f8b 6f8d +1a7e 1a8b 6f8c 6f8d +1a89 1a7f 6f89 6f8e +1a7f 1a8a 6f8b 6f8f +1a8c 1a7f 6f8e 6f8f +1a80 1a82 6f7e 6f90 +1a83 1a80 6f81 6f91 +1a80 1a8d 6f90 6f92 +1a8e 1a80 6f91 6f93 +1a80 1a8f 6f92 6f93 +1a82 1a81 6f7f 6f94 +1a81 1a85 6f83 6f95 +1a90 1a81 6f94 6f96 +1a81 1a91 6f95 6f96 +1a8d 1a82 6f90 6f97 +1a82 1a90 6f94 6f98 +1a92 1a82 6f97 6f99 +1a82 1a93 6f98 6f99 +1a87 1a83 6f86 6f9a +1a83 1a8e 6f91 6f9b +1a94 1a83 6f9a 6f9b +1a85 1a84 6f84 6f9c +1a84 1a89 6f8a 6f9d +1a95 1a84 6f9c 6f9e +1a84 1a96 6f9d 6f9f +1a97 1a84 6f9e 6f9f +1a91 1a85 6f95 6fa0 +1a85 1a95 6f9c 6fa0 +1a86 1a88 6f87 6fa1 +1a8b 1a86 6f8c 6fa2 +1a86 1a98 6fa1 6fa3 +1a99 1a86 6fa2 6fa4 +1a86 1a9a 6fa3 6fa4 +1a88 1a87 6f88 6fa5 +1a87 1a94 6f9a 6fa6 +1a9b 1a87 6fa5 6fa7 +1a87 1a9c 6fa6 6fa7 +1a98 1a88 6fa1 6fa8 +1a88 1a9b 6fa5 6fa8 +1a89 1a8c 6f8e 6fa9 +1a96 1a89 6f9d 6faa +1a89 1a9d 6fa9 6faa +1a8a 1a8b 6f8d 6fac +1a8c 1a8a 6f8f 6fab +1a9e 1a8a 6fab 6fad +1a8a 1a9f 6fac 6fad +1a8b 1a99 6fa2 6fb0 +1a9f 1a8b 6fac 6fb1 +1a8b 1aa1 6fb0 6fb1 +1a9d 1a8c 6fa9 6fae +1a8c 1a9e 6fab 6faf +1aa0 1a8c 6fae 6faf +1a8f 1a8d 6f92 6fb2 +1a8d 1a92 6f97 6fb3 +1aa2 1a8d 6fb2 6fb4 +1a8d 1aa3 6fb3 6fb4 +1a8e 1a8f 6f93 6fb5 +1a94 1a8e 6f9b 6fb6 +1a8e 1aa4 6fb5 6fb6 +1a8f 1aa2 6fb2 6fb7 +1aa4 1a8f 6fb5 6fb7 +1a90 1a91 6f96 6fb8 +1a93 1a90 6f98 6fb9 +1a90 1aa5 6fb8 6fb9 +1a91 1a95 6fa0 6fbb +1aa5 1a91 6fb8 6fba +1aa6 1a91 6fba 6fbc +1a91 1aa7 6fbb 6fbc +1a92 1a93 6f99 6fbd +1aa3 1a92 6fb3 6fc0 +1a92 1aa8 6fbd 6fc1 +1aaa 1a92 6fc0 6fc1 +1a93 1aa5 6fb9 6fbe +1aa8 1a93 6fbd 6fbf +1a93 1aa9 6fbe 6fbf +1a9c 1a94 6fa6 6fc3 +1a94 1aa4 6fb6 6fc2 +1a94 1aab 6fc2 6fc3 +1a95 1a97 6f9e 6fc7 +1aa7 1a95 6fbb 6fc6 +1aad 1a95 6fc6 6fc7 +1a97 1a96 6f9f 6fd7 +1a96 1a9d 6faa 6fd8 +1a96 1ab3 6fd8 6fd9 +1aad 1a97 6fc7 6fda +1a9a 1a98 6fa3 6ffa +1a98 1a9b 6fa8 6ff5 +1a98 1abe 6ff5 6ffa +1a99 1a9a 6fa4 6ffb +1aa1 1a99 6fb0 6ffc +1a99 1ac1 6ffb 6ffd +1ac2 1a99 6ffc 6ffd +1a9a 1abe 6ffa 6fff +1ac1 1a9a 6ffb 6ffe +1ac3 1a9a 6ffe 6fff +1a9b 1a9c 6fa7 6ff4 +1a9b 1abd 6ff4 6ff7 +1abe 1a9b 6ff5 6ff6 +1abf 1a9b 6ff6 6ff7 +1a9c 1aab 6fc3 6ff8 +1abd 1a9c 6ff4 6ff9 +1a9c 1ac0 6ff8 6ff9 +1a9d 1aa0 6fae 6fdd +1ab3 1a9d 6fd8 6fdc +1ab4 1a9d 6fdc 6fdd +1a9e 1a9f 6fad 790d +1aa0 1a9e 6faf 7909 +1eeb 1a9e 7909 790b +1eec 1a9e 790b 790d +1a9f 1aa1 6fb1 791c +1eec 1a9f 790d 7911 +1eed 1a9f 7911 791c +1ab4 1aa0 6fdd 78fd +1ee8 1aa0 78fd 7904 +1eeb 1aa0 7904 7909 +1aa1 1ac2 6ffc 791b +1aa1 1eed 7919 791c +1eee 1aa1 7919 791b +1aa2 1aa3 6fb4 6fcc +1aa4 1aa2 6fb7 6fcf +1aa2 1aae 6fcc 6fd0 +1ab0 1aa2 6fcf 6fd0 +1aa3 1aaa 6fc0 6fcd +1aae 1aa3 6fcc 6fce +1aa3 1aaf 6fcd 6fce +1aab 1aa4 6fc2 6fe4 +1aa4 1ab0 6fcf 6fe3 +1aa4 1ab6 6fe3 6fe4 +1aa5 1aa6 6fba 6fc4 +1aa9 1aa5 6fbe 6fc5 +1aa5 1aac 6fc4 6fc5 +1aa6 1aa7 6fbc 6fc8 +1aac 1aa6 6fc4 6fca +1aa7 1aad 6fc6 6fc9 +1aa8 1aa9 6fbf 6fd2 +1aaa 1aa8 6fc1 6fd1 +1ab1 1aa8 6fd1 6fd3 +1aa8 1ab2 6fd2 6fd3 +1aa9 1aac 6fc5 6fd6 +1ab2 1aa9 6fd2 6fd6 +1aaf 1aaa 6fcd 6fd4 +1aaa 1ab1 6fd1 6fd5 +1aab 1ab6 6fe4 7000 +1ac0 1aab 6ff8 7001 +1aab 1ac4 7000 7001 +1ab2 1aac 6fd6 6fef +1abb 1aac 6fef 6ff3 +1aae 1aaf 6fce 6fe5 +1ab0 1aae 6fd0 6fe6 +1aae 1ab7 6fe5 6fe8 +1ab8 1aae 6fe6 6fe7 +1ab9 1aae 6fe7 6fe8 +1ab7 1aaf 6fe5 6fe9 +1ab6 1ab0 6fe3 6feb +1ab0 1ab8 6fe6 6fea +1ab0 1aba 6fea 6feb +1ab1 1ab2 6fd3 6fec +1ab2 1abb 6fef 6ff0 +1ab2 1abc 6ff0 6ff1 +1ab3 1ab4 6fdc 6fe2 +1ab5 1ab3 6fe0 6fe2 +1ab5 1ab4 6fe2 78f2 +1ab4 1ee4 78f0 78f2 +1ee5 1ab4 78f0 78f7 +1ee8 1ab4 78f7 78fd +1ab5 1ee4 78f2 78f4 +1ab6 1aba 6feb 7029 +1ac4 1ab6 7000 702b +1ab6 1ad0 7029 702b +1ab9 1ab7 6fe8 7044 +1adc 1ab7 7044 7051 +1ab8 1ab9 6fe7 7030 +1aba 1ab8 6fea 7027 +1acf 1ab8 7027 7028 +1ad2 1ab8 7028 7030 +1ad2 1ab9 7030 7031 +1ad5 1ab9 7031 703d +1adc 1ab9 703d 7044 +1aba 1acb 701b 701c +1acf 1aba 701b 7027 +1aba 1ad0 701c 7029 +1abc 1abb 6ff0 79a7 +1abb 1ac9 79a6 79a7 +1abc 1ac9 79a7 79a8 +1abf 1abd 6ff7 79b3 +1abd 1ac0 6ff9 704d +1abd 1adb 704d 704e +1abd 1ae2 704e 79b4 +1f17 1abd 79b3 79b4 +1abe 1abf 6ff6 799c +1ac3 1abe 6fff 7995 +1f13 1abe 7995 799c +1f13 1abf 799c 799d +1f17 1abf 799d 79b3 +1ac0 1ac4 7001 703b +1ac0 1adb 703b 704d +1ac2 1ac1 6ffd 7962 +1ac1 1ac3 6ffe 798e +1f02 1ac1 7962 798b +1f03 1ac1 798b 798e +1ac2 1eee 791a 791b +1eef 1ac2 791a 795a +1f02 1ac2 795a 7962 +1f03 1ac3 798e 798f +1f11 1ac3 798f 7991 +1f13 1ac3 7991 7995 +1ad0 1ac4 702a 702b +1ac4 1ad4 702a 7034 +1ac4 1ad9 7034 703a +1ac4 1adb 703a 703b +1ac5 1ac6 7004 7344 +1ac8 1ac5 7009 733d +1c4e 1ac5 733a 733b +1ac5 1c4f 733a 733d +1c51 1ac5 733b 7344 +1c50 1ac6 733f 7343 +1ac6 1c51 733f 7344 +1c4f 1ac8 733c 733d +1acb 1aca 7013 7014 +1aca 1acc 7013 7015 +1acd 1aca 7014 7016 +1ace 1aca 7016 7018 +1acc 1acb 7013 7019 +1acb 1acd 7014 701a +1acf 1acb 7019 701b +1acb 1ad0 701a 701c +1acc 1acf 7019 701e +1ad1 1acc 701d 701f +1acc 1ad2 701e 701f +1acd 1ace 7016 7020 +1ad0 1acd 701a 7021 +1acd 1ad3 7020 7022 +1ad4 1acd 7021 7022 +1ad3 1ace 7020 7025 +1ad2 1acf 701e 7028 +1ad0 1ad4 7021 702a +1ad1 1ad2 701f 702c +1ad1 1ad5 702c 702e +1ad6 1ad1 702d 702f +1ad1 1ad7 702e 702f +1ad5 1ad2 702c 7031 +1ad4 1ad3 7022 7032 +1ad8 1ad3 7032 7033 +1ad4 1ad8 7032 7035 +1ad9 1ad4 7034 7035 +1ad7 1ad5 702e 703c +1ad5 1adc 703d 703e +1ad6 1ad7 702f 703f +1ad6 1add 7041 7042 +1ad9 1ad8 7035 7045 +1ad8 1ada 7038 7046 +1ade 1ad8 7045 7047 +1ad8 1adf 7046 7047 +1adb 1ad9 703a 7048 +1ad9 1ade 7045 7049 +1ae0 1ad9 7048 7049 +1adf 1ada 7046 704b +1ada 1ae1 704a 704b +1adb 1ae0 7048 704f +1ae2 1adb 704e 704f +253a 1add 83d4 8abf +1add 253b 83d4 83d5 +1add 2664 8613 8abf +1ade 1adf 7047 79cb +1ae0 1ade 7049 79c5 +1f21 1ade 79c5 79cb +1adf 1ae1 704b 79d8 +1f21 1adf 79cb 79cc +1f23 1adf 79cc 79d2 +1f29 1adf 79d2 79d8 +1ae2 1ae0 704f 79be +1ae0 1f19 79bc 79be +1f1e 1ae0 79bc 79c1 +1f21 1ae0 79c1 79c5 +1f29 1ae1 79d8 79e0 +1f17 1ae2 79b4 79bf +1ae2 1f19 79be 79bf +2243 1ae3 83d7 8b98 +1ae3 2244 83d7 8b99 +2403 1ae3 814a 8b99 +1ae3 253b 83d8 8b98 +1ae4 1ae5 7057 705c +1ae6 1ae4 7059 705d +1ae4 1ae8 705c 705d +1ae8 1ae5 705c 7062 +1ae5 1ae9 705e 7061 +1ae5 1aeb 7061 7062 +1ae7 1ae6 705b 7065 +1ae6 1ae8 705d 7068 +1aed 1ae6 7065 7067 +1aee 1ae6 7066 7068 +1ae6 1aef 7066 7067 +1aec 1ae7 7063 706a +1ae7 1aed 7065 7069 +1ae7 1af0 7069 706a +1ae8 1aeb 7062 79ef +1aee 1ae8 7068 79ef +1ae9 1aea 7060 7932 +1aeb 1ae9 7061 7937 +1ae9 1ef3 7932 7933 +1ae9 1ef5 7933 7937 +1aea 1af1 706c 7925 +1aea 1ef0 7925 7927 +1aea 1ef3 7927 7932 +1aeb 1aee 79e6 79ef +1aeb 1ef5 7937 7938 +1aeb 1ef9 7938 79e6 +1aec 1af0 706a 79f2 +1f2b 1aec 79f1 79f2 +1aed 1aef 7067 79df +1af0 1aed 7069 79e1 +1f28 1aed 79de 79df +1aed 1f29 79de 79e1 +1aef 1aee 7066 79e4 +1ef9 1aee 79e5 79e6 +1f2a 1aee 79e4 79e5 +1f25 1aef 79d6 79d7 +1aef 1f28 79d6 79df +1f2a 1aef 79d7 79e4 +1af0 1f29 79e1 79e2 +1af0 1f2b 79e2 79f2 +1afc 1af1 7921 7923 +1af1 1ef0 7921 7925 +1af3 1af2 706d 861d +1af2 1af4 706e 7070 +1af2 1af5 7070 8b55 +2544 1af2 8b33 8b55 +2668 1af2 861d 8b33 +2667 1af3 8a96 8b32 +1af3 2668 861d 8b32 +1af5 1af4 7070 7072 +1af6 1af4 7072 7074 +1af4 1af7 7073 7074 +1af5 1af6 7072 7075 +1af5 1af8 7075 7076 +1af5 1af9 7076 861a +1af5 2544 861a 8b55 +1af6 1af7 7074 7079 +1af8 1af6 7075 707a +1af6 1afb 7079 707b +1af7 1afa 7077 707c +1afb 1af7 7079 707d +1af7 1afc 707c 707d +1af9 1af8 7076 707e +2544 1af9 861a 8a30 +2545 1af9 8a30 8b4c +1afc 1afa 707c 791d +1ef0 1afa 791d 791e +1ef1 1afa 791e 791f +1afb 1afc 707d 7922 +1afc 1ef0 791d 7921 +2501 1afd 87b0 8833 +1afd 254d 87b0 87b3 +2686 1afd 869a 89ce +1afd 2687 869a 8833 +1afd 26db 87b3 89e9 +1afe 1aff 7084 7087 +1afe 1b01 7087 7089 +1b02 1afe 7088 708a +1afe 1b03 7089 708a +1aff 1b00 7085 87ba +1b01 1aff 7087 85e4 +2642 1aff 85e4 87ba +2642 1b00 87ba 8a2d +1b00 26d9 89fb 8a2d +1b00 26dc 8839 89fb +1b03 1b01 7089 7474 +1cea 1b01 7474 7475 +1ceb 1b01 7475 8a2c +1b01 2642 85e4 8a2c +1b02 1b03 708a 7476 +1b02 1cec 7476 7478 +1ced 1b02 7477 7478 +1b03 1cea 7474 7479 +1cec 1b03 7476 7479 +1b05 1b04 708d 708e +1b06 1b04 708e 708f +1b07 1b04 708f 86a3 +268e 1b04 86a3 8924 +1b05 1b06 708e 7092 +1b05 1b08 7092 7094 +1b09 1b05 7093 7095 +1b05 1b0a 7094 7095 +1b06 1b07 708f 7096 +1b08 1b06 7092 7097 +1b06 1b0b 7096 7098 +1b0c 1b06 7097 7098 +1b0b 1b07 7096 7099 +1b0d 1b07 7099 88b2 +268c 1b07 86a5 8925 +1b07 268e 86a3 8925 +1b07 268f 86a5 8900 +2690 1b07 88b2 8900 +1b0a 1b08 7094 709b +1b08 1b0c 7097 709c +1b0e 1b08 709b 709c +1b09 1b0a 7095 709d +1b0a 1b0e 709b 709f +1b0c 1b0b 7098 70a1 +1b0b 1b0d 7099 70a3 +1b0f 1b0b 70a1 70a2 +1b10 1b0b 70a2 70a3 +1b0e 1b0c 709c 70a4 +1b0c 1b0f 70a1 70a5 +1b11 1b0c 70a4 70a7 +1b0c 1b12 70a5 70a6 +1b0c 1b13 70a6 70a7 +1b10 1b0d 70a3 86a9 +2690 1b0d 86aa 88b2 +2691 1b0d 86a9 86aa +1b0e 1b11 70a4 70aa +1b0f 1b10 70a2 70ab +1b12 1b0f 70a5 70ac +1b0f 1b14 70ab 70ac +1b14 1b10 70ab 70ad +1b15 1b10 70ad 8897 +1b10 2691 86a9 8897 +1b11 1b13 70a7 70b0 +1b11 1b17 70b0 70b3 +1b13 1b12 70a6 70ae +1b12 1b14 70ac 70af +1b16 1b12 70ae 70af +1b13 1b16 70ae 70b1 +1b17 1b13 70b0 70b2 +1b13 1b18 70b1 70b2 +1b14 1b15 70ad 70b4 +1b16 1b14 70af 70b6 +1b14 1b19 70b4 70b5 +1b14 1b1a 70b5 70b6 +1b19 1b15 70b4 8269 +247c 1b15 8269 86a7 +2691 1b15 86a7 8897 +1b18 1b16 70b1 70bc +1b16 1b1a 70b6 70b9 +1b16 1b1d 70b9 70bc +1b17 1b18 70b2 70c7 +1b17 1b25 70c7 7376 +1b18 1b1d 70bc 70c1 +1b18 1b22 70c1 70c6 +1b18 1b25 70c6 70c7 +1b1a 1b19 70b5 70b7 +1b1b 1b19 70b7 70b8 +1b1c 1b19 70b8 8718 +1b19 247c 8269 8718 +1b1a 1b1b 70b7 70ba +1b1d 1b1a 70b9 70bb +1b1a 1b1e 70ba 70bb +1b1b 1b1c 70b8 70bd +1b1e 1b1b 70ba 70be +1b1b 1b1f 70bd 70be +1b1f 1b1c 70bd 70bf +1b20 1b1c 70bf 871a +247c 1b1c 8509 8718 +1b1c 2572 8509 871a +1b1d 1b1e 70bb 70c0 +1b1d 1b21 70c0 70c2 +1b22 1b1d 70c1 70c2 +1b1e 1b1f 70be 70c3 +1b21 1b1e 70c0 70c5 +1b1e 1b23 70c3 70c4 +1b1e 1b24 70c4 70c5 +1b1f 1b20 70bf 70c8 +1b23 1b1f 70c3 70c9 +1b1f 1b26 70c8 70c9 +1b26 1b20 70c8 86ab +1b20 2572 871a 871b +1b20 2574 871b 8863 +2692 1b20 86ab 8863 +1b22 1b21 70c2 735f +1b21 1b24 70c5 735c +1b21 1c63 735c 735f +1b25 1b22 70c6 736e +1b22 1c63 735f 7369 +1b22 1c6b 7369 736f +1b24 1b23 70c4 735a +1b23 1b26 70c9 7357 +1b23 1c5f 7357 735b +1c62 1b23 735a 735b +1b24 1c62 735a 735d +1c63 1b24 735c 735e +1b24 1c64 735d 735e +1c5f 1b26 7357 7358 +1c60 1b26 7358 7359 +1c61 1b26 7359 8862 +1b26 2692 86ab 8862 +2599 1b27 84a7 888b +1b29 1b2a 70da 743c +1b2b 1b29 70db 744c +1b29 1cd2 743c 744b +1b29 1cd9 744b 744c +1b2a 1ccb 7431 743b +1b2a 1cd1 743b 743d +1cd2 1b2a 743c 743e +1b2a 1cd3 743d 743e +1b2b 1cd9 744c 7861 +1b2b 1eb0 7861 7866 +1b2d 1b2c 70e0 70e6 +1b2c 1b2e 70e1 70e7 +1b30 1b2c 70e6 70e8 +1b2c 1b31 70e7 70e8 +1b2f 1b2d 70e4 70e9 +1b2d 1b30 70e6 70ea +1b32 1b2d 70e9 70eb +1b2d 1b33 70ea 70eb +1b31 1b2e 70e7 70ee +1b2e 1b34 70ec 70ef +1b35 1b2e 70ee 70ef +1b2f 1b32 70e9 70f1 +1b36 1b2f 70f0 70f3 +1b2f 1b37 70f1 70f2 +1b2f 1b38 70f2 70f3 +1b30 1b31 70e8 70fa +1b33 1b30 70ea 70fb +1b30 1b3c 70fa 70fb +1b31 1b35 70ee 70fc +1b3c 1b31 70fa 70fc +1b32 1b33 70eb 70fd +1b37 1b32 70f1 7101 +1b32 1b3d 70fd 7101 +1b33 1b3c 70fb 70fe +1b3d 1b33 70fd 70ff +1b33 1b3e 70fe 7100 +1b3f 1b33 70ff 7100 +1b35 1b34 70ef 7113 +1b3c 1b35 70fc 7103 +1b41 1b35 7103 7114 +1b36 1b38 70f3 7108 +1b39 1b36 70f5 7109 +1b36 1b44 7108 7109 +1b38 1b37 70f2 7105 +1b37 1b3d 7101 7106 +1b42 1b37 7105 7107 +1b37 1b43 7106 7107 +1b38 1b42 7105 710b +1b44 1b38 7108 710a +1b45 1b38 710a 710b +1b3a 1b39 70f9 7438 +1b39 1b44 7109 7438 +1b3b 1b3a 70f8 7433 +1b3a 1b44 7438 7439 +1ccc 1b3a 7433 7437 +1ccf 1b3a 7437 743a +1b3a 1cd0 7439 743a +1cca 1b3b 742f 7432 +1ccc 1b3b 7432 7433 +1b3e 1b3c 70fe 7102 +1b40 1b3c 7102 7104 +1b3c 1b41 7103 7104 +1b3d 1b3f 70ff 710c +1b43 1b3d 7106 710e +1b3d 1b46 710c 710d +1b3f 1b3e 7100 710f +1b3e 1b40 7102 7110 +1b47 1b3e 710f 7110 +1b46 1b3f 710c 7111 +1b3f 1b47 710f 7112 +1b48 1b3f 7111 7112 +1b40 1b41 7104 7460 +1b47 1b40 7110 745e +1ce0 1b40 745e 745f +1ce1 1b40 745f 7460 +1ce1 1b41 7460 7461 +1ce2 1b41 7461 7462 +1b42 1b43 7107 7466 +1b45 1b42 710b 76f0 +1b42 1cdf 7466 7468 +1b42 1ce4 7468 76f0 +1b43 1cdf 745b 7466 +1b44 1b45 710a 7447 +1cd0 1b44 7439 7446 +1cd7 1b44 7446 7447 +1cd7 1b45 7447 76f3 +1b45 1ce4 76f0 76f1 +1b45 1ce6 76f1 76f3 +1b46 1b48 7111 7457 +1b48 1b47 7112 745d +1ce0 1b47 745d 745e +1cde 1b48 7458 745c +1ce0 1b48 745c 745d +1b4a 1b49 7117 79b9 +1b4a 1f1c 88c0 8946 +25cc 1b4a 84ef 895c +1b4a 25cf 8911 895c +25db 1b4a 8911 8946 +1b4c 1b4b 7119 711c +1b4e 1b4b 711c 8b7a +1b4b 25e6 855a 8b7a +1b4d 1b4c 711a 711d +1b4c 1b4e 711c 711e +1b4f 1b4c 711d 711f +1b4c 1b50 711e 7120 +1b51 1b4c 711f 7120 +1b4d 1b4f 711d 7124 +1b52 1b4d 7121 7124 +1b50 1b4e 711e 855d +25e6 1b4e 855b 8b7a +1b4e 25e7 855b 8a51 +25ea 1b4e 855d 8a51 +1b4f 1b51 711f 7125 +1b52 1b4f 7124 7126 +1b4f 1b54 7125 7127 +1b51 1b50 7120 7128 +1b55 1b50 7128 7129 +1b56 1b50 7129 8b49 +1b50 25ea 855d 8b49 +1b54 1b51 7125 712b +1b51 1b55 7128 712a +1b51 1b57 712a 712b +1b53 1b52 7122 712c +1b54 1b57 712b 7133 +1b54 1b5a 7133 7135 +1b55 1b56 7129 7130 +1b57 1b55 712a 7131 +1b55 1b58 7130 7132 +1b59 1b55 7131 7132 +1b58 1b56 7130 8b65 +25ea 1b56 8aa8 8b49 +25eb 1b56 8561 8aa8 +1b56 25ee 8561 8b65 +1b57 1b59 7131 7136 +1b5a 1b57 7133 7137 +1b57 1b5b 7136 7137 +1b59 1b58 7132 7138 +1b5c 1b58 7138 7139 +1b5d 1b58 7139 713a +1b5e 1b58 713a 8562 +25ee 1b58 8562 8b65 +1b5b 1b59 7136 713b +1b59 1b5c 7138 713b +1b5a 1b5b 7137 713f +1b5b 1b5c 713b 7152 +1b5f 1b5b 713e 7154 +1b64 1b5b 7151 7152 +1b5b 1b65 7151 7154 +1b5c 1b5d 7139 714e +1b5c 1b64 714e 7152 +1b5d 1b5e 713a 714d +1b5d 1b62 7147 7148 +1b63 1b5d 7147 714c +1b5d 1b64 7148 714e +1b66 1b5d 714c 714d +1b66 1b5e 714d 8aee +25ed 1b5e 8564 8b64 +1b5e 25ee 8562 8b64 +1b5e 25f0 8564 8aee +1b65 1b5f 7153 7154 +1b5f 1b67 7153 7944 +1b61 1b60 7141 7145 +1b60 1b62 7143 7144 +1b60 1b63 7144 7145 +1b61 1b63 7145 714b +1b61 1b66 714b 8ace +25f1 1b61 8568 8ace +1b63 1b62 7144 7147 +1b64 1b62 7148 714a +1b62 1b65 7149 714a +1b66 1b63 714b 714c +1b64 1b65 714a 7151 +1b65 1b67 714f 7153 +25ef 1b66 8567 8b04 +1b66 25f0 8aee 8b04 +1b66 25f1 8567 8ace +1b69 1b68 715b 71a7 +1b68 1b7c 7192 719b +1b68 1b84 719b 71a7 +1b69 1b84 71a7 71bd +1b69 1b95 71bd 78d0 +1b6b 1b6a 715f 7165 +1b6a 1b6d 7161 7166 +1b6e 1b6a 7165 7166 +1b6b 1b6e 7165 7168 +1b6b 1b6f 7168 7169 +1b6d 1b6c 7162 716a +1b70 1b6c 716a 716f +1b6e 1b6d 7166 716b +1b6d 1b70 716a 716c +1b71 1b6d 716b 716d +1b6d 1b72 716c 716d +1b6f 1b6e 7168 7170 +1b6e 1b71 716b 7172 +1b73 1b6e 7170 7171 +1b74 1b6e 7171 7172 +1b6f 1b73 7170 7175 +1b75 1b6f 7173 7174 +1b76 1b6f 7174 7175 +1b72 1b70 716c 78cf +1b71 1b72 716d 78d1 +1b74 1b71 7172 71fd +1b71 1b93 78d1 78d2 +1b94 1b71 71fd 78d2 +1b72 1b85 71bb 71bc +1b72 1b93 71bc 78d1 +1b95 1b72 71bb 78ce +1b73 1b74 7171 71f2 +1b76 1b73 7175 71e8 +1ba8 1b73 71e8 71f2 +1b94 1b74 71fc 71fd +1ba8 1b74 71f2 71f3 +1bad 1b74 71f3 71fc +1b75 1b76 7174 71dc +1ba1 1b75 71d9 71dc +1b76 1ba1 71db 71dc +1ba2 1b76 71db 71de +1ba5 1b76 71de 71e6 +1ba7 1b76 71e6 71e7 +1ba8 1b76 71e7 71e8 +1b79 1b78 7186 718c +1b78 1b7a 7187 718d +1b7d 1b78 718c 718e +1b78 1b7e 718d 718f +1b7f 1b78 718e 718f +1b7b 1b79 7189 7190 +1b79 1b7d 718c 7190 +1b7e 1b7a 718d 7195 +1b7a 1b80 7194 7196 +1b81 1b7a 7195 7196 +1b7c 1b7b 718b 7198 +1b7b 1b7d 7190 7199 +1b82 1b7b 7198 719a +1b7b 1b83 7199 719a +1b7c 1b82 7198 719c +1b84 1b7c 719b 719d +1b7c 1b85 719c 719d +1b7d 1b7f 718e 719e +1b83 1b7d 7199 719f +1b7d 1b86 719e 719f +1b7f 1b7e 718f 71a0 +1b7e 1b81 7195 71a1 +1b87 1b7e 71a0 71a2 +1b7e 1b88 71a1 71a2 +1b86 1b7f 719e 71a3 +1b7f 1b87 71a0 71a4 +1b89 1b7f 71a3 71a4 +1b81 1b80 7196 71a8 +1b80 1b8a 71a5 71a8 +1b88 1b81 71a1 71a9 +1b81 1b8a 71a8 71aa +1b8b 1b81 71a9 71ab +1b81 1b8c 71aa 71ab +1b82 1b83 719a 71af +1b85 1b82 719c 71b7 +1b82 1b8d 71af 71b9 +1b93 1b82 71b7 71b8 +1b94 1b82 71b8 71b9 +1b83 1b86 719f 71ac +1b83 1b8d 71ac 71af +1b84 1b85 719d 71ba +1b84 1b95 71ba 71bd +1b85 1b93 71b7 71bc +1b95 1b85 71ba 71bb +1b86 1b89 71a3 71ad +1b8d 1b86 71ac 71ae +1b86 1b8e 71ad 71ae +1b87 1b88 71a2 71b1 +1b89 1b87 71a4 71b0 +1b8f 1b87 71b0 71b2 +1b87 1b90 71b1 71b3 +1b91 1b87 71b2 71b3 +1b88 1b8b 71a9 71b6 +1b90 1b88 71b1 71b6 +1b8e 1b89 71ad 71b4 +1b89 1b8f 71b0 71b5 +1b92 1b89 71b4 71b5 +1b8c 1b8a 71aa 71c2 +1b8a 1b96 71be 71c1 +1b8a 1b98 71c1 71c2 +1b8b 1b8c 71ab 7233 +1b90 1b8b 71b6 78c3 +1b8b 1bc5 7233 78c4 +1ed4 1b8b 78c3 78c4 +1b8c 1b98 71c2 7220 +1b8c 1bc0 7220 7232 +1b8c 1bc5 7232 7233 +1b8d 1b8e 71ae 7202 +1b94 1b8d 71b9 7203 +1b8d 1bad 7202 7203 +1b8e 1b92 71b4 71fe +1b8e 1ba8 71f4 71f5 +1bab 1b8e 71f4 71fe +1b8e 1bad 71f5 7202 +1b8f 1b91 71b2 7292 +1b92 1b8f 71b5 7293 +1b8f 1bb1 7292 7293 +1b91 1b90 71b3 78bc +1ed2 1b90 78bc 78be +1ed4 1b90 78be 78c3 +1b91 1bb1 728d 7292 +1bee 1b91 728d 728e +1bf1 1b91 728e 78b9 +1ed2 1b91 78b9 78bc +1bab 1b92 71fe 7201 +1bb1 1b92 7201 7293 +1b93 1b94 71b8 78d2 +1bad 1b94 71fc 7203 +1b96 1b97 71c0 71ce +1b98 1b96 71c1 7211 +1b96 1b9d 71ce 7208 +1b96 1bb4 7208 7211 +1b97 1b9a 71c7 71cb +1b97 1b9b 71cb 71cd +1b97 1b9d 71cd 71ce +1b98 1bb4 7211 7212 +1b98 1bb6 7212 7217 +1b98 1bbc 7217 721f +1b98 1bc0 721f 7220 +1b9a 1b99 71c5 71c8 +1b9b 1b99 71c8 71ca +1b99 1b9c 71c9 71ca +1b9a 1b9b 71c8 71cb +1b9b 1b9c 71ca 71cf +1b9d 1b9b 71cd 71d0 +1b9b 1b9e 71cf 71d0 +1b9e 1b9c 71cf 71d1 +1b9f 1b9c 71d1 71d2 +1b9d 1b9e 71d0 7204 +1b9d 1bb2 7204 7207 +1b9d 1bb4 7207 7208 +1b9e 1b9f 71d1 7206 +1bb2 1b9e 7204 7205 +1bb3 1b9e 7205 7206 +1bb3 1b9f 7206 720c +1bb7 1b9f 720c 7210 +1ba0 1ba1 71d3 71d5 +1ba0 1ba2 71d5 71d7 +1ba0 1ba3 71d7 71d8 +1ba2 1ba1 71d5 71db +1ba3 1ba2 71d7 71dd +1ba4 1ba2 71dd 71df +1ba2 1ba5 71de 71df +1ba3 1ba4 71dd 71e2 +1ba3 1ba6 71e2 71e4 +1ba4 1ba5 71df 71e9 +1ba6 1ba4 71e2 71ea +1ba4 1ba9 71e9 71ea +1ba5 1ba7 71e6 71eb +1ba9 1ba5 71e9 71eb +1ba6 1ba9 71ea 71ed +1ba6 1baa 71ed 71ee +1ba7 1ba8 71e7 71ef +1ba9 1ba7 71eb 71f0 +1ba7 1bab 71ef 71f1 +1bac 1ba7 71f0 71f1 +1bab 1ba8 71ef 71f4 +1ba8 1bad 71f3 71f5 +1baa 1ba9 71ed 71f6 +1ba9 1bac 71f0 71f6 +1baa 1bac 71f6 71f9 +1bae 1baa 71f7 71fa +1baa 1baf 71f9 71fb +1bb0 1baa 71fa 71fb +1bac 1bab 71f1 71ff +1baf 1bab 71ff 7200 +1bb1 1bab 7200 7201 +1baf 1bac 71f9 71ff +1bae 1bb0 71fa 7280 +1beb 1bae 727d 727f +1bec 1bae 727f 7280 +1bb0 1baf 71fb 7287 +1baf 1bb1 7200 728b +1bee 1baf 7287 728b +1bec 1bb0 7280 7284 +1bee 1bb0 7284 7287 +1bee 1bb1 728b 728d +1bb2 1bb3 7205 7209 +1bb4 1bb2 7207 720a +1bb2 1bb5 7209 720b +1bb6 1bb2 720a 720b +1bb5 1bb3 7209 720d +1bb3 1bb7 720c 720e +1bb8 1bb3 720d 720e +1bb4 1bb6 720a 7212 +1bb6 1bb5 720b 7213 +1bb5 1bb8 720d 7214 +1bb9 1bb5 7213 7215 +1bb5 1bba 7214 7216 +1bbb 1bb5 7215 7216 +1bb6 1bb9 7213 7218 +1bbc 1bb6 7217 7219 +1bb6 1bbd 7218 7219 +1bb8 1bb7 720e 721a +1bbe 1bb7 721a 721c +1bba 1bb8 7214 721d +1bb8 1bbe 721a 721e +1bbf 1bb8 721d 721e +1bb9 1bbb 7215 7221 +1bbd 1bb9 7218 7222 +1bb9 1bc1 7221 7222 +1bbb 1bba 7216 7223 +1bba 1bbf 721d 7224 +1bc2 1bba 7223 7224 +1bc1 1bbb 7221 7225 +1bbb 1bc2 7223 7226 +1bc3 1bbb 7225 7226 +1bbc 1bbd 7219 7227 +1bc0 1bbc 721f 7228 +1bbc 1bc4 7227 7229 +1bc5 1bbc 7228 7229 +1bbd 1bc1 7222 722b +1bc4 1bbd 7227 722a +1bc6 1bbd 722a 722b +1bbf 1bbe 721e 722d +1bbe 1bc7 722c 722e +1bc8 1bbe 722d 722e +1bc2 1bbf 7224 7230 +1bbf 1bc8 722d 7231 +1bc9 1bbf 7230 7231 +1bc0 1bc5 7228 7232 +1bc1 1bc3 7225 7970 +1bc6 1bc1 722b 7967 +1ed5 1bc1 7967 7969 +1f09 1bc1 7969 7970 +1bc3 1bc2 7226 7979 +1bc2 1bc9 7230 797a +1be5 1bc2 7978 797a +1bc2 1f0c 7977 7979 +1f0f 1bc2 7977 7978 +1f09 1bc3 7970 7971 +1f0a 1bc3 7971 7972 +1f0c 1bc3 7972 7979 +1bc5 1bc4 7229 78c2 +1bc4 1bc6 722a 78c6 +1bfc 1bc4 78c1 78c6 +1bc4 1ed3 78c1 78c2 +1ed3 1bc5 78c0 78c2 +1bc5 1ed4 78c0 78c4 +1bfc 1bc6 78c6 78c7 +1ed5 1bc6 78c7 7967 +1bc8 1bc7 722e 7983 +1be3 1bc7 7983 7984 +1be4 1bc7 7984 798a +1bc9 1bc8 7231 797f +1be3 1bc8 797f 7983 +1bc9 1bdc 7264 7266 +1bdd 1bc9 7264 7267 +1be3 1bc9 7267 797f +1bc9 1be5 7266 797a +1bcb 1bca 7234 7235 +1bca 1bcc 7234 7236 +1bcd 1bca 7235 7237 +1bca 1bce 7236 7238 +1bca 1bcf 7238 723a +1bcc 1bcb 7234 723b +1bcb 1bcd 7235 723c +1bd0 1bcb 723b 723d +1bcb 1bd1 723c 723e +1bd2 1bcb 723d 723e +1bce 1bcc 7236 723f +1bcc 1bd0 723b 7240 +1bd3 1bcc 723f 7240 +1bd1 1bcd 723c 7242 +1bcf 1bce 7238 7243 +1bce 1bd3 723f 7244 +1bcf 260a 8a77 8b5f +260b 1bcf 8591 8b5f +1bd0 1bd2 723d 7247 +1bd3 1bd0 7240 7248 +1bd0 1bd6 7247 7249 +1bd7 1bd0 7248 7249 +1bd2 1bd1 723e 724a +1bd8 1bd1 724a 724c +1bd1 1bd9 724b 724c +1bd6 1bd2 7247 724d +1bd2 1bd8 724a 724e +1bda 1bd2 724d 724e +1bd3 1bd7 7248 724f +1bd5 1bd4 7246 8a81 +1f73 1bd4 8a78 8b69 +1bd4 236f 8a78 8a81 +260b 1bd4 858f 8b5e +1bd4 260c 858f 8b69 +236f 1bd5 8592 8a81 +1bd5 2497 8592 8b08 +1bd7 1bd6 7249 7252 +1bd6 1bda 724d 7253 +1bdb 1bd6 7252 7254 +1bd6 1bdc 7253 7255 +1bdd 1bd6 7254 7255 +1bd7 1bdb 7252 7257 +1bd8 1bd9 724c 7258 +1bda 1bd8 724e 7259 +1bd8 1bde 7258 7259 +1bde 1bd9 7258 725b +1bd9 1bdf 725a 725b +1bdc 1bda 7253 725c +1bda 1bde 7259 725d +1be0 1bda 725c 725e +1bda 1be1 725d 725e +1bdb 1bdd 7254 7261 +1bdb 1be3 7261 7263 +1be4 1bdb 7262 7263 +1bdd 1bdc 7255 7264 +1bdc 1be0 725c 7265 +1bdc 1be5 7265 7266 +1be3 1bdd 7261 7267 +1bde 1bdf 725b 726a +1be1 1bde 725d 7269 +1be6 1bde 7269 726b +1bde 1be7 726a 726b +1bdf 1be2 725f 7270 +1be7 1bdf 726a 7271 +1bdf 1bea 7270 7271 +1be0 1be1 725e 726c +1be5 1be0 7265 726f +1be0 1be8 726c 726f +1be1 1be6 7269 726d +1be8 1be1 726c 726e +1be1 1be9 726d 726e +1bea 1be2 7270 7274 +1be4 1be3 7263 7984 +1be5 1be8 726f 797c +1f0f 1be5 7978 797c +1be6 1be7 726b 7279 +1be9 1be6 726d 727b +1be7 1bea 7271 7278 +1be8 1be9 726e 797e +1f0f 1be8 797c 797e +1f0d 1be9 797d 7980 +1be9 1f0f 797d 797e +1f10 1be9 7980 7982 +1beb 1bec 727f 7282 +1beb 1bed 7282 7283 +1bed 1bec 7282 7285 +1bec 1bee 7284 7286 +1bef 1bec 7285 7286 +1bed 1bef 7285 728a +1bf0 1bed 7288 728a +1bef 1bee 7286 728c +1bf1 1bee 728c 728e +1bf0 1bef 728a 728f +1bef 1bf1 728c 7291 +1bf2 1bef 728f 7290 +1bf3 1bef 7290 7291 +1bf0 1bf2 728f 7298 +1bf5 1bf0 7295 7298 +1bf3 1bf1 7291 78b8 +1ed2 1bf1 78b8 78b9 +1bf2 1bf3 7290 72a0 +1bf5 1bf2 7298 729b +1bf7 1bf2 729b 729f +1bf9 1bf2 729f 72a0 +1bf9 1bf3 72a0 78bb +1bf3 1ed2 78b8 78ba +1bf3 1ed3 78ba 78bb +1bf4 1bf5 7296 7299 +1bf4 1bf6 7299 729a +1bf6 1bf5 7299 729c +1bf5 1bf7 729b 729d +1bf8 1bf5 729c 729d +1bf6 1bf8 729c 72a1 +1bf6 1bfa 72a1 72a2 +1bf8 1bf7 729d 72a3 +1bf7 1bf9 729f 72a4 +1bfb 1bf7 72a3 72a6 +1bf7 1bfc 72a4 72a5 +1bf7 1bfd 72a5 72a6 +1bfa 1bf8 72a1 72a7 +1bf8 1bfb 72a3 72a7 +1bfc 1bf9 72a4 78bf +1bf9 1ed3 78bb 78bf +1bfa 1bfb 72a7 78c9 +1bfa 1ed7 78c9 7940 +1bfb 1bfd 72a6 78c8 +1bfb 1ed6 78c8 78ca +1ed7 1bfb 78c9 78ca +1bfd 1bfc 72a5 78c5 +1bfc 1ed3 78bf 78c1 +1ed5 1bfc 78c5 78c7 +1bfd 1ed5 78c5 78cc +1ed6 1bfd 78c8 78cb +1ed8 1bfd 78cb 78cc +1bff 1bfe 72ad 72b1 +1bfe 1c01 72b0 72b2 +1c02 1bfe 72b1 72b3 +1bfe 1c03 72b2 72b3 +1c00 1bff 72ae 72b5 +1bff 1c02 72b1 72b6 +1c04 1bff 72b5 72b6 +1c00 1c04 72b5 72ba +1c05 1c00 72b7 72bb +1c00 1c07 72ba 72bb +1c03 1c01 72b2 72bc +1c08 1c01 72bc 72bd +1c02 1c03 72b3 72be +1c04 1c02 72b6 72bf +1c02 1c09 72be 72c0 +1c0a 1c02 72bf 72c0 +1c03 1c08 72bc 72c2 +1c09 1c03 72be 72c1 +1c0b 1c03 72c1 72c2 +1c07 1c04 72ba 72c6 +1c04 1c0a 72bf 72c5 +1c04 1c0d 72c5 72c6 +1c06 1c05 72b9 72d6 +1c05 1c07 72bb 72d7 +1c16 1c05 72d6 72d7 +1c15 1c06 72d4 72d9 +1c06 1c16 72d6 72da +1c17 1c06 72d8 72da +1c06 1c18 72d8 72d9 +1c07 1c0d 72c6 72db +1c16 1c07 72d7 72dc +1c07 1c19 72db 72dc +1c0b 1c08 72c2 72cd +1c08 1c0c 72c3 72cc +1c08 1c11 72cc 72cd +1c0a 1c09 72c0 72c7 +1c09 1c0b 72c1 72c8 +1c0e 1c09 72c7 72c9 +1c09 1c0f 72c8 72c9 +1c0d 1c0a 72c5 72ca +1c0a 1c0e 72c7 72cb +1c10 1c0a 72ca 72cb +1c0f 1c0b 72c8 72d2 +1c0b 1c11 72cd 72d3 +1c14 1c0b 72d2 72d3 +1c11 1c0c 72cc 72d0 +1c0c 1c12 72ce 72d1 +1c13 1c0c 72d0 72d1 +1c0d 1c10 72ca 72dd +1c19 1c0d 72db 72df +1c0d 1c1a 72dd 72de +1c0d 1c1b 72de 72df +1c0e 1c0f 72c9 763b +1c10 1c0e 72cb 7664 +1dcf 1c0e 7639 763b +1c0e 1dd1 7639 763d +1c0e 1ddb 763d 7664 +1c0f 1c14 72d2 7642 +1dcc 1c0f 763a 7642 +1c0f 1dcf 763a 763b +1c1a 1c10 72dd 7665 +1c10 1ddb 7664 7665 +1c11 1c13 72d0 7659 +1c14 1c11 72d3 7656 +1de7 1c11 7656 7659 +1c13 1c12 72d1 7660 +1de8 1c12 7660 7662 +1ded 1c12 7662 7670 +1de7 1c13 7659 765a +1de8 1c13 765a 7660 +1c14 1dcc 7641 7642 +1ddd 1c14 7641 7654 +1de7 1c14 7654 7656 +1c15 1c18 72d9 77d2 +1c15 1e81 77d2 77dd +1c15 1e88 77dd 77e1 +1c17 1c16 72da 7793 +1c16 1c19 72dc 7791 +1c16 1e5d 7791 7793 +1c18 1c17 72d8 77c6 +1e5d 1c17 7792 7793 +1c17 1e65 7792 77c5 +1c17 1e7b 77c5 77c6 +1e7b 1c18 77c4 77c6 +1c18 1e7e 77c4 77cf +1c18 1e81 77cf 77d2 +1c19 1c1b 72df 778d +1c19 1e5d 778d 7791 +1c1b 1c1a 72de 777d +1c1a 1ddb 7665 7666 +1c1a 1ddc 7666 7773 +1c1a 1e31 7773 7774 +1c1a 1e55 7774 777d +1e55 1c1b 777c 777d +1c1b 1e57 777c 7780 +1c1b 1e5d 7780 778d +1c1d 1c1c 72e2 72ea +1c1c 1c1f 72e7 72ea +1c1d 1c1f 72ea 72ec +1c21 1c1d 72eb 72ed +1c1d 1c22 72ec 72ed +1c20 1c1e 72e8 72f3 +1c1e 1c23 72ef 72f3 +1c1f 1c20 72e9 72f6 +1c22 1c1f 72ec 72f9 +1c1f 1c27 72f6 72f9 +1c20 1c23 72f3 72f8 +1c27 1c20 72f6 72f7 +1c28 1c20 72f7 72f8 +1c21 1c22 72ed 76b4 +1c82 1c21 76ad 76b4 +1c84 1c21 76a7 76ad +1c21 1e07 76a7 76a9 +1c22 1c27 72f9 76be +1c82 1c22 76b4 76ba +1c83 1c22 76ba 76be +1c23 1c25 72f2 7382 +1c28 1c23 72f8 7384 +1c23 1c6f 7382 7384 +1c25 1c24 72f1 7386 +1c24 1c26 72f5 77eb +1c73 1c24 7386 77eb +1c25 1c6f 7379 7382 +1c73 1c25 7385 7386 +1c26 1c73 77e0 77eb +1c26 1e82 77df 77e0 +1e87 1c26 77df 77ea +1c27 1c28 72f7 76c7 +1c74 1c27 73ab 76c7 +1c76 1c27 73aa 73ab +1c27 1c83 73aa 76be +1c6f 1c28 7383 7384 +1c28 1c70 7383 7388 +1c28 1c74 7388 76c7 +1c2a 1c29 72fa 72fb +1c29 1c2b 72fa 72fc +1c2c 1c29 72fb 8608 +1c29 1c2d 72fc 8ac9 +265e 1c29 8aac 8ac9 +265f 1c29 8608 8aac +1c2b 1c2a 72fa 72fd +1c2a 1c2c 72fb 72fe +1c2e 1c2a 72fd 72ff +1c2a 1c2f 72fe 7300 +1c30 1c2a 72ff 7300 +1c2d 1c2b 72fc 896e +1c2b 1c2e 72fd 7301 +1c2b 1c31 7301 8ad7 +1c3a 1c2b 896e 8ad7 +1c2f 1c2c 72fe 7302 +1c32 1c2c 7302 8aaf +1c2c 265f 8608 860a +1c2c 2661 860a 8aaf +1c2d 1c3a 896e 8a4d +1c2d 23ed 8603 8605 +265d 1c2d 8603 8a4d +1c2d 265e 8605 8ac9 +1c2e 1c30 72ff 7303 +1c31 1c2e 7301 7304 +1c2e 1c33 7303 7305 +1c34 1c2e 7304 7305 +1c30 1c2f 7300 7306 +1c2f 1c32 7302 7309 +1c35 1c2f 7306 730a +1c33 1c30 7303 7307 +1c30 1c35 7306 7308 +1c36 1c30 7307 7308 +1c31 1c34 7304 730d +1c31 1c38 730d 87f5 +1c39 1c31 730e 87f5 +1c31 1c3a 730e 8ad7 +1c37 1c32 730c 8611 +2661 1c32 860c 8aaf +1c32 2662 860c 8611 +1c34 1c33 7305 7310 +1c33 1c36 7307 730f +1c33 1c3b 730f 7311 +1c3c 1c33 7310 7311 +1c38 1c34 730d 7317 +1c34 1c3c 7310 7317 +1c36 1c35 7308 7312 +1c3b 1c36 730f 7315 +1c3d 1c36 7315 7316 +1c37 2662 8611 8ab0 +2663 1c37 860f 8610 +1c39 1c38 87f5 87f7 +1c38 1c3c 7317 7319 +1c38 1c41 7319 731a +1c38 1c42 731a 87f7 +1c3a 1c39 730e 8a55 +1c39 1c42 87f7 8a54 +1c39 1c43 731b 896f +1c44 1c39 731b 8a54 +1c39 2700 896f 8a55 +265d 1c3a 8a4d 8ad6 +1c3a 2700 8a55 8ad6 +1c3c 1c3b 7311 731d +1c3b 1c3d 7315 731c +1c3b 1c45 731c 731e +1c46 1c3b 731d 731f +1c3b 1c47 731e 731f +1c41 1c3c 7319 7324 +1c3c 1c46 731d 7323 +1c3c 1c49 7323 7324 +1c45 1c3d 731c 7322 +1c3d 1c48 7321 7322 +1c3f 1c3e 7318 83c4 +1c3e 1c40 7318 8b5c +226b 1c3e 83c5 8b5c +1c3e 2533 83c5 8b87 +1c40 1c3f 7318 8453 +1c3f 23f6 81bf 8453 +2418 1c3f 81bf 89dc +1c40 2202 8136 81c2 +2203 1c40 7e83 81c2 +1c40 226b 7e83 8b5c +23f6 1c40 8136 8453 +1c42 1c41 731a 75c5 +1c41 1c49 7324 75c2 +1c41 1da4 75c2 75c5 +1c42 1c44 75cd 8a54 +1c42 1da4 75c5 75c8 +1c42 1da7 75c8 75cd +1c43 1c44 731b 8a0c +1c43 265a 87f2 8a0d +265b 1c43 87f3 8a0d +26fd 1c43 87f2 8a0c +1c43 26ff 87f3 8aa7 +2700 1c43 896f 8aa7 +1c44 1da7 75cd 87f1 +1c44 26fd 87f1 8a0c +1c47 1c45 731e 734e +1c45 1c48 7322 733e +1c45 1c53 733e 7348 +1c45 1c57 7348 734d +1c45 1c5a 734d 734e +1c46 1c47 731f 75bc +1c49 1c46 7323 75bd +1c46 1da1 75bc 75bd +1c47 1c5a 734e 75b9 +1c47 1da1 75b9 75bc +1c48 1c4c 732f 7335 +1c48 1c53 7335 733e +1c49 1da1 75bd 75be +1c49 1da3 75be 75c3 +1da4 1c49 75c2 75c4 +1c49 1da5 75c3 75c4 +1c4b 1c4a 7327 732c +1c4e 1c4a 732c 732e +1c4a 1c4f 732d 732e +1c4d 1c4b 7329 7331 +1c4b 1c4e 732c 7332 +1c50 1c4b 7331 7333 +1c4b 1c51 7332 7333 +1c4c 1c4d 732a 7334 +1c4c 1c52 7334 7336 +1c53 1c4c 7335 7336 +1c4d 1c50 7331 7337 +1c52 1c4d 7334 7338 +1c4d 1c54 7337 7338 +1c4e 1c4f 732e 733a +1c51 1c4e 7332 733b +1c50 1c51 7333 733f +1c54 1c50 7337 7340 +1c55 1c50 7340 7341 +1c56 1c50 7341 7342 +1c53 1c52 7336 7345 +1c52 1c54 7338 7346 +1c57 1c52 7345 7347 +1c52 1c58 7346 7347 +1c53 1c57 7345 7348 +1c54 1c55 7340 7349 +1c58 1c54 7346 734a +1c54 1c59 7349 734a +1c55 1c56 7341 75a2 +1c59 1c55 7349 75a0 +1d9d 1c55 75a0 75a1 +1d9e 1c55 75a1 75a2 +1d9e 1c56 75a2 75aa +1c57 1c58 7347 75a7 +1c5a 1c57 734d 75b2 +1c57 1da0 75a7 75b2 +1c58 1c59 734a 75a3 +1c58 1d9f 75a3 75a6 +1c58 1da0 75a6 75a7 +1c59 1d9b 75a4 75a5 +1c59 1d9d 75a0 75a4 +1d9f 1c59 75a3 75a5 +1c5a 1da0 75b2 75b4 +1c5a 1da1 75b4 75b9 +1c5b 1c5c 7351 7355 +1c5d 1c5b 7353 7356 +1c5b 1c5e 7355 7356 +1c5e 1c5c 7355 7864 +1c5c 1eaf 7862 7864 +1eb1 1c5c 7862 7868 +1eb4 1c5c 7868 7873 +1c5d 1c5e 7356 786d +1eb2 1c5d 786c 786d +1c5d 1eb3 786c 786f +1c5d 1eb7 786f 787c +1eaf 1c5e 7863 7864 +1c5e 1eb2 7863 786d +1c5f 1c60 7358 7360 +1c62 1c5f 735b 7361 +1c5f 1c65 7360 7363 +1c66 1c5f 7361 7362 +1c67 1c5f 7362 7363 +1c60 1c61 7359 7364 +1c65 1c60 7360 7365 +1c60 1c68 7364 7366 +1c69 1c60 7365 7366 +1c68 1c61 7364 8857 +2576 1c61 86ae 871e +2579 1c61 8483 86ae +1c61 257a 8483 8857 +2692 1c61 871e 8862 +1c64 1c62 735d 7367 +1c62 1c66 7361 7367 +1c63 1c64 735e 7368 +1c63 1c6a 7368 736a +1c6b 1c63 7369 736a +1c64 1c66 7367 736b +1c6a 1c64 7368 736c +1c64 1c6c 736b 736d +1c6d 1c64 736c 736d +1c67 1c65 7363 7398 +1c65 1c69 7365 739f +1c7a 1c65 7398 739e +1c7e 1c65 739e 739f +1c66 1c67 7362 7390 +1c6c 1c66 736b 738f +1c77 1c66 738f 7390 +1c77 1c67 7390 7395 +1c7a 1c67 7395 7398 +1c69 1c68 7366 73ac +1c85 1c68 73ac 73af +1c87 1c68 73af 8722 +257a 1c68 8722 8857 +1c7e 1c69 739f 73ad +1c69 1c85 73ac 73ae +1c86 1c69 73ad 73ae +1c6b 1c6a 736a 7381 +1c6a 1c6d 736c 738a +1c71 1c6a 7381 738a +1c6e 1c6b 7375 7380 +1c71 1c6b 7380 7381 +1c6d 1c6c 736d 7391 +1c6c 1c77 738f 7392 +1c78 1c6c 7391 7393 +1c6c 1c79 7392 7393 +1c71 1c6d 738a 738b +1c75 1c6d 738b 7394 +1c6d 1c78 7391 7394 +1c71 1c6e 737b 7380 +1c6f 1c70 737e 7383 +1c70 1c72 737c 7387 +1c70 1c74 7387 7388 +1c72 1c71 737d 7389 +1c75 1c71 7389 738b +1c74 1c72 7387 738d +1c72 1c75 7389 738c +1c72 1c76 738c 738d +1e82 1c73 77d5 77e0 +1c74 1c76 738d 73ab +1c76 1c75 738c 739d +1c75 1c78 7394 739a +1c75 1c7c 739a 739d +1c76 1c7c 739d 73a6 +1c76 1c83 73a6 73aa +1c79 1c77 7392 7396 +1c77 1c7a 7395 7397 +1c7b 1c77 7396 7397 +1c78 1c79 7393 7399 +1c78 1c7c 7399 739a +1c79 1c7b 7396 739b +1c7c 1c79 7399 739c +1c79 1c7d 739b 739c +1c7b 1c7a 7397 73a0 +1c7a 1c7e 739e 73a1 +1c7f 1c7a 73a0 73a2 +1c7a 1c80 73a1 73a2 +1c7d 1c7b 739b 73a3 +1c7b 1c7f 73a0 73a4 +1c81 1c7b 73a3 73a4 +1c7c 1c7d 739c 73a5 +1c7c 1c82 73a5 73a7 +1c83 1c7c 73a6 73a7 +1c7d 1c81 73a3 73a8 +1c82 1c7d 73a5 73a9 +1c7d 1c84 73a8 73a9 +1c80 1c7e 73a1 73b0 +1c7e 1c86 73ad 73b0 +1c7f 1c80 73a2 76b0 +1c81 1c7f 73a4 76ae +1e09 1c7f 76ae 76b0 +1c80 1c86 73b0 76bb +1e09 1c80 76b0 76b1 +1e0c 1c80 76b1 76bb +1c84 1c81 73a8 76a3 +1e06 1c81 76a3 76a4 +1e09 1c81 76a4 76ae +1c83 1c82 73a7 76ba +1c82 1c84 73a9 76ad +1e06 1c84 76a1 76a3 +1c84 1e07 76a1 76a7 +1c86 1c85 73ae 76c0 +1c85 1c87 73af 76c8 +1e0e 1c85 76c0 76c1 +1e11 1c85 76c1 76c8 +1e0c 1c86 76bb 76bc +1e0e 1c86 76bc 76c0 +1e11 1c87 76c8 884f +1c87 257a 8722 8856 +257d 1c87 8486 8723 +1c87 257e 8486 884f +25d3 1c87 8723 8856 +1c89 1c88 73b1 73b2 +1c88 1c8a 73b1 73b3 +1c8b 1c88 73b2 73b4 +1c88 1c8c 73b3 86c9 +1c8d 1c88 73b4 873b +1c88 269b 86c9 873b +1c8a 1c89 73b1 73b5 +1c89 1c8b 73b2 73b6 +1c8e 1c89 73b5 73b7 +1c89 1c8f 73b6 73b7 +1c8c 1c8a 73b3 73ba +1c8a 1c8e 73b5 73b8 +1c8a 1c90 73b8 73b9 +1c8b 1c8d 73b4 73bb +1c8f 1c8b 73b6 73bd +1c8b 1c91 73bb 73bc +1c8b 1c92 73bc 73bd +25a9 1c8c 88bb 890d +269b 1c8c 86c9 8922 +1c8c 269c 88bb 8922 +1c91 1c8d 73bb 86c8 +1c8d 269b 873b 8891 +269d 1c8d 86c8 8891 +1c8e 1c8f 73b7 73bf +1c90 1c8e 73b8 73be +1c93 1c8e 73be 73c0 +1c8e 1c94 73bf 73c0 +1c8f 1c92 73bd 73c5 +1c94 1c8f 73bf 73c7 +1c8f 1c97 73c5 73c6 +1c8f 1c98 73c6 73c7 +1c90 1c93 73be 73c2 +1c92 1c91 73bc 73c3 +1c95 1c91 73c3 73c4 +1c96 1c91 73c4 86ce +1c91 269d 86c8 86ce +1c92 1c95 73c3 73c9 +1c97 1c92 73c5 73c8 +1c99 1c92 73c8 73c9 +1c93 1c94 73c0 73f4 +1c9a 1c93 73ca 740c +1c93 1cad 73f4 7406 +1c93 1cb7 7406 740c +1c94 1c98 73c7 73de +1c94 1ca6 73de 73f0 +1c94 1cad 73f0 73f4 +1c95 1c96 73c4 73ff +1c99 1c95 73c9 73ec +1ca5 1c95 73ec 73ee +1cac 1c95 73ee 73ff +1cac 1c96 73ff 7403 +1cb5 1c96 7403 7417 +1cbd 1c96 7417 8890 +1c96 269d 86ce 8890 +1c98 1c97 73c6 73d1 +1c97 1c99 73c8 73d9 +1c97 1c9b 73cf 73d1 +1c9e 1c97 73cf 73d9 +1c9b 1c98 73d0 73d1 +1c98 1c9f 73d0 73dc +1c98 1ca6 73dc 73de +1c9e 1c99 73d9 73db +1ca5 1c99 73db 73ec +1c9a 1cb7 740c 76fc +1c9a 1e1b 76fc 76ff +1c9a 1e1d 76ff 7700 +1c9c 1c9b 73cc 73cd +1c9b 1c9d 73cc 73ce +1c9e 1c9b 73cd 73cf +1c9b 1c9f 73ce 73d0 +1c9d 1c9c 73cc 73d2 +1c9c 1c9e 73cd 73d3 +1ca0 1c9c 73d2 73d4 +1c9c 1ca1 73d3 73d5 +1ca2 1c9c 73d4 73d5 +1c9f 1c9d 73ce 73d6 +1c9d 1ca0 73d2 73d7 +1ca3 1c9d 73d6 73d8 +1c9d 1ca4 73d7 73d8 +1ca1 1c9e 73d3 73da +1ca5 1c9e 73da 73db +1c9f 1ca3 73d6 73dd +1ca6 1c9f 73dc 73dd +1ca0 1ca2 73d4 73df +1ca4 1ca0 73d7 73e0 +1ca0 1ca7 73df 73e1 +1ca2 1ca1 73d5 73e3 +1ca1 1ca5 73da 73e4 +1ca8 1ca1 73e3 73e5 +1ca1 1ca9 73e4 73e5 +1ca7 1ca2 73df 73e6 +1ca2 1ca8 73e3 73e6 +1ca3 1ca4 73d8 73e7 +1ca6 1ca3 73dd 73e8 +1caa 1ca3 73e8 73e9 +1ca9 1ca5 73e4 73ed +1cab 1ca5 73ed 73ef +1ca5 1cac 73ee 73ef +1ca6 1caa 73e8 73f1 +1cad 1ca6 73f0 73f2 +1ca6 1cae 73f1 73f3 +1caf 1ca6 73f2 73f3 +1ca7 1ca8 73e6 73f6 +1ca7 1cb0 73f6 73f7 +1ca8 1ca9 73e5 73f8 +1cb0 1ca8 73f6 73f9 +1ca8 1cb1 73f8 73f9 +1ca9 1cab 73ed 73fa +1cb1 1ca9 73f8 73fb +1ca9 1cb2 73fa 73fb +1cae 1caa 73f1 73fe +1cab 1cac 73ef 7400 +1cb2 1cab 73fa 7401 +1cab 1cb3 7400 7402 +1cb4 1cab 7401 7402 +1cb3 1cac 7400 7404 +1cac 1cb5 7403 7404 +1cad 1caf 73f2 7405 +1cad 1cb6 7405 7407 +1cb7 1cad 7406 7407 +1caf 1cae 73f3 7408 +1cb8 1cae 7408 740a +1cb6 1caf 7405 740b +1caf 1cb8 7408 740b +1cb0 1cb1 73f9 740e +1cb0 1cb9 740e 740f +1cb0 1cba 740f 7410 +1cb1 1cb2 73fb 7411 +1cb9 1cb1 740e 7411 +1cb2 1cb4 7401 7412 +1cb9 1cb2 7411 7413 +1cb2 1cbb 7412 7413 +1cb4 1cb3 7402 741e +1cb3 1cb5 7404 7418 +1cb3 1cbe 7418 741a +1cb3 1cc0 741a 741e +1cbb 1cb4 7412 7426 +1cb4 1cc0 741e 7420 +1cb4 1cc4 7420 7426 +1cb5 1cbc 7414 7415 +1cbd 1cb5 7414 7417 +1cb5 1cbe 7415 7418 +1cb7 1cb6 7407 76fd +1cb6 1cb8 740b 7472 +1cb6 1ce8 7472 7701 +1e1c 1cb6 76fd 7701 +1e1b 1cb7 76fc 76fe +1cb7 1e1c 76fd 76fe +1cb8 1ce7 7470 7471 +1cb8 1ce8 7471 7472 +1cba 1cb9 740f 76ce +1cb9 1cbb 7413 76d9 +1cc7 1cb9 76d1 76d9 +1cbb 1cc4 7426 7428 +1cbb 1cc7 7428 76d9 +1cbc 1cbd 7414 8740 +1cbe 1cbc 7415 7416 +1cbf 1cbc 7416 86cf +25af 1cbc 86d0 8740 +1cbc 25b2 86d0 886b +269f 1cbc 86cf 886b +1cbd 25af 8528 8740 +25b0 1cbd 8528 873e +269d 1cbd 873e 8890 +1cbe 1cbf 7416 7419 +1cbe 1cc0 7419 741a +1cc0 1cbf 7419 741b +1cc1 1cbf 741b 741c +1cc2 1cbf 741c 741d +1cc3 1cbf 741d 886a +1cbf 269f 86cf 886a +1cc0 1cc1 741b 741f +1cc0 1cc4 741f 7420 +1cc1 1cc2 741c 7421 +1cc4 1cc1 741f 7422 +1cc5 1cc1 7422 7423 +1cc2 1cc3 741d 7424 +1f34 1cc3 852c 86d4 +1f35 1cc3 86d4 8744 +1cc3 25d5 852c 8872 +269f 1cc3 8744 886a +1cc4 1cc5 7422 7427 +1cc4 1cc6 7427 7429 +1cc7 1cc4 7428 7429 +1cc6 1cc5 7427 742c +1cc5 1cc8 742a 742d +1cc9 1cc5 742c 742d +1cc7 1cc6 7429 76db +1cc6 1cc9 742c 76e2 +1e13 1cc6 76db 76dc +1e15 1cc6 76dc 76e2 +1e13 1cc7 76d2 76db +1cc9 1cc8 742d 76ea +1cc8 1e17 76e9 76ea +1e15 1cc9 76e2 76e3 +1e17 1cc9 76e3 76ea +1ccb 1cca 7430 7434 +1cca 1ccc 7432 7435 +1ccd 1cca 7434 7436 +1cca 1cce 7435 7436 +1ccb 1ccd 7434 743f +1cd1 1ccb 743b 7440 +1ccb 1cd4 743f 7440 +1cce 1ccc 7435 7441 +1ccc 1ccf 7437 7441 +1ccd 1cce 7436 7442 +1cd4 1ccd 743f 7442 +1cce 1ccf 7441 7443 +1cd4 1cce 7442 7444 +1cce 1cd5 7443 7445 +1cd6 1cce 7444 7445 +1ccf 1cd0 743a 7448 +1cd5 1ccf 7443 7448 +1cd5 1cd0 7448 744a +1cd0 1cd7 7446 7449 +1cd0 1cd8 7449 744a +1cd3 1cd1 743d 744d +1cd1 1cd4 7440 744e +1cda 1cd1 744d 744f +1cd1 1cdb 744e 744f +1cd2 1cd3 743e 7450 +1cd9 1cd2 744b 7450 +1cd9 1cd3 7450 7452 +1cd3 1cda 744d 7451 +1cd3 1cdc 7451 7452 +1cd4 1cd6 7444 7454 +1cdb 1cd4 744e 7453 +1cdd 1cd4 7453 7454 +1cd6 1cd5 7445 7879 +1cd5 1cd8 744a 76fa +1cdd 1cd6 7454 786b +1eb5 1cd6 786b 7878 +1cd8 1cd7 7449 76f7 +1cd7 1ce6 76f3 76f4 +1cd7 1e1a 76f4 76f7 +1cd8 1e1a 76f7 76f9 +1cd9 1cdc 7452 7856 +1cd9 1ead 7856 7858 +1cd9 1eb0 7858 7861 +1cda 1cdb 744f 7853 +1cdc 1cda 7451 7852 +1db6 1cda 7600 7601 +1db8 1cda 7601 7853 +1cda 1dbb 7600 7851 +1cda 1ead 7851 7852 +1cdb 1cdd 7453 785b +1db8 1cdb 7853 785b +1cdc 1ead 7852 7856 +1db7 1cdd 785c 7869 +1db8 1cdd 785b 785c +1db9 1cdd 7869 786a +1eb5 1cdd 786a 786b +1cde 1ce0 745c 86e6 +1cde 26a7 86e4 885d +26a8 1cde 86e4 86e6 +1cdf 1ce3 7464 7467 +1cdf 1ce4 7467 7468 +1ce0 1ce1 745f 8858 +1ce0 25d8 8858 889c +26a8 1ce0 86e6 889c +1ce1 1ce2 7461 889d +25d8 1ce1 8858 889d +2323 1ce2 885a 88a5 +25d7 1ce2 853a 88a2 +1ce2 25d8 853a 889d +1ce2 26a2 885a 88a2 +1ce2 26a3 86df 88a5 +1ce4 1ce3 7467 746b +1ce3 1ce5 746a 746c +1ce6 1ce3 746b 746c +1ce4 1ce6 746b 76f1 +1ce6 1ce5 746c 76f2 +1e1a 1ce5 76f2 76f5 +1ce6 1e1a 76f2 76f4 +1ce8 1ce7 7471 7473 +1ce9 1ce7 7473 8762 +26ba 1ce7 8762 892e +1ce8 1ce9 7473 7704 +1e1c 1ce8 7701 7704 +1e1c 1ce9 7704 7706 +1e1f 1ce9 7706 770d +1ce9 26ba 8762 8781 +1cea 1ceb 7475 87bd +1cec 1cea 7479 768f +1dfc 1cea 768f 7692 +1dfe 1cea 7692 883f +1cea 26e0 87bd 883f +1ceb 2642 8a2c 8ade +26df 1ceb 8a40 8ade +26e0 1ceb 87bd 8a40 +1ced 1cec 7478 768e +1dfc 1cec 768e 768f +1dfb 1ced 768c 7690 +1ced 1dfc 768e 7691 +1dfd 1ced 7690 7691 +1cef 1cee 747a 747b +1cee 1cf0 747a 747c +1cf1 1cee 747b 747d +1cee 1cf2 747c 747e +1cf3 1cee 747d 747f +1cee 1cf4 747e 747f +1cf0 1cef 747a 7480 +1cef 1cf1 747b 7481 +1cf5 1cef 7480 7482 +1cef 1cf6 7481 7483 +1cf7 1cef 7482 7483 +1cf2 1cf0 747c 7484 +1cf0 1cf5 7480 7485 +1cf8 1cf0 7484 7486 +1cf0 1cf9 7485 7486 +1cf1 1cf3 747d 7487 +1cf6 1cf1 7481 7488 +1cf1 1cfa 7487 7489 +1cfb 1cf1 7488 748a +1cf1 1cfc 7489 748a +1cf4 1cf2 747e 748b +1cf2 1cf8 7484 748c +1cfd 1cf2 748b 748d +1cf2 1cfe 748c 748e +1cff 1cf2 748d 748e +1cf3 1cf4 747f 748f +1cfa 1cf3 7487 7490 +1cf3 1d00 748f 7491 +1d01 1cf3 7490 7492 +1cf3 1d02 7491 7492 +1cf4 1cfd 748b 7493 +1d00 1cf4 748f 7493 +1cf5 1cf7 7482 7494 +1cf9 1cf5 7485 7495 +1cf5 1d03 7494 7495 +1cf7 1cf6 7483 7496 +1cf6 1cfb 7488 7497 +1d04 1cf6 7496 7497 +1d03 1cf7 7494 7498 +1cf7 1d04 7496 7499 +1d05 1cf7 7498 749a +1cf7 1d06 7499 749a +1cf8 1cf9 7486 749b +1cfe 1cf8 748c 749c +1cf8 1d07 749b 749c +1cf9 1d03 7495 749d +1d07 1cf9 749b 749e +1cf9 1d08 749d 749f +1d09 1cf9 749e 74a0 +1cf9 1d0a 749f 74a0 +1cfc 1cfa 7489 74a1 +1cfa 1d01 7490 74a2 +1d0b 1cfa 74a1 74a2 +1cfb 1cfc 748a 74a3 +1d04 1cfb 7497 74a4 +1cfb 1d0c 74a3 74a5 +1d0d 1cfb 74a4 74a5 +1cfc 1d0b 74a1 74a6 +1d0c 1cfc 74a3 74a7 +1cfc 1d0e 74a6 74a7 +1cfd 1cff 748d 74a8 +1d00 1cfd 7493 74a9 +1cfd 1d0f 74a8 74aa +1d10 1cfd 74a9 74ab +1cfd 1d11 74aa 74ab +1cff 1cfe 748e 74ac +1cfe 1d07 749c 74ad +1d12 1cfe 74ac 74ae +1cfe 1d13 74ad 74ae +1d0f 1cff 74a8 74af +1cff 1d12 74ac 74af +1d02 1d00 7491 74b0 +1d00 1d10 74a9 74b1 +1d14 1d00 74b0 74b2 +1d00 1d15 74b1 74b2 +1d01 1d02 7492 74b3 +1d0b 1d01 74a2 74b4 +1d01 1d16 74b3 74b5 +1d17 1d01 74b4 74b6 +1d01 1d18 74b5 74b6 +1d02 1d14 74b0 74b7 +1d16 1d02 74b3 74b7 +1d03 1d05 7498 74b8 +1d08 1d03 749d 74b9 +1d03 1d19 74b8 74b9 +1d06 1d04 7499 74ba +1d04 1d0d 74a4 74bb +1d1a 1d04 74ba 74bb +1d05 1d06 749a 74bc +1d19 1d05 74b8 74bd +1d05 1d1b 74bc 74be +1d1c 1d05 74bd 74be +1d06 1d1a 74ba 74bf +1d1b 1d06 74bc 74c0 +1d06 1d1d 74bf 74c1 +1d1e 1d06 74c0 74c1 +1d07 1d09 749e 74c2 +1d13 1d07 74ad 74c3 +1d07 1d1f 74c2 74c4 +1d20 1d07 74c3 74c4 +1d0a 1d08 749f 74c5 +1d08 1d19 74b9 74c5 +1d09 1d0a 74a0 74c6 +1d1f 1d09 74c2 74c7 +1d09 1d21 74c6 74c7 +1d0a 1d19 74c5 74c8 +1d21 1d0a 74c6 74c9 +1d0a 1d22 74c8 74ca +1d23 1d0a 74c9 74ca +1d0e 1d0b 74a6 74cb +1d0b 1d17 74b4 74cb +1d0d 1d0c 74a5 74cc +1d0c 1d0e 74a7 74cd +1d24 1d0c 74cc 74ce +1d0c 1d25 74cd 74ce +1d1a 1d0d 74bb 74cf +1d0d 1d24 74cc 74d0 +1d26 1d0d 74cf 74d2 +1d0d 1d27 74d0 74d1 +1d0d 1d28 74d1 74d2 +1d0e 1d17 74cb 74d3 +1d25 1d0e 74cd 74d4 +1d0e 1d29 74d3 74d4 +1d11 1d0f 74aa 74d5 +1d0f 1d12 74af 74d6 +1d2a 1d0f 74d5 74d7 +1d0f 1d2b 74d6 74d8 +1d2c 1d0f 74d7 74d8 +1d10 1d11 74ab 74d9 +1d15 1d10 74b1 74da +1d10 1d2d 74d9 74da +1d11 1d2a 74d5 74dc +1d2d 1d11 74d9 74db +1d2e 1d11 74db 74dc +1d12 1d13 74ae 74dd +1d2b 1d12 74d6 74de +1d12 1d2f 74dd 74de +1d13 1d20 74c3 74df +1d2f 1d13 74dd 74df +1d14 1d15 74b2 74e0 +1d16 1d14 74b7 74e1 +1d14 1d30 74e0 74e2 +1d31 1d14 74e1 74e2 +1d15 1d2d 74da 74e3 +1d30 1d15 74e0 74e4 +1d15 1d32 74e3 74e4 +1d18 1d16 74b5 74e5 +1d16 1d31 74e1 74e6 +1d33 1d16 74e5 74e6 +1d17 1d18 74b6 74e7 +1d29 1d17 74d3 74eb +1d17 1d34 74e7 74ea +1d17 1d36 74ea 74eb +1d18 1d33 74e5 74e8 +1d34 1d18 74e7 74e9 +1d18 1d35 74e8 74e9 +1d19 1d1c 74bd 74ec +1d22 1d19 74c8 74ed +1d19 1d37 74ec 74ed +1d1d 1d1a 74bf 74ee +1d1a 1d26 74cf 74ee +1d1c 1d1b 74be 74f0 +1d1b 1d1e 74c0 74ef +1d1b 1d38 74ef 74f1 +1d39 1d1b 74f0 74f1 +1d37 1d1c 74ec 74f7 +1d1c 1d39 74f0 74f7 +1d1e 1d1d 74c1 74f2 +1d1d 1d26 74ee 74f3 +1d3a 1d1d 74f2 74f4 +1d1d 1d3b 74f3 74f4 +1d38 1d1e 74ef 74f6 +1d1e 1d3a 74f2 74f5 +1d1e 1d3c 74f5 74f6 +1d20 1d1f 74c4 74f8 +1d1f 1d21 74c7 74f9 +1d3d 1d1f 74f8 74fa +1d1f 1d3e 74f9 74fa +1d2f 1d20 74df 74fb +1d20 1d3d 74f8 74fd +1d3f 1d20 74fb 74fc +1d40 1d20 74fc 74fd +1d21 1d23 74c9 74fe +1d3e 1d21 74f9 74ff +1d21 1d41 74fe 74ff +1d23 1d22 74ca 7500 +1d22 1d37 74ed 7501 +1d42 1d22 7500 7502 +1d22 1d43 7501 7502 +1d41 1d23 74fe 7503 +1d23 1d42 7500 7503 +1d24 1d25 74ce 7582 +1d27 1d24 74d0 7589 +1d24 1d8d 7582 7586 +1d24 1d91 7586 7589 +1d25 1d29 74d4 757e +1d25 1d88 757e 757f +1d25 1d8d 757f 7582 +1d26 1d28 74d2 7592 +1d3b 1d26 74f3 7594 +1d26 1d96 7592 7594 +1d28 1d27 74d1 758f +1d27 1d91 7589 758e +1d27 1d94 758e 758f +1d28 1d94 758f 7593 +1d96 1d28 7592 7593 +1d29 1d36 74eb 7570 +1d29 1d82 7570 7577 +1d29 1d88 7577 757e +1d2a 1d2c 74d7 7521 +1d2e 1d2a 74dc 750f +1d4b 1d2a 750f 7520 +1d55 1d2a 7520 7521 +1d2c 1d2b 74d8 753d +1d2b 1d2f 74de 7541 +1d65 1d2b 753d 7540 +1d67 1d2b 7540 7541 +1d55 1d2c 7521 753e +1d2c 1d65 753d 753f +1d66 1d2c 753e 753f +1d2d 1d2e 74db 7505 +1d32 1d2d 74e3 7504 +1d44 1d2d 7504 7505 +1d44 1d2e 7505 750c +1d49 1d2e 750c 750e +1d4a 1d2e 750e 7510 +1d2e 1d4b 750f 7510 +1d2f 1d3f 74fb 7835 +1d67 1d2f 7541 7830 +1ea8 1d2f 7830 7835 +1d31 1d30 74e2 750a +1d30 1d32 74e4 7506 +1d30 1d45 7506 7509 +1d30 1d47 7509 750b +1d48 1d30 750a 750b +1d33 1d31 74e6 7517 +1d31 1d48 750a 7516 +1d31 1d4f 7516 7517 +1d32 1d44 7504 7507 +1d45 1d32 7506 7508 +1d32 1d46 7507 7508 +1d35 1d33 74e8 752d +1d33 1d4f 7517 752c +1d33 1d5b 752c 752d +1d34 1d35 74e9 7563 +1d36 1d34 74ea 7566 +1d34 1d7b 7563 7564 +1d34 1d7c 7564 7566 +1d35 1d5b 752d 755b +1d35 1d77 755b 755f +1d35 1d7b 755f 7563 +1d36 1d7c 7566 7567 +1d36 1d7e 7567 756d +1d36 1d82 756d 7570 +1d37 1d39 74f7 75e1 +1d43 1d37 7501 75df +1d37 1dab 75dd 75df +1dac 1d37 75dd 75e1 +1d39 1d38 74f1 75c1 +1d38 1d3c 74f6 75b8 +1d39 1dac 75e0 75e1 +1d3a 1d3b 74f4 759f +1d3c 1d3a 74f5 75ac +1d3a 1d9b 759f 75a9 +1d9d 1d3a 75a8 75a9 +1d3a 1d9e 75a8 75ac +1d3b 1d96 7594 759c +1d3b 1d9b 759c 759f +1d3c 1d9e 75ac 75ae +1d3d 1d3e 74fa 7842 +1d40 1d3d 74fd 7840 +1d3e 1d41 74ff 7604 +1d3f 1d40 74fc 783b +1ea8 1d3f 7835 7839 +1ea9 1d3f 7839 783b +1ea9 1d40 783b 783d +1eaa 1d40 783d 7841 +1d41 1d42 7503 75f2 +1d42 1d43 7502 75e4 +1d42 1dae 75e4 75e6 +1dab 1d43 75de 75df +1d43 1dae 75de 75e4 +1d46 1d44 7507 750d +1d44 1d49 750c 750d +1d45 1d46 7508 7511 +1d47 1d45 7509 7512 +1d45 1d4c 7511 7512 +1d46 1d49 750d 7513 +1d4c 1d46 7511 7514 +1d46 1d4d 7513 7515 +1d4e 1d46 7514 7515 +1d48 1d47 750b 7518 +1d47 1d4c 7512 7519 +1d50 1d47 7518 751b +1d47 1d51 7519 751a +1d47 1d52 751a 751b +1d4f 1d48 7516 751c +1d48 1d50 7518 751d +1d53 1d48 751c 751d +1d49 1d4a 750e 751e +1d4d 1d49 7513 751f +1d49 1d54 751e 751f +1d4a 1d4b 7510 7522 +1d54 1d4a 751e 7523 +1d4a 1d56 7522 7523 +1d4b 1d55 7520 7524 +1d56 1d4b 7522 7525 +1d4b 1d57 7524 7525 +1d4c 1d4e 7514 7526 +1d51 1d4c 7519 7526 +1d4e 1d4d 7515 7527 +1d4d 1d54 751f 7528 +1d58 1d4d 7527 7528 +1d51 1d4e 7526 7529 +1d4e 1d58 7527 752b +1d59 1d4e 7529 752a +1d5a 1d4e 752a 752b +1d4f 1d53 751c 752e +1d5b 1d4f 752c 752f +1d4f 1d5c 752e 752f +1d50 1d52 751b 7536 +1d53 1d50 751d 7537 +1d50 1d61 7536 7538 +1d62 1d50 7537 7538 +1d52 1d51 751a 7534 +1d51 1d59 7529 7535 +1d60 1d51 7534 7535 +1d52 1d60 7534 7539 +1d61 1d52 7536 7539 +1d5c 1d53 752e 8a4f +1d53 1d62 7537 753a +1d53 1d63 753a 753b +1d53 1d64 753b 8a4f +1d54 1d56 7523 7531 +1d58 1d54 7528 7530 +1d5d 1d54 7530 7532 +1d54 1d5e 7531 7533 +1d5f 1d54 7532 7533 +1d57 1d55 7524 7542 +1d55 1d66 753e 7543 +1d68 1d55 7542 7543 +1d56 1d57 7525 7544 +1d5e 1d56 7531 7545 +1d56 1d69 7544 7546 +1d6a 1d56 7545 7546 +1d57 1d68 7542 7547 +1d69 1d57 7544 7547 +1d5a 1d58 752b 753c +1d58 1d5d 7530 753c +1d59 1d5a 752a 89d8 +1d60 1d59 7535 87d3 +26eb 1d59 87d3 89d8 +1d5a 1d5d 753c 87cf +1d5a 26e9 87cf 87d1 +26eb 1d5a 89d8 89e4 +1d5a 26ec 87d1 89e4 +1d5b 1d5c 752f 7558 +1d5b 1d76 7558 755a +1d5b 1d77 755a 755b +1d64 1d5c 7559 8a4f +1d76 1d5c 7558 7559 +1d5d 1d5f 7532 89c7 +26e7 1d5d 87cc 89c7 +1d5d 26e9 87cc 87cf +1d5f 1d5e 7533 8927 +1d5e 1d6a 7545 87c7 +1d5e 26e5 87c7 8927 +26e4 1d5f 89c8 8a01 +1d5f 26e5 8927 8a01 +26e6 1d5f 87c9 89c8 +1d5f 26e7 87c9 89c7 +1d61 1d60 7539 89d7 +1d60 26e8 87d6 8a08 +1d60 26eb 87d3 87d6 +26ed 1d60 89d7 8a08 +1d62 1d61 7538 89c4 +26ed 1d61 87d8 89d7 +1d61 26ef 87d8 89c4 +1d63 1d62 753a 87d9 +26ef 1d62 87d9 89c4 +1d64 1d63 753b 7557 +1d75 1d63 7557 8a10 +1d63 26ee 87db 8a10 +1d63 26ef 87d9 87db +1d64 1d75 7557 89a9 +1d76 1d64 7559 8a4e +1d64 1d78 89a9 8a4e +1d66 1d65 753f 7833 +1d65 1d67 7540 782f +1d74 1d65 7833 7834 +1d65 1ea2 7832 7834 +1d65 1ea7 782f 7832 +1d68 1d66 7543 7550 +1d6e 1d66 7550 7556 +1d74 1d66 7556 7833 +1ea7 1d67 782f 7831 +1d67 1ea8 7830 7831 +1d69 1d68 7547 754b +1d6e 1d68 754b 7550 +1d6a 1d69 7546 7548 +1d6b 1d69 7548 754a +1d6d 1d69 754a 754c +1d69 1d6e 754b 754c +1d6a 1d6b 7548 7549 +1d6a 1d6c 7549 8a00 +26e5 1d6a 87c7 8a00 +1d6c 1d6b 7549 754d +1d6b 1d6d 754a 754e +1d6f 1d6b 754d 754f +1d6b 1d70 754e 754f +1d6c 1d6f 754d 89ae +26e3 1d6c 87c8 89ae +26e4 1d6c 87c6 87c8 +1d6c 26e5 87c6 8a00 +1d6d 1d6e 754c 7551 +1d70 1d6d 754e 7552 +1d6d 1d71 7551 7554 +1d72 1d6d 7552 7553 +1d73 1d6d 7553 7554 +1d71 1d6e 7551 7555 +1d74 1d6e 7555 7556 +1d6f 1d70 754f 89bc +26e2 1d6f 87c4 89bc +1d6f 26e3 87c4 89ae +1d70 1d72 7552 7817 +1d70 1e9c 7817 87c2 +1d70 26e2 87c2 89bc +1d73 1d71 7554 781a +1d71 1d74 7555 781c +1e9d 1d71 781a 781b +1e9e 1d71 781b 781c +1d72 1d73 7553 7816 +1e05 1d72 7814 7816 +1d72 1e9c 7814 7817 +1e00 1d73 7815 7818 +1d73 1e05 7815 7816 +1e9d 1d73 7818 781a +1e9e 1d74 781c 7828 +1ea2 1d74 7828 7834 +1d75 1d78 87de 89a9 +1d75 251c 87da 8a23 +26ee 1d75 87da 8a10 +26f1 1d75 87de 8a23 +1d77 1d76 755a 755d +1d78 1d76 755c 8a4e +1d76 1d79 755c 755e +1d7a 1d76 755d 755e +1d77 1d7a 755d 7562 +1d7b 1d77 755f 7560 +1d7c 1d77 7560 7561 +1d7d 1d77 7561 7562 +1d79 1d78 755c 89bb +2675 1d78 89bb 8a22 +1d78 26f1 87de 8a22 +1d7a 1d79 755e 756a +1d80 1d79 756a 89d1 +1d79 2653 8669 89d1 +2675 1d79 8669 89bb +1d7d 1d7a 7562 7568 +1d7f 1d7a 7568 7569 +1d80 1d7a 7569 756a +1d7b 1d7c 7560 7564 +1d7c 1d7d 7561 7565 +1d7c 1d7e 7565 7567 +1d7e 1d7d 7565 756b +1d7d 1d7f 7568 756c +1d81 1d7d 756b 756c +1d7e 1d81 756b 756e +1d82 1d7e 756d 756f +1d7e 1d83 756e 756f +1d7f 1d80 7569 89f6 +1d81 1d7f 756c 7571 +1d84 1d7f 7571 866e +2677 1d7f 866e 89f6 +2653 1d80 87e1 89d1 +1d80 2654 87e1 8a43 +1d80 2677 87e0 89f6 +26f2 1d80 87e0 8a43 +1d83 1d81 756e 7572 +1d81 1d84 7571 7572 +1d82 1d83 756f 7573 +1d82 1d85 7573 7578 +1d88 1d82 7577 7578 +1d83 1d84 7572 7574 +1d85 1d83 7573 7576 +1d83 1d86 7574 7575 +1d83 1d87 7575 7576 +1d86 1d84 7574 7579 +1d89 1d84 7579 8943 +1d84 2677 866e 8943 +1d85 1d87 7576 7584 +1d88 1d85 7578 7580 +1d8e 1d85 7580 7583 +1d8f 1d85 7583 7584 +1d87 1d86 7575 757c +1d86 1d89 7579 757a +1d86 1d8a 757a 757b +1d86 1d8b 757b 757d +1d8c 1d86 757c 757d +1d87 1d8c 757c 758b +1d8f 1d87 7584 758a +1d92 1d87 758a 758b +1d8d 1d88 757f 7581 +1d88 1d8e 7580 7581 +1d8a 1d89 757a 8441 +2554 1d89 8441 89f8 +1d89 2677 8943 89f7 +1d89 26f2 89f7 89f8 +1d8b 1d8a 757b 89ec +1d8a 2554 8441 87e5 +1d8a 26f3 87e5 8a28 +26f4 1d8a 89ec 8a28 +1d8c 1d8b 757d 79ea +1f2d 1d8b 79ea 87e6 +26f4 1d8b 87e6 89ec +1d92 1d8c 758b 79e7 +1f2c 1d8c 79e7 79e9 +1f2d 1d8c 79e9 79ea +1d8d 1d8e 7581 7585 +1d8d 1d90 7585 7587 +1d91 1d8d 7586 7587 +1d8e 1d8f 7583 7588 +1d90 1d8e 7585 7588 +1d90 1d8f 7588 758c +1d8f 1d92 758a 758d +1d93 1d8f 758c 758d +1d91 1d90 7587 7590 +1d90 1d93 758c 7597 +1d95 1d90 7590 7595 +1d97 1d90 7595 7596 +1d98 1d90 7596 7597 +1d94 1d91 758e 7591 +1d91 1d95 7590 7591 +1d93 1d92 758d 79a3 +1f1a 1d92 79a3 79e8 +1d92 1f2c 79e7 79e8 +1d98 1d93 7597 79a2 +1da8 1d93 79a2 79a4 +1d93 1f1a 79a3 79a4 +1d94 1d95 7591 7598 +1d96 1d94 7593 7599 +1d94 1d99 7598 759a +1d9a 1d94 7599 759a +1d95 1d97 7595 759b +1d99 1d95 7598 759b +1d96 1d9a 7599 759e +1d9b 1d96 759c 759d +1d9c 1d96 759d 759e +1d97 1d98 7596 75ca +1d99 1d97 759b 75ba +1da2 1d97 75ba 75bf +1da3 1d97 75bf 75c6 +1da5 1d97 75c6 75ca +1da5 1d98 75ca 75cb +1da8 1d98 75cb 79a2 +1d9a 1d99 759a 75b3 +1da0 1d99 75b3 75b5 +1da2 1d99 75b5 75ba +1d9c 1d9a 759e 75b1 +1d9a 1d9f 75b0 75b1 +1da0 1d9a 75b0 75b3 +1d9b 1d9c 759d 75af +1d9b 1d9d 75a4 75a9 +1d9f 1d9b 75a5 75af +1d9f 1d9c 75af 75b1 +1d9d 1d9e 75a1 75a8 +1da0 1d9f 75a6 75b0 +1da1 1da0 75b4 75b6 +1da0 1da2 75b5 75b6 +1da1 1da2 75b6 75bb +1da1 1da3 75bb 75be +1da3 1da2 75bb 75bf +1da5 1da3 75c3 75c6 +1da4 1da5 75c4 75c7 +1da4 1da6 75c7 75c9 +1da7 1da4 75c8 75c9 +1da6 1da5 75c7 75cc +1da5 1da8 75cb 75cc +1da7 1da6 75c9 79ee +1da6 1da8 75cc 79ec +1f1a 1da6 79eb 79ec +1da6 1f2e 79eb 79ed +1da6 1f2f 79ed 79ee +1da7 1f2f 79ee 87ee +1da7 26fd 87ee 87f1 +1da8 1f1a 79a4 79ec +1da9 1daa 75cf 75d4 +1dab 1da9 75d1 75d5 +1da9 1dad 75d4 75d6 +1dae 1da9 75d5 75d6 +1dad 1daa 75d4 75d8 +1daa 1daf 75d7 75d9 +1db0 1daa 75d8 75d9 +1dac 1dab 75d3 75dd +1dab 1dae 75d5 75de +1dae 1dad 75d6 75e2 +1dad 1db0 75d8 75e3 +1db0 1daf 75d9 75e8 +1daf 1db1 75da 75e9 +1db2 1daf 75e8 75ea +1daf 1db3 75e9 75ea +1db0 1db2 75e8 75ec +1db3 1db1 75e9 75f0 +1db1 1db4 75ed 75f1 +1db6 1db1 75f0 75f1 +1db2 1db3 75ea 75f4 +1db2 1db7 75f4 75f8 +1db9 1db2 75f7 75f8 +1db3 1db6 75f0 75f5 +1db7 1db3 75f4 75f6 +1db3 1db8 75f5 75f6 +1db4 1db5 75ee 75f9 +1db6 1db4 75f1 75fa +1db4 1dba 75f9 75fb +1dbb 1db4 75fa 75fb +1dba 1db5 75f9 75ff +1db5 1dbc 75fc 75ff +1db8 1db6 75f5 7601 +1db6 1dbb 75fa 7600 +1db7 1db8 75f6 785c +1db9 1db7 75f8 7869 +1db9 1eb5 786a 7876 +1dbb 1dba 75fb 7855 +1dba 1dbc 75ff 7860 +1eae 1dba 7855 785d +1eb2 1dba 785d 785f +1eb3 1dba 785f 7860 +1ead 1dbb 7851 7854 +1eae 1dbb 7854 7855 +1dbc 1dbd 75fe 7871 +1eb3 1dbc 7860 786e +1eb6 1dbc 786e 7871 +1eb6 1dbd 7871 787d +1eb8 1dbd 787d 7880 +1dbe 1dc0 7608 760d +1dc1 1dbe 760a 760e +1dbe 1dc2 760d 760f +1dc3 1dbe 760e 760f +1dc0 1dbf 7609 7610 +1dc4 1dbf 7610 7612 +1dbf 1dc5 7611 7612 +1dc2 1dc0 760d 7613 +1dc0 1dc4 7610 7614 +1dc6 1dc0 7613 7614 +1dc1 1dc3 760e 7617 +1dc7 1dc1 7615 7618 +1dc1 1dc8 7617 7618 +1dc3 1dc2 760f 761c +1dc2 1dc6 7613 761d +1dcb 1dc2 761c 761e +1dc2 1dcc 761d 761e +1dc8 1dc3 7617 761f +1dc3 1dcb 761c 7620 +1dcd 1dc3 761f 7620 +1dc4 1dc5 7612 7621 +1dc6 1dc4 7614 7622 +1dc4 1dce 7621 7623 +1dcf 1dc4 7622 7624 +1dc4 1dd0 7623 7625 +1dd1 1dc4 7624 7625 +1dc5 1dc9 7619 7626 +1dce 1dc5 7621 7626 +1dcc 1dc6 761d 7627 +1dc6 1dcf 7622 7627 +1dc7 1dc8 7618 762c +1dd2 1dc7 7628 762d +1dc7 1dd5 762c 762d +1dc8 1dcd 761f 7630 +1dd5 1dc8 762c 7631 +1dc8 1dd7 7630 7631 +1dc9 1dca 761a 7632 +1dce 1dc9 7626 7633 +1dc9 1dd8 7632 7634 +1dd9 1dc9 7633 7634 +1dd8 1dca 7632 7637 +1dca 1dda 7636 7637 +1dcb 1dcc 761e 7640 +1dcd 1dcb 7620 7643 +1dcb 1ddd 7640 7643 +1dcc 1dcf 7627 763a +1ddd 1dcc 7640 7641 +1dd7 1dcd 7630 7646 +1dcd 1ddd 7643 7644 +1dcd 1dde 7644 7645 +1dcd 1ddf 7645 7646 +1dd0 1dce 7623 7638 +1dce 1dd9 7633 7638 +1dcf 1dd1 7624 7639 +1dd1 1dd0 7625 763c +1dd0 1dd9 7638 763f +1ddb 1dd0 763c 763e +1ddc 1dd0 763e 763f +1dd1 1ddb 763c 763d +1dd4 1dd2 762a 7649 +1dd2 1dd5 762d 764a +1de1 1dd2 7649 764c +1dd2 1de2 764a 764b +1dd2 1de3 764b 764c +1dd3 1dd4 762b 764d +1dd6 1dd3 762f 764e +1dd3 1de4 764d 764e +1dd4 1de1 7649 7650 +1de4 1dd4 764d 764f +1de5 1dd4 764f 7651 +1dd4 1de6 7650 7651 +1dd5 1dd7 7631 7652 +1de2 1dd5 764a 7652 +1de0 1dd6 7647 7653 +1dd6 1de4 764e 7653 +1dd7 1ddf 7646 765b +1de2 1dd7 7652 765f +1dd7 1de9 765b 765e +1dd7 1deb 765e 765f +1dd9 1dd8 7634 771d +1dd8 1dda 7637 7719 +1dd8 1e25 7719 771c +1dd8 1e26 771c 771d +1ddc 1dd9 763f 772e +1dd9 1e26 771d 772e +1dda 1e21 7713 7718 +1dda 1e24 7718 771a +1e25 1dda 7719 771a +1ddb 1ddc 763e 7666 +1ddc 1e26 772e 7730 +1ddc 1e31 7730 7773 +1dde 1ddd 7644 7655 +1ddd 1de7 7654 7655 +1ddf 1dde 7645 7658 +1dde 1de7 7655 7657 +1dde 1de8 7657 7658 +1ddf 1de8 7658 765c +1de9 1ddf 765b 765d +1ddf 1dea 765c 765d +1de0 1de4 7653 7935 +1ef4 1de0 792a 7934 +1ef6 1de0 7934 7935 +1de1 1de3 764c 795d +1de6 1de1 7650 7999 +1de1 1f00 795d 7961 +1de1 1f06 7961 7999 +1de3 1de2 764b 766f +1de2 1deb 765f 766c +1de2 1df1 766c 766f +1de3 1df1 766f 7956 +1de3 1f00 7956 795d +1de4 1de5 764f 793a +1ef6 1de4 7935 793a +1de5 1de6 7651 79b5 +1de5 1ef6 7939 793a +1ef8 1de5 7939 793d +1efb 1de5 793d 79b5 +1efb 1de6 79b5 79b6 +1de6 1f06 7999 799a +1de6 1f15 799a 79b6 +1de8 1de7 7657 765a +1dea 1de8 765c 7661 +1dec 1de8 7661 7663 +1de8 1ded 7662 7663 +1de9 1dea 765d 7667 +1deb 1de9 765e 7668 +1de9 1dee 7667 7668 +1dea 1dec 7661 7669 +1dee 1dea 7667 766b +1dea 1def 7669 766a +1dea 1df0 766a 766b +1deb 1dee 7668 766d +1df1 1deb 766c 766e +1deb 1df2 766d 766e +1dec 1ded 7663 7671 +1def 1dec 7669 7671 +1def 1ded 7671 7673 +1ded 1df3 7672 7673 +1dee 1df0 766b 78ea +1df2 1dee 766d 7916 +1dee 1ee2 78ea 7916 +1df0 1def 766a 78e0 +1def 1df3 7673 78dd +1def 1edb 78dd 78e0 +1df0 1edb 78e0 78e2 +1df0 1ede 78e2 78e9 +1df0 1ee2 78e9 78ea +1df1 1df2 766e 7952 +1df1 1efe 7952 7955 +1df1 1f00 7955 7956 +1df2 1ee2 7916 7917 +1df2 1eef 7917 7954 +1efe 1df2 7952 7953 +1eff 1df2 7953 7954 +1df3 1edb 78da 78dd +1df4 1df5 7678 7679 +1df6 1df5 767d 767f +1df7 1df6 7683 7684 +1df7 1df8 7688 7850 +1df8 1dfa 768b 784d +1eac 1df8 784b 784d +1dfa 1df9 7689 784c +1ea4 1df9 7843 7844 +1ea6 1df9 7844 784f +1df9 1eab 7843 7848 +1df9 1eac 7848 784c +1dfa 1eac 784c 784d +1dfb 1dfd 7690 7695 +1dff 1dfb 7693 7696 +1dfb 1e00 7695 7696 +1dfd 1dfc 7691 769a +1dfc 1dfe 7692 769b +1e03 1dfc 769a 769c +1dfc 1e04 769b 769c +1e00 1dfd 7695 769e +1dfd 1e03 769a 769d +1dfd 1e05 769d 769e +1e04 1dfe 769b 8841 +1dfe 2645 8656 8841 +2646 1dfe 8656 8a41 +1dfe 26e0 883f 8a41 +1dff 1e00 7696 7819 +1e01 1dff 7697 781d +1dff 1e9d 7819 781d +1e00 1e05 769e 7815 +1e00 1e9d 7818 7819 +1e02 1e01 7698 7820 +1e01 1e9d 781d 781e +1e01 1e9f 781e 7820 +1e02 1e9f 7820 7822 +1e02 1ea0 7822 7824 +1ea1 1e02 7823 7824 +1e03 1e04 769c 89e0 +1e05 1e03 769d 7813 +1e9c 1e03 7813 8845 +2649 1e03 8845 89e0 +1e04 2645 8841 8842 +2648 1e04 85ec 8842 +1e04 2649 85ec 89e0 +1e05 1e9c 7813 7814 +1e06 1e07 769f 76a1 +1e08 1e06 76a0 76a2 +1e09 1e06 76a2 76a4 +1e08 1e09 76a2 76aa +1e08 1e0a 76aa 76ac +1e0b 1e08 76ab 76ac +1e0a 1e09 76aa 76af +1e0c 1e09 76af 76b1 +1e0b 1e0a 76ac 76b5 +1e0a 1e0c 76af 76b6 +1e0d 1e0a 76b5 76b8 +1e0a 1e0e 76b6 76b7 +1e0a 1e0f 76b7 76b8 +1e0b 1e0d 76b5 76b9 +1e0e 1e0c 76b6 76bc +1e0d 1e0f 76b8 76c3 +1e0f 1e0e 76b7 76bf +1e10 1e0e 76bf 76c2 +1e0e 1e11 76c1 76c2 +1e0f 1e10 76bf 76c6 +1e10 1e11 76c2 76c9 +1e10 1e12 76c9 76ca +1e12 1e11 76c9 8726 +257e 1e11 8726 884f +1e12 257e 8726 8728 +1e12 2695 8728 884d +1e15 1e13 76d5 76dc +1e14 1e15 76d6 76df +1e16 1e14 76d7 76e0 +1e14 1e17 76df 76e1 +1e18 1e14 76e0 76e1 +1e17 1e15 76df 76e3 +1e16 1e18 76e0 76e5 +1e16 1e19 76e5 76e6 +1e18 1e17 76e1 76ef +1e19 1e18 76e5 76eb +1e1b 1e1c 76fe 7702 +1e1d 1e1b 76ff 7703 +1e1b 1e1e 7702 7703 +1e1e 1e1c 7702 7705 +1e1f 1e1c 7705 7706 +1e1d 1e1e 7703 7708 +1e1e 1e1f 7705 770a +1e20 1e1e 770b 770c +1e21 1e23 7715 771b +1e24 1e21 7718 771b +1e23 1e22 7716 771e +1e27 1e22 771e 7720 +1e22 1e28 771f 7721 +1e29 1e22 7720 7721 +1e24 1e23 771b 7722 +1e23 1e27 771e 7723 +1e2a 1e23 7722 7723 +1e25 1e24 771a 7728 +1e24 1e2a 7722 7729 +1e2d 1e24 7728 772a +1e24 1e2e 7729 772a +1e26 1e25 771c 772b +1e25 1e2d 7728 772c +1e2f 1e25 772b 772d +1e25 1e30 772c 772d +1e26 1e2f 772b 772f +1e26 1e31 772f 7730 +1e27 1e29 7720 7731 +1e2a 1e27 7723 7732 +1e27 1e32 7731 7732 +1e29 1e28 7721 7733 +1e28 1e2b 7725 7734 +1e33 1e28 7733 7735 +1e28 1e34 7734 7735 +1e32 1e29 7731 7737 +1e29 1e33 7733 7736 +1e29 1e35 7736 7737 +1e2e 1e2a 7729 7738 +1e2a 1e32 7732 7739 +1e36 1e2a 7738 7739 +1e2b 1e2c 7726 773a +1e34 1e2b 7734 773a +1e34 1e2c 773a 773e +1e2c 1e37 773b 773f +1e39 1e2c 773e 773f +1e2d 1e2e 772a 7740 +1e30 1e2d 772c 7741 +1e2d 1e3a 7740 7742 +1e3b 1e2d 7741 7742 +1e2e 1e36 7738 7743 +1e3a 1e2e 7740 7743 +1e2f 1e30 772d 7744 +1e31 1e2f 772f 7747 +1e2f 1e3c 7744 7746 +1e2f 1e3d 7746 7747 +1e30 1e3b 7741 7745 +1e3c 1e30 7744 7745 +1e31 1e3d 7747 776f +1e31 1e55 776f 7774 +1e32 1e35 7737 774c +1e36 1e32 7739 774f +1e32 1e41 774c 774f +1e33 1e34 7735 774a +1e35 1e33 7736 7748 +1e3e 1e33 7748 7749 +1e3f 1e33 7749 774a +1e34 1e39 773e 8928 +1e3f 1e34 774a 8807 +266c 1e34 8807 8928 +1e35 1e3e 7748 774b +1e35 1e40 774b 774d +1e41 1e35 774c 774e +1e35 1e42 774d 774e +1e3a 1e36 7743 7757 +1e36 1e41 774f 7752 +1e36 1e45 7752 7756 +1e36 1e46 7756 7757 +1e37 1e38 773c 7755 +1e39 1e37 773f 7755 +1e39 1e38 7755 85ce +1e38 2630 8801 8802 +2633 1e38 85ce 8802 +2632 1e39 8629 8804 +1e39 2633 85ce 8804 +1e39 266c 8629 8928 +1e3b 1e3a 7742 7760 +1e3a 1e46 7757 775e +1e3a 1e4a 775e 775f +1e3a 1e4b 775f 7761 +1e4c 1e3a 7760 7761 +1e3c 1e3b 7745 776b +1e3b 1e4c 7760 776e +1e53 1e3b 776b 776e +1e3d 1e3c 7746 776c +1e3c 1e53 776b 776d +1e54 1e3c 776c 776d +1e3d 1e54 776c 7770 +1e55 1e3d 776f 7771 +1e3d 1e56 7770 7772 +1e57 1e3d 7771 7772 +1e3e 1e3f 7749 880b +1e40 1e3e 774b 8913 +26c4 1e3e 878b 880b +1e3e 26c5 878b 8913 +1e3f 266c 8807 894c +26c4 1e3f 880b 894c +1e42 1e40 774d 7750 +1e43 1e40 7750 880f +26c5 1e40 88f4 8913 +26c8 1e40 880f 88f4 +1e41 1e42 774e 7751 +1e41 1e44 7751 7753 +1e45 1e41 7752 7753 +1e42 1e43 7750 7754 +1e44 1e42 7751 7754 +1e44 1e43 7754 7758 +1e47 1e43 7758 88ff +26c8 1e43 878e 880f +1e43 26c9 878e 88ff +1e45 1e44 7753 7759 +1e44 1e47 7758 775a +1e48 1e44 7759 775b +1e44 1e49 775a 775b +1e46 1e45 7756 775c +1e45 1e48 7759 775d +1e4a 1e45 775c 775d +1e46 1e4a 775c 775e +1e49 1e47 775a 7762 +1e4d 1e47 7762 7763 +1e4e 1e47 7763 8811 +26c9 1e47 8811 88ff +1e48 1e49 775b 7764 +1e4a 1e48 775d 7765 +1e4b 1e48 7765 7766 +1e48 1e4f 7764 7767 +1e50 1e48 7766 7767 +1e49 1e4d 7762 7768 +1e4f 1e49 7764 7768 +1e4b 1e4a 775f 7765 +1e4c 1e4b 7761 777b +1e4b 1e50 7766 778a +1e5b 1e4b 777b 778a +1e53 1e4c 776e 7776 +1e59 1e4c 7776 777a +1e5b 1e4c 777a 777b +1e4d 1e4e 7763 8631 +1e4f 1e4d 7768 7769 +1e51 1e4d 7769 776a +1e52 1e4d 776a 88ea +1e4d 266d 8631 88ea +266d 1e4e 8631 88eb +1e4e 26c9 8811 8813 +1e4e 26cb 8813 88eb +1e50 1e4f 7767 779b +1e4f 1e51 7769 7796 +1e4f 1e67 7796 779b +1e5b 1e50 778a 778b +1e63 1e50 778b 779d +1e50 1e67 779b 779d +1e51 1e52 776a 7798 +1e67 1e51 7796 7797 +1e68 1e51 7797 7799 +1e51 1e69 7798 779a +1e6a 1e51 7799 779a +1e69 1e52 7798 8921 +266d 1e52 8816 88ea +26cd 1e52 8798 8816 +1e52 26ce 8798 8921 +1e54 1e53 776d 7775 +1e58 1e53 7775 7777 +1e53 1e59 7776 7777 +1e56 1e54 7770 7778 +1e54 1e58 7775 7779 +1e5a 1e54 7778 7779 +1e55 1e57 7771 777c +1e57 1e56 7772 777e +1e56 1e5a 7778 777f +1e5c 1e56 777e 777f +1e57 1e5c 777e 7781 +1e5d 1e57 7780 7782 +1e57 1e5e 7781 7782 +1e58 1e59 7777 7783 +1e5a 1e58 7779 7784 +1e58 1e5f 7783 7784 +1e59 1e5b 777a 7785 +1e5f 1e59 7783 7785 +1e5c 1e5a 777f 7786 +1e5a 1e5f 7784 7789 +1e60 1e5a 7786 7787 +1e61 1e5a 7787 7788 +1e62 1e5a 7788 7789 +1e5f 1e5b 7785 778c +1e5b 1e63 778b 778c +1e5e 1e5c 7781 778e +1e5c 1e60 7786 778f +1e64 1e5c 778e 778f +1e5d 1e5e 7782 7790 +1e5d 1e65 7790 7792 +1e5e 1e64 778e 7794 +1e65 1e5e 7790 7795 +1e5e 1e66 7794 7795 +1e62 1e5f 7789 77e3 +1e5f 1e63 778c 77a8 +1e5f 1e70 77a8 79ab +1e89 1e5f 77e3 79ab +1e60 1e61 7787 77cd +1e64 1e60 778f 77cd +1e61 1e62 7788 77d4 +1e61 1e64 77c8 77cd +1e61 1e7c 77c7 77c8 +1e7d 1e61 77c7 77cb +1e80 1e61 77cb 77d3 +1e83 1e61 77d3 77d4 +1e83 1e62 77d4 77e2 +1e89 1e62 77e2 77e3 +1e63 1e67 779d 779e +1e63 1e6b 779e 77a5 +1e63 1e70 77a5 77a8 +1e66 1e64 7794 77be +1e79 1e64 77be 77bf +1e7c 1e64 77bf 77c8 +1e65 1e66 7795 77c3 +1e65 1e7b 77c3 77c5 +1e66 1e77 77b6 77b8 +1e79 1e66 77b6 77be +1e66 1e7b 77b8 77c3 +1e67 1e68 7797 779c +1e67 1e6b 779c 779e +1e68 1e6a 7799 779f +1e6b 1e68 779c 77a0 +1e68 1e6c 779f 77a0 +1e6a 1e69 779a 77a1 +1e6d 1e69 77a1 8799 +26ce 1e69 8799 8921 +1e6c 1e6a 779f 77a3 +1e6a 1e6d 77a1 77a2 +1e6a 1e6e 77a2 77a4 +1e6f 1e6a 77a3 77a4 +1e6b 1e6c 77a0 77a6 +1e70 1e6b 77a5 77a7 +1e6b 1e71 77a6 77a7 +1e6c 1e6f 77a3 77aa +1e71 1e6c 77a6 77ab +1e6c 1e73 77aa 77ab +1e6e 1e6d 77a2 77a9 +1e72 1e6d 77a9 8819 +1e6d 26ce 8799 8819 +1e6f 1e6e 77a4 77ac +1e6e 1e72 77a9 77ae +1e74 1e6e 77ac 77ad +1e75 1e6e 77ad 77ae +1e73 1e6f 77aa 77b0 +1e6f 1e74 77ac 77af +1e6f 1e76 77af 77b0 +1e70 1e71 77a7 793f +1e89 1e70 79ab 79ac +1e70 1e8a 793f 79ac +1e71 1e73 77ab 77fa +1e71 1e8a 7810 793f +1e71 1e94 77fa 7810 +1e75 1e72 77ae 881d +1e72 24ed 8638 881d +24ee 1e72 8638 881b +266e 1e72 881b 8920 +1e72 26ce 8819 8920 +1e73 1e76 77b0 77f3 +1e73 1e90 77f3 77f9 +1e73 1e94 77f9 77fa +1e74 1e75 77ad 77ec +1e76 1e74 77af 77ee +1e74 1e8b 77ec 77ed +1e74 1e8c 77ed 77ee +1e8b 1e75 77ec 8905 +1e75 24ed 881d 881f +1e75 26d1 881f 8905 +1e76 1e8c 77ee 77f1 +1e76 1e8f 77f1 77f4 +1e90 1e76 77f3 77f4 +1e78 1e77 77b1 77b4 +1e79 1e77 77b4 77b6 +1e77 1e7a 77b5 77b7 +1e77 1e7b 77b7 77b8 +1e78 1e79 77b4 77ba +1e7c 1e78 77b9 77ba +1e7c 1e79 77ba 77bf +1e7b 1e7a 77b7 77c0 +1e7e 1e7a 77c0 77c2 +1e7a 1e7f 77c1 77c2 +1e7b 1e7e 77c0 77c4 +1e7d 1e7c 77bc 77c7 +1e7d 1e80 77cb 77cc +1e7e 1e7f 77c2 77ce +1e7e 1e81 77ce 77cf +1e81 1e7f 77ce 77d1 +1e7f 1e82 77d0 77d1 +1e80 1e83 77d3 77d8 +1e84 1e80 77d6 77d9 +1e80 1e85 77d8 77d9 +1e81 1e82 77d1 77dc +1e81 1e87 77dc 77de +1e88 1e81 77dd 77de +1e87 1e82 77dc 77df +1e85 1e83 77d8 77e4 +1e83 1e89 77e2 77e5 +1e8a 1e83 77e4 77e5 +1e84 1e85 77d9 7811 +1e86 1e84 77db 780d +1e98 1e84 780d 7811 +1e85 1e8a 77e4 780f +1e94 1e85 780e 780f +1e85 1e98 780e 7811 +1e86 1e95 7808 7809 +1e96 1e86 7808 780a +1e98 1e86 780a 780d +1e88 1e87 77de 77e8 +1e8a 1e89 77e5 79ac +1e94 1e8a 780f 7810 +1e8c 1e8b 77ed 77ef +1e8d 1e8b 77ef 77f0 +1e8e 1e8b 77f0 891f +26d1 1e8b 879f 8905 +1e8b 26d2 879f 891f +1e8c 1e8d 77ef 77f2 +1e8f 1e8c 77f1 77f2 +1e8d 1e8e 77f0 77f5 +1e8f 1e8d 77f2 77f6 +1e8d 1e91 77f5 77f7 +1e92 1e8d 77f6 77f7 +1e91 1e8e 77f5 77f8 +1e93 1e8e 77f8 8821 +26d2 1e8e 8821 891f +1e90 1e8f 77f4 77fc +1e8f 1e92 77f6 77fb +1e8f 1e95 77fb 77fd +1e96 1e8f 77fc 77fd +1e94 1e90 77f9 7805 +1e90 1e96 77fc 7805 +1e92 1e91 77f7 77ff +1e91 1e93 77f8 77fe +1e91 1e97 77fe 7801 +1e95 1e92 77fb 7804 +1e97 1e93 77fe 8825 +2636 1e93 85d1 8823 +1e93 2637 85d1 8825 +1e93 26d2 8821 8823 +1e94 1e96 7805 780b +1e94 1e98 780b 780e +1e96 1e95 77fd 7808 +1e96 1e98 780a 780b +1e97 2637 8825 894b +26d3 1e97 87a1 894b +1e9a 1e99 7812 8644 +1e99 1e9b 7812 882e +1e99 24f6 85d9 8644 +263d 1e99 85d9 882d +1e99 2672 87a7 882d +26d7 1e99 87a7 882e +1e9b 1e9a 7812 8645 +1e9a 21af 8384 840a +21b1 1e9a 8385 840a +24f6 1e9a 8384 8644 +1e9a 24f7 8385 8645 +24f7 1e9b 85da 8645 +1e9b 254c 85da 87a9 +26d5 1e9b 87a6 87a9 +1e9b 26d6 87a6 89cd +26d7 1e9b 882e 89cd +2649 1e9c 87c1 8845 +1e9c 26e2 87c1 87c2 +1e9d 1e9e 781b 781f +1e9f 1e9d 781e 781f +1e9f 1e9e 781f 7825 +1ea2 1e9e 7825 7828 +1ea0 1e9f 7822 7826 +1e9f 1ea2 7825 7827 +1ea3 1e9f 7826 7827 +1ea1 1ea0 7824 782a +1ea0 1ea3 7826 782b +1ea4 1ea0 782a 782c +1ea0 1ea5 782b 782c +1ea1 1ea4 782a 782d +1ea1 1ea6 782d 782e +1ea3 1ea2 7827 7837 +1ea2 1ea7 7832 7837 +1ea5 1ea3 782b 7838 +1ea3 1ea7 7837 7838 +1ea4 1ea5 782c 783c +1ea6 1ea4 782d 7844 +1ea4 1ea9 783c 783e +1ea4 1eab 783e 7843 +1ea7 1ea5 7836 7838 +1ea5 1ea8 7836 783a +1ea5 1ea9 783a 783c +1ea7 1ea8 7831 7836 +1ea8 1ea9 7839 783a +1ea9 1eaa 783d 783f +1eab 1ea9 783e 783f +1eab 1eaa 783f 7845 +1eac 1eaa 7845 7847 +1eab 1eac 7845 7848 +1ead 1eae 7854 7857 +1ead 1eaf 7857 7859 +1eb0 1ead 7858 785a +1ead 1eb1 7859 785a +1eaf 1eae 7857 785e +1eae 1eb2 785d 785e +1eb1 1eaf 7859 7862 +1eaf 1eb2 785e 7863 +1eb0 1eb1 785a 7865 +1eb0 1eb4 7865 7867 +1eb4 1eb1 7865 7868 +1eb2 1eb3 785f 786c +1eb3 1eb6 786e 7870 +1eb7 1eb3 786f 7870 +1eb7 1eb6 7870 787e +1eb6 1eb8 787d 787f +1eb9 1eb6 787e 787f +1eb7 1eb9 787e 7882 +1eb9 1eb8 787f 788a +1ebb 1eb8 788a 7891 +1ebb 1eb9 7885 788a +1eba 1ebc 7886 788e +1ebe 1eba 788b 788f +1eba 1ec0 788e 788f +1ebd 1ebb 7887 7890 +1ebc 1ebd 7888 7893 +1ec0 1ebc 788e 7896 +1ebc 1ec1 7895 7896 +1ebf 1ebe 788d 7898 +1ebe 1ec0 788f 7899 +1ec2 1ebe 7898 7899 +1ebf 1ec2 7898 789b +1ec3 1ebf 789a 789b +1ec0 1ec1 7896 78d4 +1ec2 1ec0 7899 78d4 +1ec2 1ec1 78d4 78d7 +1ed9 1ec1 78d5 78d6 +1ec1 1eda 78d5 78d7 +1ec3 1ec2 789b 7908 +1ec2 1eda 78d7 7906 +1ec2 1eea 7906 7908 +1ecb 1ec3 78ae 7907 +1eea 1ec3 7907 7908 +1ec4 1ec5 789e 78a2 +1ec6 1ec4 78a0 78a3 +1ec4 1ec7 78a2 78a3 +1ec7 1ec5 78a2 78a5 +1ec6 1ec7 78a3 78a8 +1ec8 1ec6 78a6 78a9 +1ec6 1ec9 78a8 78aa +1eca 1ec6 78a9 78aa +1ec9 1ec7 78a8 78ac +1ec7 1ecb 78ab 78ad +1ecc 1ec7 78ac 78ad +1ec8 1eca 78a9 78b0 +1ecd 1ec8 78af 78b0 +1eca 1ec9 78aa 78b3 +1ec9 1ecc 78ac 78b4 +1ecf 1ec9 78b3 78b4 +1ecd 1eca 78b0 78b5 +1eca 1ecf 78b3 78b6 +1ed0 1eca 78b5 78b7 +1eca 1ed1 78b6 78b7 +1ecc 1ecb 78ad 7902 +1ecb 1ee7 7900 7902 +1eea 1ecb 7900 7907 +1ecf 1ecc 78b4 7901 +1ee7 1ecc 7901 7902 +1ece 1ecd 78b2 78e5 +1ecd 1ed0 78b5 78ed +1edf 1ecd 78e5 78ed +1edc 1ece 78de 78e3 +1edd 1ece 78e3 78e4 +1edf 1ece 78e4 78e5 +1ed1 1ecf 78b6 790a +1ee7 1ecf 78ff 7901 +1ecf 1ee9 78ff 7905 +1ecf 1eeb 7905 790a +1ed0 1ed1 78b7 790e +1edf 1ed0 78ed 78ee +1ee1 1ed0 78ee 790f +1ed0 1eec 790e 790f +1ed1 1eeb 790a 790c +1ed1 1eec 790c 790e +1ed3 1ed2 78ba 78bd +1ed4 1ed2 78bd 78be +1ed3 1ed4 78bd 78c0 +1ed8 1ed5 78cc 7968 +1f09 1ed5 7968 7969 +1ed7 1ed6 78ca 7963 +1ed6 1ed8 78cb 7964 +1f07 1ed6 7963 7965 +1ed6 1f08 7964 7965 +1ed7 1f07 7963 7966 +1f08 1ed8 7964 796a +1ed8 1f09 7968 796b +1f0a 1ed8 796a 796b +1eda 1ed9 78d5 78fa +1ee4 1ed9 78f1 78f3 +1ed9 1ee6 78f1 78fa +1eda 1ee6 78fa 78fc +1eda 1eea 78fc 7906 +1edb 1edc 78dc 78df +1edb 1edd 78df 78e1 +1edb 1ede 78e1 78e2 +1edd 1edc 78df 78e3 +1ede 1edd 78e1 78e6 +1edd 1edf 78e4 78e7 +1ee0 1edd 78e6 78e8 +1edd 1ee1 78e7 78e8 +1ede 1ee0 78e6 78eb +1ee2 1ede 78e9 78ec +1ede 1ee3 78eb 78ec +1ee1 1edf 78e7 78ee +1ee0 1ee1 78e8 7912 +1ee3 1ee0 78eb 7914 +1ee0 1eee 7912 7914 +1ee1 1eec 790f 7910 +1ee1 1eed 7910 7913 +1eee 1ee1 7912 7913 +1ee2 1ee3 78ec 7915 +1ee2 1eef 7915 7917 +1ee3 1eee 7914 7918 +1eef 1ee3 7915 7918 +1ee5 1ee4 78ef 78f0 +1ee4 1ee6 78ef 78f1 +1ee6 1ee5 78ef 78f6 +1ee7 1ee5 78f6 78f8 +1ee5 1ee8 78f7 78f9 +1ee9 1ee5 78f8 78f9 +1ee6 1ee7 78f6 78fb +1ee6 1eea 78fb 78fc +1ee7 1ee9 78f8 78ff +1eea 1ee7 78fb 7900 +1ee9 1ee8 78f9 7903 +1eeb 1ee8 7903 7904 +1ee9 1eeb 7903 7905 +1eeb 1eec 790b 790c +1eed 1eec 7910 7911 +1eee 1eed 7913 7919 +1eef 1eee 7918 791a +1eff 1eef 7954 7959 +1f02 1eef 7959 795a +1ef0 1ef1 791e 7924 +1ef0 1ef2 7924 7926 +1ef0 1ef3 7926 7927 +1ef2 1ef1 7924 7929 +1ef1 1ef4 7928 7929 +1ef3 1ef2 7926 792d +1ef2 1ef4 7929 792e +1ef5 1ef2 792d 792f +1ef2 1ef6 792e 7930 +1ef7 1ef2 792f 7931 +1ef2 1ef8 7930 7931 +1ef3 1ef5 792d 7933 +1ef6 1ef4 792e 7934 +1ef5 1ef7 792f 7936 +1ef5 1ef9 7936 7938 +1ef8 1ef6 7930 7939 +1ef7 1ef8 7931 793b +1ef9 1ef7 7936 793c +1ef7 1efa 793b 793c +1efa 1ef8 793b 793e +1ef8 1efb 793d 793e +1ef9 1efa 793c 79dc +1f27 1ef9 79db 79dc +1ef9 1f2a 79db 79e5 +1efa 1efb 793e 79dd +1f15 1efa 79da 79dd +1f26 1efa 79d9 79da +1efa 1f27 79d9 79dc +1efb 1f15 79b6 79dd +1efc 1efd 7949 794b +1efe 1eff 7953 7957 +1f00 1efe 7955 7958 +1efe 1f01 7957 7958 +1f01 1eff 7957 795c +1eff 1f02 7959 795b +1eff 1f03 795b 795c +1f00 1f01 7958 795e +1f00 1f04 795e 795f +1f00 1f05 795f 7960 +1f00 1f06 7960 7961 +1f01 1f03 795c 798c +1f04 1f01 795e 798d +1f01 1f11 798c 798d +1f03 1f02 795b 798b +1f11 1f03 798c 798f +1f05 1f04 795f 7993 +1f04 1f11 798d 7990 +1f04 1f12 7990 7994 +1f14 1f04 7993 7994 +1f06 1f05 7960 7996 +1f05 1f14 7993 7997 +1f15 1f05 7996 7998 +1f05 1f16 7997 7998 +1f06 1f15 7996 799a +1f07 1f08 7965 796c +1f07 1f0b 796c 796f +1f08 1f0a 796a 796d +1f0b 1f08 796c 796d +1f0a 1f09 796b 7971 +1f0b 1f0a 796d 7975 +1f0a 1f0c 7972 7973 +1f0a 1f0d 7973 7974 +1f0a 1f0e 7974 7975 +1f0b 1f0e 7975 7987 +1f0d 1f0c 7973 797b +1f0c 1f0f 7977 797b +1f0e 1f0d 7974 7981 +1f0d 1f0f 797b 797d +1f0d 1f10 7980 7981 +1f0e 1f10 7981 7985 +1f12 1f11 7990 7992 +1f11 1f13 7991 7992 +1f12 1f13 7992 799b +1f14 1f12 7994 799e +1f12 1f17 799b 79a0 +1f18 1f12 799e 799f +1f19 1f12 799f 79a0 +1f17 1f13 799b 799d +1f16 1f14 7997 79a1 +1f14 1f18 799e 79a1 +1f15 1f16 7998 79d0 +1f15 1f26 79d0 79da +1f16 1f18 79a1 79c6 +1f16 1f22 79c6 79cd +1f16 1f26 79cd 79d0 +1f19 1f17 79a0 79bf +1f18 1f19 799f 79bd +1f18 1f1f 79bd 79c3 +1f18 1f22 79c3 79c6 +1f1e 1f19 79bb 79bc +1f19 1f1f 79bb 79bd +1f1a 1f2c 79e8 87e8 +1f2e 1f1a 79eb 8a02 +1f1a 26f6 87e8 8a02 +1f1c 1f1b 79ba 890f +1f1b 1f1d 79ba 890a +1f1b 25db 88c1 890f +1f1b 26b3 890a 8915 +26b4 1f1b 88c1 8915 +1f1d 1f1c 79ba 8947 +1f1c 25db 890f 8946 +1f1d 26b3 86ff 890a +1f1f 1f1e 79bb 79c0 +1f20 1f1e 79c0 79c2 +1f1e 1f21 79c1 79c2 +1f1f 1f20 79c0 79c4 +1f22 1f1f 79c3 79c4 +1f20 1f21 79c2 79c7 +1f22 1f20 79c4 79c8 +1f20 1f23 79c7 79c9 +1f24 1f20 79c8 79ca +1f20 1f25 79c9 79ca +1f23 1f21 79c7 79cc +1f22 1f24 79c8 79ce +1f26 1f22 79cd 79cf +1f22 1f27 79ce 79cf +1f25 1f23 79c9 79d1 +1f28 1f23 79d1 79d3 +1f23 1f29 79d2 79d3 +1f24 1f25 79ca 79d4 +1f27 1f24 79ce 79d5 +1f24 1f2a 79d4 79d5 +1f25 1f28 79d1 79d6 +1f2a 1f25 79d4 79d7 +1f26 1f27 79cf 79d9 +1f27 1f2a 79d5 79db +1f28 1f29 79d3 79de +1f2b 1f29 79e2 79e3 +1f2c 1f2d 79e9 8a03 +26f6 1f2c 87e8 8a99 +1f2c 26f9 8a03 8a99 +1f2d 2678 898a 8a2e +1f2d 26f4 87e6 898a +26f5 1f2d 87eb 8a2e +1f2d 26f9 87eb 8a03 +1f2f 1f2e 79ed 8a8c +26f6 1f2e 897a 8a02 +1f2e 26fe 897a 8a8c +26fd 1f2f 87ee 8998 +26fe 1f2f 8998 8a8c +1f31 1f30 79f8 8181 +1f30 1f32 79f8 838e +1f30 21b9 7d6c 8181 +21ba 1f30 7d6c 8b93 +2415 1f30 8182 838e +1f30 2416 8182 8b93 +1f32 1f31 79f8 8183 +21b9 1f31 7e39 8181 +1f31 21bb 7d6e 8183 +1f32 21bb 8183 8ca8 +1f32 23c4 8ca8 8cd8 +2415 1f32 838e 8bff +24fe 1f32 8bff 8cd8 +1f34 1f33 79f9 8743 +1f33 1f35 79f9 8741 +1f33 22e9 84c7 8529 +22ec 1f33 84c9 8529 +25b1 1f33 84c7 8741 +1f33 25b3 84c9 8743 +1f35 1f34 79f9 86d4 +25b3 1f34 86d3 8743 +25d5 1f34 852c 8873 +1f34 26a0 86d3 8873 +1f35 25b1 84c8 8741 +25b2 1f35 84c8 8742 +269f 1f35 8742 8744 +1f37 1f36 79fa 80bf +1f36 1f38 79fa 80be +2126 1f36 7c61 80be +1f36 2129 7c63 80bf +1f38 1f37 79fa 8b8a +1f37 2129 80bf 80c0 +212a 1f37 804b 80c0 +1f37 2371 804b 82ee +249b 1f37 8b8a 8b8d +1f37 249c 82ee 8b8d +1f38 2126 7c62 80be +2127 1f38 7c62 80ba +23a8 1f38 80ba 82eb +249b 1f38 82eb 8b8a +1f3a 1f39 79fb 7dd6 +221d 1f39 7dd6 8d15 +1f39 2224 8e19 8ea1 +2226 1f39 8d15 8ea1 +1f3a 221d 7dd6 8e18 +1f3a 2220 8e18 8e5c +1f3c 1f3b 79fc 8c4e +1f3b 2233 8ccc 8d25 +2238 1f3b 8cf6 8e14 +1f3b 2239 8cf6 8d88 +223b 1f3b 8c4e 8d88 +1f3b 2748 8d25 8e14 +1f3c 223b 8c4e 8dba +1f3e 1f3d 79fd 8152 +1f3d 1f3f 79fd 8d1a +225b 1f3d 814f 8d1a +1f3d 2407 814f 8bc4 +1f3d 2408 8bc4 8d1b +1f3f 1f3e 79fd 8d6d +1f3e 2258 7e07 8d5f +1f3e 225a 8d5b 8d6d +2724 1f3e 8d5b 8d5f +225a 1f3f 8d52 8d6d +225b 1f3f 8d1a 8d52 +1f41 1f40 79fe 7f9a +1f6b 1f40 7f9a 7f9b +1f40 1fd3 7a70 7f9b +1f6b 1f41 7a0e 7f9a +1f41 1f6c 7a0e 7f99 +1fd2 1f41 7a6e 7f99 +1f43 1f42 79ff 8a27 +1f42 20e6 8322 8776 +1f42 26be 8774 8782 +1f42 26c0 8782 8a27 +200f 1f43 7aac 8778 +26c0 1f43 8778 8a27 +1f45 1f44 7a00 80c3 +1f44 1f46 7a00 7c7b +213d 1f44 7c7a 80c2 +1f44 213f 7c7b 80c2 +1f44 2140 7c7c 80c3 +1f46 1f45 7a00 834c +1f7f 1f45 82f3 834e +2140 1f45 805c 80c3 +1f45 237b 805c 834d +1f45 237d 834d 834e +1f45 24a0 82f3 834c +213f 1f46 7c7b 834b +1f46 2379 82f2 834b +24a0 1f46 82f2 834c +1f48 1f47 7a01 8092 +1f47 1f49 7a01 82d2 +1f47 20fd 7c36 8092 +20fe 1f47 7c36 854f +1f47 2489 82d2 82d3 +1f47 248a 82d3 854f +1f49 1f48 7a01 8093 +20fd 1f48 7c37 8092 +1f48 20ff 7c38 8093 +20ff 1f49 8014 8093 +1f49 2338 8014 8326 +2489 1f49 82d2 8326 +1f4b 1f4a 7a02 80c8 +1f4a 1f4c 7a02 8b2d +1f4a 2145 7c83 80c7 +1f4a 2146 80c7 80c8 +2147 1f4a 7c83 859b +2611 1f4a 859b 8b2d +1f4c 1f4b 7a02 8350 +2146 1f4b 8061 80c8 +2148 1f4b 8060 8061 +1f4b 237f 8060 8303 +1f4b 24b3 8303 8350 +1f4c 24b3 8350 8a47 +24da 1f4c 8351 8a47 +1f4c 24db 8351 8bcc +2611 1f4c 8b2d 8bcc +1f4d 1f4e 7a03 816e +21a4 1f4d 7d57 816c +23b4 1f4d 816c 816e +1f4e 21a5 7d58 816f +1f4e 23b4 80f6 816e +23b7 1f4e 80f6 816f +1f50 1f4f 7a04 81c5 +1f4f 1f51 7a04 8c11 +1f4f 2205 8138 81c5 +23f7 1f4f 8138 8b12 +2536 1f4f 8b12 8c11 +1f51 1f50 7a04 81c6 +2205 1f50 7dbc 81c5 +1f50 2206 7dbd 81c6 +2206 1f51 7dbe 81c6 +1f51 2207 7dbe 8b72 +2535 1f51 83cb 8bd5 +1f51 2536 83cb 8c11 +1f51 2538 8b72 8bd5 +1f53 1f52 7a05 81d2 +1f52 2189 7ea3 81d3 +1f52 240f 8159 81d2 +2410 1f52 8159 81d3 +2265 1f53 7e11 81d1 +1f53 240e 815a 81d1 +240f 1f53 815a 81d2 +1f55 1f54 7a06 7fe5 +1f54 1f56 7a06 7fe4 +209b 1f54 7b17 7fe4 +1f54 209c 7b18 7fe5 +1f56 1f55 7a06 82a9 +1f55 209c 7fe5 7fe6 +209d 1f55 7f4b 7fe6 +1f55 2304 7f4b 82aa +245d 1f55 82a9 82aa +1f56 209b 7f4a 7fe4 +2303 1f56 7f4a 82a8 +1f56 245c 8233 82a8 +245d 1f56 8233 82a9 +1f58 1f57 7a07 8088 +1f57 1f59 7a07 8ba0 +1f57 20f5 7c2d 8088 +20f7 1f57 7c2d 8c3a +1f57 2480 82c5 8c3a +2481 1f57 82c5 8c06 +1f57 2482 8ba0 8c06 +1f59 1f58 7a07 8089 +20f5 1f58 7c29 8088 +1f58 20f8 7c2e 8089 +20f8 1f59 800d 8089 +1f59 2330 800d 8ae0 +2482 1f59 8ba0 8c07 +1f59 2485 8ae0 8c07 +1f5b 1f5a 7a08 7cd2 +1f5a 1f5c 7a08 7c34 +1f5a 20fd 7c35 8091 +20fe 1f5a 7cd2 8091 +1f5c 1f5b 7a08 8090 +1f5b 20fe 7cd2 82d1 +2335 1f5b 8090 8b0f +1f5b 2336 8013 8b0f +2337 1f5b 8013 82d1 +20fc 1f5c 7c33 808f +2335 1f5c 808f 8090 +1f5e 1f5d 7a09 818c +1f5d 21cb 7d83 818c +1f5d 21cc 7d82 818d +21cd 1f5d 7d83 818d +21c8 1f5e 7d7f 818a +1f5e 21c9 7d81 818a +21cb 1f5e 7d81 818c +1f60 1f5f 7a0a 819a +1f5f 1f61 7a0a 8199 +21d9 1f5f 7d8f 8199 +1f5f 21db 7d91 819a +1f61 1f60 7a0a 8429 +21db 1f60 7d93 819a +1f60 21dd 7d93 842a +1f60 250a 83a0 8429 +250d 1f60 83a0 842a +1f61 21d9 7d90 8199 +21da 1f61 7d90 8427 +1f61 2509 839e 8427 +250a 1f61 839e 8429 +1f63 1f62 7a0b 7dee +1f62 1f64 7a0b 7df0 +1f62 223f 7df0 7e90 +1f64 1f63 7a0b 81ca +1f63 2240 7def 81c9 +2241 1f63 7df1 81c9 +1f63 2242 7df1 81ca +223f 1f64 7df0 8144 +2242 1f64 8149 81ca +23ff 1f64 8144 8148 +2401 1f64 8148 8617 +1f64 2402 8149 8617 +1f66 1f65 7a0c 864e +1f65 1f67 7a0c 864d +1f65 21cb 8396 8418 +21cd 1f65 8398 8418 +1f65 23c9 8398 864e +2503 1f65 8396 864d +1f67 1f66 7a0c 8834 +23c9 1f66 85e2 864e +1f66 2641 85e2 87b2 +26d9 1f66 87b1 87b2 +1f66 26da 87b1 8834 +2500 1f67 8397 8832 +1f67 2503 8397 864d +254d 1f67 8832 8837 +1f67 26da 8834 8837 +1f69 1f68 7a0d 7f8d +1f68 1f6a 7a0d 7f8c +1fc8 1f68 7a64 7f8c +1f68 1fc9 7a65 7f8d +1f6a 1f69 7a0d 826e +1fc9 1f69 7a67 7f8d +1f69 1fcb 7a67 826f +1f69 22a6 7edf 826e +22a7 1f69 7edf 826f +1f6a 1fc8 7edc 7f8c +22a3 1f6a 7edc 826d +1f6a 22a4 7ede 826d +22a6 1f6a 7ede 826e +1f6c 1f6b 7a0e 8278 +1fd3 1f6b 7eed 7f9b +1f6b 1fd5 7eed 8279 +22b6 1f6b 8278 8279 +1f6c 1fd2 7eeb 7f99 +22b3 1f6c 7eeb 8277 +1f6c 22b5 7eee 8277 +22b6 1f6c 7eee 8278 +1f6d 1f6e 7a0f 857b +1f6d 1f70 857d 857e +1f6d 235c 857b 8a48 +2492 1f6d 857d 8a48 +1f6e 235b 89f4 8ac5 +235c 1f6e 857b 8ac5 +25fc 1f6e 8578 8ac4 +1f6e 2600 8578 89f4 +1f70 1f6f 7a10 89cb +1f6f 1f71 7a10 8580 +2361 1f6f 857f 8580 +1f6f 2602 857f 8b06 +1f71 1f70 7a10 8abc +1f70 2492 857d 8abc +1f71 235e 82e0 833f +1f71 235f 833f 8341 +1f71 2361 8341 8580 +2492 1f71 82e0 8abc +1f73 1f72 7a11 82e3 +1f72 1f74 7a11 8347 +1f72 211e 8043 80b5 +211f 1f72 8044 80b5 +236a 1f72 8043 8347 +1f72 236c 8044 82e3 +1f74 1f73 7a11 8a76 +236c 1f73 8047 82e3 +1f73 236f 8047 8a78 +260c 1f73 8a76 8b69 +236a 1f74 8347 8348 +236b 1f74 8348 8b66 +1f74 2609 8a75 8b66 +260c 1f74 8a75 8a76 +1f76 1f75 7a12 815b +1f75 1f77 7a12 83ec +1f75 2187 7ea4 815b +2188 1f75 7ea4 83e9 +24dc 1f75 836d 83ec +1f75 24dd 836d 83e9 +1f77 1f76 7a12 815c +2187 1f76 7d3e 815b +1f76 218a 7d3f 815c +218a 1f77 80eb 815c +1f77 23ab 80eb 83ed +23ac 1f77 836c 83ed +1f77 24dc 836c 83ec +1f79 1f78 7a13 862a +1f78 1f7a 7a13 8806 +1f78 23b1 85cf 862a +1f78 2632 8786 8805 +2634 1f78 85cf 8805 +26c1 1f78 8786 8806 +1f7a 1f79 7a13 83f2 +1f79 2190 836e 836f +23b1 1f79 836e 862a +1f79 24de 836f 862b +254b 1f79 83f2 862b +1f7a 254b 83f2 8809 +1f7a 26c1 8788 8806 +26c2 1f7a 8788 8789 +26c3 1f7a 8789 8809 +1f7c 1f7b 7a14 8197 +1f7b 1f7d 7a14 810c +21d7 1f7b 7d8c 8196 +1f7b 21d8 7d8d 8197 +1f7b 23cc 810c 8196 +1f7d 1f7c 7a14 8425 +21d8 1f7c 7e58 8197 +1f7c 21da 7e58 8426 +1f7c 2507 839c 8425 +2508 1f7c 839c 8426 +23cc 1f7d 810c 8424 +1f7d 23cd 810d 8424 +23ce 1f7d 810d 839b +2507 1f7d 839b 8425 +1f7f 1f7e 7a15 85bb +1f7e 1f80 7a15 877e +1f7e 24a0 8599 85bb +260d 1f7e 8599 875e +262a 1f7e 875e 877e +1f80 1f7f 7a15 805b +237a 1f7f 805b 85bc +1f7f 237d 834e 85bc +24a0 1f7f 82f3 85bb +1f80 237a 805b 8780 +1f80 262a 8760 877e +26b9 1f80 8760 8780 +1f82 1f81 7a16 89f3 +1f81 1f83 8b19 8bce +2558 1f81 8686 8bce +1f81 267d 8686 8bcf +2703 1f81 89f3 8bcf +226c 1f82 7ea7 8c8d +1f82 226d 7ea6 8be0 +226e 1f82 7ea6 8c85 +1f82 2703 89f3 8c85 +1f82 2712 8be0 8c8d +1f83 1f84 7a17 8b36 +1f83 2558 8b36 8bce +1f84 1f85 7a19 845d +1f84 2558 845d 8b36 +1f85 1f86 7a1a 8682 +2558 1f85 845d 89a3 +1f85 2679 8682 8a45 +267e 1f85 89a3 8a45 +1f86 1f87 7a1b 88dd +1f86 2559 88dd 8afd +255a 1f86 8681 8afd +1f86 2679 8681 8682 +2274 1f87 89ad 89b8 +2559 1f87 88dd 89ad +1f88 1f89 7a1d 8be9 +1f88 226f 8be9 8c43 +2702 1f88 8be6 8c43 +1f89 226f 8af0 8be9 +1f89 2273 7eac 8be8 +2275 1f89 8af0 8be8 +1f8a 1f8b 7a20 7f61 +2272 1f8a 7ea9 7eb0 +1f8a 2273 7ea9 8af1 +2277 1f8a 7eb0 7f61 +1f8b 1f8c 7a21 7f62 +2276 1f8b 7eaf 7f62 +1f8b 2277 7eaf 7f61 +1f8c 1f8d 7a22 7f63 +1f8c 2276 7eb2 7f62 +2278 1f8c 7eb2 7f63 +1f8d 1f8e 7a23 7f64 +1f8d 2278 7eb3 7f63 +2279 1f8d 7eb3 7f64 +1f8e 1f8f 7a24 7f65 +1f8e 2279 7eb5 7f64 +227c 1f8e 7eb5 7f65 +1f8f 1f90 7a25 7f66 +227c 1f8f 7f65 7f66 +1f90 1f91 7a26 7f67 +1f90 227c 7eb6 7f66 +227d 1f90 7eb6 7f67 +1f91 1f93 7b57 7f68 +1f91 227d 7eb9 7f67 +2281 1f91 7eb9 7f69 +1f91 2313 7f68 7f69 +1f92 1f93 7a28 7a29 +1f94 1f92 7a28 7f6b +1f92 1f95 7a2a 7f6b +1f93 1f94 7a28 7f6a +2313 1f93 7f68 7f6a +1f94 1f95 7f6b 846a +1f94 2283 846a 8bbb +2313 1f94 7f6a 8254 +1f94 241b 81db 8254 +241f 1f94 81db 8bbb +1f95 1f96 7a2c 7a2e +1f95 1f98 7a2e 8bba +2283 1f95 846a 8bba +1f96 1f97 7a2d 7ebc +1f98 1f96 7a2e 7ebc +1f98 1f97 7ebc 7f6c +1f97 1f99 7a2f 7f6d +2285 1f97 7f6c 7f6d +2282 1f98 7eba 8a3a +1f98 2283 7eba 8bba +2285 1f98 7ebe 7f6c +1f98 2286 7ebe 8a3a +1f99 1f9a 7a30 7f6f +2284 1f99 7ebd 7f6f +1f99 2285 7ebd 7f6d +1f9a 1f9b 7a31 7f70 +1f9c 1f9a 7ebb 7f70 +1f9a 2284 7ebb 7f6f +1f9b 1f9c 7a32 7f70 +1f9d 1f9b 7a32 7f71 +1f9b 1f9e 7a33 7f71 +1f9c 1f9d 7a32 8258 +2284 1f9c 7ebb 8257 +1f9c 2314 81dc 8257 +2420 1f9c 81dc 8258 +1f9e 1f9d 7ebf 7f71 +1f9d 2287 7ebf 8259 +1f9d 2420 81de 8258 +2421 1f9d 81de 8259 +1f9e 1f9f 7a34 7f72 +2287 1f9e 7ebf 7f72 +1f9f 1fa0 7a35 7f73 +1f9f 2287 7ec0 7f72 +2288 1f9f 7ec0 7f73 +1fa0 1fa1 7a36 7f74 +1fa0 2288 7ec2 7f73 +228b 1fa0 7ec2 7f74 +1fa1 1fa2 7a37 7ec3 +228b 1fa1 7f74 7f77 +1fa1 228c 7ec3 7f77 +1fa2 1fa3 7a38 7d7d +1fa2 20d4 7d7d 8184 +228c 1fa2 7ec3 7f79 +228e 1fa2 7f79 8184 +1fa3 1fa6 7e42 8185 +1fa3 1fa8 7a3c 7e42 +20d4 1fa3 7d7d 8185 +1fa4 1fa5 7a39 7b66 +1fa6 1fa4 7a3a 7b64 +20d4 1fa4 7b64 7b66 +20d4 1fa5 7b66 7f78 +1fa5 21c7 7d7c 8187 +2266 1fa5 7f78 8187 +1fa7 1fa6 7a3b 7e3f +1fa8 1fa6 7e3f 7e42 +1fa6 20d4 7b64 8185 +1fa8 1fa7 7a41 7e3f +1fa7 1faa 7a41 7e40 +1fa8 1fa9 7a3d 7e3d +1faa 1fa8 7a41 7e3d +1fa9 1faa 7a40 7e3d +1fa9 1fab 7a42 7a43 +1fab 1fac 7a45 7a46 +1fac 1fae 7b6f 7d7b +20d5 1fac 7b6e 7d7b +1fae 1fad 7a49 8d39 +1fad 1faf 7a4b 7ec6 +1fad 2291 7ec6 8dcd +2295 1fad 8d39 8dcd +20d5 1fae 7d7b 8d50 +1fae 2295 8d39 8df5 +271c 1fae 8d50 8df5 +1faf 1fb0 7a4c 8d27 +2291 1faf 7ec6 7ecc +2296 1faf 7ecc 8d27 +1fb0 1fb1 7a4d 8c3e +20d6 1fb0 7ece 8c3e +1fb0 2296 7ece 8d27 +1fb2 1fb1 7a4f 7b74 +1fb1 1fb3 7a4f 7b73 +1fb1 20d6 7b73 8c3e +1fb3 1fb2 7a4f 7a51 +1fb2 1fb4 7a50 7f7a +1fb5 1fb2 7a51 7f7a +1fb3 1fb5 7a51 81e1 +20d6 1fb3 7b73 81e3 +2297 1fb3 81e3 8c28 +1fb3 2424 8bd3 8c28 +1fb3 2425 81e1 8bd3 +1fb4 1fb5 7ecf 7f7a +1fb4 1fb6 7a52 7f7b +2298 1fb4 7ecf 7f7b +1fb5 2298 7ecf 81e6 +1fb5 2422 81e6 8bae +2425 1fb5 81e1 8bae +1fb6 1fb7 7a53 7f7c +1fb6 2298 7ed0 7f7b +2299 1fb6 7ed0 7f7c +1fb7 1fb8 7a54 7f7d +1fb7 2299 7ed2 7f7c +229b 1fb7 7ed2 7f7d +1fb8 1fb9 7a55 7f7e +229a 1fb8 7ed1 7f7e +1fb8 229b 7ed1 7f7d +1fb9 1fba 7a56 7f7f +1fb9 229a 7ed4 7f7e +229d 1fb9 7ed4 7f7f +1fba 1fbb 7a57 7f80 +20d8 1fba 7ed6 7f80 +1fba 229d 7ed6 7f7f +1fbb 1fbc 7a58 7f82 +20d7 1fbb 7b7e 7f82 +1fbb 20d8 7b7e 7f80 +1fbc 1fbd 7a59 7f83 +1fbc 20d7 7ed8 7f82 +20da 1fbc 7ed8 7f83 +1fbd 1fbe 7a5a 7f84 +20d9 1fbd 7b80 7f84 +1fbd 20da 7b80 7f83 +1fbe 1fbf 7a5b 7f85 +1fbe 20d9 7ed9 7f84 +20db 1fbe 7ed9 7f85 +1fbf 1fc0 7a5c 7f86 +1fc3 1fbf 7b82 7f86 +1fbf 20db 7b82 7f85 +1fc0 1fc1 7a5d 7f87 +1fc2 1fc0 7a5e 7f87 +1fc0 1fc3 7a5e 7f86 +1fc1 1fc2 7a60 7f87 +1fc1 1fc4 7a5f 7f88 +1fc5 1fc1 7a60 7f88 +1fc3 1fc2 7a5e 8268 +1fc2 1fc5 7a60 826a +22a1 1fc2 7eda 826a +1fc2 22a2 7eda 8268 +20db 1fc3 7b82 8267 +22a2 1fc3 81ef 8268 +1fc3 242b 81ef 8267 +1fc4 1fc5 7a62 7f88 +1fc4 1fc6 7a61 7f89 +1fc7 1fc4 7a62 7f89 +1fc5 1fc7 7a62 826b +1fc5 22a1 81f0 826a +2317 1fc5 81f0 826b +1fc6 1fc7 7edb 7f89 +1fc6 1fc8 7a63 7f8b +22a3 1fc6 7edb 7f8b +1fc7 22a3 7edb 826c +22a5 1fc7 7f8a 826c +1fc7 2317 7f8a 826b +1fc8 22a3 7edc 7f8b +1fc9 1fca 7a66 7f8e +1fcb 1fc9 7a67 7f8e +1fca 1fcb 7ee0 7f8e +1fca 1fcc 7a68 7f8f +22a8 1fca 7ee0 7f8f +1fcb 22a7 7f90 826f +1fcb 22a8 7ee0 8270 +2318 1fcb 7f90 8270 +1fcc 1fcd 7a69 7f91 +1fcc 22a8 7ee1 7f8f +22a9 1fcc 7ee1 7f91 +1fcd 1fce 7a6a 7f93 +1fcd 22a9 7ee2 7f91 +22aa 1fcd 7ee2 7f93 +1fce 1fcf 7a6b 7f94 +1fce 22aa 7ee4 7f93 +22ad 1fce 7ee4 7f94 +1fcf 1fd0 7a6c 7f96 +1fcf 22ad 7ee5 7f94 +22ae 1fcf 7ee5 7f96 +1fd0 1fd1 7a6d 7f97 +1fd0 22ae 7ee7 7f96 +22b1 1fd0 7ee7 7f97 +1fd1 1fd2 7a6f 7f98 +1fd1 22b1 7ee9 7f97 +22b3 1fd1 7ee9 7f98 +1fd2 22b3 7eeb 7f98 +1fd3 1fd4 7a71 7f9c +1fd5 1fd3 7eed 7f9c +1fd4 1fd5 7a72 7f9c +1fd6 1fd4 7a72 7f9d +1fd4 1fd7 7a73 7f9d +1fd5 1fd6 7a72 827a +1fd5 22b6 81f1 8279 +242e 1fd5 81f1 827a +1fd7 1fd6 7a74 7f9d +1fd6 1fd8 7a74 827b +1fd6 242e 81f2 827a +242f 1fd6 81f2 827b +1fd8 1fd7 7a74 7f9e +1fd7 1fd9 7a75 7f9e +1fd9 1fd8 7eef 7f9e +1fd8 22b7 7eef 827c +1fd8 242f 81f3 827b +2430 1fd8 81f3 827c +1fd9 1fda 7a76 7f9f +22b7 1fd9 7eef 7f9f +1fda 1fdb 7a77 7b98 +1fda 20dc 7b98 7fa1 +22b7 1fda 7f9f 7fa1 +1fdb 1fdc 7a78 7fa2 +20dc 1fdb 7b98 7ef1 +20dd 1fdb 7ef1 7fa2 +1fdd 1fdc 7b9d 7fa4 +1fdc 20dd 7b9d 7fa2 +1fdd 1fde 7a7a 88f6 +20dd 1fdd 7b9d 827f +1fdd 2319 81f6 827f +2433 1fdd 81f6 88f6 +22bb 1fde 81f7 81f8 +1fde 231a 81f7 8917 +2433 1fde 88f6 8917 +1fdf 1fe0 7a7c 7ef2 +1fdf 22ba 7ef2 8973 +22bb 1fdf 8953 8973 +1fe0 1fe1 7a7d 7ef4 +22ba 1fe0 7ef2 8a6a +1fe0 22bc 7ef4 8a6a +1fe1 1fe2 7a7e 8a6b +22bc 1fe1 7ef4 8a6b +1fe2 1fe3 7a7f 81fd +1fe2 22bc 7ef6 8a6b +22bd 1fe2 7ef6 893f +1fe2 2435 81fd 893f +2435 1fe3 81fd 898f +1fe4 1fe5 7a82 7fa7 +1fe6 1fe4 7a83 7fa7 +1fe6 1fe5 7fa7 7fa8 +1fe5 1fe7 7a84 7ba8 +1fe5 20de 7ba8 7fa8 +1fe6 20de 7fa8 8902 +2439 1fe6 8200 8902 +1fe6 243a 8200 8981 +1fe7 1fe8 7a85 7fa9 +20de 1fe7 7ba8 7baa +20df 1fe7 7baa 7fa9 +1fe8 1fe9 7a86 7faa +1fe8 20df 7ef8 7fa9 +22be 1fe8 7ef8 7faa +1fe9 1fea 7a87 7fab +1fe9 22be 7ef9 7faa +22bf 1fe9 7ef9 7fab +1fea 1feb 7a88 7fac +1fea 22bf 7efa 7fab +22c0 1fea 7efa 7fac +1feb 1fec 7a89 7fae +1feb 22c0 7efb 7fac +22c1 1feb 7efb 7fae +1fec 1fed 7a8a 7faf +1fec 22c1 7efc 7fae +22c2 1fec 7efc 7faf +1fed 1fee 7a8b 7fb0 +1fed 22c2 7efd 7faf +22c3 1fed 7efd 7fb0 +1fee 1fef 7a8c 7fb1 +22c3 1fee 7fb0 7fb1 +1fef 1ff0 7a8d 7fb2 +1fef 22c3 7efe 7fb1 +22c4 1fef 7efe 7fb2 +1ff0 1ff1 7a8e 7fb4 +1ff0 22c4 7eff 7fb2 +22c5 1ff0 7eff 7fb4 +1ff1 1ff2 7a8f 7fb5 +1ff1 22c5 7f00 7fb4 +22c6 1ff1 7f00 7fb5 +1ff2 1ff3 7a90 7fb6 +1ff2 22c6 7f01 7fb5 +22c7 1ff2 7f01 7fb6 +1ff3 1ff4 7a91 7fb7 +1ff3 22c7 7f02 7fb6 +22c8 1ff3 7f02 7fb7 +1ff4 1ff5 7a92 7fb8 +1ff4 22c8 7f03 7fb7 +22c9 1ff4 7f03 7fb8 +1ff5 1ff6 7a93 7fb9 +1ff5 22c9 7f04 7fb8 +22ca 1ff5 7f04 7fb9 +1ff6 1ff7 7a94 7fba +1ff6 22ca 7f06 7fb9 +22cd 1ff6 7f06 7fba +1ff7 1ff8 7a95 7fbb +1ff7 22cd 7f07 7fba +22ce 1ff7 7f07 7fbb +1ff8 1ff9 7a96 7fbc +1ff8 22ce 7f09 7fbb +22d0 1ff8 7f09 7fbc +1ff9 1ffa 7a97 7fbd +20e1 1ff9 7f0a 7fbd +1ff9 22d0 7f0a 7fbc +1ffa 1ffb 7a98 7fbe +1ffc 1ffa 7f0b 7fbe +1ffa 20e1 7f0b 7fbd +1ffb 1ffc 7a99 7fbe +1ffd 1ffb 7a99 7fbf +1ffb 1fff 7bc1 7fbf +1ffc 1ffd 7a99 88fa +20e1 1ffc 7f0b 8290 +20e2 1ffc 8290 84b6 +2446 1ffc 84b6 88fa +1fff 1ffd 7a9b 7fbf +1ffd 2000 7a9b 8212 +1ffd 2445 8212 8213 +1ffd 2446 8213 88fa +1fff 1ffe 7a9c 7fc0 +1ffe 2001 7a9d 7fc1 +20e3 1ffe 7fc0 7fc1 +2000 1fff 7a9b 7bc0 +20e3 1fff 7bc0 7fc0 +2000 20e3 7bc0 88fc +2444 2000 8215 88fc +2445 2000 8212 8215 +2001 2002 7a9e 8977 +2001 20e3 7f0c 7fc1 +2001 20e4 8977 8a16 +22d1 2001 7f0c 8a16 +2002 2003 7a9f 8a17 +20e4 2002 8977 8a17 +2003 2004 7aa0 8995 +2003 20e4 7f0e 8a17 +20e5 2003 7f0e 8995 +2004 2005 7aa1 897f +2004 20e5 7f11 8995 +22d2 2004 7f11 89a1 +2004 22d4 897f 89a1 +2005 2006 7aa2 7f14 +22d3 2005 7f10 7f14 +2005 22d4 7f10 897f +2006 2007 7aa3 8a38 +22d3 2006 7f14 895f +22d7 2006 895f 8a38 +2007 2008 7aa4 8955 +22d5 2007 7f1a 8955 +2007 22d7 7f19 8a38 +2008 2009 7aa5 89be +2008 22d5 7f17 8955 +22d6 2008 7f17 89be +2009 200a 7aa6 8a1a +2009 22d6 7f1c 89be +22d8 2009 7f1c 8a1a +200a 200b 7aa7 8a1d +22d8 200a 8a1a 8add +200a 22da 8a1d 8add +200b 200c 7aa8 7f20 +22d9 200b 7f1f 7f20 +200b 22da 7f1f 8a1d +200c 200d 7aa9 8b4e +22d9 200c 7f20 8a0b +22db 200c 8a0b 8b4e +200d 200e 7aaa 89e7 +200d 22db 7f22 8b4e +22dc 200d 7f22 7f23 +22dd 200d 7f23 89e7 +200e 200f 7aab 8b00 +22dd 200e 89e7 8b00 +200f 22dd 8779 8b00 +200f 26c0 8778 8779 +2011 2010 7aae 7ab0 +2010 2012 7aae 7bd6 +2010 20e6 7bd6 8369 +2012 2011 7aae 85c1 +2011 2013 7ab1 85c1 +2013 2012 807f 85c1 +20e6 2012 7bd6 8366 +216e 2012 807e 807f +2012 2170 807e 85c2 +23aa 2012 8366 85c2 +2013 216e 7caa 807f +2015 2014 7ab2 8b7d +2014 2016 7ab2 8319 +215e 2014 7c9b 8319 +2014 215f 7c9c 8b7d +2016 2015 7ab2 8d54 +2015 215f 8b7d 8c68 +2160 2015 8b3f 8c68 +2162 2015 7c9f 8b3f +2015 2163 7c9f 8c69 +2015 2715 8c69 8d54 +215e 2016 8319 8ac2 +2707 2016 8ac2 8b7c +2710 2016 8b7c 8ca7 +2715 2016 8ca7 8d54 +2018 2017 7ab3 8e0d +2017 2019 7ab3 7ab4 +2017 201a 7ab4 8e2b +2017 271e 8e2b 8e75 +271f 2017 8e0d 8e75 +2019 2018 7ab3 8e8c +2018 24c6 8e74 8e89 +2018 271f 8e0d 8e74 +2018 2731 8e89 8ef3 +2733 2018 8e8c 8ef3 +201a 2019 7ab4 8e8d +2019 2733 8e8c 8ef2 +2734 2019 8e62 8ef2 +2019 2752 8e62 8e8d +2020 201a 7ab7 8ecb +201a 271e 8c77 8e2b +201a 2747 8dda 8ecb +2752 201a 8dda 8e8d +201c 201b 7ab5 8ef7 +201b 201d 7ab5 8f20 +201b 201e 7ab6 8ef7 +201f 201b 7ab6 8f05 +201d 201c 7ab5 8f21 +201c 201e 8ef7 8f08 +201c 24ca 8f1a 8f21 +201c 270d 8b60 8f1a +270e 201c 8b60 8f08 +24ca 201d 8317 8f21 +201e 201f 7ab6 8f1e +201e 270e 8cd5 8f08 +2734 201e 8cd5 8efa +273f 201e 8df2 8f1e +201e 2755 8df2 8efa +201f 2721 8c76 8f04 +201f 273f 8f04 8f1e +2020 202f 8e77 8eca +2020 2746 8d21 8e77 +2747 2020 8d21 8ecb +2022 2021 7ab8 8ea8 +2021 2023 7ab8 8e25 +2027 2021 8d0e 8e71 +2028 2021 8e71 8f0e +202b 2021 8f0e 8f12 +2021 202c 8e25 8f12 +2721 2021 8ea8 8f1f +2021 273f 8d0e 8f1f +2023 2022 7ab8 8f11 +2022 2721 8ea8 8f10 +202c 2023 8e25 8f13 +2023 202e 8ea9 8f13 +2025 2024 7ab9 8ed5 +2024 2026 7ab9 8d20 +2030 2024 8d94 8ddf +2031 2024 8ddf 8ed4 +2024 2745 8d20 8ed4 +2024 274d 8d94 8ed5 +2026 2025 7ab9 8edd +2025 202b 8e1d 8f00 +2025 2032 8e42 8edd +274d 2025 8ead 8ed5 +274f 2025 8e42 8f00 +2753 2025 8e1d 8ead +2032 2026 7ac0 8edd +2026 2033 7ac0 8ee7 +273a 2026 8e20 8ee7 +2745 2026 8d20 8e20 +2028 2027 7aba 8e71 +2027 2029 7aba 8efb +273f 2027 8d0e 8ed7 +2755 2027 8ed7 8efb +2029 2028 7aba 8f0f +202b 2028 8ece 8f0e +2028 2753 8ece 8f0f +2747 2029 8e76 8e9e +2029 2752 8e76 8ed6 +2753 2029 8e9e 8f0f +2029 2755 8ed6 8efb +202b 202a 7abb 8ecf +202a 202c 7abb 8f0a +202a 202d 7abe 8eeb +202e 202a 7abe 8f0a +202a 2727 8eeb 8f01 +274f 202a 8ecf 8f01 +202c 202b 7abb 8f12 +202b 274f 8ecf 8f00 +202b 2753 8e1d 8ece +202e 202c 8f0a 8f13 +202e 202d 7abc 7abe +202d 2727 8ed2 8eeb +2728 202d 8ed2 8f22 +2030 202f 7abd 8e46 +2746 202f 8e46 8e77 +2031 2030 7abf 8ddf +2030 2746 8e46 8eac +274d 2030 8d94 8eac +2745 2031 8e80 8ed4 +2033 2032 7ac0 8ee8 +2032 2727 8db8 8edc +2032 273b 8edc 8ee8 +274f 2032 8db8 8e42 +2035 2033 7ac3 8ea4 +2033 2036 7ac3 8e43 +2033 273a 8e43 8ee7 +273b 2033 8ec7 8ee8 +2757 2033 8ea4 8ec7 +2038 2034 8eb5 8f1c +2034 203a 8eb5 8f1d +2729 2034 8db9 8f1d +2036 2035 7ac3 8e3c +203b 2035 8e3c 8ee5 +2035 2743 8ec6 8ee5 +2035 2757 8ea4 8ee4 +2758 2035 8ec6 8ee4 +2036 203b 8e3c 8ea5 +2739 2036 8ce0 8ea5 +2036 273a 8ce0 8e43 +2038 2037 7ac4 8f19 +2037 2039 8eb4 8f19 +2037 203e 7ac7 8e3d +203f 2037 7ac7 8f02 +2041 2037 8f02 8f0d +2037 2758 8e3d 8eb4 +2039 2038 7ac5 8f19 +2038 203a 7ac5 8eb5 +203a 2039 7ac5 8f18 +2039 2757 8eb0 8f18 +2758 2039 8eb0 8eb4 +203a 2729 8ce1 8f1d +273b 203a 8ce1 8e39 +2757 203a 8e39 8f18 +203c 203b 7ac6 8e55 +203b 203d 7ac6 8e21 +203b 2739 8e21 8ea5 +2743 203b 8d12 8ee5 +203b 2744 8d12 8e55 +203d 203c 7ac6 8e7b +2738 203c 8cdf 8eb3 +203c 2744 8e55 8eb3 +2739 203d 8e21 8e7a +203e 203f 7ac7 8ecc +2740 203e 8e3f 8e9d +203e 2743 8e3f 8ecd +2749 203e 8e9d 8ecc +2758 203e 8e3d 8ecd +2040 203f 8cde 8f0c +203f 2041 8f02 8f0c +203f 2737 8cde 8d28 +203f 2749 8d28 8ecc +2041 2040 7ac8 8f0c +2737 2040 8cde 8e3e +2042 2737 8e6e 8eff +2042 274a 8d29 8efe +2754 2042 8e6e 8efe +2044 2043 7acb 8eae +2043 2045 7acb 8edf +2046 2043 7acc 8edf +2043 2047 7acc 8ede +2048 2043 8eae 8ede +2045 2044 7acb 8ed1 +2048 2044 7acd 8eae +2044 2049 7acd 8eab +2044 2741 8e40 8ed1 +2742 2044 8e40 8eab +2045 2046 8ec9 8edf +2045 204a 8e41 8ec9 +2741 2045 8e9c 8ed1 +2754 2045 8e41 8e9c +2047 2046 7acc 8e5b +204a 2046 7ace 8ec9 +2046 204b 7ace 8e5e +2046 204c 8e17 8e5b +204d 2046 7ad5 8e5e +2046 2051 7ad5 8e17 +2047 2048 8e16 8ede +204c 2047 7acf 8e5b +2049 2048 7acd 8cdd +2049 2738 8d10 8e6b +2049 2742 8e6b 8eab +204b 204a 7ace 8ec8 +204a 274a 8de6 8ec8 +2754 204a 8de6 8e41 +204b 204d 7ad2 8e5e +204e 204b 7ad2 8e83 +204b 2736 8cdc 8e83 +274a 204b 8e6f 8ec8 +2051 204c 8da5 8e17 +204c 272f 8da5 8e01 +204d 204e 7ad2 8e5f +2051 204d 7ad5 8da4 +273d 204d 8da4 8e5f +204e 2050 8db1 8e7d +2736 204e 8db1 8e83 +273d 204e 8e5f 8e7d +2050 204f 7ad3 8e9b +204f 2730 8cd1 8e9a +204f 273e 8e8e 8e9b +274e 204f 8e8e 8e9a +2050 2736 8db1 8e82 +273d 2050 8e7d 8e90 +273e 2050 8e90 8e9b +2054 2051 8cd0 8e7c +2051 272f 8cd0 8da5 +2051 273d 8da4 8e7c +2053 2052 7ad6 8c72 +2052 2054 7ad6 8e48 +2057 2052 8d84 8e49 +2058 2052 8c72 8d84 +273d 2052 8cf8 8e48 +2052 273e 8cf8 8db0 +2052 274e 8db0 8e49 +2054 2053 7ad6 8d01 +2053 2058 8c72 8dbe +272f 2053 8d01 8e00 +272f 2054 8cd0 8d01 +273d 2054 8e48 8e7c +2056 2055 7ad8 8dc3 +2055 2057 7ad8 7ae0 +2055 205a 7ae0 8c99 +2055 205b 8d81 8dc3 +2055 205e 8c99 8daf +2060 2055 8c32 8daf +2057 2056 7ad8 8e59 +2056 2058 7ad9 8e59 +2056 205b 8dc3 8e58 +2058 2057 8d84 8e59 +2057 2059 8d96 8dec +205a 2057 7ae0 8dec +274e 2057 8d96 8e49 +2059 205a 7adb 8dec +2730 2059 8cf9 8ded +2059 274e 8d96 8ded +205a 205e 8c73 8c99 +205e 205c 7adf 8d9f +205c 205f 7ae1 8cbc +205c 2062 8cbc 8d9f +2060 205d 8c98 8dae +205d 2061 8d1c 8d5c +205d 2062 8c98 8d1c +205e 2060 8d80 8daf +2062 205e 8d80 8d9f +2061 205f 7ae3 8d5d +205f 2062 7ae3 8cbc +2063 205f 8d5d 8d8a +205f 2065 8cbd 8d8a +2062 2060 8c98 8d80 +2062 2061 7ae3 8d1c +2063 2061 7ae4 8d5d +2061 2064 7ae4 7ae5 +2064 2063 7ae4 8d90 +2065 2063 7ae6 8d8a +2063 2066 7ae6 8c59 +2066 2065 7ae6 8cac +2067 2066 7ae9 8c58 +2066 2068 7ae9 8d40 +2068 2067 7ae9 8d45 +2067 2069 7aea 8d45 +2069 2068 8d41 8d45 +22de 2068 8ccf 8d41 +2069 206c 7f25 8b3c +2069 22de 8b3c 8d41 +206b 206a 7aeb 8b3d +206a 206c 7aeb 8c70 +206a 206d 7aec 8a34 +206a 22df 8a34 8b3d +206c 206b 7aeb 8c71 +22de 206b 8c71 8cce +22df 206b 7f26 8b3d +22de 206c 8b3c 8c71 +206d 206e 7aee 7f27 +206d 2071 7f27 821c +22df 206d 8a34 8b50 +206d 22e1 821c 8b50 +206e 206f 7aef 7fc2 +2070 206e 7af0 7fc2 +206e 2071 7af0 7f27 +206f 2070 7f29 7fc2 +206f 2072 7af1 7fc3 +22e3 206f 7f29 7fc3 +2071 2070 7af0 8a37 +2070 22e3 7f29 8217 +2070 2447 8217 8218 +2070 2448 8218 8a37 +22e1 2071 821c 8b51 +2071 2448 8a37 8b51 +2072 2073 7af2 7fc4 +2072 22e3 7f2b 7fc3 +22e4 2072 7f2b 7fc4 +2073 2074 7af3 7fc5 +20e7 2073 7f2a 7fc5 +2073 22e4 7f2a 7fc4 +2074 2075 7af4 7fc6 +2078 2074 7be0 7fc6 +2074 20e7 7be0 7fc5 +2075 2076 7af5 7fc7 +2077 2075 7af6 7fc7 +2075 2078 7af6 7fc6 +2076 2077 7af8 7fc7 +2076 2079 7af7 7fc8 +207a 2076 7af8 7fc8 +2078 2077 7af6 8294 +2077 207a 7af8 8295 +22e5 2077 7f2c 8295 +2077 22e6 7f2c 8294 +20e7 2078 7be0 8293 +22e6 2078 8222 8294 +2078 244e 8222 8293 +2079 207a 7f2d 7fc8 +2079 207b 7af9 7fca +22e7 2079 7f2d 7fca +207a 22e5 7fc9 8295 +207a 22e7 7f2d 8296 +22ea 207a 7fc9 8296 +207b 207c 7afa 7fcb +207b 22e7 7f2e 7fca +22e8 207b 7f2e 7fcb +207c 207d 7afb 7fcc +207c 22e8 7f30 7fcb +22eb 207c 7f30 7fcc +207d 207e 7afc 7fcd +207d 22eb 7f32 7fcc +22ed 207d 7f32 7fcd +207e 207f 7afd 7fce +207e 22ed 7f34 7fcd +22ef 207e 7f34 7fce +207f 2080 7afe 7fcf +207f 22ef 7f36 7fce +22f1 207f 7f36 7fcf +2080 2081 7aff 7fd0 +2080 22f1 7f38 7fcf +22f3 2080 7f38 7fd0 +2081 2082 7b00 7fd1 +2081 22f3 7f3a 7fd0 +22f5 2081 7f3a 7fd1 +2082 2083 7b01 7fd2 +2082 22f5 7f3c 7fd1 +22f7 2082 7f3c 7fd2 +2083 2084 7b02 7fd3 +20e8 2083 7f3e 7fd3 +2083 22f7 7f3e 7fd2 +2084 2085 7b03 7fd4 +2089 2084 7bef 7fd4 +2084 20e8 7bef 7fd3 +2085 2087 7b05 7fd5 +2088 2085 7b06 7fd5 +2085 2089 7b06 7fd4 +2087 2086 7b04 7fd6 +2086 208a 7b07 7fd8 +2086 22fa 7f41 7fd6 +22fb 2086 7f41 7fd8 +2087 2088 7f40 7fd5 +22fa 2087 7f40 7fd6 +2089 2088 7b06 82a1 +2088 22fa 7f40 82a2 +2088 231f 8225 82a1 +2450 2088 8225 82a2 +20e8 2089 7bef 82a0 +231f 2089 8224 82a1 +208a 208b 7b08 7fd9 +208e 208a 7f42 7fd9 +208a 22fb 7f42 7fd8 +208b 208c 7b09 7fda +208d 208b 7b0a 7fda +208b 208e 7b0a 7fd9 +208d 208c 7fda 7fdb +208c 208f 7b0b 7fdb +208e 208d 7b0a 84d5 +208d 208f 7fdb 8931 +2452 208d 8227 88de +208d 2453 8227 84d5 +2458 208d 88de 8931 +22fb 208e 7f42 82a4 +2451 208e 82a4 88f0 +208e 2453 84d5 88f0 +208f 2090 7b0c 822c +208f 2458 822c 8931 +2090 2091 7b0d 8228 +2090 2454 8228 89aa +2458 2090 822c 89aa +2091 2092 7b0e 822e +2091 22fc 822e 89ab +2454 2091 8228 89ab +2092 2093 7b0f 7f43 +2092 20e9 7f43 8963 +22fc 2092 822e 8963 +2093 2094 7bfa 7fdc +2097 2093 7bfc 7fdc +2093 20e9 7bfc 7f43 +2094 2095 7b11 7fdd +2096 2094 7b12 7fdd +2094 2097 7b12 7fdc +2096 2095 7fdd 7fde +2095 2098 7b13 7f45 +2095 22ff 7f45 7fde +2097 2096 7b12 8938 +22ff 2096 7f47 7fde +2096 2301 7f47 84da +2096 2456 84d9 8938 +25c3 2096 84d9 84da +20e9 2097 7bfc 8906 +2456 2097 8906 8938 +2098 2099 7b14 7fdf +22ff 2098 7f45 7f46 +2300 2098 7f46 7fdf +2099 209a 7b15 7fe1 +2099 2300 7f48 7fdf +2302 2099 7f48 7fe1 +209a 209b 7b16 7fe2 +209a 2302 7f49 7fe1 +2303 209a 7f49 7fe2 +209b 2303 7f4a 7fe2 +209c 209d 7b19 7fe6 +209d 209e 7b1a 7fe7 +2304 209d 7f4b 7fe7 +209e 209f 7b1b 7fe8 +209e 2304 7f4d 7fe7 +2305 209e 7f4d 7fe8 +209f 20a0 7b1c 7fe9 +20a1 209f 7f4c 7fe9 +209f 2305 7f4c 7fe8 +20a0 20a1 7b1d 7fe9 +20a2 20a0 7b1d 7fea +20a0 20a3 7b1e 7fea +20a1 20a2 7b1d 82ad +2305 20a1 7f4c 82ac +20a1 245f 8237 82ac +2462 20a1 8237 82ad +20a3 20a2 7b1f 7fea +20a2 20a4 7b1f 82ae +20a2 2462 8238 82ad +2463 20a2 8238 82ae +20a4 20a3 7b1f 7feb +20a3 20a5 7b20 7feb +20a5 20a4 7b21 7feb +20a4 20a6 7b21 82b0 +20a4 2463 8239 82ae +2464 20a4 8239 82b0 +20a6 20a5 7b21 7fec +20a5 20a7 7b22 7fec +20a7 20a6 7b23 7fec +20a6 20a8 7b23 82b1 +20a6 2464 823b 82b0 +2467 20a6 823b 82b1 +20a8 20a7 7b23 7fed +20a7 20a9 7b24 7fed +20a9 20a8 7b25 7fed +20a8 20aa 7b25 82b2 +20a8 2467 823c 82b1 +2468 20a8 823c 82b2 +20aa 20a9 7b25 7fee +20a9 20ab 7b26 7fee +20ab 20aa 7b27 7fee +20aa 20ac 7b27 82b3 +20aa 2468 823d 82b2 +2469 20aa 823d 82b3 +20ac 20ab 7b27 7fef +20ab 20ad 7b28 7fef +20ad 20ac 7b29 7fef +20ac 20ae 7b29 82b4 +20ac 2469 823e 82b3 +246a 20ac 823e 82b4 +20ae 20ad 7b29 7ff0 +20ad 20af 7b2a 7ff0 +20af 20ae 7b2b 7ff0 +20ae 20b0 7b2b 82b5 +20ae 246a 823f 82b4 +246b 20ae 823f 82b5 +20b0 20af 7b2b 7ff1 +20af 20b1 7b2c 7ff1 +20b1 20b0 7b2d 7ff1 +20b0 20b2 7b2d 82b6 +20b0 246b 8241 82b5 +246e 20b0 8241 82b6 +20b2 20b1 7b2d 7ff2 +20b1 20b3 7b2e 7ff2 +20b3 20b2 7f4e 7ff2 +20b2 2306 7f4e 82b8 +20b2 246e 8243 82b6 +2470 20b2 8243 82b8 +20b3 20b4 7b2f 7ff3 +2306 20b3 7f4e 7ff3 +20b4 20b5 7b30 7ff4 +20b4 2306 7f4f 7ff3 +2307 20b4 7f4f 7ff4 +20b5 20b6 7b31 7ff5 +20b5 2307 7f50 7ff4 +2308 20b5 7f50 7ff5 +20b6 20b7 7b32 7ff6 +20b6 2308 7f51 7ff5 +2309 20b6 7f51 7ff6 +20b7 20b8 7b33 7ff7 +20b7 2309 7f52 7ff6 +230a 20b7 7f52 7ff7 +20b8 20b9 7b34 7ff9 +20b8 230a 7f54 7ff7 +230c 20b8 7f54 7ff9 +20b9 20ba 7b35 7ffa +20bc 20b9 7f56 7ffa +20b9 230c 7f56 7ff9 +20ba 20bc 7f53 7ffa +20ba 20be 7b37 7ffb +230b 20ba 7f53 7ffb +20bc 20bb 7b36 82bf +20bb 20bd 7b36 84ec +20bb 230c 7f55 82bf +230d 20bb 7f55 8910 +20bb 25cc 84ec 84ee +20bb 25cf 84ee 8910 +20bd 20bc 7b36 82c0 +20bc 230b 7f53 82c0 +230c 20bc 7f56 82bf +20bd 230b 82c0 899a +25cc 20bd 84ec 895d +25cd 20bd 895d 8a21 +20bd 25ce 899a 8a21 +20be 20bf 7b38 7f57 +230b 20be 7ffb 7ffc +20be 230e 7f57 7ffc +20bf 20c0 7b39 7ffd +230e 20bf 7f57 7f58 +230f 20bf 7f58 7ffd +20c0 20c1 7b3a 8ab6 +230f 20c0 7ffd 897d +2310 20c0 897d 8ab6 +20c1 20c2 7b3b 7f5b +20c1 2310 7f5a 8ab6 +2311 20c1 7f5a 7f5b +20c2 20c4 8b41 8bf0 +2311 20c2 7f5b 8b79 +2312 20c2 8b79 8bf0 +20c4 20c3 7b3c 7b3d +20c3 20c5 7b3c 8d8c +20c3 20c7 7b3f 7b40 +20c8 20c3 7b3f 8d8c +20c3 20c9 7b40 8d0b +20c5 20c4 7b3c 8d04 +20c4 2312 7f5e 8bf0 +20c5 20c8 8d05 8d8c +20c6 20c7 8d70 8db7 +20c6 20ca 7b41 8db6 +2720 20c6 8d70 8db6 +20c7 20c8 7b3f 8d8d +20c9 20c7 7b40 8c6f +2720 20c7 8c6f 8d70 +20cb 20c9 7b42 8d0a +20c9 2720 8c6f 8d0a +20d2 20ca 8c88 8e2f +20ca 271d 8c5d 8e2f +2720 20ca 8db6 8dfe +20ca 2726 8c88 8dfe +20cb 2720 8d0a 8d56 +2726 20cb 8d0d 8d56 +20cd 20cc 7b43 8c89 +20cc 20ce 8ca3 8dc9 +20cc 20d0 7b47 8d2e +20d3 20cc 8c89 8dc9 +20cc 2712 8d2e 8dd7 +272e 20cc 8ca3 8dd7 +20d2 20cd 8dc8 8e4c +20cd 20d3 8c89 8e4c +20cd 271d 8dc8 8e4d +20cf 20ce 7b45 8bb2 +20d2 20ce 7b49 8be1 +20ce 20d3 7b49 8dc9 +2711 20ce 8bb2 8cf5 +2723 20ce 8cf5 8dd6 +20ce 272e 8ca3 8dd6 +20cf 2711 8bb2 8d87 +20d0 20d1 7b48 8de9 +2712 20d0 8d2e 8de9 +20d1 226c 7ea5 8bb3 +20d1 2712 8bb3 8de9 +20d3 20d2 7b49 8e4c +271d 20d2 8dc8 8e2f +2726 20d2 8c88 8dff +20d4 2266 7f78 8186 +228e 20d4 8184 8186 +228f 20d5 7ec7 8df4 +20d5 2290 7ec7 8dfd +20d5 271c 8d50 8df4 +2296 20d6 7ece 81e4 +20d6 2297 81e3 8c3f +20d8 20d7 7b7e 8261 +20d7 20da 7ed8 8262 +20d7 229f 81ea 8261 +2428 20d7 81ea 8262 +229d 20d8 7ed6 7f81 +229f 20d8 7ed7 8261 +20d8 22a0 7ed7 7f81 +20da 20d9 7b80 8263 +20d9 20db 7ed9 8265 +20d9 2429 81ec 8263 +242a 20d9 81ec 8265 +20da 2428 81eb 8262 +2429 20da 81eb 8263 +20db 242a 81ed 8265 +242b 20db 81ed 8267 +20dc 20dd 7ef1 827e +22b7 20dc 7fa1 81f4 +20dc 22b8 7ef0 81f4 +22b9 20dc 7ef0 827e +20dd 22b9 7fa0 827e +2319 20dd 7fa0 827f +20de 20df 7baa 88b4 +20de 2439 8203 8902 +243b 20de 8203 88b4 +20df 22be 7ef8 8205 +20df 243b 8204 88b4 +243c 20df 8204 8205 +20e1 20e0 7bbe 828f +20e0 20e2 7bbe 887c +20e0 22d0 8210 828f +2443 20e0 8210 84b5 +25a4 20e0 84b5 891c +20e2 20e1 7bbe 8290 +22d0 20e1 7f0a 828f +20e2 2446 84b6 88c2 +20e3 22d1 7f0c 895b +2444 20e3 88fc 895b +20e5 20e4 7bc3 7f0e +20e4 22d1 8994 8a16 +20e5 22d2 7f11 7f12 +20e6 23aa 8366 85c4 +20e6 262b 85c4 8783 +22e4 20e7 7f2a 8292 +20e7 244a 8220 8292 +244e 20e7 8220 8293 +22f7 20e8 7f3e 829f +20e8 22f9 8223 829f +20e9 22fc 88d5 8963 +20e9 22fd 822a 88d5 +2456 20e9 822a 8906 +20eb 20ea 7c1e 7ffe +20ea 20ee 7c21 8001 +2326 20ea 7ffe 8002 +20ea 2327 8001 8bd6 +2328 20ea 8002 8bd6 +20ec 20eb 7c1f 8d69 +20eb 2326 7ffe 8c61 +20ec 2182 8003 8caf +20ed 217f 8cb7 8d30 +2180 20ed 7cbd 8d30 +2181 20ed 8cae 8cb6 +2182 20ed 8cb6 8d83 +20ee 20ef 7cc3 8004 +2327 20ee 8001 8c44 +20ee 2329 8004 8c44 +20ef 20f0 7c22 8bed +2329 20ef 8004 8ce4 +20ef 232b 8bed 8ce4 +20f0 20f1 7c23 8bee +20f0 232a 8009 8ce5 +232b 20f0 8bed 8ce5 +20f2 20f3 7c27 7c28 +20f2 20f4 7c28 800b +20f4 20f3 7c28 8086 +20f3 20f6 7c2a 8086 +20f6 20f4 7c2b 8086 +20f4 20f7 7c2b 82c3 +20f4 232d 82c3 8baa +20f4 232e 8baa 8c2d +232f 20f4 800c 8c2d +20f6 20f5 7c2c 8087 +20f5 20f7 7c2d 8087 +20f7 20f6 7c2b 8087 +232d 20f7 82c3 8ba8 +2480 20f7 8ba8 8c3a +20f8 20f9 7c2f 808a +2330 20f8 800d 808a +20f9 20fa 7c30 808b +20f9 2330 800f 808a +2332 20f9 800f 808b +20fa 20fb 7c31 808c +20fa 2332 8010 808b +2333 20fa 8010 808c +20fb 20fc 7c32 808d +20fb 2333 8011 808c +2334 20fb 8011 808d +20fc 2334 8012 808d +2335 20fc 8012 808f +20fd 20fe 7c36 8091 +2337 20fe 82d1 8ba4 +20fe 248a 854f 8ba4 +20ff 2100 7c39 8094 +2338 20ff 8014 8094 +2100 2101 7c3a 8095 +2100 2338 8015 8094 +2339 2100 8015 8095 +2101 2102 7c3b 8096 +2101 2339 8016 8095 +233a 2101 8016 8096 +2102 2103 7c3c 8097 +2102 233a 8018 8096 +233d 2102 8018 8097 +2103 2104 7c3d 8098 +2103 233d 801a 8097 +233f 2103 801a 8098 +2104 2105 7c3e 8099 +2104 233f 801b 8098 +2340 2104 801b 8099 +2105 2106 7c3f 809a +2105 2340 801c 8099 +2341 2105 801c 809a +2106 2107 7c40 809b +2106 2341 801d 809a +2342 2106 801d 809b +2107 2108 7c41 809c +2107 2342 801f 809b +2345 2107 801f 809c +2108 2109 7c42 809d +2108 2345 8022 809c +2349 2108 8022 809d +2109 210a 7c43 809e +2109 2349 8024 809d +234b 2109 8024 809e +210a 210b 7c44 809f +2348 210a 8026 809f +210a 234b 8026 809e +210b 210c 7c45 80a0 +2347 210b 8021 80a0 +210b 2348 8021 809f +210c 210d 7c46 80a1 +210c 2347 8027 80a0 +234d 210c 8027 80a1 +210d 210e 7c47 80a2 +210d 234d 8028 80a1 +234e 210d 8028 80a2 +210e 210f 7c48 80a3 +210e 234e 8029 80a2 +234f 210e 8029 80a3 +210f 2110 7c49 80a5 +210f 234f 802a 80a3 +2350 210f 802a 80a5 +2110 2111 7c4a 80a6 +2110 2350 802b 80a5 +2351 2110 802b 80a6 +2111 2112 7c4b 80a7 +2111 2351 802d 80a6 +2354 2111 802d 80a7 +2112 2113 7c4c 80a8 +2112 2354 802f 80a7 +2356 2112 802f 80a8 +2113 2114 7c4d 80aa +2113 2356 8030 80a8 +2357 2113 8030 80aa +2114 2115 7c4e 80ab +2114 2357 8032 80aa +2359 2114 8032 80ab +2115 2116 7c4f 80ac +2115 2359 8033 80ab +235a 2115 8033 80ac +2116 2117 7c50 80ad +2116 235a 8035 80ac +235d 2116 8035 80ad +2117 2118 7c51 80ae +2117 235d 8036 80ad +235e 2117 8036 80ae +2118 2119 7c52 80af +2118 235e 8037 80ae +235f 2118 8037 80af +2119 211a 7c53 80b0 +2119 235f 8039 80af +2360 2119 8039 80b0 +211a 211b 7c54 80b1 +211a 2360 803a 80b0 +2362 211a 803a 803c +2364 211a 803c 80b1 +211b 211c 7c55 80b2 +211b 2364 803d 80b1 +2365 211b 803d 80b2 +211c 211d 7c56 80b3 +211c 2365 803f 80b2 +2368 211c 803f 80b3 +211d 211e 7c57 80b4 +211d 2368 8041 80b3 +236a 211d 8041 80b4 +211e 211f 7c58 80b5 +211e 236a 8043 80b4 +211f 2120 7c59 80b6 +236c 211f 8044 80b6 +2120 2121 7c5a 80b7 +2120 236c 8045 80b6 +236d 2120 8045 80b7 +2121 2122 7c5b 80b8 +2121 236d 8046 80b7 +236e 2121 8046 80b8 +2122 2123 7c5c 80b9 +2122 236e 8048 80b8 +2370 2122 8048 80b9 +2123 2124 7c5d 80bb +2123 2183 80bb 80bc +2370 2123 80b9 80bc +2124 2125 7c5e 8049 +2128 2124 7cfc 8049 +2124 2183 7cfc 80bb +2125 2126 7c5f 80bd +2127 2125 7c60 80bd +2125 2128 7c60 8049 +2126 2127 7c62 80bd +2128 2127 7c60 82e8 +2127 23a8 80ba 82e8 +2183 2128 7cfc 8c1a +2128 23a8 82e8 8beb +2128 2498 82e7 8c1a +2499 2128 82e7 8beb +2129 212a 7c64 80c0 +212a 212b 7c65 8bdf +2371 212a 804b 8bdf +212b 212c 7c66 804d +212b 2371 804c 8bdf +2372 212b 804c 804d +212c 212d 7c67 8050 +2372 212c 804d 8c34 +2374 212c 804f 8050 +212c 2375 804f 8c34 +212d 212e 7c68 8cba +2374 212d 8050 8cba +212e 2130 7d06 8c26 +212e 2374 8b2b 8cba +2376 212e 8053 8c26 +212e 2377 8053 8b2b +2130 212f 7c6a 8ce6 +212f 2133 8055 8058 +212f 2376 8bbc 8ce6 +212f 2378 8058 8bbc +2376 2130 8c26 8ce6 +2131 2132 7c6b 8d17 +2133 2131 7c6c 7c6d +2132 2134 7c6f 8cff +2135 2132 7c6f 8cfa +2378 2133 8058 8c6d +2135 2134 7c6e 7c6f +2134 2136 7c6e 8cfe +2136 2135 7c6e 7c70 +2136 2137 7c72 7c73 +2138 2136 7c72 8cf0 +2137 2138 7c72 8d46 +2137 2139 7c74 8b9e +213a 2137 7c74 8d46 +2137 249e 8b9e 8c03 +2138 213a 8c02 8d46 +2139 213a 7c74 8c65 +2139 213b 7c75 7d08 +2139 2184 7d08 8c64 +249e 2139 8b9e 8c64 +213b 213c 7c77 805a +213b 213e 805a 8b9f +2184 213b 7d08 8b9f +213c 213d 7c78 80c1 +213e 213c 805a 80c1 +213d 213e 7c79 80c1 +213f 213d 7c79 80c2 +213e 213f 7c79 8059 +213e 2184 82f1 8b9f +213e 2379 8059 8596 +249f 213e 82f1 8597 +213e 260e 8596 8597 +2379 213f 8059 834b +2140 2141 7c7d 80c4 +237b 2140 805c 80c4 +2141 2142 7c7e 80c5 +2141 237b 805e 80c4 +237e 2141 805e 80c5 +2142 2143 7c7f 80c6 +237e 2142 80c5 80c6 +237e 2143 80c6 8300 +24ad 2143 8bf6 8e50 +2143 24ae 8a95 8e50 +24b0 2143 8300 8cea +2143 24d9 8bf6 8cea +2144 2145 7c81 805f +2144 2147 805f 8bc9 +24a3 2144 82f6 8bc9 +2144 24a4 82f6 8c94 +2145 2146 7c82 80c7 +2145 2147 7c83 805f +2146 2148 7c84 8061 +2147 24a3 8301 8bc9 +24b1 2147 8301 8966 +2147 2611 859b 8966 +2148 2149 7c85 80c9 +237f 2148 8060 80c9 +2149 214a 7c86 80ca +2149 237f 8062 80c9 +2380 2149 8062 80ca +214a 214b 7c87 80cb +214a 2380 8063 80ca +2381 214a 8063 80cb +214b 214c 7c88 80cc +214b 2381 8064 80cb +2382 214b 8064 80cc +214c 214d 7c89 80cd +214c 2382 8065 80cc +2383 214c 8065 80cd +214d 214e 7c8a 80ce +214d 2383 8066 80cd +2384 214d 8066 80ce +214e 214f 7c8b 80cf +214e 2384 8068 80ce +2386 214e 8068 80cf +214f 2150 7c8c 80d0 +2385 214f 8067 80d0 +214f 2386 8067 80cf +2150 2151 7c8d 80d1 +2150 2385 8069 80d0 +2387 2150 8069 80d1 +2151 2152 7c8e 80d2 +2151 2387 806a 80d1 +2388 2151 806a 80d2 +2152 2153 7c8f 80d4 +2152 2388 806c 80d2 +238b 2152 806c 80d4 +2153 2154 7c90 80d5 +2153 238b 806e 80d4 +238d 2153 806e 80d5 +2154 2155 7c91 80d6 +2154 238d 806f 80d5 +238e 2154 806f 80d6 +2155 2156 7c92 80d7 +2155 238e 8070 80d6 +238f 2155 8070 80d7 +2156 2157 7c93 80d8 +2156 238f 8071 80d7 +2390 2156 8071 80d8 +2157 2158 7c94 80d9 +2157 2390 8072 80d8 +2391 2157 8072 80d9 +2158 2159 7c95 80da +2391 2158 80d9 80db +2158 2392 80da 80db +2159 215a 7c96 8073 +2159 2392 8073 80da +215a 215d 7c98 80dc +2392 215a 8073 8074 +2393 215a 8074 80dc +215c 215b 7c97 8075 +215b 215d 7c97 7c99 +215b 215e 7c9a 80de +2394 215b 8075 80de +215d 215c 7c97 80dd +2393 215c 80dd 8b58 +215c 2394 8075 8c1d +24c4 215c 8b30 8c1d +215c 2625 8b30 8b58 +2393 215d 80dc 80dd +2394 215e 80de 8c0d +215e 2707 8ac2 8c0d +215f 2160 7c9d 8c68 +2160 2161 7c9e 8c46 +2162 2160 8b3f 8c46 +2161 2162 8078 8c46 +2166 2161 8078 8bb6 +2161 2167 7ca1 7ca2 +2161 2168 7ca2 8bb6 +2163 2162 7c9f 8c51 +2162 2166 8078 8d72 +271a 2162 8c51 8d72 +2397 2163 8cbf 8db5 +2715 2163 8c69 8d55 +2163 271a 8c51 8db5 +2163 272d 8cbf 8d55 +2165 2164 7ca0 8de0 +2164 2166 7ca0 8d64 +2169 2164 7ca3 8d64 +271b 2164 8de0 8e09 +2166 2165 7ca0 8c47 +2165 2397 8312 8d73 +2398 2165 8312 8e08 +271a 2165 8c47 8d73 +2165 271b 8de0 8e08 +2166 2168 8bb6 8d63 +2166 2169 7d2e 8d64 +2185 2166 7d2e 8d63 +2166 271a 8c47 8d72 +2168 2167 7ca2 80df +2167 216a 7ca4 80df +216a 2168 7ca5 80df +2168 216b 7ca5 7ca6 +2168 216c 7ca6 8d65 +2185 2168 8d63 8d65 +2169 2185 7d2e 8db2 +216b 216a 7ca5 80e2 +216a 216d 7ca7 80e2 +216c 216b 7ca6 8363 +216d 216b 7d31 80e2 +216b 216f 7d31 8363 +216c 216e 7ca8 7ca9 +216f 216c 7ca8 8363 +216c 2185 80e1 8d65 +216f 216d 7d31 80e4 +216d 2172 7cae 80e4 +216e 216f 7ca8 8365 +216e 2170 7cac 807e +2171 216e 7cac 8365 +216f 2171 7cb1 8365 +2172 216f 7cb1 80e4 +2170 2171 7cac 8367 +239f 2170 80e5 8367 +2170 23aa 80e5 85c2 +2171 2172 7cb1 80e6 +2173 2171 807d 80e6 +2171 239f 807d 8367 +2172 2173 7cb0 80e6 +2173 2174 7d36 80e7 +2177 2173 807c 80e7 +2173 239f 807c 807d +2176 2174 7cb4 80e8 +2174 2177 7cb4 80e7 +2174 2178 7d39 80e8 +2178 2175 7cb5 80e9 +2175 2179 7cb6 80ea +2186 2175 80e9 80ea +2177 2176 7cb4 836a +2178 2176 7d38 80e8 +2176 2186 7d38 836b +23a4 2176 836a 836b +239f 2177 807c 8368 +23a4 2177 8320 836a +2177 24d7 8320 8368 +2186 2178 7d38 80e9 +2179 217b 8085 8b9b +2186 2179 80ea 8b2f +23a0 2179 8b2f 8b9b +217b 217a 7cb7 8d4f +217c 217a 8d4f 8da0 +217a 217e 8080 8da0 +217c 217b 8c37 8d4f +23a0 217b 8b9b 8cb9 +217b 23a2 8c37 8cb9 +217c 217d 7cb9 8d31 +217e 217c 7cb9 8da0 +23a2 217c 8c37 8c90 +217d 217e 7cb9 8da1 +217f 217d 7cbb 8da8 +217d 2180 8d49 8da8 +2180 217f 8d30 8da8 +2182 2181 7cc0 8cb6 +2370 2183 80bc 8bdd +2183 2495 8b0b 8bdd +2496 2183 8b0b 8b0d +2498 2183 8b0d 8c1a +249d 2184 8598 8a69 +2184 249e 8598 8c64 +2184 249f 82f1 8a69 +23a0 2186 8081 8b2f +2186 23a1 8081 85b7 +23a4 2186 836b 85b7 +2188 2187 7d3d 7ea4 +2187 2189 7d3d 7e12 +2189 2188 7d3d 81d4 +2410 2188 81d4 8459 +2188 24dd 83e9 845a +254a 2188 8459 845a +2410 2189 81d3 81d4 +218a 218b 7d40 815d +23ab 218a 80eb 815d +218b 218c 7d41 815e +218b 23ab 80ed 815d +23ae 218b 80ed 815e +218c 218d 7d42 815f +218c 23ae 80ef 815e +23b0 218c 80ef 815f +218d 218e 7d43 8160 +218f 218d 7d44 8160 +218d 2190 7d44 80f1 +218d 23b0 80f1 815f +218e 218f 7e1a 8160 +218e 2191 7d45 8161 +2194 218e 7e1a 8161 +2190 218f 7d44 83f1 +218f 2194 7e1a 83f3 +218f 24de 8370 83f1 +24df 218f 8370 83f3 +23b0 2190 80f1 83f0 +2190 23b1 836e 83f0 +24de 2190 836f 83f1 +2191 2192 7d46 8162 +2193 2191 7d47 8162 +2191 2194 7d47 8161 +2192 2193 7d49 8162 +2192 2195 7d48 8163 +2196 2192 7d49 8163 +2194 2193 7d47 83f5 +2193 2196 7d49 83f6 +2193 24e0 8373 83f5 +24e3 2193 8373 83f6 +2194 24df 8371 83f3 +24e0 2194 8371 83f5 +2195 2196 7d4b 8163 +2195 2197 7d4a 8164 +2198 2195 7d4b 8164 +2196 2198 7d4b 83f8 +2196 24e3 8374 83f6 +24e4 2196 8374 83f8 +2197 2198 7d4d 8164 +2197 2199 7d4c 8165 +219a 2197 7d4d 8165 +2198 219a 7d4d 83f9 +2198 24e4 8376 83f8 +24e7 2198 8376 83f9 +2199 219a 7d4f 8165 +2199 219b 7d4e 8166 +219c 2199 7d4f 8166 +219a 219c 7d4f 83fb +219a 24e7 8377 83f9 +24e8 219a 8377 83fb +219c 219b 8166 8167 +219b 219d 7d50 8167 +219d 219c 7e21 8167 +219c 219f 7e21 83fc +24e8 219c 83fb 83fc +219d 219e 7d51 8168 +219f 219d 7e21 8168 +219e 219f 7d52 8168 +21a0 219e 7d52 8169 +219e 21a1 7d53 8169 +219f 21a0 7d52 83fd +219f 24e8 8378 83fc +24e9 219f 8378 83fd +21a1 21a0 7d54 8169 +21a0 21a2 7d54 83ff +21a0 24e9 837a 83fd +24ec 21a0 837a 83ff +21a2 21a1 7d54 816a +21a1 21a3 7d55 816a +21a3 21a2 80f2 816a +21a2 23b2 80f2 8400 +21a2 24ec 837d 83ff +24f2 21a2 837d 8400 +21a3 21a4 7d56 816b +23b2 21a3 80f2 80f3 +23b3 21a3 80f3 816b +21a4 23b3 80f4 816b +23b4 21a4 80f4 816c +21a5 21a6 7d59 8171 +21a5 23b7 80f8 816f +23b9 21a5 80f8 8171 +21a6 21a7 7d5a 8172 +21a8 21a6 80f9 8172 +21a6 23b9 80f9 8171 +21a7 21a8 7d5b 8172 +21a9 21a7 7d5b 8173 +21a7 21aa 7d5c 8173 +21a8 21a9 7d5b 8406 +23b9 21a8 80f9 8405 +21a8 23ba 80fa 8405 +23bb 21a8 80fa 8406 +21aa 21a9 7d5d 8173 +21a9 21ab 7d5d 8407 +21a9 23bb 8381 8406 +24f4 21a9 8381 8407 +21ab 21aa 7d5d 8174 +21aa 21ac 7d5e 8174 +21ac 21ab 7d5f 8174 +21ab 21ad 7d5f 8408 +21ab 24f4 8382 8407 +24f5 21ab 8382 8408 +21ad 21ac 7d5f 8175 +21ac 21ae 7d60 8175 +21ae 21ad 7d61 8175 +21ad 21af 7d61 8409 +21ad 24f5 8383 8408 +24f6 21ad 8383 8409 +21af 21ae 7d61 8176 +21ae 21b0 7d62 8176 +21b0 21af 7d63 8176 +21af 21b1 7d63 840a +21af 24f6 8384 8409 +21b1 21b0 7d63 8177 +21b0 21b2 7d64 8177 +21b2 21b1 80fb 8177 +21b1 23bc 80fb 840b +24f7 21b1 8385 840b +21b2 21b3 7d65 8178 +23bc 21b2 80fb 8178 +21b3 21b4 7d66 8179 +21b3 23bc 80fc 8178 +23bd 21b3 80fc 8179 +21b4 21b5 7d67 817a +21b4 23bd 80fd 8179 +23be 21b4 80fd 817a +21b5 21b6 7d68 817c +21b5 23be 80fe 817a +23bf 21b5 80fe 817c +21b6 21b7 7d69 80ff +23bf 21b6 817c 817e +21b6 23c0 80ff 817e +21b7 21b8 7d6a 817f +23c0 21b7 80ff 8100 +23c1 21b7 8100 817f +21b8 21b9 7d6b 7e36 +21b8 21ba 7e36 8180 +23c1 21b8 817f 8180 +21b9 21ba 7d6c 7e36 +23c1 21ba 8180 85df +2414 21ba 85df 8c53 +21ba 2416 8b93 8c53 +21bb 21bc 7d6f 8391 +21bb 23c4 8391 8ca8 +21bc 21bd 7d70 8cd9 +21bc 23c3 8cd9 8d9b +23c4 21bc 8391 8d9b +23c2 21bd 8102 8d33 +21bd 23c3 8102 8cd9 +23c5 21bd 8d33 8d93 +21be 21bf 7d71 8e36 +21be 23c5 8e0e 8e37 +21bf 21c0 8e0f 8ebb +21c1 21bf 7d73 8ebb +21c0 21c1 7d74 8ebb +21c2 21c1 7d77 8e93 +21c1 21c3 8e86 8e93 +21c3 21c2 7d76 8e93 +21c4 21c3 7d78 8de2 +21c4 21c5 7d79 8c57 +21c5 21c6 7d7a 8e8a +2292 21c5 8e85 8e8a +21c6 228f 7ec5 8dfc +2290 21c6 7ec5 8e8b +21c6 2292 8dfc 8e8a +21c7 21c8 7d7e 8189 +21ca 21c7 7e46 8189 +21c7 2266 7e44 8187 +2267 21c7 7e44 7e46 +21c9 21c8 7d80 818a +21c8 21ca 7d80 8189 +21ca 21c9 7d80 8415 +21c9 21cb 7d81 8416 +21c9 2502 8395 8415 +2503 21c9 8395 8416 +2267 21ca 7e46 8413 +21ca 2479 8394 8413 +2502 21ca 8394 8415 +21cb 21cd 7d83 8418 +21cb 2503 8396 8416 +21cc 21cd 7d84 818d +21ce 21cc 7d84 818e +21cc 21cf 7d85 818e +21cd 21ce 7d84 8419 +23c9 21cd 8398 8419 +21ce 21cf 818e 818f +21d0 21ce 8107 818f +21ce 23c6 8107 841b +23c9 21ce 8419 841b +21cf 21d0 7d86 818f +21d0 21d1 7d87 8190 +23c6 21d0 8107 8190 +21d1 21d2 7d88 8191 +2268 21d1 810a 8191 +21d1 23c6 810a 8190 +21d2 21d3 7e51 8192 +21d6 21d2 7e4f 8192 +21d2 2268 7e4f 8191 +21d3 21d4 7d8a 7d8b +21d5 21d3 7d8a 7e53 +21d3 21d6 7d8b 8192 +21d4 21d5 7d8a 8194 +21d6 21d4 7d8b 841e +21d4 23ca 810b 8420 +23cb 21d4 810b 8194 +2504 21d4 841e 8420 +21d5 21d7 7e54 8193 +21d5 23cb 8193 8194 +2268 21d6 7e4f 841d +21d6 23c8 8399 841d +2504 21d6 8399 841e +23cb 21d7 8193 8195 +23cc 21d7 8195 8196 +21d8 21d9 7d8e 8198 +21da 21d8 7e58 8198 +21d9 21da 7d90 8198 +21da 2508 839d 8426 +2509 21da 839d 8427 +21db 21dc 7d92 819b +21dd 21db 7d93 819b +21dc 21dd 810e 819b +21dc 21de 7d94 819c +23cf 21dc 810e 819c +21dd 23cf 810e 842b +21dd 250d 83a1 842a +250e 21dd 83a1 842b +21de 21df 7d95 819d +23cf 21de 819c 819d +21df 21e0 7d96 819e +21df 23cf 810f 819d +23d0 21df 810f 8110 +23d1 21df 8110 819e +21e0 21e1 7d97 819f +21e0 23d1 8111 819e +23d2 21e0 8111 819f +21e1 21e2 7d98 81a0 +21e1 23d2 8112 819f +23d3 21e1 8112 81a0 +21e2 21e3 7d99 81a1 +21e2 23d3 8113 81a0 +23d4 21e2 8113 81a1 +21e3 21e4 7d9a 81a2 +21e3 23d4 8114 81a1 +23d5 21e3 8114 81a2 +21e4 21e5 7d9b 81a3 +23d5 21e4 81a2 81a3 +21e5 21e6 7d9c 81a4 +21e5 23d5 8115 81a3 +23d6 21e5 8115 81a4 +21e6 21e7 7d9d 81a5 +21e6 23d6 8116 81a4 +23d7 21e6 8116 81a5 +21e7 21e8 7d9e 81a6 +21e7 23d7 8117 81a5 +23d8 21e7 8117 81a6 +21e8 21e9 7d9f 81a7 +21e8 23d8 8118 81a6 +23d9 21e8 8118 81a7 +21e9 21ea 7da0 81a8 +21e9 23d9 8119 81a7 +23da 21e9 8119 81a8 +21ea 21eb 7da1 81a9 +21ea 23da 811a 81a8 +23db 21ea 811a 81a9 +21eb 21ec 7da2 81aa +21eb 23db 811b 81a9 +23dc 21eb 811b 81aa +21ec 21ed 7da3 81ab +21ec 23dc 811c 81aa +23dd 21ec 811c 81ab +21ed 21ee 7da4 81ac +21ed 23dd 811d 81ab +23de 21ed 811d 81ac +21ee 21ef 7da5 81ad +21ee 23de 811e 81ac +23df 21ee 811e 81ad +21ef 21f0 7da6 81ae +21ef 23df 811f 81ad +23e0 21ef 811f 81ae +21f0 21f1 7da7 81af +21f0 23e0 8120 81ae +23e1 21f0 8120 81af +21f1 21f2 7da8 81b0 +21f1 23e1 8121 81af +23e2 21f1 8121 81b0 +21f2 21f3 7da9 81b1 +21f2 23e2 8122 81b0 +23e3 21f2 8122 81b1 +21f3 21f4 7daa 81b2 +21f3 23e3 8123 81b1 +23e4 21f3 8123 81b2 +21f4 21f5 7dab 81b3 +21f4 23e4 8124 81b2 +23e5 21f4 8124 81b3 +21f5 21f6 7dac 81b4 +21f5 23e5 8125 81b3 +23e6 21f5 8125 81b4 +21f6 21f7 7dad 81b5 +21f6 23e6 8126 81b4 +23e7 21f6 8126 81b5 +21f7 21f8 7dae 81b6 +21f7 23e7 8127 81b5 +23e8 21f7 8127 81b6 +21f8 21f9 7daf 81b7 +21f8 23e8 8128 81b6 +23e9 21f8 8128 81b7 +21f9 21fa 7db0 81b8 +21f9 23e9 8129 81b7 +23ea 21f9 8129 81b8 +21fa 21fb 7db1 81b9 +21fa 23ea 812a 81b8 +23eb 21fa 812a 81b9 +21fb 21fc 7db2 81ba +21fb 23eb 812b 81b9 +23ec 21fb 812b 81ba +21fc 21fd 7db3 81bb +21fc 23ec 812d 81ba +23ef 21fc 812d 81bb +21fd 21fe 7db4 81bc +21fd 23ef 812f 81bb +23f1 21fd 812f 81bc +21fe 21ff 7db5 81bd +21fe 23f1 8131 81bc +23f3 21fe 8131 81bd +21ff 2200 7db6 81be +2269 21ff 8133 81be +21ff 23f3 8133 81bd +2200 2201 7db7 81c0 +2200 2269 7e81 81be +226a 2200 7e81 81c0 +2201 2202 7db8 81c1 +2201 226a 8135 81c0 +23f6 2201 8135 81c1 +2202 2203 7db9 81c2 +2202 23f6 8136 81c1 +2203 2204 7dba 81c3 +226b 2203 7e83 81c3 +2204 2205 7dbb 81c4 +2204 226b 8137 81c3 +23f7 2204 8137 81c4 +2205 23f7 8138 81c4 +2207 2206 7dbe 81c7 +2206 2208 7dbf 81c7 +2208 2207 7dc0 81c7 +2207 2209 7dc0 83cc +2207 2538 83cc 8b72 +2209 2208 7dc0 81c8 +2208 220a 7e8a 81c8 +220a 2209 8139 81c8 +2209 23f8 8139 8b25 +2538 2209 83cc 83cf +2539 2209 83cf 8b25 +220a 220b 7dc2 8be4 +23f8 220a 8139 8c7b +220a 23f9 8be4 8c7b +220b 220c 7dc3 813a +220b 23f9 813a 8be4 +220c 220d 7dc4 8c14 +23f9 220c 813a 813b +23fa 220c 813b 8c41 +220c 23fb 8c14 8c41 +220d 220e 7dc6 813d +220d 23fb 813d 8c14 +220e 220f 7dc5 8bdb +23fb 220e 813d 8142 +23fc 220e 8141 8bdb +220e 23fd 8141 8142 +220f 2210 8c74 8cc0 +2211 220f 8c48 8cc0 +23fc 220f 8bdb 8c48 +2210 2211 7dc8 8cc0 +2212 2210 8c9a 8cc1 +2211 23fc 813f 8c48 +2214 2212 7dcc 8ccb +2214 2213 7dcd 8dad +2213 2215 8d36 8dad +2217 2213 8d36 8dac +2215 2214 8cca 8dad +2215 2216 7dd0 8d7d +2217 2215 7dd0 8d36 +2217 2216 7dcf 7dd0 +2216 2218 7dcf 8d7c +2218 2217 7dcf 8ddc +2217 2219 7dd1 8ddc +2219 2218 7dd3 8ddc +221a 2218 7dd2 7dd5 +2218 221b 7dd3 7dd5 +221b 2219 7dd3 8cc8 +221a 221b 7dd5 8d7e +221e 221a 8cb3 8d07 +2221 221a 8d07 8d7e +221b 221c 7dd4 8deb +2221 221b 8d7e 8deb +2220 221c 7dd8 8cb2 +221c 2221 7dd8 8deb +221d 221f 8cb5 8d4d +221d 2220 8d4d 8e18 +2222 221d 8cb5 8e0b +221d 2223 8dc1 8e0b +221d 2226 8d15 8dc1 +221f 221e 7dd7 8d9c +221e 2221 8d07 8d9c +2220 221f 8d4d 8d61 +2221 221f 8d61 8d9c +221f 2222 8cb5 8e0a +2221 2220 7dd8 8d61 +2223 2222 7dd9 8e0b +2223 2226 8dc1 8e69 +2227 2223 8d14 8e69 +2223 222c 8d14 8dc0 +2225 2224 7ddb 8ea0 +2224 2226 7ddb 8ea1 +2226 2225 7ddb 7ddc +2227 2225 7ddc 8dfa +2228 2225 8d4a 8e99 +2225 2229 8cc2 8e99 +222a 2225 8dfa 8e57 +2225 2232 8d4a 8e57 +2226 2227 7ddc 8e69 +2227 222a 8dfa 8e68 +222c 2227 8d14 8e68 +2229 2228 7ddd 8e99 +222f 2228 7de1 7de4 +2231 2228 7de4 8e23 +2228 2232 7de1 8d4a +222b 222a 7dde 8dab +222a 222c 7dde 8e68 +2232 222a 8dab 8e57 +222c 222b 7dde 8e33 +222b 2232 8dab 8e56 +2735 222b 8e32 8e56 +222e 222d 7ddf 8d23 +222d 222f 7ddf 8df7 +222d 2230 8df7 8ea3 +2233 222d 7de2 8e64 +222d 2234 7de2 8d23 +2235 222d 8e64 8ea3 +222f 222e 7ddf 8e66 +222e 2234 8d23 8e67 +222e 2735 8cdb 8e66 +2230 222f 8df7 8e22 +222f 2231 7de4 8e22 +2232 222f 7de1 8d99 +2735 222f 8d99 8e66 +2231 2230 7de0 8e22 +2230 2235 8d22 8ea3 +2236 2230 8d22 8e78 +2232 2735 8d99 8e56 +2234 2233 7de2 8e30 +2235 2233 8d7b 8e64 +2748 2233 8d25 8d7b +2236 2235 7de3 8d22 +2235 2237 7de3 8ea2 +2748 2235 8d7b 8ea2 +2237 2236 7de3 8d24 +2237 2238 7de6 8e65 +2237 2748 8e65 8ea2 +2238 2239 7de7 8cf6 +2238 2748 8e14 8e65 +223a 2239 8dbb 8e12 +223b 2239 8d88 8dbb +2239 223d 8cf7 8e12 +223a 223b 7de9 8dbb +223a 223c 8145 8d09 +223d 223a 8145 8e12 +223e 223a 7deb 8bc0 +2400 223a 8bc0 8d09 +223d 223c 7dea 8145 +223f 223c 8146 8d08 +223c 2400 8146 8d09 +223e 2400 8bc0 8ca5 +223f 23ff 8144 8bc1 +2400 223f 8146 8bc1 +2241 2240 81c9 81cb +2240 2243 7df2 81cb +2242 2241 7df1 8454 +2241 2243 81cb 8ae6 +2241 2402 83d3 8454 +253a 2241 83d3 8abe +253b 2241 8abe 8ae6 +2402 2242 8149 8454 +2243 2244 7df3 83d7 +253b 2243 8ae6 8b98 +2403 2244 8b99 8cb0 +2244 2405 8c19 8cb0 +2245 2247 8c01 8c8a +2248 2245 8bca 8c8a +2403 2245 814c 8c00 +2404 2245 8c01 8d79 +2245 2405 814c 8d79 +2247 2246 7df5 7df6 +2248 2246 7df6 8bcb +2246 2249 7df8 814e +2246 2406 814e 8bcb +2247 2248 7df6 8c8a +2247 2404 8c01 8d78 +2406 2248 83da 8bcb +253c 2248 83d9 83df +2248 253d 83da 83df +2406 2249 814e 81cc +224b 224a 7df9 8da7 +224a 224c 7df9 8dd3 +224a 224e 7dfd 8da7 +2255 224a 8d43 8dd3 +224c 224b 7df9 8df1 +224d 224b 8cf3 8e10 +224b 224e 8da7 8e10 +224f 224b 8df1 8e11 +224b 2250 8cf3 8e11 +224f 224c 7dff 8df1 +224c 2251 7dff 8e44 +2253 224c 8c66 8e44 +224c 2255 8c66 8dd3 +224e 224d 7dfa 8e10 +2250 224d 8cf3 8cfc +224d 2406 8bc6 8cfc +2250 224f 7dfb 8e11 +2251 224f 7dff 8e45 +2252 224f 8e45 8ef0 +2406 2250 83db 8cfc +2252 2251 7dfc 8e45 +2251 2253 7dfe 8e44 +2254 2253 8d19 8def +2255 2253 8c66 8d18 +2725 2253 8d18 8d19 +2254 2257 7e02 8dee +2725 2254 8d19 8dee +2256 2255 7e01 8dd2 +2255 2725 8d18 8dd2 +2258 2256 7e03 8dcf +2725 2256 8dcf 8dd2 +2258 2257 8c87 8dc5 +2257 2259 7e04 8e1a +2724 2257 8dc5 8e1a +2257 2725 8c87 8dee +2724 2258 8d5f 8dc5 +2725 2258 8c87 8dcf +2259 225a 7e05 8c86 +2259 2724 8c86 8e1a +225a 225b 7e06 8d52 +2724 225a 8c86 8d5b +2407 225b 814f 8d53 +225c 225d 7e09 8c08 +2409 225c 8151 8c08 +225c 240a 8151 8bc5 +225d 225e 7e0a 83e4 +225d 2409 83e3 8c08 +225d 253e 83e4 8be3 +2543 225d 83e3 8be3 +225e 225f 7e0b 7e9b +225e 2260 7e9b 8ab9 +253e 225e 83e4 8ab9 +2260 225f 7e9b 81cd +225f 2261 7e0d 81cd +2261 2260 7e0c 81cd +2260 2262 7e0c 8b3a +253e 2260 8ab9 8be2 +2260 253f 8b3a 8be2 +2262 2261 7e0c 81ce +2261 2263 7e0e 81ce +2263 2262 8156 81ce +2262 240c 8156 83e1 +2262 253f 8a31 8b3a +2262 2541 83e1 8a31 +2263 2264 7e0f 81cf +240c 2263 8156 81cf +2264 2265 7e10 81d0 +2264 240c 8157 81cf +240d 2264 8157 81d0 +2265 240d 8158 81d0 +240e 2265 8158 81d1 +2266 2267 7e44 7f76 +228e 2266 8186 8188 +2266 2316 7f76 8188 +2316 2267 7f76 825d +2479 2267 825d 8413 +23c6 2268 810a 841c +2268 23c7 8108 841c +23c8 2268 8108 841d +2269 226a 7e81 8451 +23f3 2269 8133 8450 +2269 23f4 8134 8450 +23f5 2269 8134 8451 +226a 23f5 83c3 8451 +226a 23f6 8135 8452 +2418 226a 83c3 8452 +226b 23f7 8137 83c6 +2533 226b 83c5 83c6 +2712 226c 8bb3 8c8d +226d 226e 7ea6 8d6a +2712 226d 8be0 8cc5 +226d 2723 8c84 8d6b +272e 226d 8cc5 8d6b +2703 226e 8bd1 8c85 +2270 226f 7ea8 8be7 +226f 2271 7ea8 8ce2 +226f 2275 8af0 8be7 +2702 226f 8c43 8ce2 +2271 2270 7ea8 8c3c +2274 2270 7eaa 8ac7 +2275 2270 8ac7 8be7 +2271 2702 8c3d 8ce2 +2273 2272 7ea9 7eab +2272 2274 8848 89b9 +2275 2272 7eab 89b9 +2272 2277 7eb0 81d7 +2272 241a 81d7 894e +2555 2272 8848 894e +2273 2275 7eab 8be8 +2275 2274 89b9 8ac7 +2274 2555 8848 8afc +2559 2274 89ad 8afc +2277 2276 7eaf 824d +2276 2278 7eb2 824e +227b 2276 81d5 824e +2276 2419 81d5 824d +2419 2277 81d6 824d +2277 241a 81d6 81d7 +2278 2279 7eb3 824f +227a 2278 7eb4 824f +2278 227b 7eb4 824e +227a 2279 824f 8250 +2279 227c 7eb5 8250 +227b 227a 7eb4 84f5 +227c 227a 81d8 8250 +227a 2280 81d8 84f6 +255e 227a 84f5 84f6 +2419 227b 81d5 84f3 +227b 255c 8461 84f3 +255d 227b 8461 8462 +255e 227b 8462 84f5 +227c 227d 7eb6 8251 +227f 227c 7eb8 8251 +227c 2280 7eb8 81d8 +227e 227d 7eb7 8252 +227d 227f 7eb7 8251 +227d 2281 7eb9 8252 +227f 227e 7eb7 84f8 +2281 227e 81d9 8252 +227e 241b 81d9 84fa +227e 2563 8467 84f8 +2564 227e 8467 84fb +227e 2565 84fa 84fb +2280 227f 7eb8 84f7 +227f 2561 8466 84f7 +2563 227f 8466 84f8 +2280 255e 8464 84f6 +2561 2280 8464 84f7 +2281 2313 7f69 8253 +241b 2281 81d9 8253 +2283 2282 7eba 8b29 +2286 2282 846b 8a3a +2282 241c 846b 8b28 +2282 241f 846c 8b29 +2566 2282 846c 8b28 +2283 241f 8b29 8bbb +2285 2284 7ebd 8256 +2284 2286 7f6e 8256 +2314 2284 7f6e 8257 +2286 2285 7ebe 8256 +2286 2314 7f6e 89eb +241c 2286 846b 89eb +2287 2288 7ec0 825a +2289 2287 81dd 825a +2287 2421 81dd 8259 +2288 2289 7ec1 825a +228a 2288 7ec1 825b +2288 228b 7ec2 825b +2289 228a 7ec1 84fe +2421 2289 81dd 84fd +2289 2567 846f 84fd +2568 2289 846f 84fe +228b 228a 7f75 825b +228a 2315 7f75 84ff +228a 2568 8470 84fe +2569 228a 8470 84ff +228b 228c 7f77 825c +2315 228b 7f75 825c +228c 228d 7ec4 825e +228e 228c 7ec4 7f79 +2315 228c 825c 825e +228d 228e 7ec4 8412 +2315 228d 825e 8471 +2316 228d 818b 8412 +228d 2417 818b 864a +256a 228d 8471 864a +228e 2316 8188 8412 +228f 2290 7ec5 7ec7 +228f 2292 8d77 8dfc +2293 228f 8d77 8e02 +228f 2294 8dd8 8e02 +271c 228f 8dd8 8df4 +2291 2295 7ecb 8dcd +2291 2296 7ecc 8dcc +2293 2292 7ec8 8d77 +2294 2293 7ec9 8e02 +2294 2295 8c56 8e03 +271c 2294 8c56 8dd8 +2295 271c 8c56 8df5 +2424 2297 81e2 8c28 +2298 2299 7ed0 81e8 +2422 2298 81e6 8b1b +2298 2423 81e8 8b1b +2299 229b 7ed2 8a61 +2423 2299 81e8 8a61 +229b 229a 7ed1 7ed3 +229c 229a 7ed3 7ed5 +229a 229d 7ed4 825f +229e 229a 7ed5 825f +229b 229c 7ed3 8474 +229b 2423 8473 8a61 +2426 229b 8473 8474 +229c 229e 7ed5 8478 +2426 229c 8474 89de +229c 256b 8979 89de +229c 256e 8478 8979 +229e 229d 825f 8260 +229d 22a0 7f81 8260 +229e 22a0 8260 89b5 +256e 229e 8478 8919 +268b 229e 8919 89b5 +22a0 229f 7ed7 88d3 +229f 2428 81ea 8264 +229f 247a 8264 869f +229f 268a 869f 88d3 +268a 22a0 869e 88d3 +22a0 268b 869e 89b5 +22a2 22a1 7eda 8506 +22a1 2317 81f0 8508 +22a1 2571 847d 8506 +2573 22a1 847d 8508 +242b 22a2 81ef 8505 +22a2 2570 847b 8505 +2571 22a2 847b 8506 +22a4 22a3 7edd 826d +22a3 22a5 7edd 826c +22a5 22a4 7edd 850b +22a4 22a6 7ede 850d +22a4 2577 8482 850b +2578 22a4 8482 850d +2317 22a5 7f8a 850a +22a5 2575 8481 850a +2577 22a5 8481 850b +22a6 22a7 7edf 850e +22a6 2578 8484 850d +257b 22a6 8484 850e +22a7 2318 7f90 8510 +22a7 257b 8485 850e +257c 22a7 8485 8510 +22a8 22a9 7ee1 8271 +22ac 22a8 7f92 8271 +22a8 2318 7f92 8270 +22a9 22aa 7ee2 8272 +22ab 22a9 7ee3 8272 +22a9 22ac 7ee3 8271 +22aa 22ab 7f95 8272 +22aa 22ad 7ee4 8273 +22b0 22aa 7f95 8273 +22ac 22ab 7ee3 8512 +22ab 22b0 7f95 8513 +22ab 2580 8489 8512 +2581 22ab 8489 8513 +2318 22ac 7f92 8511 +22ac 257f 8488 8511 +2580 22ac 8488 8512 +22ad 22ae 7ee5 8274 +22af 22ad 7ee6 8274 +22ad 22b0 7ee6 8273 +22ae 22af 7ee8 8274 +22ae 22b1 7ee7 8275 +22b2 22ae 7ee8 8275 +22b0 22af 7ee6 8514 +22af 22b2 7ee8 8515 +22af 2582 848c 8514 +2585 22af 848c 8515 +22b0 2581 848a 8513 +2582 22b0 848a 8514 +22b1 22b2 7eea 8275 +22b1 22b3 7ee9 8276 +22b4 22b1 7eea 8276 +22b2 22b4 7eea 8517 +22b2 2585 848e 8515 +2587 22b2 848e 8517 +22b3 22b4 7eec 8276 +22b5 22b3 7eec 8277 +22b4 22b5 7eec 8519 +22b4 2587 8490 8517 +2589 22b4 8490 8519 +22b5 22b6 7eee 851b +22b5 2589 8492 8519 +258b 22b5 8492 851b +22b6 242e 81f1 851c +258b 22b6 851b 851c +22b7 22b8 81f4 827d +2430 22b7 827c 827d +22b8 22b9 7ef0 8521 +2430 22b8 827d 8520 +22b8 2431 81f5 8520 +2432 22b8 81f5 8521 +22b9 2319 7fa0 86c1 +2432 22b9 8521 8868 +22b9 2699 86c1 8868 +22ba 22bb 893e 8973 +22bc 22ba 7ef5 8a6a +22ba 22bd 7ef5 8972 +231a 22bb 81f7 8952 +22bd 22bc 7ef5 7ef6 +22bd 2435 893f 898e +2437 22bd 88ca 898e +22be 22bf 7ef9 8280 +231c 22be 8206 8280 +243c 22be 8205 8206 +22bf 22c0 7efa 8281 +231b 22bf 7fad 8281 +22bf 231c 7fad 8280 +22c0 22c1 7efb 8282 +22c0 231b 8207 8281 +243d 22c0 8207 8282 +22c1 22c2 7efc 8283 +22c1 243d 8208 8282 +243e 22c1 8208 8283 +22c2 22c3 7efd 8284 +22c2 243e 8209 8283 +243f 22c2 8209 8284 +22c3 22c4 7efe 8285 +243f 22c3 8284 8285 +22c4 22c5 7eff 8286 +22c4 243f 820a 8285 +2440 22c4 820a 8286 +22c5 22c6 7f00 8287 +231d 22c5 820b 8287 +22c5 2440 820b 8286 +22c6 22c7 7f01 8288 +22c6 231d 7fb3 8287 +231e 22c6 7fb3 8288 +22c7 22c8 7f02 8289 +22c7 231e 820c 8288 +2441 22c7 820c 8289 +22c8 22c9 7f03 828a +22c8 2441 820e 8289 +2442 22c8 820e 828a +22c9 22ca 7f04 828b +22cb 22c9 820d 828b +22c9 2442 820d 828a +22ca 22cb 7f05 828b +22cc 22ca 7f05 828c +22ca 22cd 7f06 828c +22cb 22cc 7f05 88af +2442 22cb 820d 84b0 +25a1 22cb 84b0 88d1 +22cd 22cc 7f08 828c +22cc 22cf 7f08 8876 +25a2 22cc 84b2 8876 +22cd 22ce 7f07 828d +22cf 22cd 7f08 828d +22cf 22ce 828d 828e +22ce 22d0 7f09 820f +22ce 2443 820f 828e +22cf 2443 828e 84b3 +25a2 22cf 8876 88ad +22cf 25a3 84b3 88ad +2443 22d0 820f 8210 +2444 22d1 895b 8976 +22d4 22d2 895e 89a1 +22d4 22d3 7f10 89a0 +22d3 22d7 895f 8a1f +22d5 22d6 7f17 8a1b +22d6 22d8 7f1c 7f1d +22da 22d8 8a0a 8add +22da 22d9 7f1f 8adc +22db 22d9 7f21 8a0b +22db 22dc 7f22 8b4f +22dc 22dd 7f23 8b01 +26be 22dc 8959 8b01 +22dd 26be 8a26 8b01 +22dd 26c0 8779 8a26 +22df 22e0 8a35 8c16 +22e1 22df 8a35 8b50 +22e1 22e0 7f28 8a35 +22e0 22e2 7f28 8b96 +2449 22e0 8ae9 8b96 +22e2 22e1 7f28 89b0 +2448 22e1 89b0 8b51 +2448 22e2 8934 89b0 +22e2 2449 89b1 8b96 +22e3 22e4 7f2b 8291 +2447 22e3 8217 821e +244b 22e3 821e 8291 +244a 22e4 821d 8292 +22e4 244b 821d 8291 +22e6 22e5 7f2c 8525 +22e5 22ea 7fc9 8526 +22e5 25ad 84c3 8525 +25ae 22e5 84c3 8526 +244e 22e6 8222 8524 +22e6 25ac 84c2 8524 +25ad 22e6 84c2 8525 +22e7 22e8 7f2e 8297 +22e9 22e7 7f2f 8297 +22e7 22ea 7f2f 8296 +22e8 22e9 7f31 8297 +22e8 22eb 7f30 8298 +22ec 22e8 7f31 8298 +22ea 22e9 7f2f 8527 +22e9 22ec 7f31 8529 +22e9 25b1 84c7 8527 +22ea 25ae 84c5 8526 +25b1 22ea 84c5 8527 +22eb 22ec 7f33 8298 +22eb 22ed 7f32 8299 +22ee 22eb 7f33 8299 +22ec 22ee 7f33 852a +25b3 22ec 84c9 852a +22ed 22ee 7f35 8299 +22ed 22ef 7f34 829a +22f0 22ed 7f35 829a +22ee 22f0 7f35 852b +22ee 25b3 84ca 852a +25b4 22ee 84ca 852b +22ef 22f0 7f37 829a +22ef 22f1 7f36 829b +22f2 22ef 7f37 829b +22f0 22f2 7f37 852d +22f0 25b4 84cb 852b +25b5 22f0 84cb 852d +22f1 22f2 7f39 829b +22f1 22f3 7f38 829c +22f4 22f1 7f39 829c +22f2 22f4 7f39 852e +22f2 25b5 84cc 852d +25b6 22f2 84cc 852e +22f3 22f4 7f3b 829c +22f3 22f5 7f3a 829d +22f6 22f3 7f3b 829d +22f4 22f6 7f3b 852f +22f4 25b6 84ce 852e +25b9 22f4 84ce 852f +22f5 22f6 7f3d 829d +22f5 22f7 7f3c 829e +22f8 22f5 7f3d 829e +22f6 22f8 7f3d 8531 +22f6 25b9 84cf 852f +25ba 22f6 84cf 8531 +22f7 22f8 7f3f 829e +22f9 22f7 7f3f 829f +22f8 22f9 7f3f 8532 +22f8 25ba 84d0 8531 +25bb 22f8 84d0 8532 +22f9 25bb 84d3 8532 +22fa 22fb 7f41 82a3 +22fa 2450 8226 82a2 +2451 22fa 8226 82a3 +2451 22fb 82a3 82a4 +22fd 22fc 7f44 88d5 +22fc 22fe 7f44 822d +22fc 2454 822d 89ab +22fe 22fd 7f44 893c +22fd 2456 822a 88b7 +22fd 2459 8907 893c +2454 22fe 822d 8962 +22fe 2455 88d4 8930 +22fe 2458 8930 8962 +2459 22fe 88d4 893c +22ff 2300 7f46 82a5 +2301 22ff 7f47 7fe0 +2321 22ff 7fe0 82a5 +2300 2302 7f48 82a6 +2300 2321 8230 82a5 +245a 2300 8230 82a6 +2301 2321 7fe0 8867 +25c1 2301 84d8 8867 +2301 25c2 84d8 88b6 +25c3 2301 84da 88b6 +2302 2303 7f49 82a7 +2302 245a 8231 82a6 +245b 2302 8231 82a7 +2303 245b 8232 82a7 +245c 2303 8232 82a8 +2304 2305 7f4d 82ab +2304 245d 8234 82aa +245e 2304 8234 82ab +2305 245e 8235 82ab +245f 2305 8235 82ac +2306 2307 7f4f 82b9 +2306 2470 8244 82b8 +2471 2306 8244 82b9 +2307 2308 7f50 82ba +2307 2471 8245 82b9 +2472 2307 8245 82ba +2308 2309 7f51 82bc +2308 2472 8246 82ba +2473 2308 8246 82bc +2309 230a 7f52 82bd +2325 2309 8247 82bd +2309 2473 8247 82bc +230a 230c 7f54 82be +230d 230a 7ff8 82be +230a 2325 7ff8 82bd +230b 230e 7ffc 84f1 +230b 25ce 84f1 899a +230c 230d 7f55 82be +2325 230d 7ff8 84eb +2475 230d 84eb 8880 +25cf 230d 8880 8910 +230e 230f 7f58 824c +230e 2477 824c 8a20 +25ce 230e 84f1 8a20 +2310 230f 7f59 897d +2477 230f 824c 8a05 +2310 2311 7f5a 8b40 +2312 2311 7f5c 8b79 +241b 2313 8253 8254 +2314 241c 846d 89eb +2314 241d 8469 846d +2314 2420 81dc 8469 +2569 2315 84ff 8501 +2315 256a 8471 8501 +2417 2316 818b 8414 +2316 2479 825d 8414 +2317 2573 847f 8508 +2575 2317 847f 850a +2318 257c 8487 8510 +257f 2318 8487 8511 +2319 2433 81f6 86c2 +2699 2319 86c1 86c2 +231a 2433 81f9 8917 +231c 231b 7fad 8908 +231b 243d 8207 8892 +2595 231b 849d 88c5 +231b 2596 849d 8908 +231b 259b 8892 88c5 +243c 231c 8206 88ef +231c 2593 888d 88ef +2596 231c 888d 8908 +231d 231e 7fb3 84a8 +2440 231d 820b 8899 +259d 231d 8899 88aa +231d 259e 84a8 88aa +231e 2441 820c 88a8 +259e 231e 84a8 84aa +259f 231e 84aa 88a8 +2320 231f 7fd7 8537 +231f 2450 8225 8537 +2320 2450 8537 8538 +2320 2451 8538 88cc +2457 2320 887b 88cc +25c0 2320 86da 887b +26a1 2320 86d7 86da +2321 245a 8230 88bc +25c1 2321 8867 88bc +2323 2322 7fe3 88a3 +2322 2324 7fe3 86e1 +245b 2322 84e1 86e1 +245c 2322 84e0 84e1 +2322 25c6 84e0 8853 +2322 26a2 8853 88a3 +2324 2323 7fe3 887f +26a2 2323 885a 88a3 +2323 26a3 88a5 88c7 +26a4 2323 887f 88c7 +2324 245a 84df 887e +245b 2324 86e1 887e +25c1 2324 84df 86e0 +25c5 2324 86e0 88c6 +2324 26a4 887f 88c6 +2473 2325 8247 854b +2325 2474 8248 854b +2475 2325 8248 84eb +2326 2328 8002 8cd3 +2328 2327 8bd6 8cd2 +2329 2327 8005 8c44 +2329 232a 8006 8008 +232b 2329 8006 8ce4 +2329 232c 8008 8cab +232a 232b 8006 8ce5 +232c 232a 8008 8c4a +232d 232e 800a 8baa +2480 232d 82c6 8ba8 +232e 232f 82c2 8c2d +2330 2332 800f 8c04 +2485 2330 8ae0 8c04 +2481 2331 82c9 8ba1 +2482 2331 82c7 82c9 +2331 2483 82c7 8c2e +2332 2333 8010 8b71 +2332 2485 82ca 8c04 +2486 2332 82ca 8c12 +2332 2487 8b71 8c12 +2333 2334 8011 8bb1 +2487 2333 8b71 8c13 +2333 2488 8bb1 8c13 +2334 2335 8012 8bf8 +23a5 2334 82ce 8bf8 +2334 2488 82ce 8bb1 +2336 2335 808e 8b0f +2335 23a5 808e 8bf8 +2336 2337 8013 8ba5 +23a5 2336 808e 8bf9 +248a 2337 8ae5 8ba4 +2338 2339 8015 82d4 +2489 2338 8326 8327 +2338 248b 82d4 8327 +2339 233a 8016 8328 +233b 2339 82d5 8328 +248b 2339 82d4 82d5 +233a 233b 8017 8328 +233c 233a 8017 8329 +233a 233d 8018 8329 +233b 233c 8017 8a92 +248b 233b 82d5 8a8e +25e2 233b 8a8e 8b91 +233b 25e5 8a92 8b91 +233d 233c 8019 8329 +233c 233e 8019 8b52 +25e4 233c 8557 8b52 +233c 25e5 8557 8a92 +233e 233d 8019 832a +233d 233f 801a 832a +233f 233e 82d6 832a +233e 248c 82d6 8558 +25e3 233e 8553 8558 +233e 25e4 8553 8b52 +233f 2340 801b 832b +248c 233f 82d6 832b +2340 2341 801c 82d7 +248c 2340 832b 832c +2340 248d 82d7 832c +2341 2342 801d 832d +2343 2341 82d8 832d +248d 2341 82d7 82d8 +2342 2343 801e 832d +2344 2342 801e 832e +2342 2345 801f 832e +2343 2344 801e 8aa9 +248d 2343 82d8 8a50 +25e9 2343 8a50 8bbe +2343 25ec 8aa9 8bbe +2345 2344 8020 832e +2344 2346 8020 8ba6 +25ec 2344 8aa9 8ba6 +2346 2345 8020 832f +2345 2349 8022 832f +2349 2346 8023 832f +2346 234a 8023 89ff +2346 25ec 8560 8ba6 +25ed 2346 8560 8b05 +2346 25f0 89ff 8b05 +2348 2347 8021 8332 +2347 234d 8027 8333 +2347 248e 82db 8332 +248f 2347 82db 8333 +234b 2348 8026 8331 +2348 234c 82d9 8331 +248e 2348 82d9 8332 +234a 2349 8023 8330 +2349 234b 8024 8330 +234b 234a 8025 8330 +234a 234c 8025 8565 +25ef 234a 8563 8565 +234a 25f0 8563 89ff +234c 234b 8025 8331 +234c 248e 82d9 8aef +25ef 234c 8565 8aef +234d 234e 8028 8334 +234d 248f 82da 8333 +2490 234d 82da 8334 +234e 234f 8029 82dc +2490 234e 8334 8335 +234e 2491 82dc 8335 +234f 2350 802a 8336 +23a6 234f 82dd 8336 +2491 234f 82dc 82dd +2350 2351 802b 8337 +2352 2350 80a4 8337 +2350 23a6 80a4 8336 +2351 2352 802c 8337 +2353 2351 802c 8338 +2351 2354 802d 8338 +2352 2353 802c 8b20 +23a6 2352 80a4 8a5b +25f6 2352 8a5b 8b20 +2354 2353 802e 8338 +2353 2355 802e 8a2b +2353 25f6 8572 8b20 +25f8 2353 8572 8a2b +2355 2354 802e 8339 +2354 2356 802f 8339 +2356 2355 8031 8339 +2355 2358 8031 8b03 +25f8 2355 8a2b 8bb9 +2355 25ff 8b03 8bb9 +2356 2357 8030 833a +2358 2356 8031 833a +2357 2358 82de 833a +2357 2359 8032 833b +23a7 2357 82de 833b +2358 23a7 82de 8aca +25fe 2358 8a14 8aca +2358 25ff 8a14 8b03 +2359 235a 8033 833c +235b 2359 80a9 833c +2359 23a7 80a9 833b +235a 235b 8034 833c +235c 235a 8034 833d +235a 235d 8035 833d +235b 235c 8034 8ac5 +23a7 235b 80a9 8b4b +235b 2600 89f4 8b4b +235d 235c 82df 833d +235c 2492 82df 8a48 +235d 235e 8036 833e +2492 235d 82df 833e +235e 235f 8037 833f +235e 2492 82e0 833e +2360 235f 8038 8039 +235f 2361 8038 8341 +2361 2360 8038 803b +2360 2362 803a 8342 +2363 2360 803b 8342 +2361 2363 803b 8581 +2602 2361 857f 8581 +2362 2363 82e1 8342 +2362 2364 803c 8343 +2367 2362 82e2 8343 +2493 2362 82e1 82e2 +2363 2493 82e1 8a52 +2602 2363 8581 896d +2603 2363 896d 8a52 +2364 2365 803d 8344 +2366 2364 803e 8344 +2364 2367 803e 8343 +2365 2366 8040 8344 +2365 2368 803f 8345 +2369 2365 8040 8345 +2367 2366 803e 8587 +2366 2369 8040 8a13 +2605 2366 8587 8589 +2607 2366 8589 8a13 +2493 2367 82e2 89e2 +2605 2367 8586 8587 +2367 2606 8586 89e2 +2368 2369 8042 8345 +2368 236a 8041 8346 +236b 2368 8042 8346 +2369 236b 8042 8a4b +2369 2607 858b 8a13 +2608 2369 858b 8a4b +236b 236a 8346 8348 +236b 2608 858d 8a4b +2609 236b 858d 8b66 +236c 236d 8045 8349 +236f 236c 8047 8349 +236d 236e 8046 834a +236f 236d 8349 834a +236f 236e 834a 8593 +236e 2370 8048 8b09 +236e 2495 8b09 8bdc +2497 236e 8593 8bdc +2497 236f 8592 8593 +2495 2370 8b09 8bdd +2371 2372 804c 8c35 +249c 2371 82ee 8bde +2375 2372 8b2a 8c34 +2373 2375 8052 8c78 +2375 2374 804f 8cbb +2374 2377 8b2b 8cbb +2377 2375 8c27 8cbb +2377 2376 8053 8ce7 +2376 2378 8bbc 8c6c +2379 24a0 82f2 85b8 +260d 2379 8595 85b8 +2379 260e 8595 8596 +237a 237c 85bd 8945 +237a 237d 85bc 85bd +2614 237a 8766 8945 +26b9 237a 8780 892f +237c 237b 805d 82f4 +237b 237d 805d 834d +237b 237e 805e 82f4 +237d 237c 805d 85bd +237c 237e 82f4 8ab5 +237c 24b0 8ab5 8bf7 +2612 237c 89d2 8bf7 +2614 237c 8945 89d2 +237e 24b0 8300 8ab5 +237f 2380 8062 8352 +24b2 237f 8302 8352 +237f 24b3 8302 8303 +2380 2381 8063 8353 +2380 24b2 8304 8352 +24b4 2380 8304 8353 +2381 2382 8064 8354 +2381 24b4 8305 8353 +24b5 2381 8305 8354 +2382 2383 8065 8355 +2382 24b5 8306 8354 +24b6 2382 8306 8355 +2383 2384 8066 8356 +2383 24b6 8307 8355 +24b7 2383 8307 8356 +2384 2386 8068 8357 +2384 24b7 8308 8356 +24b8 2384 8308 8357 +2386 2385 8067 8358 +2385 2387 8069 8359 +238a 2385 80d3 8359 +2385 23a9 80d3 8358 +23a9 2386 8309 8358 +2386 24b8 8309 8357 +2387 2388 806a 835a +2389 2387 806b 835a +2387 238a 806b 8359 +2388 2389 806d 835a +2388 238b 806c 835b +238c 2388 806d 835b +238a 2389 806b 85a4 +2389 238c 806d 8a6e +261a 2389 85a4 85a7 +261c 2389 85a7 8a6e +23a9 238a 80d3 85c0 +24b9 238a 85c0 8a3c +238a 261a 85a4 8a3c +238b 238c 830c 835b +238b 238d 806e 835c +24bc 238b 830c 835c +238c 24bc 830c 8aa1 +238c 261c 85a8 8a6e +261d 238c 85a8 8aa1 +238d 238e 806f 835d +24bb 238d 830b 835d +238d 24bc 830b 835c +238e 238f 8070 835e +238e 24bb 830d 835d +24bd 238e 830d 835e +238f 2390 8071 835f +238f 24bd 830e 835e +24be 238f 830e 835f +2390 2391 8072 8360 +2390 24be 830f 835f +24bf 2390 830f 8360 +2391 2392 80db 8361 +24bf 2391 8360 8361 +2392 2393 8074 85b1 +24bf 2392 8361 8afa +24c0 2392 8afa 8c1f +2392 2625 85b1 8c1f +2625 2393 85b1 8b58 +2394 24c4 8316 8c1d +24c5 2394 8316 8b39 +2707 2394 8b39 8c0d +2395 2396 8077 8eb6 +2395 2398 8e6c 8eb7 +2399 2395 8e6c 8eb6 +2396 2399 8d8f 8eb6 +2396 270a 8cbe 8eec +2713 2396 8d8f 8eec +2398 2397 8079 8312 +2397 2399 8079 8e4b +271a 2397 8d73 8db5 +272d 2397 8cbf 8e4b +2399 2398 8079 8e6c +271b 2398 8c50 8e08 +2399 2713 8d8f 8db4 +272c 2399 8ca1 8db4 +2399 272d 8ca1 8e4b +239b 239a 807a 8e05 +239a 239c 807a 8ee3 +24d5 239a 8e05 8e52 +239a 24d6 8d6e 8e52 +272b 239a 8d6e 8dc7 +2750 239a 8dc7 8ee3 +239c 239b 807a 8d8e +239b 24d5 8e05 8e2c +2710 239b 8c80 8e2c +239b 2714 8c80 8e2d +272c 239b 8d8e 8e2d +239d 239c 831a 8e73 +239c 239e 831a 8e53 +2713 239c 8e73 8e97 +239c 272c 8d8e 8e97 +239c 2750 8e53 8ee3 +239d 239e 807b 831a +270a 239d 8b3e 8c0a +2713 239d 8c0a 8e73 +239e 24cb 8318 8ec1 +2750 239e 8e53 8ec1 +23aa 239f 80e5 8323 +24d7 239f 8323 8368 +23a1 23a0 8081 8b9a +23a2 23a0 8084 8cb9 +23a3 23a1 8083 8b2e +23a1 23a4 8083 85b7 +23a4 23a3 8083 8a82 +24d7 23a4 8320 8324 +2488 23a5 82ce 82d0 +2491 23a6 82dd 8b10 +23a6 25f4 856e 8b10 +25f5 23a6 856e 8570 +25f6 23a6 8570 8a5b +23a7 25fe 8579 8aca +2600 23a7 8579 8b4b +23a8 2499 82ec 8beb +23a8 249b 82eb 8bea +24b8 23a9 8309 85bf +24b9 23a9 85bf 85c0 +23aa 24d7 8323 85c3 +23aa 262b 85c3 85c4 +23ab 23ac 80ec 83ed +23ad 23ab 80ec 83ee +23ab 23ae 80ed 83ee +23ac 23ad 80ec 8624 +24dc 23ac 836c 8623 +23ac 262d 85c9 8623 +262f 23ac 85c9 8624 +23ae 23ad 80ee 83ee +23ad 23af 80ee 8627 +23ad 262f 85cb 8624 +2631 23ad 85cb 8627 +23af 23ae 80ee 83ef +23ae 23b0 80ef 83ef +23b0 23af 80f0 83ef +23af 23b1 80f0 8628 +23af 2631 85cd 8627 +2634 23af 85cd 8628 +23b1 23b0 80f0 83f0 +23b1 2634 85cf 8628 +23b2 23b3 80f3 8401 +23b6 23b2 816d 8401 +23b2 2411 816d 837f +23b2 24f2 837f 8400 +23b3 23b4 80f4 8402 +23b5 23b3 80f5 8402 +23b3 23b6 80f5 8401 +23b5 23b4 8402 8403 +23b4 23b7 80f6 8403 +23b6 23b5 80f5 863a +23b7 23b5 80f7 8403 +23b5 23b8 80f7 863b +2638 23b5 863a 863b +2411 23b6 816d 8639 +23b6 2635 85d2 8639 +2638 23b6 85d2 863a +23b8 23b7 80f7 8404 +23b7 23b9 80f8 8404 +23b9 23b8 8170 8404 +23b8 23ba 8170 863c +23b8 2638 85d3 863b +2639 23b8 85d3 863c +23ba 23b9 8170 8405 +23ba 23bb 80fa 863d +23ba 2639 85d4 863c +263a 23ba 85d4 863d +23bb 24f4 8381 863f +23bb 263a 85d6 863d +263b 23bb 85d6 863f +23bc 23bd 80fc 8386 +24f7 23bc 840b 840d +23bc 24f8 8386 840d +23bd 23be 80fd 840e +24f8 23bd 8386 8388 +24f9 23bd 8388 840e +23be 23bf 80fe 840f +2412 23be 8387 840f +23be 24f9 8387 840e +23bf 23c0 817e 8410 +23bf 2412 817b 840f +2413 23bf 817b 8410 +23c0 23c1 8100 8411 +23c0 2413 838a 8410 +24fc 23c0 838a 8411 +23c1 2414 85df 8b42 +24fc 23c1 8411 8b42 +23c3 23c2 8102 8d9a +23c5 23c2 8105 8d33 +23c3 23c4 8103 8d9b +23c4 24fe 8390 8cd8 +23c7 23c6 8109 841c +23c6 23c9 8109 841b +23c7 23c8 8108 8650 +23c9 23c7 8109 864f +2641 23c7 864f 8650 +23c8 2504 8399 8651 +2505 23c8 85e3 8651 +23c8 2641 85e3 8650 +2641 23c9 85e2 864f +23ca 23cb 810b 8422 +2504 23ca 8420 8652 +23ca 2506 841f 8652 +254e 23ca 841f 85e6 +23ca 254f 8422 85e6 +23cb 23cc 8195 8421 +23cb 254f 8421 8422 +23cd 23cc 8423 8424 +254f 23cc 8421 8423 +23cd 23ce 810d 8654 +23cd 254e 85e5 8653 +254f 23cd 8423 8653 +2643 23cd 85e5 8654 +23ce 2507 839b 8655 +23ce 2643 85e7 8654 +2644 23ce 85e7 85e9 +2647 23ce 85e9 8655 +23cf 23d0 810f 842c +250e 23cf 842b 842c +23d0 23d1 8110 842e +23d0 250e 83a2 842c +250f 23d0 83a2 83a3 +2510 23d0 83a3 842e +23d1 23d2 8111 842f +23d1 2510 83a4 842e +2511 23d1 83a4 842f +23d2 23d3 8112 8430 +23d2 2511 83a5 842f +2512 23d2 83a5 8430 +23d3 23d4 8113 8432 +23d3 2512 83a6 8430 +2513 23d3 83a6 8432 +23d4 23d5 8114 8433 +23d4 2513 83a7 8432 +2514 23d4 83a7 8433 +23d5 23d6 8115 8435 +2514 23d5 8433 8435 +23d6 23d7 8116 8436 +23d6 2514 83a9 8435 +2517 23d6 83a9 8436 +23d7 23d8 8117 8437 +23d7 2517 83aa 8436 +2518 23d7 83aa 8437 +23d8 23d9 8118 8438 +23d8 2518 83ab 8437 +2519 23d8 83ab 8438 +23d9 23da 8119 8439 +23d9 2519 83ac 8438 +251a 23d9 83ac 8439 +23da 23db 811a 843a +23da 251a 83ad 8439 +251b 23da 83ad 843a +23db 23dc 811b 843b +23db 251b 83af 843a +251e 23db 83af 843b +23dc 23dd 811c 843c +23dc 251e 83b0 843b +251f 23dc 83b0 843c +23dd 23de 811d 843d +23dd 251f 83b2 843c +2522 23dd 83b2 843d +23de 23df 811e 843e +23de 2522 83b3 843d +2523 23de 83b3 843e +23df 23e0 811f 843f +23df 2523 83b4 843e +2524 23df 83b4 843f +23e0 23e1 8120 8440 +23e0 2524 83b5 843f +2525 23e0 83b5 8440 +23e1 23e2 8121 8442 +23e1 2525 83b6 8440 +2526 23e1 83b6 8442 +23e2 23e3 8122 8443 +23e2 2526 83b7 8442 +2527 23e2 83b7 8443 +23e3 23e4 8123 8444 +23e3 2527 83b8 8443 +2528 23e3 83b8 8444 +23e4 23e5 8124 8445 +23e4 2528 83ba 8444 +252b 23e4 83ba 8445 +23e5 23e6 8125 8446 +23e5 252b 83bb 8445 +252c 23e5 83bb 8446 +23e6 23e7 8126 8447 +23e6 252c 83bc 8446 +252d 23e6 83bc 8447 +23e7 23e8 8127 8448 +23e7 252d 83be 8447 +252f 23e7 83be 8448 +23e8 23e9 8128 8449 +23e8 252f 83bf 8448 +2530 23e8 83bf 8449 +23e9 23ea 8129 844a +23e9 2530 83c0 8449 +2531 23e9 83c0 844a +23ea 23eb 812a 844b +23ea 2531 83c1 844a +2532 23ea 83c1 844b +23eb 23ec 812b 844c +23ed 23eb 83c2 844c +23eb 2532 83c2 844b +23ec 23ed 812c 844c +23ee 23ec 812c 844d +23ec 23ef 812d 844d +23ed 23ee 812c 8604 +2532 23ed 83c2 867b +265c 23ed 867b 8a4c +23ed 265d 8603 8a4c +23ed 265e 8604 8605 +23ef 23ee 812e 844d +23ee 23f0 812e 8ac8 +265e 23ee 8604 8ac8 +23f0 23ef 812e 844e +23ef 23f1 812f 844e +23f1 23f0 8130 844e +23f0 23f2 8130 8607 +23f0 265e 8606 8ac8 +265f 23f0 8606 8607 +23f2 23f1 8130 844f +23f1 23f3 8131 844f +23f3 23f2 8132 844f +23f2 23f4 8132 8b94 +265f 23f2 8607 8609 +2660 23f2 8609 8b94 +23f4 23f3 8132 8450 +23f4 23f5 8134 8aae +23f4 2660 8aad 8b94 +2661 23f4 8aad 8aae +23f5 2418 83c3 860b +2661 23f5 8aae 8ab1 +23f5 2662 860b 8ab1 +23f6 2418 81bf 8452 +2533 23f7 83c6 8b86 +23f7 2536 8b12 8b86 +23f9 23f8 813c 8c7b +2539 23f8 8b25 8be5 +23f9 23fa 813b 8c7a +23fb 23fa 813e 8c41 +23fb 23fd 8142 8c40 +23fb 23fe 8c40 8c96 +23fd 23fc 8141 8c49 +23fe 23fd 8c40 8c97 +23ff 2400 8af9 8bc1 +23ff 2401 8148 8af8 +2401 2402 8617 8aea +2665 2401 8618 8aea +2402 253a 83d3 8a88 +2402 2664 8a88 8a9d +2402 2665 8a9d 8aea +2405 2403 814c 8cb0 +2405 2404 814b 8d79 +253d 2406 83da 8b1e +2408 2407 8bc4 8c31 +240a 2407 8c31 8c9f +240a 2408 8b75 8c31 +240b 2408 8154 8b75 +240a 2409 8151 8c9e +2409 240b 8c0e 8c9e +2409 2542 8c09 8c0e +2409 2543 83e3 8c09 +240b 240a 8b75 8c9e +2542 240b 83e2 8c0e +240c 240d 8157 8455 +2541 240c 83e1 8455 +240d 240e 8158 8456 +240d 2541 83e7 8455 +2546 240d 83e7 8456 +240e 240f 815a 8457 +240e 2546 83e6 8456 +2547 240e 83e6 8457 +240f 2410 8159 8458 +240f 2547 83e8 8457 +2548 240f 83e8 8458 +2410 2548 83eb 8458 +254a 2410 83eb 8459 +2411 24ef 8380 8637 +24f2 2411 837f 8637 +24f3 2411 8380 85d0 +2635 2411 85d0 8639 +2412 2413 817b 8ada +24f9 2412 8387 8649 +2412 24fb 85db 8649 +263e 2412 85db 8bad +2412 263f 8ada 8bad +2413 24fc 838a 85dc +2413 263f 85dc 8ada +2416 2414 8bfe 8c53 +24fc 2414 8b42 8b92 +2414 24fd 838b 8b92 +2416 2415 8182 8c52 +24fe 2415 838d 8bff +2417 2479 8414 8500 +2417 24ff 8500 8716 +256a 2417 864a 8699 +2685 2417 8699 8716 +2662 2418 860b 860d +241a 2419 81d6 84f2 +2419 2556 8460 84f2 +255c 2419 8460 84f3 +241a 2555 845b 894e +2556 241a 845b 84f2 +241b 241f 81db 8468 +241b 2565 8468 84fa +241d 241c 81da 846d +241c 241e 81da 8960 +241c 2566 89ea 8b28 +241e 241d 81da 8961 +241d 2420 8469 84fc +2421 241d 846e 84fc +241d 2567 846e 8694 +241d 2683 8694 8961 +2683 241e 8695 8961 +2565 241f 8468 8a3b +241f 2566 846c 8a3b +2420 2421 81de 84fc +2567 2421 846e 84fd +2423 2422 81df 8b1b +2422 2425 8b1a 8bae +2426 2423 81e7 8473 +2424 2425 8bd3 8c29 +2427 2426 8978 8ac0 +2426 256b 89de 8ac0 +256b 2427 8475 8ac0 +2428 2429 81eb 8479 +247a 2428 8264 8502 +2428 247b 8479 8502 +2429 242a 81ec 8503 +242d 2429 8266 8503 +2429 247b 8266 8479 +242a 242b 81ed 8504 +242c 242a 81ee 8504 +242a 242d 81ee 8503 +242b 242c 847a 8504 +2570 242b 847a 8505 +242d 242c 81ee 8896 +242c 247c 8507 86a8 +242c 2570 847a 8507 +242c 2691 86a8 8896 +247b 242d 8266 88b3 +242d 2690 86a6 88b3 +2691 242d 86a6 8896 +242e 242f 81f2 851d +242e 258b 8494 851c +258d 242e 8494 851d +242f 2430 81f3 8496 +258d 242f 851d 851f +242f 258f 8496 851f +2431 2430 8495 8520 +2430 258f 8495 8496 +2431 2432 81f5 86bd +258f 2431 8495 873a +2431 2590 851e 873a +25d4 2431 851e 86bd +25d4 2432 86bd 8882 +2432 2699 8868 8889 +269a 2432 8882 8889 +2699 2433 86c2 88f7 +2435 2434 81fa 8956 +2436 2434 81fc 8201 +2434 2437 81fc 8956 +2438 2434 8957 8980 +2434 243a 88cb 8980 +2435 2437 8956 898e +2437 2436 81fc 8948 +2438 2439 81ff 8903 +243a 2438 81ff 8980 +2439 243a 81ff 8200 +2439 243b 8203 849b +243b 243c 8204 849a +2592 243b 88b5 88ee +243b 2593 849a 88ee +2593 243c 849a 88ef +243d 243e 8208 84a1 +243d 259b 84a1 8892 +243e 243f 8209 88e0 +259a 243e 84a3 888f +259b 243e 84a1 84a3 +259c 243e 888f 88e0 +243f 2440 820a 888a +2599 243f 84a5 888a +243f 259c 84a5 88e0 +2440 2599 84a6 888a +259d 2440 84a6 8899 +2441 2442 820e 84af +2441 259f 84ae 88a8 +25a0 2441 84ae 84af +25a0 2442 84af 88a6 +2442 25a1 84b0 88a6 +25a3 2443 84b3 84b8 +2443 25a4 84b5 84b8 +2445 2444 8215 895a +2446 2445 8213 8214 +2448 2447 8218 84bf +2447 244b 821e 84be +2447 244d 84be 8935 +25a7 2447 84bf 8935 +2448 25a7 84bf 8a36 +244b 244a 821d 8522 +244a 244c 8221 8522 +244a 244e 8220 8523 +244f 244a 8221 8523 +244c 244b 821f 8522 +244b 244d 821f 84be +244d 244c 821f 890c +244c 244f 8221 86c4 +25a9 244c 890c 8923 +244c 269c 86c4 8923 +244d 25a7 86c6 8935 +244d 25a9 890c 892b +25ab 244d 86c6 892b +244e 244f 84c1 8523 +25ac 244e 84c1 8524 +244f 25ac 84c1 86cb +269b 244f 86c3 86ca +244f 269c 86c3 86c4 +269e 244f 86ca 86cb +2450 2451 8226 8538 +2453 2451 84d6 88f0 +2451 2457 84d6 88cc +2453 2452 8227 88f1 +2455 2452 88df 8971 +2452 2458 88de 8971 +2453 2457 822b 84d6 +2454 2458 8962 89aa +2458 2455 8930 8971 +2455 2459 88d4 8970 +2456 25c3 84d9 8939 +2457 25c0 84d7 887b +245a 245b 8231 887e +245a 25c1 84df 88bc +245b 245c 8232 84e1 +245c 245d 8233 8539 +25c6 245c 84e0 8539 +245d 245e 8234 853b +25c6 245d 8539 853b +245e 245f 8235 853c +2460 245e 84e2 853c +245e 25c6 84e2 853b +245f 2460 8236 853c +2461 245f 8236 853d +245f 2462 8237 853d +2460 2461 8236 889e +25c6 2460 84e2 885b +2460 26a5 86e3 885b +26a6 2460 86e3 889e +2462 2461 82af 853d +2461 247d 82af 885c +2461 26a6 8859 889e +26a7 2461 8859 885c +2462 2463 8238 853e +247d 2462 82af 853e +2463 2464 8239 853f +2465 2463 84e3 853f +2463 247d 84e3 853e +2464 2465 823a 853f +2466 2464 823a 8540 +2464 2467 823b 8540 +2465 2466 823a 86ec +247d 2465 84e3 86e7 +26a9 2465 86e7 86eb +26aa 2465 86eb 86ec +2467 2466 84e4 8540 +2466 25c7 84e4 84e5 +2466 25c8 84e5 8860 +26aa 2466 86ec 8860 +2467 2468 823c 8541 +25c7 2467 84e4 8541 +2468 2469 823d 8543 +2468 25c7 84e6 8541 +25c9 2468 84e6 8543 +2469 246a 823e 8544 +2469 25c9 84e7 8543 +25ca 2469 84e7 8544 +246a 246b 823f 8545 +246c 246a 84e8 8545 +246a 25ca 84e8 8544 +246b 246c 8240 8545 +246d 246b 8240 8546 +246b 246e 8241 8546 +246c 246d 8240 886d +25ca 246c 84e8 8759 +246c 25da 86f0 8759 +26ac 246c 86f0 886d +246e 246d 8242 8546 +246d 246f 8242 8874 +246d 26ac 86f5 886d +26ad 246d 86f5 8874 +246f 246e 8242 8547 +246e 2470 8243 8547 +2470 246f 82b7 8547 +246f 247e 82b7 88b8 +246f 26ad 86f1 8874 +26ae 246f 86f1 88b8 +2470 2471 8244 8548 +247e 2470 82b7 8548 +2471 2472 8245 8549 +2471 247e 84e9 8548 +25cb 2471 84e9 8549 +2472 2473 8246 84ea +2472 247f 84ea 854a +25cb 2472 8549 854a +2474 2473 82bb 854b +2473 247f 82bb 84ea +2474 2475 8248 8914 +247f 2474 82bb 86fd +26b4 2474 86fd 8914 +25cf 2475 854c 8880 +2475 25db 854c 8700 +2475 26b4 8700 8914 +2476 2477 824b 8a6c +25cd 2477 84ed 897c +2477 25ce 84ed 8a20 +2565 2478 8690 8993 +2478 2566 8690 8692 +2478 25d1 8691 8993 +24ff 2479 8500 864b +2479 2502 8394 864b +247a 247b 8502 889b +268a 247a 869f 893a +247a 268c 8901 893a +247a 268f 889b 8901 +247b 268f 86a4 889b +2690 247b 86a4 88b3 +2570 247c 847c 8507 +247c 2572 847c 8509 +247c 2691 86a7 86a8 +26a7 247d 885c 8871 +247d 26a9 86e7 8871 +247e 25cb 84e9 885e +247e 26ae 86f8 88b8 +26af 247e 86f8 88d9 +247e 26b1 885e 88d9 +25cb 247f 854a 86f9 +247f 26b1 86f7 86f9 +26b2 247f 86f7 88b0 +247f 26b4 86fd 88b0 +2480 2481 82c5 8c3b +2482 2481 82c9 8c06 +2483 2482 82c7 82cc +2485 2482 82cc 8c07 +2484 2483 8ae1 8c2b +2483 2485 82cc 8c2b +2485 2484 8c05 8c2b +2486 2484 8b70 8c05 +2485 2486 82ca 8c05 +2487 2486 82cd 8c12 +2488 2487 82cb 8c13 +248a 2489 82d3 8ae4 +2489 248b 8327 8b84 +2489 25dd 8a91 8ae4 +25e1 2489 8a91 8b84 +25dd 248a 854e 8ae4 +248a 25de 854e 8550 +248b 25e1 8552 8b84 +25e2 248b 8552 8a8e +248c 248d 832c 8b34 +25e3 248c 8558 8a7d +25e8 248c 8a7d 8b34 +248d 25e8 855c 8b34 +25e9 248d 855c 8a50 +248e 248f 82db 8acf +248e 25ef 8566 8aef +25f1 248e 8566 8acf +248f 2490 82da 8569 +25f1 248f 8acf 8af5 +248f 25f2 8569 8af5 +2490 2491 8335 8ad3 +25f2 2490 8569 856a +25f3 2490 856a 8ad3 +2491 25f3 856d 8ad3 +25f4 2491 856d 8b10 +2493 2603 8583 8a52 +2604 2493 8583 8a5f +2493 2606 89e2 8a5f +2495 2494 82e4 82e5 +2494 2496 82e4 8bc2 +2497 2494 82e5 8bc3 +2494 249a 8bc2 8bf3 +2496 2495 82e4 8b0b +2495 2497 82e5 8bdc +2498 2496 82e9 8b0d +2496 249a 82e9 8bc2 +2498 2499 82e7 8c1b +249a 2498 82e9 8c1b +2499 249a 8bf2 8c1b +249c 249b 82ed 8b8d +249d 249e 82f0 8598 +249d 249f 8a69 8bb4 +26b7 249d 8a65 8bb4 +249f 260e 8597 8a68 +249f 26b7 8a68 8bb4 +24a0 260d 8599 85b8 +24a2 24a1 82f5 8f17 +24a9 24a1 8cd6 8f16 +24a1 24ab 8cd6 8f17 +24ab 24a2 8f15 8f17 +24af 24a2 82ff 8f15 +24a4 24a3 82f6 8c95 +24a3 24b1 8301 8d1e +270b 24a3 8c95 8d1e +24a5 24a4 82f7 8bc8 +24a4 24a6 82f7 82f8 +270b 24a4 8bc8 8c95 +24a6 24a5 82f7 8dd4 +24a5 24a7 8d74 8dd4 +24a5 270b 8bc8 8c24 +24a5 2718 8c24 8d35 +24a5 274b 8d35 8d74 +24a7 24a6 8c25 8dd4 +24a8 24a7 82fa 8dd5 +24a7 274b 8d74 8e4f +2751 24a7 8dd5 8e4f +24a9 24a8 82fc 8ea6 +24a8 2751 8dd5 8ea6 +24aa 24a9 82fb 8ebf +24a9 24ab 82fb 8cd6 +24a9 2751 8ea6 8ebf +24ab 24aa 82fb 8ec3 +24aa 24ac 8dbc 8ec3 +274b 24aa 8dbc 8ec2 +24aa 2751 8ebf 8ec2 +24ac 24ab 82fe 8ec3 +24ab 24af 82fe 8f15 +24ad 24ac 82fd 8cd7 +24ac 24ae 82fd 8e34 +24af 24ac 82fe 8e34 +2718 24ac 8cd7 8e4e +24ac 274b 8dbc 8e4e +24ae 24ad 82fd 8e50 +24d9 24ad 8bf6 8ceb +24ad 2718 8cd7 8d1f +2719 24ad 8ceb 8d1f +24af 24ae 8e34 8ec4 +24b0 24d8 834f 8c38 +24d9 24b0 834f 8cea +2612 24b0 8bf7 8c38 +24b1 24d8 8a94 8b46 +24b1 2611 8966 8b47 +2705 24b1 8a94 8b47 +24b1 270b 8b46 8d1e +24b3 24b2 8302 8a56 +24b2 24b4 8304 85a0 +2617 24b2 8a56 8a87 +24b2 2618 85a0 8a87 +24da 24b3 8a47 8b8f +24b3 2617 8a56 8b8f +24b4 24b5 8305 85a1 +2618 24b4 85a0 85a1 +24b5 24b6 8306 876b +2618 24b5 85a1 8769 +24b6 24b7 8307 85a3 +24b6 2619 85a3 876a +24b7 24b8 8308 85be +24ba 24b7 85a2 85be +24b7 2619 85a2 85a3 +24b9 24b8 830a 85bf +24b8 24ba 830a 85be +24ba 24b9 830a 8984 +261a 24b9 85a5 8a3c +24b9 261b 85a5 8772 +24b9 26bc 8772 8984 +2619 24ba 85a2 8a62 +26bc 24ba 8982 8984 +24bc 24bb 830b 8b88 +24bb 24bd 830d 8b62 +24bb 261d 8a9e 8b88 +261f 24bb 8a9e 8b62 +261d 24bc 8aa1 8b88 +24bd 24be 830e 8a71 +24bd 261f 85ac 8b62 +2620 24bd 85ac 8a71 +24be 24bf 830f 8a73 +2620 24be 8a71 8b6f +24be 2624 8a73 8b6f +24c0 24bf 85b0 8afa +24bf 24c2 85b0 8c22 +24bf 2624 85b4 8a73 +2626 24bf 85b4 8c22 +24c1 24c0 8310 8c23 +24c0 24c2 8310 85b0 +2625 24c0 8c1c 8c1f +24c0 270c 8c1c 8c23 +24c2 24c1 8310 8cef +24c9 24c1 8315 8cee +24c1 270c 8c23 8cee +24c2 2626 85b2 8c22 +24c4 24c3 8311 8b59 +24c3 24c5 8311 8b61 +24c3 24c9 8b38 8d58 +270c 24c3 8b59 8d58 +24c3 270f 8b61 8d3d +271e 24c3 8cec 8d3d +24c5 24c4 8311 8316 +2625 24c4 8b30 8c1e +24c4 270c 8b59 8c1e +24c5 2707 8b39 8c63 +270f 24c5 8b61 8c7c +24c5 2717 8c63 8d3e +2722 24c5 8c7c 8d3e +24c7 24c6 8313 8dd0 +24c6 24c8 8313 8ced +271f 24c6 8dd0 8e74 +2731 24c6 8e89 8edb +24c6 273c 8ced 8edb +24c8 24c7 8313 8e7e +270f 24c7 8dd1 8e2a +24c7 271e 8c62 8e2a +271f 24c7 8c62 8dd0 +24c7 2722 8dd1 8e7e +24cf 24c8 8d3b 8e7f +24c8 2716 8d3c 8d66 +2722 24c8 8d3c 8e7e +273c 24c8 8ced 8d3b +24c8 274c 8d66 8e7f +24c9 270c 8cee 8d58 +24d1 24ca 8eee 8ef9 +270d 24ca 8ef9 8f1a +24cd 24cb 8e06 8ebc +24cb 2708 8e06 8ee2 +2750 24cb 8ec1 8ee2 +24cd 24cc 831b 8f06 +24d3 24cc 8c81 8e07 +24cc 2709 8c81 8f06 +2708 24cd 8e06 8efc +2709 24cd 8efc 8f06 +24cf 24ce 831c 8eda +24ce 24d0 831c 8eb9 +24d1 24ce 8e88 8ef5 +24ce 24d2 831e 8ef5 +24d3 24ce 831e 8eb9 +2731 24ce 8e28 8ef8 +24ce 273c 8e28 8eda +24ce 2756 8e88 8ef8 +24d0 24cf 831c 8ee0 +272a 24cf 8ca0 8ed9 +24cf 272b 8ca0 8ee0 +273c 24cf 8d3b 8eda +24cf 274c 8e7f 8ed9 +24d3 24d0 8eb9 8ee1 +2708 24d0 8ac3 8d67 +24d0 2709 8ac3 8ee1 +272b 24d0 8d67 8ee0 +24d2 24d1 831d 8ef5 +270d 24d1 8e60 8ef9 +24d1 2756 8e60 8e88 +24d2 24d3 831e 8d3a +2709 24d3 8c81 8ee1 +24d5 24d4 831f 8d6f +24d4 24d6 831f 8e27 +2707 24d4 8ca6 8d3f +24d4 2710 8ca6 8d6f +2716 24d4 8c0c 8e27 +24d4 2717 8c0c 8d3f +24d6 24d5 831f 8e52 +24d5 2710 8d6f 8e2c +24d6 2716 8e04 8e27 +272a 24d6 8e29 8ed8 +24d6 272b 8d6e 8ed8 +274c 24d6 8e04 8e29 +262b 24d7 85c3 85c5 +24d8 24d9 834f 8c93 +24d8 2612 8b2c 8c38 +24d8 2705 8a94 8b2c +270b 24d8 8b46 8c39 +2719 24d8 8c39 8c93 +2719 24d9 8c93 8ceb +24db 24da 8351 8b8e +24da 2615 859f 8b8e +24da 2616 859e 859f +2617 24da 859e 8b8f +24db 2611 8967 8bcc +2613 24db 8af2 8bcd +24db 2615 8b8e 8bcd +2705 24db 8967 8af2 +24dd 24dc 836d 85c6 +262c 24dc 85c6 85c7 +262d 24dc 85c7 8623 +254a 24dd 845a 867d +24dd 262c 85c6 867f +24de 24df 8370 862c +24e2 24de 83f4 862c +24de 254b 83f4 862b +24df 24e0 8371 862d +24e1 24df 8372 862d +24df 24e2 8372 862c +24e0 24e1 83f7 862d +24e0 24e3 8373 862e +24e6 24e0 83f7 862e +24e2 24e1 8372 880c +24e1 24e6 83f7 880e +24e1 26c7 8790 880c +26ca 24e1 8790 880e +254b 24e2 83f4 880a +24e2 26c6 878d 880a +26c7 24e2 878d 880c +24e3 24e4 8374 862f +24e5 24e3 8375 862f +24e3 24e6 8375 862e +24e4 24e5 83fa 862f +24e4 24e7 8376 8630 +24eb 24e4 83fa 8630 +24e6 24e5 8375 8810 +24e5 24eb 83fa 8812 +24e5 26cb 8793 8810 +26cc 24e5 8793 8812 +24e6 26ca 8791 880e +26cb 24e6 8791 8810 +24e7 24e8 8377 8632 +24ea 24e7 8379 8632 +24e7 24eb 8379 8630 +24e8 24e9 8378 8633 +24ea 24e8 8632 8633 +24e9 24ea 83fe 8633 +24e9 24ec 837a 8634 +24f0 24e9 83fe 8634 +24eb 24ea 8379 8814 +24ea 24f0 83fe 8817 +26cd 24ea 8814 8817 +24eb 26cc 8794 8812 +26cd 24eb 8794 8814 +24ec 24f0 837c 8634 +24f1 24ec 837c 8636 +24ec 24f2 837d 8636 +24ee 24ed 837b 8638 +24ed 24ef 837b 881c +24f3 24ed 879a 881c +24ed 26cf 879a 879c +24ed 26d1 879c 881f +24ef 24ee 837b 881a +24ee 24f1 8635 881a +266e 24ee 8635 881b +24f1 24ef 837e 881a +24ef 24f2 837e 8637 +24ef 24f3 8380 881c +24f0 24f1 837c 8818 +266e 24f0 8796 8818 +24f0 26cd 8796 8817 +24f2 24f1 837e 8636 +24f1 266e 8635 8818 +24f3 2635 85d0 881e +26cf 24f3 879a 879d +26d0 24f3 879d 881e +24f4 24f5 8382 8641 +24f4 263b 85d7 863f +263c 24f4 85d7 8641 +24f5 24f6 8383 8642 +24f5 263c 85d8 8641 +263d 24f5 85d8 8642 +24f6 263d 85d9 8642 +24f7 24f8 840d 8646 +254c 24f7 85da 8646 +24f8 24f9 8388 8648 +24fa 24f8 840c 8648 +24f8 254c 840c 8646 +24f9 24fa 8389 8648 +24fb 24f9 8389 8649 +24fa 24fb 8389 89f1 +254c 24fa 840c 8a3f +24fa 26d5 87ab 8a3f +26d8 24fa 87ab 89f1 +24fb 263e 85db 8aa3 +2674 24fb 87ae 8aa3 +24fb 26d8 87ae 89f1 +24fd 24fc 8a5d 8b92 +263f 24fc 85dc 85e1 +2640 24fc 85e1 8a5d +24fd 2640 85e0 8a5d +2500 24ff 8393 8417 +24ff 2501 8393 8831 +2502 24ff 8417 864b +2685 24ff 8716 8830 +2689 24ff 8830 8831 +2501 2500 8393 841a +2500 2502 8417 864c +2503 2500 8397 864c +254d 2500 841a 8832 +2501 254d 841a 87b0 +2687 2501 869d 8833 +2501 2689 869d 8831 +2502 2503 8395 864c +2504 2505 839a 8651 +2506 2504 839a 8652 +2505 2506 839a 883a +2641 2505 85e3 8838 +2505 26d9 87b7 8838 +26de 2505 87b7 883a +2506 254e 841f 87bb +2506 26dd 87bb 8adf +2506 26de 87b8 883a +26df 2506 87b8 8adf +2507 2508 839c 8657 +2550 2507 85eb 8657 +2507 2647 85eb 8655 +2508 2509 839d 8658 +250c 2508 8428 8658 +2508 2550 8428 8657 +2509 250a 839e 8659 +250b 2509 839f 8659 +2509 250c 839f 8658 +250a 250b 85ed 8659 +250a 250d 83a0 865a +264a 250a 85ed 865a +250c 250b 839f 87c0 +250b 264a 85ed 89af +26e2 250b 87c0 87c3 +26e3 250b 87c3 89af +2550 250c 8428 8844 +26e1 250c 8844 89bd +250c 26e2 87c0 89bd +250d 250e 83a1 865b +250d 264a 85ee 865a +264b 250d 85ee 865b +250e 250f 83a2 865c +264b 250e 865b 865c +250f 2510 83a3 865d +2551 250f 842d 865d +250f 2552 842d 85ef +250f 264b 85ef 865c +2510 2511 83a4 865e +2510 2551 85f0 865d +264c 2510 85f0 865e +2511 2512 83a5 8431 +2511 2516 8431 865f +264c 2511 865e 865f +2512 2513 83a6 8660 +2515 2512 83a8 8660 +2512 2516 83a8 8431 +2513 2514 83a7 8661 +2513 2515 8434 8660 +2553 2513 8434 8661 +2514 2517 83a9 8662 +2553 2514 8661 8662 +2516 2515 83a8 87d2 +2515 2553 8434 89d9 +2515 26e8 89d9 8a09 +26eb 2515 87d2 8a09 +264c 2516 865f 89c6 +26eb 2516 87d0 87d2 +2516 26ec 87d0 89c6 +2517 2518 83aa 8663 +2517 2553 85f1 8662 +264d 2517 85f1 8663 +2518 2519 83ab 8664 +2518 264d 85f2 8663 +264e 2518 85f2 8664 +2519 251a 83ac 8665 +2519 264e 85f3 8664 +264f 2519 85f3 8665 +251a 251b 83ad 8666 +251c 251a 85f4 8666 +251a 264f 85f4 8665 +251b 251c 83ae 8666 +251d 251b 83ae 8667 +251b 251e 83af 8667 +251c 251d 83ae 89a8 +264f 251c 85f4 87d5 +26ee 251c 87d5 87da +251c 26f1 89a8 8a23 +251e 251d 85f5 8667 +251d 2520 85f5 87dc +251d 26f1 87dc 89a8 +251e 251f 83b0 8668 +2520 251e 85f5 8668 +251f 2520 83b1 8668 +2521 251f 83b1 866a +251f 2522 83b2 866a +2520 2521 83b1 89ba +2675 2520 87dd 89ba +26f1 2520 87dc 87dd +2522 2521 85f8 866a +2521 2650 85f8 89d0 +2653 2521 87df 89d0 +2521 2675 87df 89ba +2522 2523 83b3 866b +2650 2522 85f8 866b +2523 2524 83b4 866d +2523 2650 85f6 866b +2651 2523 85f6 866d +2524 2525 83b5 866f +2524 2651 85f7 866d +2652 2524 85f7 866f +2525 2526 83b6 8670 +2525 2652 85fa 866f +2655 2525 85fa 8670 +2526 2527 83b7 8671 +2526 2655 85fb 8670 +2656 2526 85fb 8671 +2527 2528 83b8 8673 +2527 2656 85fc 8671 +2657 2527 85fc 8673 +252a 2528 85fd 8674 +2528 252b 83ba 8674 +2528 2657 85fd 8673 +252a 2529 83b9 898b +2529 252b 83b9 8675 +252c 2529 83bd 8675 +2529 252e 83bd 8a7e +2529 26f7 8940 898b +26fa 2529 8940 8a7e +252b 252a 83b9 8674 +2657 252a 85fd 8672 +2678 252a 8672 87e7 +26f5 252a 87e7 87e9 +26f7 252a 87e9 898b +252b 252c 83bb 8675 +252c 252d 83bc 8676 +252e 252c 83bd 8676 +252d 252e 85fe 8676 +252d 252f 83be 8677 +2658 252d 85fe 8677 +252e 2658 85fe 8aa5 +26fa 252e 8a7e 8aa5 +252f 2530 83bf 8678 +252f 2658 85ff 8677 +2659 252f 85ff 8678 +2530 2531 83c0 8679 +2530 2659 8600 8678 +265a 2530 8600 8679 +2531 2532 83c1 8602 +265a 2531 8679 867a +2531 265b 8602 867a +2532 265b 8601 8602 +265c 2532 8601 867b +2534 2533 83c7 8c10 +2533 2536 8b86 8c10 +2534 2535 83c9 8bfa +2536 2534 83c9 8c10 +2537 2534 8b13 8bfa +2535 2536 83c9 83cb +2535 2537 8b73 8bfa +2538 2535 83cd 8bd5 +2538 2539 83cf 8bd4 +253b 253a 83d4 8abe +2664 253a 8a88 8abf +253c 253d 83df 8bfd +253f 253e 83e0 8be2 +253e 2540 83e0 8a32 +253e 2543 8a32 8be3 +2540 253f 83e0 8b3b +2541 253f 861c 8a31 +253f 2666 861c 8b3b +2543 2540 8a32 8b4d +2544 2540 83e5 8b54 +2540 2545 83e5 8b4d +2666 2540 861e 8b3b +2540 2668 861e 8b54 +2541 2546 83e7 8af6 +2666 2541 861c 8a33 +2669 2541 8a33 8af6 +2543 2542 8ab8 8c09 +2542 2545 8ab8 8c0f +2545 2543 8ab8 8b4d +2545 2544 83e5 8a30 +2668 2544 8b33 8b54 +2546 2547 83e6 89c2 +2546 2669 896a 8af6 +266b 2546 896a 89c2 +2547 2548 83e8 861f +2547 2549 861f 87fd +2547 266b 87fd 89c2 +2549 2548 861f 867c +2548 254a 83eb 867c +254a 2549 83ea 867c +266a 2549 8621 8937 +2549 266b 8621 87fd +254b 26c3 878c 8809 +26c6 254b 878c 880a +26d5 254c 87a9 8a3f +26da 254d 8835 8837 +26db 254d 87b3 8835 +254e 254f 85e6 8653 +254e 2643 85e5 883d +26dd 254e 87bb 883d +2647 2550 85eb 8843 +26e1 2550 8843 8844 +2552 2551 842d 89c9 +2551 264c 85f0 87ce +2551 26e9 87ce 8ad1 +26ea 2551 89c9 8ad1 +264b 2552 85ef 8a19 +2552 26e6 87ca 8a19 +26e7 2552 87ca 8ad0 +2552 26ea 89c9 8ad0 +2553 264d 85f1 87cb +2553 26e8 87cb 89d9 +2554 2652 8942 89f9 +2554 2655 89f9 8a29 +2676 2554 8942 8abb +2554 26f2 89f8 8abb +26f3 2554 87e5 8a29 +2555 2556 845b 845c +2555 2557 845c 845f +2555 2559 845e 8afc +255a 2555 845e 894f +2555 255b 845f 894f +2557 2556 845c 8968 +2556 255c 8460 8680 +2556 25d0 8680 8968 +255b 2557 845f 8acc +25d0 2557 88d7 8968 +2557 267a 88d7 8969 +267c 2557 8933 8969 +2557 267f 8933 8acc +267d 2558 8686 8b15 +2558 267e 89a3 8b37 +2706 2558 8b15 8b37 +2559 255a 845e 8afd +255a 255b 894f 8a44 +2679 255a 8681 8a44 +255b 2679 89ac 8a44 +255b 267e 8687 89ac +267f 255b 8687 8acc +255c 255d 8461 8704 +25d0 255c 8680 8704 +255d 255e 8462 8705 +255f 255d 84f4 8705 +255d 25d0 84f4 8704 +255e 255f 8463 8705 +2560 255e 8463 868a +255e 2561 8464 8708 +2681 255e 868a 8708 +255f 2560 8463 8707 +25d0 255f 84f4 8689 +2680 255f 8689 88da +2560 2562 868b 88cf +2560 2681 868a 868b +2561 2563 8466 8709 +2561 25d2 8709 870c +2681 2561 8708 870c +2562 2681 868b 870a +2563 2564 8467 868d +25d1 2563 84f9 868d +2563 25d2 84f9 8709 +2564 2565 84fb 870d +25d1 2564 868d 870d +2566 2565 8690 8a3b +25d1 2565 870d 8993 +2567 2568 846f 870f +2683 2567 8694 870f +2568 2569 8470 8712 +2568 2683 8698 870f +2684 2568 8698 8712 +2569 256a 8501 869b +2684 2569 8712 8714 +2569 2688 869b 8714 +256a 2685 8699 8715 +2688 256a 869b 8715 +256c 256b 8472 8477 +256e 256b 8477 8979 +256d 256c 89b6 89d5 +256c 256e 8477 89d5 +256e 256d 8476 89d5 +256d 256f 8476 89b7 +268d 256d 8965 89b7 +256f 256e 8476 89b4 +256e 268b 8919 89b4 +268a 256f 86a0 893b +268b 256f 893b 89b4 +256f 268c 86a0 86a2 +256f 268d 86a2 89b7 +2570 2571 847b 8717 +2572 2570 847c 8717 +2571 2572 847e 8717 +2571 2573 847d 8719 +2574 2571 847e 8719 +2572 2574 847e 871b +2573 2574 8480 8719 +2573 2575 847f 871c +2576 2573 8480 871c +2574 2576 8480 86ac +2574 2692 86ac 8863 +2575 2576 850c 871c +2575 2577 8481 871d +2579 2575 850c 871d +2576 2579 850c 86ae +2692 2576 86ac 871e +2577 2578 8482 871f +2577 2579 86ad 871d +25d3 2577 86ad 871f +2578 257b 8484 8721 +257d 2578 850f 8721 +2578 25d3 850f 871f +257a 2579 8483 8720 +2579 25d3 86ad 8720 +257a 25d3 8720 8856 +257b 257c 8485 8724 +257b 257d 86af 8721 +2693 257b 86af 8724 +257c 257f 8487 8725 +257c 2693 86b2 8724 +2696 257c 86b2 8725 +257e 257d 8486 86b1 +25d3 257d 850f 8723 +257d 2693 86af 86b1 +257e 2693 86b1 884e +2695 257e 8728 884e +257f 2580 8488 8727 +257f 2696 86b4 8725 +2697 257f 86b4 8727 +2580 2581 8489 8729 +2584 2580 86b5 8729 +2580 2697 86b5 8727 +2581 2582 848a 872b +2583 2581 848b 872b +2581 2584 848b 8729 +2582 2583 848d 872b +2582 2585 848c 872d +2586 2582 848d 872d +2584 2583 848b 8516 +2583 2586 848d 8518 +2584 2694 872c 884a +2697 2584 86b5 884a +2585 2586 848f 872d +2585 2587 848e 872f +2588 2585 848f 872f +2586 2588 848f 851a +2587 2588 8491 872f +2587 2589 8490 8731 +258a 2587 8491 8731 +2588 258a 8491 8733 +258a 2589 8731 8736 +2589 258b 8492 8734 +2589 258c 8734 8736 +258c 258a 86b9 8736 +2698 258a 86b8 86b9 +258b 258c 86b7 8734 +258b 258d 8494 86b7 +258d 258c 8493 86b7 +258c 258e 8493 8850 +2698 258c 86b9 8735 +26b6 258c 8735 8850 +258e 258d 8493 8737 +258d 258f 851f 8737 +258f 258e 8497 8737 +258e 2590 8497 8739 +26b6 258e 8850 886e +2590 258f 8497 873a +2590 25d4 851e 8883 +2591 2592 8498 88ed +2594 2591 88be 88ed +2593 2592 8499 88ee +2592 2594 8499 88ed +2594 2593 8499 8864 +2596 2593 849f 888d +2593 2598 849f 8864 +2594 2597 88bf 88f3 +2594 2598 8864 88bf +2596 2595 849d 8909 +2595 2597 88f2 8909 +259b 2595 84a2 88c5 +2597 2596 849e 8909 +2596 2598 849e 849f +2598 2597 849e 88bf +2599 259a 84a0 88e1 +259c 2599 84a5 88e1 +2599 259d 84a6 8898 +259b 259a 84a3 88c4 +259a 259c 888f 88e1 +259e 259d 84a9 88aa +259e 259f 84aa 88ab +259f 25a0 84ae 88a7 +25a0 25a1 88a6 88ae +25a3 25a2 84b9 88ad +25a3 25a4 84b8 891d +25a5 25a3 88ac 891d +25a4 25a5 84b7 891d +25a6 25a5 88e5 891a +25a8 25a7 84bc 8a07 +25a7 25ab 86c6 8a07 +25ab 25a8 84c0 8a07 +25a9 25aa 84bd 8974 +25ab 25a9 892b 8974 +269c 25a9 88bb 8923 +25aa 25ab 86c7 8974 +25ac 25ad 84c2 873c +25b0 25ac 86cc 873c +269e 25ac 86cb 86cc +25ad 25ae 84c3 873d +25af 25ad 84c4 873d +25ad 25b0 84c4 873c +25ae 25af 84c6 873d +25ae 25b1 84c5 873f +25b2 25ae 84c6 873f +25b0 25af 84c4 8528 +25af 25b2 84c6 86d0 +269d 25b0 86cd 873e +269e 25b0 86cc 86cd +25b1 25b2 84c8 873f +25b2 269f 8742 886b +25b3 25b4 84ca 8745 +26a0 25b3 86d3 8745 +25b4 25b5 84cb 8747 +25b8 25b4 86d1 8747 +25b4 26a0 86d1 8745 +25b5 25b6 84cc 8749 +25b7 25b5 84cd 8749 +25b5 25b8 84cd 8747 +25b6 25b7 86d5 8749 +25b6 25b9 84ce 874c +25bd 25b6 86d5 874c +25b8 25b7 84cd 874b +25b7 25bd 86d5 86d6 +25d6 25b7 8530 86d6 +26a0 25b8 86d1 8748 +25b9 25ba 84cf 874d +25bc 25b9 84d1 874d +25b9 25bd 84d1 874c +25ba 25bb 84d0 874f +25ba 25bc 84d2 874d +25be 25ba 84d2 874f +25bb 25be 84d4 874f +25bf 25bb 84d4 8751 +25bd 25bc 84d1 8533 +25bc 25be 84d2 8535 +25d6 25bd 86d6 8854 +25be 25bf 84d4 8754 +25bf 26a1 86d8 8885 +26a1 25c0 86da 8884 +25c2 25c1 84d8 88bd +25c1 25c5 86e0 88bd +25c2 25c3 84db 88b6 +25c4 25c2 84db 88f9 +25c2 25c5 88bd 88c9 +25c3 25c4 84db 88f8 +26a4 25c5 8852 88c6 +25d7 25c6 86dd 88a1 +25c6 26a2 86dd 8853 +25c6 26a5 885b 88a1 +25c8 25c7 84e5 8755 +25c7 25c9 84e6 8755 +25c9 25c8 86ed 8755 +25c8 25d9 86ed 86ef +25c8 26aa 86e9 8860 +25c9 25ca 84e7 8757 +25d9 25c9 86ed 8757 +25ca 25d9 8542 8757 +25da 25ca 8542 8759 +25cb 26b1 86f9 885e +25cd 25cc 84f0 895d +25cf 25cc 84ee 895c +25ce 25cd 84ed 8a21 +25db 25cf 854c 8911 +25d0 267a 8683 88d7 +2680 25d0 8688 8689 +25d2 25d1 84f9 870b +2682 25d1 870b 8951 +25d2 2681 868f 870c +25d2 2682 870b 8950 +269a 25d4 86be 8882 +26a0 25d5 86d2 8873 +25d8 25d7 853a 86e2 +26a2 25d7 86dd 88a2 +26a5 25d7 86e2 88a1 +25d8 26a5 86e2 86e5 +25d8 26a8 86e5 889c +25d9 25da 8542 8758 +25d9 26ab 8758 8887 +26ab 25da 8758 875a +25da 26ac 86f0 86f3 +26b4 25db 8700 88c1 +25e0 25dc 8556 8b5b +25e2 25dc 8555 8556 +25dc 25e5 8555 8b5a +25de 25dd 854e 8b80 +25df 25dd 8554 8b77 +25dd 25e1 8a91 8b77 +25e0 25df 8551 8b85 +25df 25e1 8b77 8b85 +25e0 25e1 8b85 8b90 +25e2 25e0 8556 8b90 +25e1 25e2 8552 8b90 +25e5 25e2 8555 8b91 +25e4 25e3 8553 8b53 +25e6 25e3 8559 8b7b +25e3 25e8 8a7d 8b7b +25e5 25e4 8557 8a7c +25e7 25e6 855b 8b35 +25e8 25e6 8b35 8b7b +25e7 25e8 8b35 8bbf +25e9 25e7 855e 8bbf +25ea 25e7 8a51 8b48 +25e7 25eb 855e 8b48 +25e8 25e9 855c 8bbf +25eb 25e9 855e 855f +25ec 25e9 855f 8bbe +25eb 25ea 8aa8 8b48 +25eb 25ec 855f 8ba7 +25ed 25eb 89fe 8ba7 +25ee 25eb 8561 89fe +25ec 25ed 8560 8ba7 +25ee 25ed 89fe 8b64 +25f0 25ed 8564 8b05 +25f0 25ef 8563 8b04 +25ef 25f1 8566 8567 +25f2 25f1 856b 8af5 +25f2 25f3 856a 8af4 +25f3 25f4 856d 856f +25f4 25f5 856e 8b11 +25f5 25f6 8570 8571 +25f5 25f7 8571 8b17 +25f7 25f6 8571 8b21 +25f6 25f8 8572 8b02 +25f6 25f9 8b02 8b21 +25f9 25f7 8b16 8b21 +25f9 25f8 8b02 8b27 +25f8 25fa 8574 8b27 +25fb 25f8 8574 8577 +25ff 25f8 8577 8bb9 +25fa 25f9 8573 8b27 +25fa 25fb 8574 8576 +25fd 25fb 89f5 8b6b +25fe 25fb 8b6b 8bb8 +25fb 25ff 8577 8bb8 +25fd 25fc 8575 8acb +25fc 25fe 8575 8b4a +2600 25fc 8578 8b4a +2601 25fc 8acb 8b22 +25fe 25fd 8575 8b6b +25fd 2601 8acb 8b6a +25ff 25fe 8a14 8bb8 +25fe 2600 8579 8b4a +2603 2602 8584 896d +2603 2604 8583 8a53 +2604 2606 8a5f 8ad8 +2606 2605 8586 8a5e +2605 2607 8589 8a4a +2607 2608 858b 8a74 +2608 2609 858d 8b67 +260a 2608 858e 8b67 +260a 2609 8b67 8b68 +2609 260c 8a75 8b68 +260a 260b 8590 8b5f +260c 260a 8590 8b68 +260c 260b 858f 8590 +260e 260d 8595 8a64 +260d 2629 8987 89b3 +260d 262a 875e 8987 +260d 26b8 89b3 8a64 +260e 260f 89ee 8b44 +26b7 260e 8a68 8b44 +26b8 260e 89ee 8a64 +2610 260f 859a 8ab3 +260f 26b7 875b 8b44 +260f 26b8 89ee 8ab3 +26b8 2610 875c 8ab3 +2611 2705 8967 8b47 +2613 2612 859c 8ab4 +2612 2614 859c 89d2 +2705 2612 8ab4 8b2c +2614 2613 859c 8af3 +2615 2613 8a46 8bcd +2613 2705 8ab4 8af2 +2616 2615 859d 859f +2616 2617 859e 8b56 +2618 2617 89db 8a87 +261b 261a 85a5 8a6f +261a 261c 85a7 8aa0 +26bc 261b 8772 8aed +261b 26bd 8773 8aed +261c 261d 85a8 8b89 +261e 261c 85a9 8b89 +261d 261e 85ab 8b89 +261f 261d 85ab 8a9e +261e 261f 85ab 8b7f +2622 261e 8a9f 8b7f +261f 2620 85ac 8b6e +261f 2622 8b63 8b7f +2627 261f 8b63 8b6e +2620 2623 85af 85b3 +2624 2620 85af 8b6f +2620 2627 85b3 8b6e +2621 2624 85b6 8ba3 +2626 2621 85b5 8ba3 +2623 2622 85ae 8a70 +2627 2622 8a70 8b63 +2623 2624 85af 8b6c +2627 2623 85b3 8a70 +2624 2626 85b4 8ba3 +270c 2625 8c1c 8c1e +2629 2628 85b9 877f +2628 262a 85b9 892c +26b9 2628 8761 892c +2628 26ba 8761 8763 +262a 2629 85b9 8987 +26b8 2629 89b3 89ef +262a 26b9 8760 892c +262c 262d 85c7 867e +262c 262e 867e 8847 +262e 262d 867e 87ff +262d 262f 85c9 87ff +262f 262e 85ca 87ff +262e 2630 85ca 8625 +2630 262f 85ca 8800 +262f 2631 85cb 8800 +2631 2630 8626 8800 +2630 2633 8626 8802 +2633 2631 8626 8803 +2631 2634 85cd 8803 +2633 2632 85cc 8804 +2632 2634 85cc 8805 +266c 2632 8629 8787 +2632 26c1 8786 8787 +2634 2633 85cc 8803 +2636 2635 879b 8820 +2635 2638 85d2 8820 +2635 26d0 879b 881e +2637 2636 85d1 85d5 +2636 2638 8820 8822 +2639 2636 85d5 8822 +26d0 2636 879b 891e +2636 26d2 8823 891e +2637 2639 85d5 8824 +263a 2637 87a0 8824 +2637 266f 87a0 87a2 +2637 26d3 87a2 894b +2638 2639 85d3 8822 +2639 263a 85d4 8824 +263a 263b 85d6 8826 +266f 263a 87a0 8826 +263b 263c 85d7 8828 +263b 266f 863e 8826 +2670 263b 863e 8828 +263c 263d 85d8 882a +263c 2670 87a4 8828 +26d4 263c 87a4 882a +2672 263d 87a3 882d +263d 26d4 87a3 882a +263f 263e 8a5c 8bad +2674 263e 8aa3 8adb +263f 2640 85e1 8bac +26d9 2641 87b2 8838 +26d9 2642 87b9 8a2d +2642 26de 87b9 883b +2642 26df 883b 8ade +2643 2644 85e7 883e +2645 2643 85e8 883e +2643 2646 85e8 87b6 +2643 26dd 87b6 883d +2644 2645 85ea 883e +2644 2647 85e9 8840 +2648 2644 85ea 8840 +2646 2645 85e8 8656 +2645 2648 85ea 8842 +26dd 2646 87b6 87bc +26e0 2646 87bc 8a41 +2647 2648 87be 8840 +26e1 2647 87be 8843 +2649 2648 85ec 87bf +2648 26e1 87be 87bf +2649 26e1 87bf 89e1 +26e2 2649 87c1 89e1 +264a 264b 85ee 8926 +264a 26e3 87c5 89af +26e4 264a 87c5 8a18 +264a 26e6 8926 8a18 +26e6 264b 8926 8a19 +26e9 264c 87ce 89e5 +264c 26ec 89c6 89e5 +264d 264e 85f2 89d6 +26e8 264d 87cb 87d4 +26ed 264d 87d4 8a9a +264d 26f0 89d6 8a9a +264e 264f 85f3 89c5 +264e 26ee 89c5 8a9b +26f0 264e 89d6 8a9b +264f 26ee 87d5 89c5 +2650 2651 85f6 8a42 +2650 2653 85f9 89d0 +2654 2650 85f9 8a42 +2651 2652 85f7 8aba +2651 2654 866c 8a42 +2676 2651 866c 8aba +2652 2655 85fa 89f9 +2652 2676 8942 8aba +2653 2654 85f9 87e1 +2653 2675 8669 87df +2654 2676 866c 87e2 +2654 26f2 87e2 8a43 +2655 2656 85fb 87e3 +2655 26f3 87e3 8a29 +2656 2657 85fc 89ed +2656 2678 89ed 8a2f +26f3 2656 87e3 87e4 +26f4 2656 87e4 8a2f +2657 2678 8672 89ed +2658 2659 85ff 8ad4 +2658 26fa 87ec 8aa5 +26fb 2658 87ec 87ed +26fc 2658 87ed 8ad4 +2659 265a 8600 87f0 +2659 26fc 87f0 8ad4 +265a 265b 867a 8a0d +26fc 265a 87f0 897b +265a 26fd 87f2 897b +265b 265c 8601 8aa6 +26ff 265b 87f3 8aa6 +265d 265c 87f4 8a4c +265c 26ff 87f4 8aa6 +26ff 265d 87f4 87f6 +2700 265d 87f6 8ad6 +265e 265f 8606 8aac +265f 2660 8609 8b95 +2661 265f 860a 8b95 +2660 2661 8aad 8b95 +2662 2661 860c 8ab1 +2665 2664 8a9d 8aeb +2667 2666 861b 8620 +2666 2668 861b 861e +2669 2666 8620 8a33 +2668 2667 861b 8b32 +2667 2669 8620 8af7 +266b 2667 8936 8af7 +2667 2701 8936 8aaa +2669 266b 896a 8af7 +266b 266a 8621 8aab +266a 2701 89c3 8aab +2701 266b 8936 8aab +266c 26c1 8787 8929 +26c2 266c 8808 8929 +266c 26c4 8808 894c +26cb 266d 8795 88eb +266d 26cc 8795 8815 +266d 26cd 8815 8816 +26cd 266e 8796 8797 +26ce 266e 8797 8920 +266f 2670 863e 8827 +26d3 266f 87a2 8827 +2671 2670 8640 87a5 +26d3 2670 8827 8829 +2670 26d4 87a4 87a5 +2672 2671 882c 898d +2671 26d4 87a5 898d +2673 2672 8643 87aa +26d4 2672 87a3 898d +2672 26d7 87a7 87aa +26d6 2673 87a8 8990 +2673 26d7 87aa 8990 +26d8 2674 87ae 8aa2 +26f1 2675 87dd 8a22 +26f2 2676 87e2 8abb +2677 26f2 87e0 89f7 +2678 26f4 898a 8a2f +2678 26f5 87e7 8a2e +2679 267e 89ac 8a45 +267a 267c 8685 8969 +26b5 267a 88dc 899c +267c 267b 8a8b 8b14 +267b 2704 89a2 8b14 +267f 267c 8933 8acd +267c 2704 8b14 8b9c +2706 267c 8acd 8b9c +2703 267d 8bcf 8bd0 +267d 2704 8a8a 8bd0 +2706 267d 8a8a 8b15 +267e 267f 8687 89f2 +267e 2706 89f2 8b37 +2706 267f 89f2 8acd +2683 2684 8698 8711 +2683 2686 8711 89fc +2686 2684 8711 89fd +2684 2688 8714 89fd +2685 2688 8713 8715 +2689 2685 8713 8830 +2687 2686 869a 869c +2688 2686 869c 89fd +2687 2688 869c 89cf +2689 2687 869d 89cf +2688 2689 8713 89cf +268b 268a 869e 893b +268c 268a 86a0 893a +268d 268c 86a2 8964 +268c 268e 8925 8964 +268f 268c 86a5 8901 +268e 268d 86a1 8964 +268f 2690 86a4 8900 +2690 2691 86a6 86aa +2693 2695 86b3 884e +2693 2696 86b2 86b3 +2694 2695 86b0 86b6 +2694 2697 86b6 884a +2695 2696 86b3 884c +2697 2695 86b6 884c +2696 2697 86b4 884c +2698 26b6 8735 886f +2699 269a 86c0 8889 +269c 269b 86c3 8922 +269d 269b 8891 88ba +269b 269e 86ca 88ba +269e 269d 86cd 88ba +26a3 26a4 86de 88c7 +26a5 26a6 86e3 88a0 +26a8 26a5 86e5 88a0 +26a6 26a7 8859 889f +26a6 26a8 889f 88a0 +26a7 26a8 86e4 889f +26a9 26a7 86ea 8871 +26a9 26aa 86eb 8870 +26ac 26ad 86f5 86f6 +26ad 26ae 86f1 86fa +26ae 26af 86f8 88b9 +26b0 26af 86f2 88e3 +26b1 26af 88b1 88d9 +26b1 26b2 86f7 88d8 +26b3 26b2 86fc 86fe +26b4 26b2 86fe 88b0 +26b3 26b4 86fe 8915 +26ba 26b9 8761 8765 +26bd 26bc 876d 8aed +26be 26bf 8958 8997 +26c0 26be 8782 8a26 +26c1 26c2 8788 8929 +26c2 26c3 8789 878a +26c2 26c4 878a 8808 +26c4 26c3 878a 894d +26c3 26c5 8912 894d +26c3 26c6 878c 8912 +26c5 26c4 878b 894d +26c6 26c5 880d 8912 +26c5 26c8 880d 88f4 +26c6 26c7 878d 878f +26c6 26c8 878f 880d +26c8 26c7 878f 8792 +26c9 26c7 8792 88f5 +26c7 26ca 8790 88f5 +26c9 26c8 878e 8792 +26c9 26ca 88f5 88fe +26cb 26c9 8813 88fe +26ca 26cb 8791 88fe +26cb 26cc 8793 8795 +26cc 26cd 8794 8815 +26cd 26ce 8797 8798 +26cf 26d0 879d 8904 +26d1 26cf 879c 8904 +26d0 26d1 879e 8904 +26d2 26d0 879e 891e +26d1 26d2 879e 879f +26d6 26d5 87a6 8a3e +26d5 26d8 87ab 87ac +26d6 26d7 8990 89cd +26da 26d9 87b1 87b5 +26dc 26d9 87b5 89fb +26d9 26de 87b7 87b9 +26db 26da 8835 89e8 +26da 26dc 87b5 89e8 +26db 26dc 89e8 89fa +26dd 26df 883c 8adf +26dd 26e0 87bc 883c +26de 26df 87b8 883b +26df 26e0 883c 8a40 +26e1 26e2 89bd 89e1 +26e2 26e3 87c3 87c4 +26e3 26e4 87c5 87c8 +26e5 26e4 87c6 8a01 +26e6 26e4 89c8 8a18 +26e7 26e6 87c9 87ca +26e9 26e7 87cc 87cd +26ea 26e7 87cd 8ad0 +26e8 26eb 87d6 8a09 +26e8 26ed 87d4 8a08 +26e9 26ea 87cd 8ad1 +26ec 26e9 87d1 89e5 +26ec 26eb 87d0 89e4 +26ed 26ef 87d7 87d8 +26f0 26ed 87d7 8a9a +26ee 26ef 87db 8a11 +26ee 26f0 8a11 8a9b +26ef 26f0 87d7 8a11 +26f3 26f4 87e4 8a28 +26f5 26f7 87e9 8a98 +26f9 26f5 87eb 8a98 +26f6 26f8 87ea 8941 +26f9 26f6 87ea 8a99 +26fb 26f6 87ef 8941 +26f6 26fe 87ef 897a +26f8 26f7 8a7f 8aa4 +26f7 26f9 8a7f 8a98 +26f7 26fa 8940 8aa4 +26f8 26f9 87ea 8a7f +26fa 26f8 8999 8aa4 +26fb 26f8 8941 8999 +26fa 26fb 87ec 8999 +26fb 26fc 87ed 8a8d +26fe 26fb 87ef 8a8d +26fc 26fd 897b 8ad5 +26fe 26fc 8a8d 8ad5 +26fd 26fe 8998 8ad5 +26ff 2700 87f6 8aa7 +2704 2703 8932 8bd0 +2704 2706 8a8a 8b9c +2707 2710 8b7c 8ca6 +2717 2707 8c63 8d3f +2709 2708 8ac3 8efc +2708 272b 8d67 8efd +2750 2708 8ee2 8efd +270a 2713 8c0a 8eec +2718 270b 8c24 8dbd +270b 2719 8c39 8dbd +270d 270e 8b60 8e63 +270d 2732 8e63 8f1b +2756 270d 8e60 8f1b +270e 2732 8e0c 8e63 +2733 270e 8e0c 8f09 +270e 2734 8cd5 8f09 +271e 270f 8d3d 8e2a +270f 2722 8c7c 8dd1 +2710 2714 8c0b 8c80 +2715 2710 8c0b 8ca7 +2711 2723 8cf5 8d86 +2712 272e 8cc5 8dd7 +272c 2713 8db4 8e97 +2714 2715 8c0b 8e4a +272c 2714 8e2d 8e96 +2714 272d 8e4a 8e96 +2715 272d 8d55 8e4a +2717 2716 8c0c 8e26 +2716 2722 8d3c 8e26 +274c 2716 8d66 8e04 +2722 2717 8d3e 8e26 +2719 2718 8d1f 8dbd +274b 2718 8d35 8e4e +271e 271f 8c62 8e75 +2726 2720 8d56 8dfe +273f 2721 8f04 8f1f +272e 2723 8d6b 8dd6 +2728 2727 8c9d 8ed2 +2727 2729 8c9d 8ee9 +273b 2727 8edc 8ee9 +2727 274f 8db8 8f01 +2729 2728 8c9d 8f23 +2729 273b 8ce1 8ee9 +272b 272a 8ca0 8ed8 +274c 272a 8e29 8ed9 +272b 2750 8dc7 8efd +272d 272c 8ca1 8e96 +2730 274e 8ded 8e9a +2732 2731 8cd4 8e1f +2731 2733 8cd4 8ef3 +273c 2731 8e28 8edb +2756 2731 8e1f 8ef8 +2733 2732 8cd4 8e0c +2732 2756 8e1f 8f1b +2734 2733 8ef2 8f09 +2752 2734 8e62 8e9f +2755 2734 8e9f 8efa +2749 2737 8d28 8e95 +2737 2754 8e6e 8e95 +2738 2742 8df8 8e6b +2744 2738 8df8 8eb3 +273a 2739 8ce0 8ee6 +2739 2745 8d13 8ee6 +2745 273a 8e20 8ee6 +273b 2757 8e39 8ec7 +273e 273d 8cf8 8e90 +274e 273e 8db0 8e8e +2755 273f 8df2 8ed7 +2741 2740 8d11 8eaa +2740 2742 8d11 8d2d +2743 2740 8e3f 8eb2 +2740 2744 8d2d 8eb2 +2740 2749 8e9d 8eaa +2742 2741 8d11 8e40 +2741 2749 8eaa 8ed0 +2754 2741 8e9c 8ed0 +2744 2742 8d2d 8df8 +2744 2743 8d12 8eb2 +2743 2758 8ec6 8ecd +2746 2747 8d21 8e24 +2746 274d 8dde 8eac +2753 2746 8dde 8e24 +2747 2752 8dda 8e76 +2753 2747 8e24 8e9e +2749 2754 8e95 8ed0 +274a 2754 8de6 8efe +2751 274b 8e4f 8ec2 +274d 2753 8dde 8ead +2752 2755 8e9f 8ed6 +2757 2758 8eb0 8ee4 +275a 2759 3665 3722 +2759 2778 3721 3722 +275b 275a 3666 3723 +275a 2779 3722 3723 +275c 275b 3667 3724 +275b 277a 3723 3724 +275d 275c 3668 3725 +275c 277b 3724 3725 +275e 275d 3669 3726 +275d 277c 3725 3726 +275f 275e 366a 3727 +275e 277d 3726 3727 +2760 275f 366b 3728 +275f 277e 3727 3728 +2761 2760 366c 3729 +2760 277f 3728 3729 +2762 2761 366d 372a +2761 2780 3729 372a +2763 2762 366e 372b +2762 2781 372a 372b +2764 2763 366f 372c +2763 2782 372b 372c +2765 2764 3670 372d +2764 2783 372c 372d +2766 2765 3671 372e +2765 2784 372d 372e +2767 2766 3672 372f +2766 2785 372e 372f +2768 2767 3673 3730 +2767 2786 372f 3730 +2769 2768 3674 3731 +2768 2787 3730 3731 +276a 2769 3675 3732 +2769 2788 3731 3732 +276b 276a 3676 3733 +276a 2789 3732 3733 +276c 276b 3677 3734 +276b 278a 3733 3734 +276d 276c 3678 3735 +276c 278b 3734 3735 +276e 276d 3679 3736 +276d 278c 3735 3736 +276f 276e 367a 3737 +276e 278d 3736 3737 +2770 276f 367b 3738 +276f 278e 3737 3738 +2771 2770 367c 3739 +2770 278f 3738 3739 +2772 2771 367d 373a +2771 2790 3739 373a +2773 2772 367e 373b +2772 2791 373a 373b +2774 2773 367f 373c +2773 2792 373b 373c +2775 2774 3680 373d +2774 2793 373c 373d +2776 2775 3681 373e +2775 2794 373d 373e +2777 2776 3682 373f +2776 2795 373e 373f +2777 2796 373f 3740 +2779 2778 3722 37df +2778 2797 37de 37df +277a 2779 3723 37e0 +2779 2798 37df 37e0 +277b 277a 3724 37e1 +277a 2799 37e0 37e1 +277c 277b 3725 37e2 +277b 279a 37e1 37e2 +277d 277c 3726 37e3 +277c 279b 37e2 37e3 +277e 277d 3727 37e4 +277d 279c 37e3 37e4 +277f 277e 3728 37e5 +277e 279d 37e4 37e5 +2780 277f 3729 37e6 +277f 279e 37e5 37e6 +2781 2780 372a 37e7 +2780 279f 37e6 37e7 +2782 2781 372b 37e8 +2781 27a0 37e7 37e8 +2783 2782 372c 37e9 +2782 27a1 37e8 37e9 +2784 2783 372d 37ea +2783 27a2 37e9 37ea +2785 2784 372e 37eb +2784 27a3 37ea 37eb +2786 2785 372f 37ec +2785 27a4 37eb 37ec +2787 2786 3730 37ed +2786 27a5 37ec 37ed +2788 2787 3731 37ee +2787 27a6 37ed 37ee +2789 2788 3732 37ef +2788 27a7 37ee 37ef +278a 2789 3733 37f0 +2789 27a8 37ef 37f0 +278b 278a 3734 37f1 +278a 27a9 37f0 37f1 +278c 278b 3735 37f2 +278b 27aa 37f1 37f2 +278d 278c 3736 37f3 +278c 27ab 37f2 37f3 +278e 278d 3737 37f4 +278d 27ac 37f3 37f4 +278f 278e 3738 37f5 +278e 27ad 37f4 37f5 +2790 278f 3739 37f6 +278f 27ae 37f5 37f6 +2791 2790 373a 37f7 +2790 27af 37f6 37f7 +2792 2791 373b 37f8 +2791 27b0 37f7 37f8 +2793 2792 373c 37f9 +2792 27b1 37f8 37f9 +2794 2793 373d 37fa +2793 27b2 37f9 37fa +2795 2794 373e 37fb +2794 27b3 37fa 37fb +2796 2795 373f 37fc +2795 27b4 37fb 37fc +2796 27b5 37fc 37fd +2798 2797 37df 389c +2797 27b6 389b 389c +2799 2798 37e0 389d +2798 27b7 389c 389d +279a 2799 37e1 389e +2799 27b8 389d 389e +279b 279a 37e2 389f +279a 27b9 389e 389f +279c 279b 37e3 38a0 +279b 27ba 389f 38a0 +279d 279c 37e4 38a1 +279c 27bb 38a0 38a1 +279e 279d 37e5 38a2 +279d 27bc 38a1 38a2 +279f 279e 37e6 38a3 +279e 27bd 38a2 38a3 +27a0 279f 37e7 38a4 +279f 27be 38a3 38a4 +27a1 27a0 37e8 38a5 +27a0 27bf 38a4 38a5 +27a2 27a1 37e9 38a6 +27a1 27c0 38a5 38a6 +27a3 27a2 37ea 38a7 +27a2 27c1 38a6 38a7 +27a4 27a3 37eb 38a8 +27a3 27c2 38a7 38a8 +27a5 27a4 37ec 38a9 +27a4 27c3 38a8 38a9 +27a6 27a5 37ed 38aa +27a5 27c4 38a9 38aa +27a7 27a6 37ee 38ab +27a6 27c5 38aa 38ab +27a8 27a7 37ef 38ac +27a7 27c6 38ab 38ac +27a9 27a8 37f0 38ad +27a8 27c7 38ac 38ad +27aa 27a9 37f1 38ae +27a9 27c8 38ad 38ae +27ab 27aa 37f2 38af +27aa 27c9 38ae 38af +27ac 27ab 37f3 38b0 +27ab 27ca 38af 38b0 +27ad 27ac 37f4 38b1 +27ac 27cb 38b0 38b1 +27ae 27ad 37f5 38b2 +27ad 27cc 38b1 38b2 +27af 27ae 37f6 38b3 +27ae 27cd 38b2 38b3 +27b0 27af 37f7 38b4 +27af 27ce 38b3 38b4 +27b1 27b0 37f8 38b5 +27b0 27cf 38b4 38b5 +27b2 27b1 37f9 38b6 +27b1 27d0 38b5 38b6 +27b3 27b2 37fa 38b7 +27b2 27d1 38b6 38b7 +27b4 27b3 37fb 38b8 +27b3 27d2 38b7 38b8 +27b5 27b4 37fc 38b9 +27b4 27d3 38b8 38b9 +27b5 27d4 38b9 38ba +27b7 27b6 389c 3959 +27b6 27d5 3958 3959 +27b8 27b7 389d 395a +27b7 27d6 3959 395a +27b9 27b8 389e 395b +27b8 27d7 395a 395b +27ba 27b9 389f 395c +27b9 27d8 395b 395c +27bb 27ba 38a0 395d +27ba 27d9 395c 395d +27bc 27bb 38a1 395e +27bb 27da 395d 395e +27bd 27bc 38a2 395f +27bc 27db 395e 395f +27be 27bd 38a3 3960 +27bd 27dc 395f 3960 +27bf 27be 38a4 3961 +27be 27dd 3960 3961 +27c0 27bf 38a5 3962 +27bf 27de 3961 3962 +27c1 27c0 38a6 3963 +27c0 27df 3962 3963 +27c2 27c1 38a7 3964 +27c1 27e0 3963 3964 +27c3 27c2 38a8 3965 +27c2 27e1 3964 3965 +27c4 27c3 38a9 3966 +27c3 27e2 3965 3966 +27c5 27c4 38aa 3967 +27c4 27e3 3966 3967 +27c6 27c5 38ab 3968 +27c5 27e4 3967 3968 +27c7 27c6 38ac 3969 +27c6 27e5 3968 3969 +27c8 27c7 38ad 396a +27c7 27e6 3969 396a +27c9 27c8 38ae 396b +27c8 27e7 396a 396b +27ca 27c9 38af 396c +27c9 27e8 396b 396c +27cb 27ca 38b0 396d +27ca 27e9 396c 396d +27cc 27cb 38b1 396e +27cb 27ea 396d 396e +27cd 27cc 38b2 396f +27cc 27eb 396e 396f +27ce 27cd 38b3 3970 +27cd 27ec 396f 3970 +27cf 27ce 38b4 3971 +27ce 27ed 3970 3971 +27d0 27cf 38b5 3972 +27cf 27ee 3971 3972 +27d1 27d0 38b6 3973 +27d0 27ef 3972 3973 +27d2 27d1 38b7 3974 +27d1 27f0 3973 3974 +27d3 27d2 38b8 3975 +27d2 27f1 3974 3975 +27d4 27d3 38b9 3976 +27d3 27f2 3975 3976 +27d4 27f3 3976 3977 +27d6 27d5 3959 3a16 +27d5 27f4 3a15 3a16 +27d7 27d6 395a 3a17 +27d6 27f5 3a16 3a17 +27d8 27d7 395b 3a18 +27d7 27f6 3a17 3a18 +27d9 27d8 395c 3a19 +27d8 27f7 3a18 3a19 +27da 27d9 395d 3a1a +27d9 27f8 3a19 3a1a +27db 27da 395e 3a1b +27da 27f9 3a1a 3a1b +27dc 27db 395f 3a1c +27db 27fa 3a1b 3a1c +27dd 27dc 3960 3a1d +27dc 27fb 3a1c 3a1d +27de 27dd 3961 3a1e +27dd 27fc 3a1d 3a1e +27df 27de 3962 3a1f +27de 27fd 3a1e 3a1f +27e0 27df 3963 3a20 +27df 27fe 3a1f 3a20 +27e1 27e0 3964 3a21 +27e0 27ff 3a20 3a21 +27e2 27e1 3965 3a22 +27e1 2800 3a21 3a22 +27e3 27e2 3966 3a23 +27e2 2801 3a22 3a23 +27e4 27e3 3967 3a24 +27e3 2802 3a23 3a24 +27e5 27e4 3968 3a25 +27e4 2803 3a24 3a25 +27e6 27e5 3969 3a26 +27e5 2804 3a25 3a26 +27e7 27e6 396a 3a27 +27e6 2805 3a26 3a27 +27e8 27e7 396b 3a28 +27e7 2806 3a27 3a28 +27e9 27e8 396c 3a29 +27e8 2807 3a28 3a29 +27ea 27e9 396d 3a2a +27e9 2808 3a29 3a2a +27eb 27ea 396e 3a2b +27ea 2809 3a2a 3a2b +27ec 27eb 396f 3a2c +27eb 280a 3a2b 3a2c +27ed 27ec 3970 3a2d +27ec 280b 3a2c 3a2d +27ee 27ed 3971 3a2e +27ed 280c 3a2d 3a2e +27ef 27ee 3972 3a2f +27ee 280d 3a2e 3a2f +27f0 27ef 3973 3a30 +27ef 280e 3a2f 3a30 +27f1 27f0 3974 3a31 +27f0 280f 3a30 3a31 +27f2 27f1 3975 3a32 +27f1 2810 3a31 3a32 +27f3 27f2 3976 3a33 +27f2 2811 3a32 3a33 +27f3 2812 3a33 3a34 +27f5 27f4 3a16 3ad3 +27f4 2813 3ad2 3ad3 +27f6 27f5 3a17 3ad4 +27f5 2814 3ad3 3ad4 +27f7 27f6 3a18 3ad5 +27f6 2815 3ad4 3ad5 +27f8 27f7 3a19 3ad6 +27f7 2816 3ad5 3ad6 +27f9 27f8 3a1a 3ad7 +27f8 2817 3ad6 3ad7 +27fa 27f9 3a1b 3ad8 +27f9 2818 3ad7 3ad8 +27fb 27fa 3a1c 3ad9 +27fa 2819 3ad8 3ad9 +27fc 27fb 3a1d 3ada +27fb 281a 3ad9 3ada +27fd 27fc 3a1e 3adb +27fc 281b 3ada 3adb +27fe 27fd 3a1f 3adc +27fd 281c 3adb 3adc +27ff 27fe 3a20 3add +27fe 281d 3adc 3add +2800 27ff 3a21 3ade +27ff 281e 3add 3ade +2801 2800 3a22 3adf +2800 281f 3ade 3adf +2802 2801 3a23 3ae0 +2801 2820 3adf 3ae0 +2803 2802 3a24 3ae1 +2802 2821 3ae0 3ae1 +2804 2803 3a25 3ae2 +2803 2822 3ae1 3ae2 +2805 2804 3a26 3ae3 +2804 2823 3ae2 3ae3 +2806 2805 3a27 3ae4 +2805 2824 3ae3 3ae4 +2807 2806 3a28 3ae5 +2806 2825 3ae4 3ae5 +2808 2807 3a29 3ae6 +2807 2826 3ae5 3ae6 +2809 2808 3a2a 3ae7 +2808 2827 3ae6 3ae7 +280a 2809 3a2b 3ae8 +2809 2828 3ae7 3ae8 +280b 280a 3a2c 3ae9 +280a 2829 3ae8 3ae9 +280c 280b 3a2d 3aea +280b 282a 3ae9 3aea +280d 280c 3a2e 3aeb +280c 282b 3aea 3aeb +280e 280d 3a2f 3aec +280d 282c 3aeb 3aec +280f 280e 3a30 3aed +280e 282d 3aec 3aed +2810 280f 3a31 3aee +280f 282e 3aed 3aee +2811 2810 3a32 3aef +2810 282f 3aee 3aef +2812 2811 3a33 3af0 +2811 2830 3aef 3af0 +2812 2831 3af0 3af1 +2814 2813 3ad3 3b90 +2813 2832 3b8f 3b90 +2815 2814 3ad4 3b91 +2814 2833 3b90 3b91 +2816 2815 3ad5 3b92 +2815 2834 3b91 3b92 +2817 2816 3ad6 3b93 +2816 2835 3b92 3b93 +2818 2817 3ad7 3b94 +2817 2836 3b93 3b94 +2819 2818 3ad8 3b95 +2818 2837 3b94 3b95 +281a 2819 3ad9 3b96 +2819 2838 3b95 3b96 +281b 281a 3ada 3b97 +281a 2839 3b96 3b97 +281c 281b 3adb 3b98 +281b 283a 3b97 3b98 +281d 281c 3adc 3b99 +281c 283b 3b98 3b99 +281e 281d 3add 3b9a +281d 283c 3b99 3b9a +281f 281e 3ade 3b9b +281e 283d 3b9a 3b9b +2820 281f 3adf 3b9c +281f 283e 3b9b 3b9c +2821 2820 3ae0 3b9d +2820 283f 3b9c 3b9d +2822 2821 3ae1 3b9e +2821 2840 3b9d 3b9e +2823 2822 3ae2 3b9f +2822 2841 3b9e 3b9f +2824 2823 3ae3 3ba0 +2823 2842 3b9f 3ba0 +2825 2824 3ae4 3ba1 +2824 2843 3ba0 3ba1 +2826 2825 3ae5 3ba2 +2825 2844 3ba1 3ba2 +2827 2826 3ae6 3ba3 +2826 2845 3ba2 3ba3 +2828 2827 3ae7 3ba4 +2827 2846 3ba3 3ba4 +2829 2828 3ae8 3ba5 +2828 2847 3ba4 3ba5 +282a 2829 3ae9 3ba6 +2829 2848 3ba5 3ba6 +282b 282a 3aea 3ba7 +282a 2849 3ba6 3ba7 +282c 282b 3aeb 3ba8 +282b 284a 3ba7 3ba8 +282d 282c 3aec 3ba9 +282c 284b 3ba8 3ba9 +282e 282d 3aed 3baa +282d 284c 3ba9 3baa +282f 282e 3aee 3bab +282e 284d 3baa 3bab +2830 282f 3aef 3bac +282f 284e 3bab 3bac +2831 2830 3af0 3bad +2830 284f 3bac 3bad +2831 2850 3bad 3bae +2833 2832 3b90 3c4d +2832 2851 3c4c 3c4d +2834 2833 3b91 3c4e +2833 2852 3c4d 3c4e +2835 2834 3b92 3c4f +2834 2853 3c4e 3c4f +2836 2835 3b93 3c50 +2835 2854 3c4f 3c50 +2837 2836 3b94 3c51 +2836 2855 3c50 3c51 +2838 2837 3b95 3c52 +2837 2856 3c51 3c52 +2839 2838 3b96 3c53 +2838 2857 3c52 3c53 +283a 2839 3b97 3c54 +2839 2858 3c53 3c54 +283b 283a 3b98 3c55 +283a 2859 3c54 3c55 +283c 283b 3b99 3c56 +283b 285a 3c55 3c56 +283d 283c 3b9a 3c57 +283c 285b 3c56 3c57 +283e 283d 3b9b 3c58 +283d 285c 3c57 3c58 +283f 283e 3b9c 3c59 +283e 285d 3c58 3c59 +2840 283f 3b9d 3c5a +283f 285e 3c59 3c5a +2841 2840 3b9e 3c5b +2840 285f 3c5a 3c5b +2842 2841 3b9f 3c5c +2841 2860 3c5b 3c5c +2843 2842 3ba0 3c5d +2842 2861 3c5c 3c5d +2844 2843 3ba1 3c5e +2843 2862 3c5d 3c5e +2845 2844 3ba2 3c5f +2844 2863 3c5e 3c5f +2846 2845 3ba3 3c60 +2845 2864 3c5f 3c60 +2847 2846 3ba4 3c61 +2846 2865 3c60 3c61 +2848 2847 3ba5 3c62 +2847 2866 3c61 3c62 +2849 2848 3ba6 3c63 +2848 2867 3c62 3c63 +284a 2849 3ba7 3c64 +2849 2868 3c63 3c64 +284b 284a 3ba8 3c65 +284a 2869 3c64 3c65 +284c 284b 3ba9 3c66 +284b 286a 3c65 3c66 +284d 284c 3baa 3c67 +284c 286b 3c66 3c67 +284e 284d 3bab 3c68 +284d 286c 3c67 3c68 +284f 284e 3bac 3c69 +284e 286d 3c68 3c69 +2850 284f 3bad 3c6a +284f 286e 3c69 3c6a +2850 286f 3c6a 3c6b +2852 2851 3c4d 3d0a +2851 2870 3d09 3d0a +2853 2852 3c4e 3d0b +2852 2871 3d0a 3d0b +2854 2853 3c4f 3d0c +2853 2872 3d0b 3d0c +2855 2854 3c50 3d0d +2854 2873 3d0c 3d0d +2856 2855 3c51 3d0e +2855 2874 3d0d 3d0e +2857 2856 3c52 3d0f +2856 2875 3d0e 3d0f +2858 2857 3c53 3d10 +2857 2876 3d0f 3d10 +2859 2858 3c54 3d11 +2858 2877 3d10 3d11 +285a 2859 3c55 3d12 +2859 2878 3d11 3d12 +285b 285a 3c56 3d13 +285a 2879 3d12 3d13 +285c 285b 3c57 3d14 +285b 287a 3d13 3d14 +285d 285c 3c58 3d15 +285c 287b 3d14 3d15 +285e 285d 3c59 3d16 +285d 287c 3d15 3d16 +285f 285e 3c5a 3d17 +285e 287d 3d16 3d17 +2860 285f 3c5b 3d18 +285f 287e 3d17 3d18 +2861 2860 3c5c 3d19 +2860 287f 3d18 3d19 +2862 2861 3c5d 3d1a +2861 2880 3d19 3d1a +2863 2862 3c5e 3d1b +2862 2881 3d1a 3d1b +2864 2863 3c5f 3d1c +2863 2882 3d1b 3d1c +2865 2864 3c60 3d1d +2864 2883 3d1c 3d1d +2866 2865 3c61 3d1e +2865 2884 3d1d 3d1e +2867 2866 3c62 3d1f +2866 2885 3d1e 3d1f +2868 2867 3c63 3d20 +2867 2886 3d1f 3d20 +2869 2868 3c64 3d21 +2868 2887 3d20 3d21 +286a 2869 3c65 3d22 +2869 2888 3d21 3d22 +286b 286a 3c66 3d23 +286a 2889 3d22 3d23 +286c 286b 3c67 3d24 +286b 288a 3d23 3d24 +286d 286c 3c68 3d25 +286c 288b 3d24 3d25 +286e 286d 3c69 3d26 +286d 288c 3d25 3d26 +286f 286e 3c6a 3d27 +286e 288d 3d26 3d27 +286f 288e 3d27 3d28 +2871 2870 3d0a 3dc7 +2870 288f 3dc6 3dc7 +2872 2871 3d0b 3dc8 +2871 2890 3dc7 3dc8 +2873 2872 3d0c 3dc9 +2872 2891 3dc8 3dc9 +2874 2873 3d0d 3dca +2873 2892 3dc9 3dca +2875 2874 3d0e 3dcb +2874 2893 3dca 3dcb +2876 2875 3d0f 3dcc +2875 2894 3dcb 3dcc +2877 2876 3d10 3dcd +2876 2895 3dcc 3dcd +2878 2877 3d11 3dce +2877 2896 3dcd 3dce +2879 2878 3d12 3dcf +2878 2897 3dce 3dcf +287a 2879 3d13 3dd0 +2879 2898 3dcf 3dd0 +287b 287a 3d14 3dd1 +287a 2899 3dd0 3dd1 +287c 287b 3d15 3dd2 +287b 289a 3dd1 3dd2 +287d 287c 3d16 3dd3 +287c 289b 3dd2 3dd3 +287e 287d 3d17 3dd4 +287d 289c 3dd3 3dd4 +287f 287e 3d18 3dd5 +287e 289d 3dd4 3dd5 +2880 287f 3d19 3dd6 +287f 289e 3dd5 3dd6 +2881 2880 3d1a 3dd7 +2880 289f 3dd6 3dd7 +2882 2881 3d1b 3dd8 +2881 28a0 3dd7 3dd8 +2883 2882 3d1c 3dd9 +2882 28a1 3dd8 3dd9 +2884 2883 3d1d 3dda +2883 28a2 3dd9 3dda +2885 2884 3d1e 3ddb +2884 28a3 3dda 3ddb +2886 2885 3d1f 3ddc +2885 28a4 3ddb 3ddc +2887 2886 3d20 3ddd +2886 28a5 3ddc 3ddd +2888 2887 3d21 3dde +2887 28a6 3ddd 3dde +2889 2888 3d22 3ddf +2888 28a7 3dde 3ddf +288a 2889 3d23 3de0 +2889 28a8 3ddf 3de0 +288b 288a 3d24 3de1 +288a 28a9 3de0 3de1 +288c 288b 3d25 3de2 +288b 28aa 3de1 3de2 +288d 288c 3d26 3de3 +288c 28ab 3de2 3de3 +288e 288d 3d27 3de4 +288d 28ac 3de3 3de4 +288e 28ad 3de4 3de5 +2890 288f 3dc7 3e84 +288f 28ae 3e83 3e84 +2891 2890 3dc8 3e85 +2890 28af 3e84 3e85 +2892 2891 3dc9 3e86 +2891 28b0 3e85 3e86 +2893 2892 3dca 3e87 +2892 28b1 3e86 3e87 +2894 2893 3dcb 3e88 +2893 28b2 3e87 3e88 +2895 2894 3dcc 3e89 +2894 28b3 3e88 3e89 +2896 2895 3dcd 3e8a +2895 28b4 3e89 3e8a +2897 2896 3dce 3e8b +2896 28b5 3e8a 3e8b +2898 2897 3dcf 3e8c +2897 28b6 3e8b 3e8c +2899 2898 3dd0 3e8d +2898 28b7 3e8c 3e8d +289a 2899 3dd1 3e8e +2899 28b8 3e8d 3e8e +289b 289a 3dd2 3e8f +289a 28b9 3e8e 3e8f +289c 289b 3dd3 3e90 +289b 28ba 3e8f 3e90 +289d 289c 3dd4 3e91 +289c 28bb 3e90 3e91 +289e 289d 3dd5 3e92 +289d 28bc 3e91 3e92 +289f 289e 3dd6 3e93 +289e 28bd 3e92 3e93 +28a0 289f 3dd7 3e94 +289f 28be 3e93 3e94 +28a1 28a0 3dd8 3e95 +28a0 28bf 3e94 3e95 +28a2 28a1 3dd9 3e96 +28a1 28c0 3e95 3e96 +28a3 28a2 3dda 3e97 +28a2 28c1 3e96 3e97 +28a4 28a3 3ddb 3e98 +28a3 28c2 3e97 3e98 +28a5 28a4 3ddc 3e99 +28a4 28c3 3e98 3e99 +28a6 28a5 3ddd 3e9a +28a5 28c4 3e99 3e9a +28a7 28a6 3dde 3e9b +28a6 28c5 3e9a 3e9b +28a8 28a7 3ddf 3e9c +28a7 28c6 3e9b 3e9c +28a9 28a8 3de0 3e9d +28a8 28c7 3e9c 3e9d +28aa 28a9 3de1 3e9e +28a9 28c8 3e9d 3e9e +28ab 28aa 3de2 3e9f +28aa 28c9 3e9e 3e9f +28ac 28ab 3de3 3ea0 +28ab 28ca 3e9f 3ea0 +28ad 28ac 3de4 3ea1 +28ac 28cb 3ea0 3ea1 +28ad 28cc 3ea1 3ea2 +28af 28ae 3e84 3f41 +28ae 28cd 3f40 3f41 +28b0 28af 3e85 3f42 +28af 28ce 3f41 3f42 +28b1 28b0 3e86 3f43 +28b0 28cf 3f42 3f43 +28b2 28b1 3e87 3f44 +28b1 28d0 3f43 3f44 +28b3 28b2 3e88 3f45 +28b2 28d1 3f44 3f45 +28b4 28b3 3e89 3f46 +28b3 28d2 3f45 3f46 +28b5 28b4 3e8a 3f47 +28b4 28d3 3f46 3f47 +28b6 28b5 3e8b 3f48 +28b5 28d4 3f47 3f48 +28b7 28b6 3e8c 3f49 +28b6 28d5 3f48 3f49 +28b8 28b7 3e8d 3f4a +28b7 28d6 3f49 3f4a +28b9 28b8 3e8e 3f4b +28b8 28d7 3f4a 3f4b +28ba 28b9 3e8f 3f4c +28b9 28d8 3f4b 3f4c +28bb 28ba 3e90 3f4d +28ba 28d9 3f4c 3f4d +28bc 28bb 3e91 3f4e +28bb 28da 3f4d 3f4e +28bd 28bc 3e92 3f4f +28bc 28db 3f4e 3f4f +28be 28bd 3e93 3f50 +28bd 28dc 3f4f 3f50 +28bf 28be 3e94 3f51 +28be 28dd 3f50 3f51 +28c0 28bf 3e95 3f52 +28bf 28de 3f51 3f52 +28c1 28c0 3e96 3f53 +28c0 28df 3f52 3f53 +28c2 28c1 3e97 3f54 +28c1 28e0 3f53 3f54 +28c3 28c2 3e98 3f55 +28c2 28e1 3f54 3f55 +28c4 28c3 3e99 3f56 +28c3 28e2 3f55 3f56 +28c5 28c4 3e9a 3f57 +28c4 28e3 3f56 3f57 +28c6 28c5 3e9b 3f58 +28c5 28e4 3f57 3f58 +28c7 28c6 3e9c 3f59 +28c6 28e5 3f58 3f59 +28c8 28c7 3e9d 3f5a +28c7 28e6 3f59 3f5a +28c9 28c8 3e9e 3f5b +28c8 28e7 3f5a 3f5b +28ca 28c9 3e9f 3f5c +28c9 28e8 3f5b 3f5c +28cb 28ca 3ea0 3f5d +28ca 28e9 3f5c 3f5d +28cc 28cb 3ea1 3f5e +28cb 28ea 3f5d 3f5e +28cc 28eb 3f5e 3f5f +28ce 28cd 3f41 3ffe +28cd 28ec 3ffd 3ffe +28cf 28ce 3f42 3fff +28ce 28ed 3ffe 3fff +28d0 28cf 3f43 4000 +28cf 28ee 3fff 4000 +28d1 28d0 3f44 4001 +28d0 28ef 4000 4001 +28d2 28d1 3f45 4002 +28d1 28f0 4001 4002 +28d3 28d2 3f46 4003 +28d2 28f1 4002 4003 +28d4 28d3 3f47 4004 +28d3 28f2 4003 4004 +28d5 28d4 3f48 4005 +28d4 28f3 4004 4005 +28d6 28d5 3f49 4006 +28d5 28f4 4005 4006 +28d7 28d6 3f4a 4007 +28d6 28f5 4006 4007 +28d8 28d7 3f4b 4008 +28d7 28f6 4007 4008 +28d9 28d8 3f4c 4009 +28d8 28f7 4008 4009 +28da 28d9 3f4d 400a +28d9 28f8 4009 400a +28db 28da 3f4e 400b +28da 28f9 400a 400b +28dc 28db 3f4f 400c +28db 28fa 400b 400c +28dd 28dc 3f50 400d +28dc 28fb 400c 400d +28de 28dd 3f51 400e +28dd 28fc 400d 400e +28df 28de 3f52 400f +28de 28fd 400e 400f +28e0 28df 3f53 4010 +28df 28fe 400f 4010 +28e1 28e0 3f54 4011 +28e0 28ff 4010 4011 +28e2 28e1 3f55 4012 +28e1 2900 4011 4012 +28e3 28e2 3f56 4013 +28e2 2901 4012 4013 +28e4 28e3 3f57 4014 +28e3 2902 4013 4014 +28e5 28e4 3f58 4015 +28e4 2903 4014 4015 +28e6 28e5 3f59 4016 +28e5 2904 4015 4016 +28e7 28e6 3f5a 4017 +28e6 2905 4016 4017 +28e8 28e7 3f5b 4018 +28e7 2906 4017 4018 +28e9 28e8 3f5c 4019 +28e8 2907 4018 4019 +28ea 28e9 3f5d 401a +28e9 2908 4019 401a +28eb 28ea 3f5e 401b +28ea 2909 401a 401b +28eb 290a 401b 401c +28ed 28ec 3ffe 40bb +28ec 290b 40ba 40bb +28ee 28ed 3fff 40bc +28ed 290c 40bb 40bc +28ef 28ee 4000 40bd +28ee 290d 40bc 40bd +28f0 28ef 4001 40be +28ef 290e 40bd 40be +28f1 28f0 4002 40bf +28f0 290f 40be 40bf +28f2 28f1 4003 40c0 +28f1 2910 40bf 40c0 +28f3 28f2 4004 40c1 +28f2 2911 40c0 40c1 +28f4 28f3 4005 40c2 +28f3 2912 40c1 40c2 +28f5 28f4 4006 40c3 +28f4 2913 40c2 40c3 +28f6 28f5 4007 40c4 +28f5 2914 40c3 40c4 +28f7 28f6 4008 40c5 +28f6 2915 40c4 40c5 +28f8 28f7 4009 40c6 +28f7 2916 40c5 40c6 +28f9 28f8 400a 40c7 +28f8 2917 40c6 40c7 +28fa 28f9 400b 40c8 +28f9 2918 40c7 40c8 +28fb 28fa 400c 40c9 +28fa 2919 40c8 40c9 +28fc 28fb 400d 40ca +28fb 291a 40c9 40ca +28fd 28fc 400e 40cb +28fc 291b 40ca 40cb +28fe 28fd 400f 40cc +28fd 291c 40cb 40cc +28ff 28fe 4010 40cd +28fe 291d 40cc 40cd +2900 28ff 4011 40ce +28ff 291e 40cd 40ce +2901 2900 4012 40cf +2900 291f 40ce 40cf +2902 2901 4013 40d0 +2901 2920 40cf 40d0 +2903 2902 4014 40d1 +2902 2921 40d0 40d1 +2904 2903 4015 40d2 +2903 2922 40d1 40d2 +2905 2904 4016 40d3 +2904 2923 40d2 40d3 +2906 2905 4017 40d4 +2905 2924 40d3 40d4 +2907 2906 4018 40d5 +2906 2925 40d4 40d5 +2908 2907 4019 40d6 +2907 2926 40d5 40d6 +2909 2908 401a 40d7 +2908 2927 40d6 40d7 +290a 2909 401b 40d8 +2909 2928 40d7 40d8 +290a 2929 40d8 40d9 +290c 290b 40bb 4178 +290b 292a 4177 4178 +290d 290c 40bc 4179 +290c 292b 4178 4179 +290e 290d 40bd 417a +290d 292c 4179 417a +290f 290e 40be 417b +290e 292d 417a 417b +2910 290f 40bf 417c +290f 292e 417b 417c +2911 2910 40c0 417d +2910 292f 417c 417d +2912 2911 40c1 417e +2911 2930 417d 417e +2913 2912 40c2 417f +2912 2931 417e 417f +2914 2913 40c3 4180 +2913 2932 417f 4180 +2915 2914 40c4 4181 +2914 2933 4180 4181 +2916 2915 40c5 4182 +2915 2934 4181 4182 +2917 2916 40c6 4183 +2916 2935 4182 4183 +2918 2917 40c7 4184 +2917 2936 4183 4184 +2919 2918 40c8 4185 +2918 2937 4184 4185 +291a 2919 40c9 4186 +2919 2938 4185 4186 +291b 291a 40ca 4187 +291a 2939 4186 4187 +291c 291b 40cb 4188 +291b 293a 4187 4188 +291d 291c 40cc 4189 +291c 293b 4188 4189 +291e 291d 40cd 418a +291d 293c 4189 418a +291f 291e 40ce 418b +291e 293d 418a 418b +2920 291f 40cf 418c +291f 293e 418b 418c +2921 2920 40d0 418d +2920 293f 418c 418d +2922 2921 40d1 418e +2921 2940 418d 418e +2923 2922 40d2 418f +2922 2941 418e 418f +2924 2923 40d3 4190 +2923 2942 418f 4190 +2925 2924 40d4 4191 +2924 2943 4190 4191 +2926 2925 40d5 4192 +2925 2944 4191 4192 +2927 2926 40d6 4193 +2926 2945 4192 4193 +2928 2927 40d7 4194 +2927 2946 4193 4194 +2929 2928 40d8 4195 +2928 2947 4194 4195 +2929 2948 4195 4196 +292b 292a 4178 4235 +292a 2949 4234 4235 +292c 292b 4179 4236 +292b 294a 4235 4236 +292d 292c 417a 4237 +292c 294b 4236 4237 +292e 292d 417b 4238 +292d 294c 4237 4238 +292f 292e 417c 4239 +292e 294d 4238 4239 +2930 292f 417d 423a +292f 294e 4239 423a +2931 2930 417e 423b +2930 294f 423a 423b +2932 2931 417f 423c +2931 2950 423b 423c +2933 2932 4180 423d +2932 2951 423c 423d +2934 2933 4181 423e +2933 2952 423d 423e +2935 2934 4182 423f +2934 2953 423e 423f +2936 2935 4183 4240 +2935 2954 423f 4240 +2937 2936 4184 4241 +2936 2955 4240 4241 +2938 2937 4185 4242 +2937 2956 4241 4242 +2939 2938 4186 4243 +2938 2957 4242 4243 +293a 2939 4187 4244 +2939 2958 4243 4244 +293b 293a 4188 4245 +293a 2959 4244 4245 +293c 293b 4189 4246 +293b 295a 4245 4246 +293d 293c 418a 4247 +293c 295b 4246 4247 +293e 293d 418b 4248 +293d 295c 4247 4248 +293f 293e 418c 4249 +293e 295d 4248 4249 +2940 293f 418d 424a +293f 295e 4249 424a +2941 2940 418e 424b +2940 295f 424a 424b +2942 2941 418f 424c +2941 2960 424b 424c +2943 2942 4190 424d +2942 2961 424c 424d +2944 2943 4191 424e +2943 2962 424d 424e +2945 2944 4192 424f +2944 2963 424e 424f +2946 2945 4193 4250 +2945 2964 424f 4250 +2947 2946 4194 4251 +2946 2965 4250 4251 +2948 2947 4195 4252 +2947 2966 4251 4252 +2948 2967 4252 4253 +294a 2949 4235 42f2 +2949 2968 42f1 42f2 +294b 294a 4236 42f3 +294a 2969 42f2 42f3 +294c 294b 4237 42f4 +294b 296a 42f3 42f4 +294d 294c 4238 42f5 +294c 296b 42f4 42f5 +294e 294d 4239 42f6 +294d 296c 42f5 42f6 +294f 294e 423a 42f7 +294e 296d 42f6 42f7 +2950 294f 423b 42f8 +294f 296e 42f7 42f8 +2951 2950 423c 42f9 +2950 296f 42f8 42f9 +2952 2951 423d 42fa +2951 2970 42f9 42fa +2953 2952 423e 42fb +2952 2971 42fa 42fb +2954 2953 423f 42fc +2953 2972 42fb 42fc +2955 2954 4240 42fd +2954 2973 42fc 42fd +2956 2955 4241 42fe +2955 2974 42fd 42fe +2957 2956 4242 42ff +2956 2975 42fe 42ff +2958 2957 4243 4300 +2957 2976 42ff 4300 +2959 2958 4244 4301 +2958 2977 4300 4301 +295a 2959 4245 4302 +2959 2978 4301 4302 +295b 295a 4246 4303 +295a 2979 4302 4303 +295c 295b 4247 4304 +295b 297a 4303 4304 +295d 295c 4248 4305 +295c 297b 4304 4305 +295e 295d 4249 4306 +295d 297c 4305 4306 +295f 295e 424a 4307 +295e 297d 4306 4307 +2960 295f 424b 4308 +295f 297e 4307 4308 +2961 2960 424c 4309 +2960 297f 4308 4309 +2962 2961 424d 430a +2961 2980 4309 430a +2963 2962 424e 430b +2962 2981 430a 430b +2964 2963 424f 430c +2963 2982 430b 430c +2965 2964 4250 430d +2964 2983 430c 430d +2966 2965 4251 430e +2965 2984 430d 430e +2967 2966 4252 430f +2966 2985 430e 430f +2967 2986 430f 4310 +2969 2968 42f2 43af +2968 2987 43ae 43af +296a 2969 42f3 43b0 +2969 2988 43af 43b0 +296b 296a 42f4 43b1 +296a 2989 43b0 43b1 +296c 296b 42f5 43b2 +296b 298a 43b1 43b2 +296d 296c 42f6 43b3 +296c 298b 43b2 43b3 +296e 296d 42f7 43b4 +296d 298c 43b3 43b4 +296f 296e 42f8 43b5 +296e 298d 43b4 43b5 +2970 296f 42f9 43b6 +296f 298e 43b5 43b6 +2971 2970 42fa 43b7 +2970 298f 43b6 43b7 +2972 2971 42fb 43b8 +2971 2990 43b7 43b8 +2973 2972 42fc 43b9 +2972 2991 43b8 43b9 +2974 2973 42fd 43ba +2973 2992 43b9 43ba +2975 2974 42fe 43bb +2974 2993 43ba 43bb +2976 2975 42ff 43bc +2975 2994 43bb 43bc +2977 2976 4300 43bd +2976 2995 43bc 43bd +2978 2977 4301 43be +2977 2996 43bd 43be +2979 2978 4302 43bf +2978 2997 43be 43bf +297a 2979 4303 43c0 +2979 2998 43bf 43c0 +297b 297a 4304 43c1 +297a 2999 43c0 43c1 +297c 297b 4305 43c2 +297b 299a 43c1 43c2 +297d 297c 4306 43c3 +297c 299b 43c2 43c3 +297e 297d 4307 43c4 +297d 299c 43c3 43c4 +297f 297e 4308 43c5 +297e 299d 43c4 43c5 +2980 297f 4309 43c6 +297f 299e 43c5 43c6 +2981 2980 430a 43c7 +2980 299f 43c6 43c7 +2982 2981 430b 43c8 +2981 29a0 43c7 43c8 +2983 2982 430c 43c9 +2982 29a1 43c8 43c9 +2984 2983 430d 43ca +2983 29a2 43c9 43ca +2985 2984 430e 43cb +2984 29a3 43ca 43cb +2986 2985 430f 43cc +2985 29a4 43cb 43cc +2986 29a5 43cc 43cd +2988 2987 43af 446c +2987 29a6 446b 446c +2989 2988 43b0 446d +2988 29a7 446c 446d +298a 2989 43b1 446e +2989 29a8 446d 446e +298b 298a 43b2 446f +298a 29a9 446e 446f +298c 298b 43b3 4470 +298b 29aa 446f 4470 +298d 298c 43b4 4471 +298c 29ab 4470 4471 +298e 298d 43b5 4472 +298d 29ac 4471 4472 +298f 298e 43b6 4473 +298e 29ad 4472 4473 +2990 298f 43b7 4474 +298f 29ae 4473 4474 +2991 2990 43b8 4475 +2990 29af 4474 4475 +2992 2991 43b9 4476 +2991 29b0 4475 4476 +2993 2992 43ba 4477 +2992 29b1 4476 4477 +2994 2993 43bb 4478 +2993 29b2 4477 4478 +2995 2994 43bc 4479 +2994 29b3 4478 4479 +2996 2995 43bd 447a +2995 29b4 4479 447a +2997 2996 43be 447b +2996 29b5 447a 447b +2998 2997 43bf 447c +2997 29b6 447b 447c +2999 2998 43c0 447d +2998 29b7 447c 447d +299a 2999 43c1 447e +2999 29b8 447d 447e +299b 299a 43c2 447f +299a 29b9 447e 447f +299c 299b 43c3 4480 +299b 29ba 447f 4480 +299d 299c 43c4 4481 +299c 29bb 4480 4481 +299e 299d 43c5 4482 +299d 29bc 4481 4482 +299f 299e 43c6 4483 +299e 29bd 4482 4483 +29a0 299f 43c7 4484 +299f 29be 4483 4484 +29a1 29a0 43c8 4485 +29a0 29bf 4484 4485 +29a2 29a1 43c9 4486 +29a1 29c0 4485 4486 +29a3 29a2 43ca 4487 +29a2 29c1 4486 4487 +29a4 29a3 43cb 4488 +29a3 29c2 4487 4488 +29a5 29a4 43cc 4489 +29a4 29c3 4488 4489 +29a5 29c4 4489 448a +29a7 29a6 446c 4529 +29a6 29c5 4528 4529 +29a8 29a7 446d 452a +29a7 29c6 4529 452a +29a9 29a8 446e 452b +29a8 29c7 452a 452b +29aa 29a9 446f 452c +29a9 29c8 452b 452c +29ab 29aa 4470 452d +29aa 29c9 452c 452d +29ac 29ab 4471 452e +29ab 29ca 452d 452e +29ad 29ac 4472 452f +29ac 29cb 452e 452f +29ae 29ad 4473 4530 +29ad 29cc 452f 4530 +29af 29ae 4474 4531 +29ae 29cd 4530 4531 +29b0 29af 4475 4532 +29af 29ce 4531 4532 +29b1 29b0 4476 4533 +29b0 29cf 4532 4533 +29b2 29b1 4477 4534 +29b1 29d0 4533 4534 +29b3 29b2 4478 4535 +29b2 29d1 4534 4535 +29b4 29b3 4479 4536 +29b3 29d2 4535 4536 +29b5 29b4 447a 4537 +29b4 29d3 4536 4537 +29b6 29b5 447b 4538 +29b5 29d4 4537 4538 +29b7 29b6 447c 4539 +29b6 29d5 4538 4539 +29b8 29b7 447d 453a +29b7 29d6 4539 453a +29b9 29b8 447e 453b +29b8 29d7 453a 453b +29ba 29b9 447f 453c +29b9 29d8 453b 453c +29bb 29ba 4480 453d +29ba 29d9 453c 453d +29bc 29bb 4481 453e +29bb 29da 453d 453e +29bd 29bc 4482 453f +29bc 29db 453e 453f +29be 29bd 4483 4540 +29bd 29dc 453f 4540 +29bf 29be 4484 4541 +29be 29dd 4540 4541 +29c0 29bf 4485 4542 +29bf 29de 4541 4542 +29c1 29c0 4486 4543 +29c0 29df 4542 4543 +29c2 29c1 4487 4544 +29c1 29e0 4543 4544 +29c3 29c2 4488 4545 +29c2 29e1 4544 4545 +29c4 29c3 4489 4546 +29c3 29e2 4545 4546 +29c4 29e3 4546 4547 +29c6 29c5 4529 45e6 +29c5 29e4 45e5 45e6 +29c7 29c6 452a 45e7 +29c6 29e5 45e6 45e7 +29c8 29c7 452b 45e8 +29c7 29e6 45e7 45e8 +29c9 29c8 452c 45e9 +29c8 29e7 45e8 45e9 +29ca 29c9 452d 45ea +29c9 29e8 45e9 45ea +29cb 29ca 452e 45eb +29ca 29e9 45ea 45eb +29cc 29cb 452f 45ec +29cb 29ea 45eb 45ec +29cd 29cc 4530 45ed +29cc 29eb 45ec 45ed +29ce 29cd 4531 45ee +29cd 29ec 45ed 45ee +29cf 29ce 4532 45ef +29ce 29ed 45ee 45ef +29d0 29cf 4533 45f0 +29cf 29ee 45ef 45f0 +29d1 29d0 4534 45f1 +29d0 29ef 45f0 45f1 +29d2 29d1 4535 45f2 +29d1 29f0 45f1 45f2 +29d3 29d2 4536 45f3 +29d2 29f1 45f2 45f3 +29d4 29d3 4537 45f4 +29d3 29f2 45f3 45f4 +29d5 29d4 4538 45f5 +29d4 29f3 45f4 45f5 +29d6 29d5 4539 45f6 +29d5 29f4 45f5 45f6 +29d7 29d6 453a 45f7 +29d6 29f5 45f6 45f7 +29d8 29d7 453b 45f8 +29d7 29f6 45f7 45f8 +29d9 29d8 453c 45f9 +29d8 29f7 45f8 45f9 +29da 29d9 453d 45fa +29d9 29f8 45f9 45fa +29db 29da 453e 45fb +29da 29f9 45fa 45fb +29dc 29db 453f 45fc +29db 29fa 45fb 45fc +29dd 29dc 4540 45fd +29dc 29fb 45fc 45fd +29de 29dd 4541 45fe +29dd 29fc 45fd 45fe +29df 29de 4542 45ff +29de 29fd 45fe 45ff +29e0 29df 4543 4600 +29df 29fe 45ff 4600 +29e1 29e0 4544 4601 +29e0 29ff 4600 4601 +29e2 29e1 4545 4602 +29e1 2a00 4601 4602 +29e3 29e2 4546 4603 +29e2 2a01 4602 4603 +29e3 2a02 4603 4604 +29e5 29e4 45e6 46a3 +29e4 2a03 46a2 46a3 +29e6 29e5 45e7 46a4 +29e5 2a04 46a3 46a4 +29e7 29e6 45e8 46a5 +29e6 2a05 46a4 46a5 +29e8 29e7 45e9 46a6 +29e7 2a06 46a5 46a6 +29e9 29e8 45ea 46a7 +29e8 2a07 46a6 46a7 +29ea 29e9 45eb 46a8 +29e9 2a08 46a7 46a8 +29eb 29ea 45ec 46a9 +29ea 2a09 46a8 46a9 +29ec 29eb 45ed 46aa +29eb 2a0a 46a9 46aa +29ed 29ec 45ee 46ab +29ec 2a0b 46aa 46ab +29ee 29ed 45ef 46ac +29ed 2a0c 46ab 46ac +29ef 29ee 45f0 46ad +29ee 2a0d 46ac 46ad +29f0 29ef 45f1 46ae +29ef 2a0e 46ad 46ae +29f1 29f0 45f2 46af +29f0 2a0f 46ae 46af +29f2 29f1 45f3 46b0 +29f1 2a10 46af 46b0 +29f3 29f2 45f4 46b1 +29f2 2a11 46b0 46b1 +29f4 29f3 45f5 46b2 +29f3 2a12 46b1 46b2 +29f5 29f4 45f6 46b3 +29f4 2a13 46b2 46b3 +29f6 29f5 45f7 46b4 +29f5 2a14 46b3 46b4 +29f7 29f6 45f8 46b5 +29f6 2a15 46b4 46b5 +29f8 29f7 45f9 46b6 +29f7 2a16 46b5 46b6 +29f9 29f8 45fa 46b7 +29f8 2a17 46b6 46b7 +29fa 29f9 45fb 46b8 +29f9 2a18 46b7 46b8 +29fb 29fa 45fc 46b9 +29fa 2a19 46b8 46b9 +29fc 29fb 45fd 46ba +29fb 2a1a 46b9 46ba +29fd 29fc 45fe 46bb +29fc 2a1b 46ba 46bb +29fe 29fd 45ff 46bc +29fd 2a1c 46bb 46bc +29ff 29fe 4600 46bd +29fe 2a1d 46bc 46bd +2a00 29ff 4601 46be +29ff 2a1e 46bd 46be +2a01 2a00 4602 46bf +2a00 2a1f 46be 46bf +2a02 2a01 4603 46c0 +2a01 2a20 46bf 46c0 +2a02 2a21 46c0 46c1 +2a04 2a03 46a3 4760 +2a03 2a22 475f 4760 +2a05 2a04 46a4 4761 +2a04 2a23 4760 4761 +2a06 2a05 46a5 4762 +2a05 2a24 4761 4762 +2a07 2a06 46a6 4763 +2a06 2a25 4762 4763 +2a08 2a07 46a7 4764 +2a07 2a26 4763 4764 +2a09 2a08 46a8 4765 +2a08 2a27 4764 4765 +2a0a 2a09 46a9 4766 +2a09 2a28 4765 4766 +2a0b 2a0a 46aa 4767 +2a0a 2a29 4766 4767 +2a0c 2a0b 46ab 4768 +2a0b 2a2a 4767 4768 +2a0d 2a0c 46ac 4769 +2a0c 2a2b 4768 4769 +2a0e 2a0d 46ad 476a +2a0d 2a2c 4769 476a +2a0f 2a0e 46ae 476b +2a0e 2a2d 476a 476b +2a10 2a0f 46af 476c +2a0f 2a2e 476b 476c +2a11 2a10 46b0 476d +2a10 2a2f 476c 476d +2a12 2a11 46b1 476e +2a11 2a30 476d 476e +2a13 2a12 46b2 476f +2a12 2a31 476e 476f +2a14 2a13 46b3 4770 +2a13 2a32 476f 4770 +2a15 2a14 46b4 4771 +2a14 2a33 4770 4771 +2a16 2a15 46b5 4772 +2a15 2a34 4771 4772 +2a17 2a16 46b6 4773 +2a16 2a35 4772 4773 +2a18 2a17 46b7 4774 +2a17 2a36 4773 4774 +2a19 2a18 46b8 4775 +2a18 2a37 4774 4775 +2a1a 2a19 46b9 4776 +2a19 2a38 4775 4776 +2a1b 2a1a 46ba 4777 +2a1a 2a39 4776 4777 +2a1c 2a1b 46bb 4778 +2a1b 2a3a 4777 4778 +2a1d 2a1c 46bc 4779 +2a1c 2a3b 4778 4779 +2a1e 2a1d 46bd 477a +2a1d 2a3c 4779 477a +2a1f 2a1e 46be 477b +2a1e 2a3d 477a 477b +2a20 2a1f 46bf 477c +2a1f 2a3e 477b 477c +2a21 2a20 46c0 477d +2a20 2a3f 477c 477d +2a21 2a40 477d 477e +2a23 2a22 4760 481d +2a22 2a41 481c 481d +2a24 2a23 4761 481e +2a23 2a42 481d 481e +2a25 2a24 4762 481f +2a24 2a43 481e 481f +2a26 2a25 4763 4820 +2a25 2a44 481f 4820 +2a27 2a26 4764 4821 +2a26 2a45 4820 4821 +2a28 2a27 4765 4822 +2a27 2a46 4821 4822 +2a29 2a28 4766 4823 +2a28 2a47 4822 4823 +2a2a 2a29 4767 4824 +2a29 2a48 4823 4824 +2a2b 2a2a 4768 4825 +2a2a 2a49 4824 4825 +2a2c 2a2b 4769 4826 +2a2b 2a4a 4825 4826 +2a2d 2a2c 476a 4827 +2a2c 2a4b 4826 4827 +2a2e 2a2d 476b 4828 +2a2d 2a4c 4827 4828 +2a2f 2a2e 476c 4829 +2a2e 2a4d 4828 4829 +2a30 2a2f 476d 482a +2a2f 2a4e 4829 482a +2a31 2a30 476e 482b +2a30 2a4f 482a 482b +2a32 2a31 476f 482c +2a31 2a50 482b 482c +2a33 2a32 4770 482d +2a32 2a51 482c 482d +2a34 2a33 4771 482e +2a33 2a52 482d 482e +2a35 2a34 4772 482f +2a34 2a53 482e 482f +2a36 2a35 4773 4830 +2a35 2a54 482f 4830 +2a37 2a36 4774 4831 +2a36 2a55 4830 4831 +2a38 2a37 4775 4832 +2a37 2a56 4831 4832 +2a39 2a38 4776 4833 +2a38 2a57 4832 4833 +2a3a 2a39 4777 4834 +2a39 2a58 4833 4834 +2a3b 2a3a 4778 4835 +2a3a 2a59 4834 4835 +2a3c 2a3b 4779 4836 +2a3b 2a5a 4835 4836 +2a3d 2a3c 477a 4837 +2a3c 2a5b 4836 4837 +2a3e 2a3d 477b 4838 +2a3d 2a5c 4837 4838 +2a3f 2a3e 477c 4839 +2a3e 2a5d 4838 4839 +2a40 2a3f 477d 483a +2a3f 2a5e 4839 483a +2a40 2a5f 483a 483b +2a42 2a41 481d 48da +2a41 2a60 48d9 48da +2a43 2a42 481e 48db +2a42 2a61 48da 48db +2a44 2a43 481f 48dc +2a43 2a62 48db 48dc +2a45 2a44 4820 48dd +2a44 2a63 48dc 48dd +2a46 2a45 4821 48de +2a45 2a64 48dd 48de +2a47 2a46 4822 48df +2a46 2a65 48de 48df +2a48 2a47 4823 48e0 +2a47 2a66 48df 48e0 +2a49 2a48 4824 48e1 +2a48 2a67 48e0 48e1 +2a4a 2a49 4825 48e2 +2a49 2a68 48e1 48e2 +2a4b 2a4a 4826 48e3 +2a4a 2a69 48e2 48e3 +2a4c 2a4b 4827 48e4 +2a4b 2a6a 48e3 48e4 +2a4d 2a4c 4828 48e5 +2a4c 2a6b 48e4 48e5 +2a4e 2a4d 4829 48e6 +2a4d 2a6c 48e5 48e6 +2a4f 2a4e 482a 48e7 +2a4e 2a6d 48e6 48e7 +2a50 2a4f 482b 48e8 +2a4f 2a6e 48e7 48e8 +2a51 2a50 482c 48e9 +2a50 2a6f 48e8 48e9 +2a52 2a51 482d 48ea +2a51 2a70 48e9 48ea +2a53 2a52 482e 48eb +2a52 2a71 48ea 48eb +2a54 2a53 482f 48ec +2a53 2a72 48eb 48ec +2a55 2a54 4830 48ed +2a54 2a73 48ec 48ed +2a56 2a55 4831 48ee +2a55 2a74 48ed 48ee +2a57 2a56 4832 48ef +2a56 2a75 48ee 48ef +2a58 2a57 4833 48f0 +2a57 2a76 48ef 48f0 +2a59 2a58 4834 48f1 +2a58 2a77 48f0 48f1 +2a5a 2a59 4835 48f2 +2a59 2a78 48f1 48f2 +2a5b 2a5a 4836 48f3 +2a5a 2a79 48f2 48f3 +2a5c 2a5b 4837 48f4 +2a5b 2a7a 48f3 48f4 +2a5d 2a5c 4838 48f5 +2a5c 2a7b 48f4 48f5 +2a5e 2a5d 4839 48f6 +2a5d 2a7c 48f5 48f6 +2a5f 2a5e 483a 48f7 +2a5e 2a7d 48f6 48f7 +2a5f 2a7e 48f7 48f8 +2a61 2a60 48da 4997 +2a60 2a7f 4996 4997 +2a62 2a61 48db 4998 +2a61 2a80 4997 4998 +2a63 2a62 48dc 4999 +2a62 2a81 4998 4999 +2a64 2a63 48dd 499a +2a63 2a82 4999 499a +2a65 2a64 48de 499b +2a64 2a83 499a 499b +2a66 2a65 48df 499c +2a65 2a84 499b 499c +2a67 2a66 48e0 499d +2a66 2a85 499c 499d +2a68 2a67 48e1 499e +2a67 2a86 499d 499e +2a69 2a68 48e2 499f +2a68 2a87 499e 499f +2a6a 2a69 48e3 49a0 +2a69 2a88 499f 49a0 +2a6b 2a6a 48e4 49a1 +2a6a 2a89 49a0 49a1 +2a6c 2a6b 48e5 49a2 +2a6b 2a8a 49a1 49a2 +2a6d 2a6c 48e6 49a3 +2a6c 2a8b 49a2 49a3 +2a6e 2a6d 48e7 49a4 +2a6d 2a8c 49a3 49a4 +2a6f 2a6e 48e8 49a5 +2a6e 2a8d 49a4 49a5 +2a70 2a6f 48e9 49a6 +2a6f 2a8e 49a5 49a6 +2a71 2a70 48ea 49a7 +2a70 2a8f 49a6 49a7 +2a72 2a71 48eb 49a8 +2a71 2a90 49a7 49a8 +2a73 2a72 48ec 49a9 +2a72 2a91 49a8 49a9 +2a74 2a73 48ed 49aa +2a73 2a92 49a9 49aa +2a75 2a74 48ee 49ab +2a74 2a93 49aa 49ab +2a76 2a75 48ef 49ac +2a75 2a94 49ab 49ac +2a77 2a76 48f0 49ad +2a76 2a95 49ac 49ad +2a78 2a77 48f1 49ae +2a77 2a96 49ad 49ae +2a79 2a78 48f2 49af +2a78 2a97 49ae 49af +2a7a 2a79 48f3 49b0 +2a79 2a98 49af 49b0 +2a7b 2a7a 48f4 49b1 +2a7a 2a99 49b0 49b1 +2a7c 2a7b 48f5 49b2 +2a7b 2a9a 49b1 49b2 +2a7d 2a7c 48f6 49b3 +2a7c 2a9b 49b2 49b3 +2a7e 2a7d 48f7 49b4 +2a7d 2a9c 49b3 49b4 +2a7e 2a9d 49b4 49b5 +2a80 2a7f 4997 4a54 +2a7f 2a9e 4a53 4a54 +2a81 2a80 4998 4a55 +2a80 2a9f 4a54 4a55 +2a82 2a81 4999 4a56 +2a81 2aa0 4a55 4a56 +2a83 2a82 499a 4a57 +2a82 2aa1 4a56 4a57 +2a84 2a83 499b 4a58 +2a83 2aa2 4a57 4a58 +2a85 2a84 499c 4a59 +2a84 2aa3 4a58 4a59 +2a86 2a85 499d 4a5a +2a85 2aa4 4a59 4a5a +2a87 2a86 499e 4a5b +2a86 2aa5 4a5a 4a5b +2a88 2a87 499f 4a5c +2a87 2aa6 4a5b 4a5c +2a89 2a88 49a0 4a5d +2a88 2aa7 4a5c 4a5d +2a8a 2a89 49a1 4a5e +2a89 2aa8 4a5d 4a5e +2a8b 2a8a 49a2 4a5f +2a8a 2aa9 4a5e 4a5f +2a8c 2a8b 49a3 4a60 +2a8b 2aaa 4a5f 4a60 +2a8d 2a8c 49a4 4a61 +2a8c 2aab 4a60 4a61 +2a8e 2a8d 49a5 4a62 +2a8d 2aac 4a61 4a62 +2a8f 2a8e 49a6 4a63 +2a8e 2aad 4a62 4a63 +2a90 2a8f 49a7 4a64 +2a8f 2aae 4a63 4a64 +2a91 2a90 49a8 4a65 +2a90 2aaf 4a64 4a65 +2a92 2a91 49a9 4a66 +2a91 2ab0 4a65 4a66 +2a93 2a92 49aa 4a67 +2a92 2ab1 4a66 4a67 +2a94 2a93 49ab 4a68 +2a93 2ab2 4a67 4a68 +2a95 2a94 49ac 4a69 +2a94 2ab3 4a68 4a69 +2a96 2a95 49ad 4a6a +2a95 2ab4 4a69 4a6a +2a97 2a96 49ae 4a6b +2a96 2ab5 4a6a 4a6b +2a98 2a97 49af 4a6c +2a97 2ab6 4a6b 4a6c +2a99 2a98 49b0 4a6d +2a98 2ab7 4a6c 4a6d +2a9a 2a99 49b1 4a6e +2a99 2ab8 4a6d 4a6e +2a9b 2a9a 49b2 4a6f +2a9a 2ab9 4a6e 4a6f +2a9c 2a9b 49b3 4a70 +2a9b 2aba 4a6f 4a70 +2a9d 2a9c 49b4 4a71 +2a9c 2abb 4a70 4a71 +2a9d 2abc 4a71 4a72 +2a9f 2a9e 4a54 4b11 +2a9e 2abd 4b10 4b11 +2aa0 2a9f 4a55 4b12 +2a9f 2abe 4b11 4b12 +2aa1 2aa0 4a56 4b13 +2aa0 2abf 4b12 4b13 +2aa2 2aa1 4a57 4b14 +2aa1 2ac0 4b13 4b14 +2aa3 2aa2 4a58 4b15 +2aa2 2ac1 4b14 4b15 +2aa4 2aa3 4a59 4b16 +2aa3 2ac2 4b15 4b16 +2aa5 2aa4 4a5a 4b17 +2aa4 2ac3 4b16 4b17 +2aa6 2aa5 4a5b 4b18 +2aa5 2ac4 4b17 4b18 +2aa7 2aa6 4a5c 4b19 +2aa6 2ac5 4b18 4b19 +2aa8 2aa7 4a5d 4b1a +2aa7 2ac6 4b19 4b1a +2aa9 2aa8 4a5e 4b1b +2aa8 2ac7 4b1a 4b1b +2aaa 2aa9 4a5f 4b1c +2aa9 2ac8 4b1b 4b1c +2aab 2aaa 4a60 4b1d +2aaa 2ac9 4b1c 4b1d +2aac 2aab 4a61 4b1e +2aab 2aca 4b1d 4b1e +2aad 2aac 4a62 4b1f +2aac 2acb 4b1e 4b1f +2aae 2aad 4a63 4b20 +2aad 2acc 4b1f 4b20 +2aaf 2aae 4a64 4b21 +2aae 2acd 4b20 4b21 +2ab0 2aaf 4a65 4b22 +2aaf 2ace 4b21 4b22 +2ab1 2ab0 4a66 4b23 +2ab0 2acf 4b22 4b23 +2ab2 2ab1 4a67 4b24 +2ab1 2ad0 4b23 4b24 +2ab3 2ab2 4a68 4b25 +2ab2 2ad1 4b24 4b25 +2ab4 2ab3 4a69 4b26 +2ab3 2ad2 4b25 4b26 +2ab5 2ab4 4a6a 4b27 +2ab4 2ad3 4b26 4b27 +2ab6 2ab5 4a6b 4b28 +2ab5 2ad4 4b27 4b28 +2ab7 2ab6 4a6c 4b29 +2ab6 2ad5 4b28 4b29 +2ab8 2ab7 4a6d 4b2a +2ab7 2ad6 4b29 4b2a +2ab9 2ab8 4a6e 4b2b +2ab8 2ad7 4b2a 4b2b +2aba 2ab9 4a6f 4b2c +2ab9 2ad8 4b2b 4b2c +2abb 2aba 4a70 4b2d +2aba 2ad9 4b2c 4b2d +2abc 2abb 4a71 4b2e +2abb 2ada 4b2d 4b2e +2abc 2adb 4b2e 4b2f +2abe 2abd 4b11 4bce +2abf 2abe 4b12 4bcf +2ac0 2abf 4b13 4bd0 +2ac1 2ac0 4b14 4bd1 +2ac2 2ac1 4b15 4bd2 +2ac3 2ac2 4b16 4bd3 +2ac4 2ac3 4b17 4bd4 +2ac5 2ac4 4b18 4bd5 +2ac6 2ac5 4b19 4bd6 +2ac7 2ac6 4b1a 4bd7 +2ac8 2ac7 4b1b 4bd8 +2ac9 2ac8 4b1c 4bd9 +2aca 2ac9 4b1d 4bda +2acb 2aca 4b1e 4bdb +2acc 2acb 4b1f 4bdc +2acd 2acc 4b20 4bdd +2ace 2acd 4b21 4bde +2acf 2ace 4b22 4bdf +2ad0 2acf 4b23 4be0 +2ad1 2ad0 4b24 4be1 +2ad2 2ad1 4b25 4be2 +2ad3 2ad2 4b26 4be3 +2ad4 2ad3 4b27 4be4 +2ad5 2ad4 4b28 4be5 +2ad6 2ad5 4b29 4be6 +2ad7 2ad6 4b2a 4be7 +2ad8 2ad7 4b2b 4be8 +2ad9 2ad8 4b2c 4be9 +2ada 2ad9 4b2d 4bea +2adb 2ada 4b2e 4beb +2adc 2add 4b6e 4c2b +2b1b 2adc 4b6e 4b6f +2add 2ade 4b6d 4c2a +2b1c 2add 4b6d 4b6e +2ade 2adf 4b6c 4c29 +2b1d 2ade 4b6c 4b6d +2adf 2ae0 4b6b 4c28 +2b1e 2adf 4b6b 4b6c +2ae0 2ae1 4b6a 4c27 +2b1f 2ae0 4b6a 4b6b +2ae1 2ae2 4b69 4c26 +2b20 2ae1 4b69 4b6a +2ae2 2ae3 4b68 4c25 +2b21 2ae2 4b68 4b69 +2ae3 2ae4 4b67 4c24 +2b22 2ae3 4b67 4b68 +2ae4 2ae5 4b66 4c23 +2b23 2ae4 4b66 4b67 +2ae5 2ae6 4b65 4c22 +2b24 2ae5 4b65 4b66 +2ae6 2ae7 4b64 4c21 +2b25 2ae6 4b64 4b65 +2ae7 2ae8 4b63 4c20 +2b26 2ae7 4b63 4b64 +2ae8 2ae9 4b62 4c1f +2b27 2ae8 4b62 4b63 +2ae9 2aea 4b61 4c1e +2b28 2ae9 4b61 4b62 +2aea 2aeb 4b60 4c1d +2b29 2aea 4b60 4b61 +2aeb 2aec 4b5f 4c1c +2b2a 2aeb 4b5f 4b60 +2aec 2aed 4b5e 4c1b +2b2b 2aec 4b5e 4b5f +2aed 2aee 4b5d 4c1a +2b2c 2aed 4b5d 4b5e +2aee 2aef 4b5c 4c19 +2b2d 2aee 4b5c 4b5d +2aef 2af0 4b5b 4c18 +2b2e 2aef 4b5b 4b5c +2af0 2af1 4b5a 4c17 +2b2f 2af0 4b5a 4b5b +2af1 2af2 4b59 4c16 +2b30 2af1 4b59 4b5a +2af2 2af3 4b58 4c15 +2b31 2af2 4b58 4b59 +2af3 2af4 4b57 4c14 +2b32 2af3 4b57 4b58 +2af4 2af5 4b56 4c13 +2b33 2af4 4b56 4b57 +2af5 2af6 4b55 4c12 +2b34 2af5 4b55 4b56 +2af6 2af7 4b54 4c11 +2b35 2af6 4b54 4b55 +2af7 2af8 4b53 4c10 +2b36 2af7 4b53 4b54 +2af8 2af9 4b52 4c0f +2b37 2af8 4b52 4b53 +2af9 2afa 4b51 4c0e +2b38 2af9 4b51 4b52 +2afa 2afb 4b50 4c0d +2b39 2afa 4b50 4b51 +2afb 2afc 4b4f 4c0c +2b3a 2afb 4b4f 4b50 +2afc 2afd 4b4e 4c0b +2b3b 2afc 4b4e 4b4f +2afd 2afe 4b4d 4c0a +2b3c 2afd 4b4d 4b4e +2afe 2aff 4b4c 4c09 +2b3d 2afe 4b4c 4b4d +2aff 2b00 4b4b 4c08 +2b3e 2aff 4b4b 4b4c +2b00 2b01 4b4a 4c07 +2b3f 2b00 4b4a 4b4b +2b01 2b02 4b49 4c06 +2b40 2b01 4b49 4b4a +2b02 2b03 4b48 4c05 +2b41 2b02 4b48 4b49 +2b03 2b04 4b47 4c04 +2b42 2b03 4b47 4b48 +2b04 2b05 4b46 4c03 +2b43 2b04 4b46 4b47 +2b05 2b06 4b45 4c02 +2b44 2b05 4b45 4b46 +2b06 2b07 4b44 4c01 +2b45 2b06 4b44 4b45 +2b07 2b08 4b43 4c00 +2b46 2b07 4b43 4b44 +2b08 2b09 4b42 4bff +2b47 2b08 4b42 4b43 +2b09 2b0a 4b41 4bfe +2b48 2b09 4b41 4b42 +2b0a 2b0b 4b40 4bfd +2b49 2b0a 4b40 4b41 +2b0b 2b0c 4b3f 4bfc +2b4a 2b0b 4b3f 4b40 +2b0c 2b0d 4b3e 4bfb +2b4b 2b0c 4b3e 4b3f +2b0d 2b0e 4b3d 4bfa +2b4c 2b0d 4b3d 4b3e +2b0e 2b0f 4b3c 4bf9 +2b4d 2b0e 4b3c 4b3d +2b0f 2b10 4b3b 4bf8 +2b4e 2b0f 4b3b 4b3c +2b10 2b11 4b3a 4bf7 +2b4f 2b10 4b3a 4b3b +2b11 2b12 4b39 4bf6 +2b50 2b11 4b39 4b3a +2b12 2b13 4b38 4bf5 +2b51 2b12 4b38 4b39 +2b13 2b14 4b37 4bf4 +2b52 2b13 4b37 4b38 +2b14 2b15 4b36 4bf3 +2b53 2b14 4b36 4b37 +2b15 2b16 4b35 4bf2 +2b54 2b15 4b35 4b36 +2b16 2b17 4b34 4bf1 +2b55 2b16 4b34 4b35 +2b17 2b18 4b33 4bf0 +2b56 2b17 4b33 4b34 +2b18 2b19 4b32 4bef +2b57 2b18 4b32 4b33 +2b19 2b1a 4b31 4bee +2b58 2b19 4b31 4b32 +2b59 2b1a 4b30 4b31 +2b1b 2b1c 4ab1 4b6e +2b5a 2b1b 4ab1 4ab2 +2b1c 2b1d 4ab0 4b6d +2b5b 2b1c 4ab0 4ab1 +2b1d 2b1e 4aaf 4b6c +2b5c 2b1d 4aaf 4ab0 +2b1e 2b1f 4aae 4b6b +2b5d 2b1e 4aae 4aaf +2b1f 2b20 4aad 4b6a +2b5e 2b1f 4aad 4aae +2b20 2b21 4aac 4b69 +2b5f 2b20 4aac 4aad +2b21 2b22 4aab 4b68 +2b60 2b21 4aab 4aac +2b22 2b23 4aaa 4b67 +2b61 2b22 4aaa 4aab +2b23 2b24 4aa9 4b66 +2b62 2b23 4aa9 4aaa +2b24 2b25 4aa8 4b65 +2b63 2b24 4aa8 4aa9 +2b25 2b26 4aa7 4b64 +2b64 2b25 4aa7 4aa8 +2b26 2b27 4aa6 4b63 +2b65 2b26 4aa6 4aa7 +2b27 2b28 4aa5 4b62 +2b66 2b27 4aa5 4aa6 +2b28 2b29 4aa4 4b61 +2b67 2b28 4aa4 4aa5 +2b29 2b2a 4aa3 4b60 +2b68 2b29 4aa3 4aa4 +2b2a 2b2b 4aa2 4b5f +2b69 2b2a 4aa2 4aa3 +2b2b 2b2c 4aa1 4b5e +2b6a 2b2b 4aa1 4aa2 +2b2c 2b2d 4aa0 4b5d +2b6b 2b2c 4aa0 4aa1 +2b2d 2b2e 4a9f 4b5c +2b6c 2b2d 4a9f 4aa0 +2b2e 2b2f 4a9e 4b5b +2b6d 2b2e 4a9e 4a9f +2b2f 2b30 4a9d 4b5a +2b6e 2b2f 4a9d 4a9e +2b30 2b31 4a9c 4b59 +2b6f 2b30 4a9c 4a9d +2b31 2b32 4a9b 4b58 +2b70 2b31 4a9b 4a9c +2b32 2b33 4a9a 4b57 +2b71 2b32 4a9a 4a9b +2b33 2b34 4a99 4b56 +2b72 2b33 4a99 4a9a +2b34 2b35 4a98 4b55 +2b73 2b34 4a98 4a99 +2b35 2b36 4a97 4b54 +2b74 2b35 4a97 4a98 +2b36 2b37 4a96 4b53 +2b75 2b36 4a96 4a97 +2b37 2b38 4a95 4b52 +2b76 2b37 4a95 4a96 +2b38 2b39 4a94 4b51 +2b77 2b38 4a94 4a95 +2b39 2b3a 4a93 4b50 +2b78 2b39 4a93 4a94 +2b3a 2b3b 4a92 4b4f +2b79 2b3a 4a92 4a93 +2b3b 2b3c 4a91 4b4e +2b7a 2b3b 4a91 4a92 +2b3c 2b3d 4a90 4b4d +2b7b 2b3c 4a90 4a91 +2b3d 2b3e 4a8f 4b4c +2b7c 2b3d 4a8f 4a90 +2b3e 2b3f 4a8e 4b4b +2b7d 2b3e 4a8e 4a8f +2b3f 2b40 4a8d 4b4a +2b7e 2b3f 4a8d 4a8e +2b40 2b41 4a8c 4b49 +2b7f 2b40 4a8c 4a8d +2b41 2b42 4a8b 4b48 +2b80 2b41 4a8b 4a8c +2b42 2b43 4a8a 4b47 +2b81 2b42 4a8a 4a8b +2b43 2b44 4a89 4b46 +2b82 2b43 4a89 4a8a +2b44 2b45 4a88 4b45 +2b83 2b44 4a88 4a89 +2b45 2b46 4a87 4b44 +2b84 2b45 4a87 4a88 +2b46 2b47 4a86 4b43 +2b85 2b46 4a86 4a87 +2b47 2b48 4a85 4b42 +2b86 2b47 4a85 4a86 +2b48 2b49 4a84 4b41 +2b87 2b48 4a84 4a85 +2b49 2b4a 4a83 4b40 +2b88 2b49 4a83 4a84 +2b4a 2b4b 4a82 4b3f +2b89 2b4a 4a82 4a83 +2b4b 2b4c 4a81 4b3e +2b8a 2b4b 4a81 4a82 +2b4c 2b4d 4a80 4b3d +2b8b 2b4c 4a80 4a81 +2b4d 2b4e 4a7f 4b3c +2b8c 2b4d 4a7f 4a80 +2b4e 2b4f 4a7e 4b3b +2b8d 2b4e 4a7e 4a7f +2b4f 2b50 4a7d 4b3a +2b8e 2b4f 4a7d 4a7e +2b50 2b51 4a7c 4b39 +2b8f 2b50 4a7c 4a7d +2b51 2b52 4a7b 4b38 +2b90 2b51 4a7b 4a7c +2b52 2b53 4a7a 4b37 +2b91 2b52 4a7a 4a7b +2b53 2b54 4a79 4b36 +2b92 2b53 4a79 4a7a +2b54 2b55 4a78 4b35 +2b93 2b54 4a78 4a79 +2b55 2b56 4a77 4b34 +2b94 2b55 4a77 4a78 +2b56 2b57 4a76 4b33 +2b95 2b56 4a76 4a77 +2b57 2b58 4a75 4b32 +2b96 2b57 4a75 4a76 +2b58 2b59 4a74 4b31 +2b97 2b58 4a74 4a75 +2b98 2b59 4a73 4a74 +2b5a 2b5b 49f4 4ab1 +2b99 2b5a 49f4 49f5 +2b5b 2b5c 49f3 4ab0 +2b9a 2b5b 49f3 49f4 +2b5c 2b5d 49f2 4aaf +2b9b 2b5c 49f2 49f3 +2b5d 2b5e 49f1 4aae +2b9c 2b5d 49f1 49f2 +2b5e 2b5f 49f0 4aad +2b9d 2b5e 49f0 49f1 +2b5f 2b60 49ef 4aac +2b9e 2b5f 49ef 49f0 +2b60 2b61 49ee 4aab +2b9f 2b60 49ee 49ef +2b61 2b62 49ed 4aaa +2ba0 2b61 49ed 49ee +2b62 2b63 49ec 4aa9 +2ba1 2b62 49ec 49ed +2b63 2b64 49eb 4aa8 +2ba2 2b63 49eb 49ec +2b64 2b65 49ea 4aa7 +2ba3 2b64 49ea 49eb +2b65 2b66 49e9 4aa6 +2ba4 2b65 49e9 49ea +2b66 2b67 49e8 4aa5 +2ba5 2b66 49e8 49e9 +2b67 2b68 49e7 4aa4 +2ba6 2b67 49e7 49e8 +2b68 2b69 49e6 4aa3 +2ba7 2b68 49e6 49e7 +2b69 2b6a 49e5 4aa2 +2ba8 2b69 49e5 49e6 +2b6a 2b6b 49e4 4aa1 +2ba9 2b6a 49e4 49e5 +2b6b 2b6c 49e3 4aa0 +2baa 2b6b 49e3 49e4 +2b6c 2b6d 49e2 4a9f +2bab 2b6c 49e2 49e3 +2b6d 2b6e 49e1 4a9e +2bac 2b6d 49e1 49e2 +2b6e 2b6f 49e0 4a9d +2bad 2b6e 49e0 49e1 +2b6f 2b70 49df 4a9c +2bae 2b6f 49df 49e0 +2b70 2b71 49de 4a9b +2baf 2b70 49de 49df +2b71 2b72 49dd 4a9a +2bb0 2b71 49dd 49de +2b72 2b73 49dc 4a99 +2bb1 2b72 49dc 49dd +2b73 2b74 49db 4a98 +2bb2 2b73 49db 49dc +2b74 2b75 49da 4a97 +2bb3 2b74 49da 49db +2b75 2b76 49d9 4a96 +2bb4 2b75 49d9 49da +2b76 2b77 49d8 4a95 +2bb5 2b76 49d8 49d9 +2b77 2b78 49d7 4a94 +2bb6 2b77 49d7 49d8 +2b78 2b79 49d6 4a93 +2bb7 2b78 49d6 49d7 +2b79 2b7a 49d5 4a92 +2bb8 2b79 49d5 49d6 +2b7a 2b7b 49d4 4a91 +2bb9 2b7a 49d4 49d5 +2b7b 2b7c 49d3 4a90 +2bba 2b7b 49d3 49d4 +2b7c 2b7d 49d2 4a8f +2bbb 2b7c 49d2 49d3 +2b7d 2b7e 49d1 4a8e +2bbc 2b7d 49d1 49d2 +2b7e 2b7f 49d0 4a8d +2bbd 2b7e 49d0 49d1 +2b7f 2b80 49cf 4a8c +2bbe 2b7f 49cf 49d0 +2b80 2b81 49ce 4a8b +2bbf 2b80 49ce 49cf +2b81 2b82 49cd 4a8a +2bc0 2b81 49cd 49ce +2b82 2b83 49cc 4a89 +2bc1 2b82 49cc 49cd +2b83 2b84 49cb 4a88 +2bc2 2b83 49cb 49cc +2b84 2b85 49ca 4a87 +2bc3 2b84 49ca 49cb +2b85 2b86 49c9 4a86 +2bc4 2b85 49c9 49ca +2b86 2b87 49c8 4a85 +2bc5 2b86 49c8 49c9 +2b87 2b88 49c7 4a84 +2bc6 2b87 49c7 49c8 +2b88 2b89 49c6 4a83 +2bc7 2b88 49c6 49c7 +2b89 2b8a 49c5 4a82 +2bc8 2b89 49c5 49c6 +2b8a 2b8b 49c4 4a81 +2bc9 2b8a 49c4 49c5 +2b8b 2b8c 49c3 4a80 +2bca 2b8b 49c3 49c4 +2b8c 2b8d 49c2 4a7f +2bcb 2b8c 49c2 49c3 +2b8d 2b8e 49c1 4a7e +2bcc 2b8d 49c1 49c2 +2b8e 2b8f 49c0 4a7d +2bcd 2b8e 49c0 49c1 +2b8f 2b90 49bf 4a7c +2bce 2b8f 49bf 49c0 +2b90 2b91 49be 4a7b +2bcf 2b90 49be 49bf +2b91 2b92 49bd 4a7a +2bd0 2b91 49bd 49be +2b92 2b93 49bc 4a79 +2bd1 2b92 49bc 49bd +2b93 2b94 49bb 4a78 +2bd2 2b93 49bb 49bc +2b94 2b95 49ba 4a77 +2bd3 2b94 49ba 49bb +2b95 2b96 49b9 4a76 +2bd4 2b95 49b9 49ba +2b96 2b97 49b8 4a75 +2bd5 2b96 49b8 49b9 +2b97 2b98 49b7 4a74 +2bd6 2b97 49b7 49b8 +2bd7 2b98 49b6 49b7 +2b99 2b9a 4937 49f4 +2bd8 2b99 4937 4938 +2b9a 2b9b 4936 49f3 +2bd9 2b9a 4936 4937 +2b9b 2b9c 4935 49f2 +2bda 2b9b 4935 4936 +2b9c 2b9d 4934 49f1 +2bdb 2b9c 4934 4935 +2b9d 2b9e 4933 49f0 +2bdc 2b9d 4933 4934 +2b9e 2b9f 4932 49ef +2bdd 2b9e 4932 4933 +2b9f 2ba0 4931 49ee +2bde 2b9f 4931 4932 +2ba0 2ba1 4930 49ed +2bdf 2ba0 4930 4931 +2ba1 2ba2 492f 49ec +2be0 2ba1 492f 4930 +2ba2 2ba3 492e 49eb +2be1 2ba2 492e 492f +2ba3 2ba4 492d 49ea +2be2 2ba3 492d 492e +2ba4 2ba5 492c 49e9 +2be3 2ba4 492c 492d +2ba5 2ba6 492b 49e8 +2be4 2ba5 492b 492c +2ba6 2ba7 492a 49e7 +2be5 2ba6 492a 492b +2ba7 2ba8 4929 49e6 +2be6 2ba7 4929 492a +2ba8 2ba9 4928 49e5 +2be7 2ba8 4928 4929 +2ba9 2baa 4927 49e4 +2be8 2ba9 4927 4928 +2baa 2bab 4926 49e3 +2be9 2baa 4926 4927 +2bab 2bac 4925 49e2 +2bea 2bab 4925 4926 +2bac 2bad 4924 49e1 +2beb 2bac 4924 4925 +2bad 2bae 4923 49e0 +2bec 2bad 4923 4924 +2bae 2baf 4922 49df +2bed 2bae 4922 4923 +2baf 2bb0 4921 49de +2bee 2baf 4921 4922 +2bb0 2bb1 4920 49dd +2bef 2bb0 4920 4921 +2bb1 2bb2 491f 49dc +2bf0 2bb1 491f 4920 +2bb2 2bb3 491e 49db +2bf1 2bb2 491e 491f +2bb3 2bb4 491d 49da +2bf2 2bb3 491d 491e +2bb4 2bb5 491c 49d9 +2bf3 2bb4 491c 491d +2bb5 2bb6 491b 49d8 +2bf4 2bb5 491b 491c +2bb6 2bb7 491a 49d7 +2bf5 2bb6 491a 491b +2bb7 2bb8 4919 49d6 +2bf6 2bb7 4919 491a +2bb8 2bb9 4918 49d5 +2bf7 2bb8 4918 4919 +2bb9 2bba 4917 49d4 +2bf8 2bb9 4917 4918 +2bba 2bbb 4916 49d3 +2bf9 2bba 4916 4917 +2bbb 2bbc 4915 49d2 +2bfa 2bbb 4915 4916 +2bbc 2bbd 4914 49d1 +2bfb 2bbc 4914 4915 +2bbd 2bbe 4913 49d0 +2bfc 2bbd 4913 4914 +2bbe 2bbf 4912 49cf +2bfd 2bbe 4912 4913 +2bbf 2bc0 4911 49ce +2bfe 2bbf 4911 4912 +2bc0 2bc1 4910 49cd +2bff 2bc0 4910 4911 +2bc1 2bc2 490f 49cc +2c00 2bc1 490f 4910 +2bc2 2bc3 490e 49cb +2c01 2bc2 490e 490f +2bc3 2bc4 490d 49ca +2c02 2bc3 490d 490e +2bc4 2bc5 490c 49c9 +2c03 2bc4 490c 490d +2bc5 2bc6 490b 49c8 +2c04 2bc5 490b 490c +2bc6 2bc7 490a 49c7 +2c05 2bc6 490a 490b +2bc7 2bc8 4909 49c6 +2c06 2bc7 4909 490a +2bc8 2bc9 4908 49c5 +2c07 2bc8 4908 4909 +2bc9 2bca 4907 49c4 +2c08 2bc9 4907 4908 +2bca 2bcb 4906 49c3 +2c09 2bca 4906 4907 +2bcb 2bcc 4905 49c2 +2c0a 2bcb 4905 4906 +2bcc 2bcd 4904 49c1 +2c0b 2bcc 4904 4905 +2bcd 2bce 4903 49c0 +2c0c 2bcd 4903 4904 +2bce 2bcf 4902 49bf +2c0d 2bce 4902 4903 +2bcf 2bd0 4901 49be +2c0e 2bcf 4901 4902 +2bd0 2bd1 4900 49bd +2c0f 2bd0 4900 4901 +2bd1 2bd2 48ff 49bc +2c10 2bd1 48ff 4900 +2bd2 2bd3 48fe 49bb +2c11 2bd2 48fe 48ff +2bd3 2bd4 48fd 49ba +2c12 2bd3 48fd 48fe +2bd4 2bd5 48fc 49b9 +2c13 2bd4 48fc 48fd +2bd5 2bd6 48fb 49b8 +2c14 2bd5 48fb 48fc +2bd6 2bd7 48fa 49b7 +2c15 2bd6 48fa 48fb +2c16 2bd7 48f9 48fa +2bd8 2bd9 487a 4937 +2c17 2bd8 487a 487b +2bd9 2bda 4879 4936 +2c18 2bd9 4879 487a +2bda 2bdb 4878 4935 +2c19 2bda 4878 4879 +2bdb 2bdc 4877 4934 +2c1a 2bdb 4877 4878 +2bdc 2bdd 4876 4933 +2c1b 2bdc 4876 4877 +2bdd 2bde 4875 4932 +2c1c 2bdd 4875 4876 +2bde 2bdf 4874 4931 +2c1d 2bde 4874 4875 +2bdf 2be0 4873 4930 +2c1e 2bdf 4873 4874 +2be0 2be1 4872 492f +2c1f 2be0 4872 4873 +2be1 2be2 4871 492e +2c20 2be1 4871 4872 +2be2 2be3 4870 492d +2c21 2be2 4870 4871 +2be3 2be4 486f 492c +2c22 2be3 486f 4870 +2be4 2be5 486e 492b +2c23 2be4 486e 486f +2be5 2be6 486d 492a +2c24 2be5 486d 486e +2be6 2be7 486c 4929 +2c25 2be6 486c 486d +2be7 2be8 486b 4928 +2c26 2be7 486b 486c +2be8 2be9 486a 4927 +2c27 2be8 486a 486b +2be9 2bea 4869 4926 +2c28 2be9 4869 486a +2bea 2beb 4868 4925 +2c29 2bea 4868 4869 +2beb 2bec 4867 4924 +2c2a 2beb 4867 4868 +2bec 2bed 4866 4923 +2c2b 2bec 4866 4867 +2bed 2bee 4865 4922 +2c2c 2bed 4865 4866 +2bee 2bef 4864 4921 +2c2d 2bee 4864 4865 +2bef 2bf0 4863 4920 +2c2e 2bef 4863 4864 +2bf0 2bf1 4862 491f +2c2f 2bf0 4862 4863 +2bf1 2bf2 4861 491e +2c30 2bf1 4861 4862 +2bf2 2bf3 4860 491d +2c31 2bf2 4860 4861 +2bf3 2bf4 485f 491c +2c32 2bf3 485f 4860 +2bf4 2bf5 485e 491b +2c33 2bf4 485e 485f +2bf5 2bf6 485d 491a +2c34 2bf5 485d 485e +2bf6 2bf7 485c 4919 +2c35 2bf6 485c 485d +2bf7 2bf8 485b 4918 +2c36 2bf7 485b 485c +2bf8 2bf9 485a 4917 +2c37 2bf8 485a 485b +2bf9 2bfa 4859 4916 +2c38 2bf9 4859 485a +2bfa 2bfb 4858 4915 +2c39 2bfa 4858 4859 +2bfb 2bfc 4857 4914 +2c3a 2bfb 4857 4858 +2bfc 2bfd 4856 4913 +2c3b 2bfc 4856 4857 +2bfd 2bfe 4855 4912 +2c3c 2bfd 4855 4856 +2bfe 2bff 4854 4911 +2c3d 2bfe 4854 4855 +2bff 2c00 4853 4910 +2c3e 2bff 4853 4854 +2c00 2c01 4852 490f +2c3f 2c00 4852 4853 +2c01 2c02 4851 490e +2c40 2c01 4851 4852 +2c02 2c03 4850 490d +2c41 2c02 4850 4851 +2c03 2c04 484f 490c +2c42 2c03 484f 4850 +2c04 2c05 484e 490b +2c43 2c04 484e 484f +2c05 2c06 484d 490a +2c44 2c05 484d 484e +2c06 2c07 484c 4909 +2c45 2c06 484c 484d +2c07 2c08 484b 4908 +2c46 2c07 484b 484c +2c08 2c09 484a 4907 +2c47 2c08 484a 484b +2c09 2c0a 4849 4906 +2c48 2c09 4849 484a +2c0a 2c0b 4848 4905 +2c49 2c0a 4848 4849 +2c0b 2c0c 4847 4904 +2c4a 2c0b 4847 4848 +2c0c 2c0d 4846 4903 +2c4b 2c0c 4846 4847 +2c0d 2c0e 4845 4902 +2c4c 2c0d 4845 4846 +2c0e 2c0f 4844 4901 +2c4d 2c0e 4844 4845 +2c0f 2c10 4843 4900 +2c4e 2c0f 4843 4844 +2c10 2c11 4842 48ff +2c4f 2c10 4842 4843 +2c11 2c12 4841 48fe +2c50 2c11 4841 4842 +2c12 2c13 4840 48fd +2c51 2c12 4840 4841 +2c13 2c14 483f 48fc +2c52 2c13 483f 4840 +2c14 2c15 483e 48fb +2c53 2c14 483e 483f +2c15 2c16 483d 48fa +2c54 2c15 483d 483e +2c55 2c16 483c 483d +2c17 2c18 47bd 487a +2c56 2c17 47bd 47be +2c18 2c19 47bc 4879 +2c57 2c18 47bc 47bd +2c19 2c1a 47bb 4878 +2c58 2c19 47bb 47bc +2c1a 2c1b 47ba 4877 +2c59 2c1a 47ba 47bb +2c1b 2c1c 47b9 4876 +2c5a 2c1b 47b9 47ba +2c1c 2c1d 47b8 4875 +2c5b 2c1c 47b8 47b9 +2c1d 2c1e 47b7 4874 +2c5c 2c1d 47b7 47b8 +2c1e 2c1f 47b6 4873 +2c5d 2c1e 47b6 47b7 +2c1f 2c20 47b5 4872 +2c5e 2c1f 47b5 47b6 +2c20 2c21 47b4 4871 +2c5f 2c20 47b4 47b5 +2c21 2c22 47b3 4870 +2c60 2c21 47b3 47b4 +2c22 2c23 47b2 486f +2c61 2c22 47b2 47b3 +2c23 2c24 47b1 486e +2c62 2c23 47b1 47b2 +2c24 2c25 47b0 486d +2c63 2c24 47b0 47b1 +2c25 2c26 47af 486c +2c64 2c25 47af 47b0 +2c26 2c27 47ae 486b +2c65 2c26 47ae 47af +2c27 2c28 47ad 486a +2c66 2c27 47ad 47ae +2c28 2c29 47ac 4869 +2c67 2c28 47ac 47ad +2c29 2c2a 47ab 4868 +2c68 2c29 47ab 47ac +2c2a 2c2b 47aa 4867 +2c69 2c2a 47aa 47ab +2c2b 2c2c 47a9 4866 +2c6a 2c2b 47a9 47aa +2c2c 2c2d 47a8 4865 +2c6b 2c2c 47a8 47a9 +2c2d 2c2e 47a7 4864 +2c6c 2c2d 47a7 47a8 +2c2e 2c2f 47a6 4863 +2c6d 2c2e 47a6 47a7 +2c2f 2c30 47a5 4862 +2c6e 2c2f 47a5 47a6 +2c30 2c31 47a4 4861 +2c6f 2c30 47a4 47a5 +2c31 2c32 47a3 4860 +2c70 2c31 47a3 47a4 +2c32 2c33 47a2 485f +2c71 2c32 47a2 47a3 +2c33 2c34 47a1 485e +2c72 2c33 47a1 47a2 +2c34 2c35 47a0 485d +2c73 2c34 47a0 47a1 +2c35 2c36 479f 485c +2c74 2c35 479f 47a0 +2c36 2c37 479e 485b +2c75 2c36 479e 479f +2c37 2c38 479d 485a +2c76 2c37 479d 479e +2c38 2c39 479c 4859 +2c77 2c38 479c 479d +2c39 2c3a 479b 4858 +2c78 2c39 479b 479c +2c3a 2c3b 479a 4857 +2c79 2c3a 479a 479b +2c3b 2c3c 4799 4856 +2c7a 2c3b 4799 479a +2c3c 2c3d 4798 4855 +2c7b 2c3c 4798 4799 +2c3d 2c3e 4797 4854 +2c7c 2c3d 4797 4798 +2c3e 2c3f 4796 4853 +2c7d 2c3e 4796 4797 +2c3f 2c40 4795 4852 +2c7e 2c3f 4795 4796 +2c40 2c41 4794 4851 +2c7f 2c40 4794 4795 +2c41 2c42 4793 4850 +2c80 2c41 4793 4794 +2c42 2c43 4792 484f +2c81 2c42 4792 4793 +2c43 2c44 4791 484e +2c82 2c43 4791 4792 +2c44 2c45 4790 484d +2c83 2c44 4790 4791 +2c45 2c46 478f 484c +2c84 2c45 478f 4790 +2c46 2c47 478e 484b +2c85 2c46 478e 478f +2c47 2c48 478d 484a +2c86 2c47 478d 478e +2c48 2c49 478c 4849 +2c87 2c48 478c 478d +2c49 2c4a 478b 4848 +2c88 2c49 478b 478c +2c4a 2c4b 478a 4847 +2c89 2c4a 478a 478b +2c4b 2c4c 4789 4846 +2c8a 2c4b 4789 478a +2c4c 2c4d 4788 4845 +2c8b 2c4c 4788 4789 +2c4d 2c4e 4787 4844 +2c8c 2c4d 4787 4788 +2c4e 2c4f 4786 4843 +2c8d 2c4e 4786 4787 +2c4f 2c50 4785 4842 +2c8e 2c4f 4785 4786 +2c50 2c51 4784 4841 +2c8f 2c50 4784 4785 +2c51 2c52 4783 4840 +2c90 2c51 4783 4784 +2c52 2c53 4782 483f +2c91 2c52 4782 4783 +2c53 2c54 4781 483e +2c92 2c53 4781 4782 +2c54 2c55 4780 483d +2c93 2c54 4780 4781 +2c94 2c55 477f 4780 +2c56 2c57 4700 47bd +2c95 2c56 4700 4701 +2c57 2c58 46ff 47bc +2c96 2c57 46ff 4700 +2c58 2c59 46fe 47bb +2c97 2c58 46fe 46ff +2c59 2c5a 46fd 47ba +2c98 2c59 46fd 46fe +2c5a 2c5b 46fc 47b9 +2c99 2c5a 46fc 46fd +2c5b 2c5c 46fb 47b8 +2c9a 2c5b 46fb 46fc +2c5c 2c5d 46fa 47b7 +2c9b 2c5c 46fa 46fb +2c5d 2c5e 46f9 47b6 +2c9c 2c5d 46f9 46fa +2c5e 2c5f 46f8 47b5 +2c9d 2c5e 46f8 46f9 +2c5f 2c60 46f7 47b4 +2c9e 2c5f 46f7 46f8 +2c60 2c61 46f6 47b3 +2c9f 2c60 46f6 46f7 +2c61 2c62 46f5 47b2 +2ca0 2c61 46f5 46f6 +2c62 2c63 46f4 47b1 +2ca1 2c62 46f4 46f5 +2c63 2c64 46f3 47b0 +2ca2 2c63 46f3 46f4 +2c64 2c65 46f2 47af +2ca3 2c64 46f2 46f3 +2c65 2c66 46f1 47ae +2ca4 2c65 46f1 46f2 +2c66 2c67 46f0 47ad +2ca5 2c66 46f0 46f1 +2c67 2c68 46ef 47ac +2ca6 2c67 46ef 46f0 +2c68 2c69 46ee 47ab +2ca7 2c68 46ee 46ef +2c69 2c6a 46ed 47aa +2ca8 2c69 46ed 46ee +2c6a 2c6b 46ec 47a9 +2ca9 2c6a 46ec 46ed +2c6b 2c6c 46eb 47a8 +2caa 2c6b 46eb 46ec +2c6c 2c6d 46ea 47a7 +2cab 2c6c 46ea 46eb +2c6d 2c6e 46e9 47a6 +2cac 2c6d 46e9 46ea +2c6e 2c6f 46e8 47a5 +2cad 2c6e 46e8 46e9 +2c6f 2c70 46e7 47a4 +2cae 2c6f 46e7 46e8 +2c70 2c71 46e6 47a3 +2caf 2c70 46e6 46e7 +2c71 2c72 46e5 47a2 +2cb0 2c71 46e5 46e6 +2c72 2c73 46e4 47a1 +2cb1 2c72 46e4 46e5 +2c73 2c74 46e3 47a0 +2cb2 2c73 46e3 46e4 +2c74 2c75 46e2 479f +2cb3 2c74 46e2 46e3 +2c75 2c76 46e1 479e +2cb4 2c75 46e1 46e2 +2c76 2c77 46e0 479d +2cb5 2c76 46e0 46e1 +2c77 2c78 46df 479c +2cb6 2c77 46df 46e0 +2c78 2c79 46de 479b +2cb7 2c78 46de 46df +2c79 2c7a 46dd 479a +2cb8 2c79 46dd 46de +2c7a 2c7b 46dc 4799 +2cb9 2c7a 46dc 46dd +2c7b 2c7c 46db 4798 +2cba 2c7b 46db 46dc +2c7c 2c7d 46da 4797 +2cbb 2c7c 46da 46db +2c7d 2c7e 46d9 4796 +2cbc 2c7d 46d9 46da +2c7e 2c7f 46d8 4795 +2cbd 2c7e 46d8 46d9 +2c7f 2c80 46d7 4794 +2cbe 2c7f 46d7 46d8 +2c80 2c81 46d6 4793 +2cbf 2c80 46d6 46d7 +2c81 2c82 46d5 4792 +2cc0 2c81 46d5 46d6 +2c82 2c83 46d4 4791 +2cc1 2c82 46d4 46d5 +2c83 2c84 46d3 4790 +2cc2 2c83 46d3 46d4 +2c84 2c85 46d2 478f +2cc3 2c84 46d2 46d3 +2c85 2c86 46d1 478e +2cc4 2c85 46d1 46d2 +2c86 2c87 46d0 478d +2cc5 2c86 46d0 46d1 +2c87 2c88 46cf 478c +2cc6 2c87 46cf 46d0 +2c88 2c89 46ce 478b +2cc7 2c88 46ce 46cf +2c89 2c8a 46cd 478a +2cc8 2c89 46cd 46ce +2c8a 2c8b 46cc 4789 +2cc9 2c8a 46cc 46cd +2c8b 2c8c 46cb 4788 +2cca 2c8b 46cb 46cc +2c8c 2c8d 46ca 4787 +2ccb 2c8c 46ca 46cb +2c8d 2c8e 46c9 4786 +2ccc 2c8d 46c9 46ca +2c8e 2c8f 46c8 4785 +2ccd 2c8e 46c8 46c9 +2c8f 2c90 46c7 4784 +2cce 2c8f 46c7 46c8 +2c90 2c91 46c6 4783 +2ccf 2c90 46c6 46c7 +2c91 2c92 46c5 4782 +2cd0 2c91 46c5 46c6 +2c92 2c93 46c4 4781 +2cd1 2c92 46c4 46c5 +2c93 2c94 46c3 4780 +2cd2 2c93 46c3 46c4 +2cd3 2c94 46c2 46c3 +2c95 2c96 4643 4700 +2cd4 2c95 4643 4644 +2c96 2c97 4642 46ff +2cd5 2c96 4642 4643 +2c97 2c98 4641 46fe +2cd6 2c97 4641 4642 +2c98 2c99 4640 46fd +2cd7 2c98 4640 4641 +2c99 2c9a 463f 46fc +2cd8 2c99 463f 4640 +2c9a 2c9b 463e 46fb +2cd9 2c9a 463e 463f +2c9b 2c9c 463d 46fa +2cda 2c9b 463d 463e +2c9c 2c9d 463c 46f9 +2cdb 2c9c 463c 463d +2c9d 2c9e 463b 46f8 +2cdc 2c9d 463b 463c +2c9e 2c9f 463a 46f7 +2cdd 2c9e 463a 463b +2c9f 2ca0 4639 46f6 +2cde 2c9f 4639 463a +2ca0 2ca1 4638 46f5 +2cdf 2ca0 4638 4639 +2ca1 2ca2 4637 46f4 +2ce0 2ca1 4637 4638 +2ca2 2ca3 4636 46f3 +2ce1 2ca2 4636 4637 +2ca3 2ca4 4635 46f2 +2ce2 2ca3 4635 4636 +2ca4 2ca5 4634 46f1 +2ce3 2ca4 4634 4635 +2ca5 2ca6 4633 46f0 +2ce4 2ca5 4633 4634 +2ca6 2ca7 4632 46ef +2ce5 2ca6 4632 4633 +2ca7 2ca8 4631 46ee +2ce6 2ca7 4631 4632 +2ca8 2ca9 4630 46ed +2ce7 2ca8 4630 4631 +2ca9 2caa 462f 46ec +2ce8 2ca9 462f 4630 +2caa 2cab 462e 46eb +2ce9 2caa 462e 462f +2cab 2cac 462d 46ea +2cea 2cab 462d 462e +2cac 2cad 462c 46e9 +2ceb 2cac 462c 462d +2cad 2cae 462b 46e8 +2cec 2cad 462b 462c +2cae 2caf 462a 46e7 +2ced 2cae 462a 462b +2caf 2cb0 4629 46e6 +2cee 2caf 4629 462a +2cb0 2cb1 4628 46e5 +2cef 2cb0 4628 4629 +2cb1 2cb2 4627 46e4 +2cf0 2cb1 4627 4628 +2cb2 2cb3 4626 46e3 +2cf1 2cb2 4626 4627 +2cb3 2cb4 4625 46e2 +2cf2 2cb3 4625 4626 +2cb4 2cb5 4624 46e1 +2cf3 2cb4 4624 4625 +2cb5 2cb6 4623 46e0 +2cf4 2cb5 4623 4624 +2cb6 2cb7 4622 46df +2cf5 2cb6 4622 4623 +2cb7 2cb8 4621 46de +2cf6 2cb7 4621 4622 +2cb8 2cb9 4620 46dd +2cf7 2cb8 4620 4621 +2cb9 2cba 461f 46dc +2cf8 2cb9 461f 4620 +2cba 2cbb 461e 46db +2cf9 2cba 461e 461f +2cbb 2cbc 461d 46da +2cfa 2cbb 461d 461e +2cbc 2cbd 461c 46d9 +2cfb 2cbc 461c 461d +2cbd 2cbe 461b 46d8 +2cfc 2cbd 461b 461c +2cbe 2cbf 461a 46d7 +2cfd 2cbe 461a 461b +2cbf 2cc0 4619 46d6 +2cfe 2cbf 4619 461a +2cc0 2cc1 4618 46d5 +2cff 2cc0 4618 4619 +2cc1 2cc2 4617 46d4 +2d00 2cc1 4617 4618 +2cc2 2cc3 4616 46d3 +2d01 2cc2 4616 4617 +2cc3 2cc4 4615 46d2 +2d02 2cc3 4615 4616 +2cc4 2cc5 4614 46d1 +2d03 2cc4 4614 4615 +2cc5 2cc6 4613 46d0 +2d04 2cc5 4613 4614 +2cc6 2cc7 4612 46cf +2d05 2cc6 4612 4613 +2cc7 2cc8 4611 46ce +2d06 2cc7 4611 4612 +2cc8 2cc9 4610 46cd +2d07 2cc8 4610 4611 +2cc9 2cca 460f 46cc +2d08 2cc9 460f 4610 +2cca 2ccb 460e 46cb +2d09 2cca 460e 460f +2ccb 2ccc 460d 46ca +2d0a 2ccb 460d 460e +2ccc 2ccd 460c 46c9 +2d0b 2ccc 460c 460d +2ccd 2cce 460b 46c8 +2d0c 2ccd 460b 460c +2cce 2ccf 460a 46c7 +2d0d 2cce 460a 460b +2ccf 2cd0 4609 46c6 +2d0e 2ccf 4609 460a +2cd0 2cd1 4608 46c5 +2d0f 2cd0 4608 4609 +2cd1 2cd2 4607 46c4 +2d10 2cd1 4607 4608 +2cd2 2cd3 4606 46c3 +2d11 2cd2 4606 4607 +2d12 2cd3 4605 4606 +2cd4 2cd5 4586 4643 +2d13 2cd4 4586 4587 +2cd5 2cd6 4585 4642 +2d14 2cd5 4585 4586 +2cd6 2cd7 4584 4641 +2d15 2cd6 4584 4585 +2cd7 2cd8 4583 4640 +2d16 2cd7 4583 4584 +2cd8 2cd9 4582 463f +2d17 2cd8 4582 4583 +2cd9 2cda 4581 463e +2d18 2cd9 4581 4582 +2cda 2cdb 4580 463d +2d19 2cda 4580 4581 +2cdb 2cdc 457f 463c +2d1a 2cdb 457f 4580 +2cdc 2cdd 457e 463b +2d1b 2cdc 457e 457f +2cdd 2cde 457d 463a +2d1c 2cdd 457d 457e +2cde 2cdf 457c 4639 +2d1d 2cde 457c 457d +2cdf 2ce0 457b 4638 +2d1e 2cdf 457b 457c +2ce0 2ce1 457a 4637 +2d1f 2ce0 457a 457b +2ce1 2ce2 4579 4636 +2d20 2ce1 4579 457a +2ce2 2ce3 4578 4635 +2d21 2ce2 4578 4579 +2ce3 2ce4 4577 4634 +2d22 2ce3 4577 4578 +2ce4 2ce5 4576 4633 +2d23 2ce4 4576 4577 +2ce5 2ce6 4575 4632 +2d24 2ce5 4575 4576 +2ce6 2ce7 4574 4631 +2d25 2ce6 4574 4575 +2ce7 2ce8 4573 4630 +2d26 2ce7 4573 4574 +2ce8 2ce9 4572 462f +2d27 2ce8 4572 4573 +2ce9 2cea 4571 462e +2d28 2ce9 4571 4572 +2cea 2ceb 4570 462d +2d29 2cea 4570 4571 +2ceb 2cec 456f 462c +2d2a 2ceb 456f 4570 +2cec 2ced 456e 462b +2d2b 2cec 456e 456f +2ced 2cee 456d 462a +2d2c 2ced 456d 456e +2cee 2cef 456c 4629 +2d2d 2cee 456c 456d +2cef 2cf0 456b 4628 +2d2e 2cef 456b 456c +2cf0 2cf1 456a 4627 +2d2f 2cf0 456a 456b +2cf1 2cf2 4569 4626 +2d30 2cf1 4569 456a +2cf2 2cf3 4568 4625 +2d31 2cf2 4568 4569 +2cf3 2cf4 4567 4624 +2d32 2cf3 4567 4568 +2cf4 2cf5 4566 4623 +2d33 2cf4 4566 4567 +2cf5 2cf6 4565 4622 +2d34 2cf5 4565 4566 +2cf6 2cf7 4564 4621 +2d35 2cf6 4564 4565 +2cf7 2cf8 4563 4620 +2d36 2cf7 4563 4564 +2cf8 2cf9 4562 461f +2d37 2cf8 4562 4563 +2cf9 2cfa 4561 461e +2d38 2cf9 4561 4562 +2cfa 2cfb 4560 461d +2d39 2cfa 4560 4561 +2cfb 2cfc 455f 461c +2d3a 2cfb 455f 4560 +2cfc 2cfd 455e 461b +2d3b 2cfc 455e 455f +2cfd 2cfe 455d 461a +2d3c 2cfd 455d 455e +2cfe 2cff 455c 4619 +2d3d 2cfe 455c 455d +2cff 2d00 455b 4618 +2d3e 2cff 455b 455c +2d00 2d01 455a 4617 +2d3f 2d00 455a 455b +2d01 2d02 4559 4616 +2d40 2d01 4559 455a +2d02 2d03 4558 4615 +2d41 2d02 4558 4559 +2d03 2d04 4557 4614 +2d42 2d03 4557 4558 +2d04 2d05 4556 4613 +2d43 2d04 4556 4557 +2d05 2d06 4555 4612 +2d44 2d05 4555 4556 +2d06 2d07 4554 4611 +2d45 2d06 4554 4555 +2d07 2d08 4553 4610 +2d46 2d07 4553 4554 +2d08 2d09 4552 460f +2d47 2d08 4552 4553 +2d09 2d0a 4551 460e +2d48 2d09 4551 4552 +2d0a 2d0b 4550 460d +2d49 2d0a 4550 4551 +2d0b 2d0c 454f 460c +2d4a 2d0b 454f 4550 +2d0c 2d0d 454e 460b +2d4b 2d0c 454e 454f +2d0d 2d0e 454d 460a +2d4c 2d0d 454d 454e +2d0e 2d0f 454c 4609 +2d4d 2d0e 454c 454d +2d0f 2d10 454b 4608 +2d4e 2d0f 454b 454c +2d10 2d11 454a 4607 +2d4f 2d10 454a 454b +2d11 2d12 4549 4606 +2d50 2d11 4549 454a +2d51 2d12 4548 4549 +2d13 2d14 44c9 4586 +2d52 2d13 44c9 44ca +2d14 2d15 44c8 4585 +2d53 2d14 44c8 44c9 +2d15 2d16 44c7 4584 +2d54 2d15 44c7 44c8 +2d16 2d17 44c6 4583 +2d55 2d16 44c6 44c7 +2d17 2d18 44c5 4582 +2d56 2d17 44c5 44c6 +2d18 2d19 44c4 4581 +2d57 2d18 44c4 44c5 +2d19 2d1a 44c3 4580 +2d58 2d19 44c3 44c4 +2d1a 2d1b 44c2 457f +2d59 2d1a 44c2 44c3 +2d1b 2d1c 44c1 457e +2d5a 2d1b 44c1 44c2 +2d1c 2d1d 44c0 457d +2d5b 2d1c 44c0 44c1 +2d1d 2d1e 44bf 457c +2d5c 2d1d 44bf 44c0 +2d1e 2d1f 44be 457b +2d5d 2d1e 44be 44bf +2d1f 2d20 44bd 457a +2d5e 2d1f 44bd 44be +2d20 2d21 44bc 4579 +2d5f 2d20 44bc 44bd +2d21 2d22 44bb 4578 +2d60 2d21 44bb 44bc +2d22 2d23 44ba 4577 +2d61 2d22 44ba 44bb +2d23 2d24 44b9 4576 +2d62 2d23 44b9 44ba +2d24 2d25 44b8 4575 +2d63 2d24 44b8 44b9 +2d25 2d26 44b7 4574 +2d64 2d25 44b7 44b8 +2d26 2d27 44b6 4573 +2d65 2d26 44b6 44b7 +2d27 2d28 44b5 4572 +2d66 2d27 44b5 44b6 +2d28 2d29 44b4 4571 +2d67 2d28 44b4 44b5 +2d29 2d2a 44b3 4570 +2d68 2d29 44b3 44b4 +2d2a 2d2b 44b2 456f +2d69 2d2a 44b2 44b3 +2d2b 2d2c 44b1 456e +2d6a 2d2b 44b1 44b2 +2d2c 2d2d 44b0 456d +2d6b 2d2c 44b0 44b1 +2d2d 2d2e 44af 456c +2d6c 2d2d 44af 44b0 +2d2e 2d2f 44ae 456b +2d6d 2d2e 44ae 44af +2d2f 2d30 44ad 456a +2d6e 2d2f 44ad 44ae +2d30 2d31 44ac 4569 +2d6f 2d30 44ac 44ad +2d31 2d32 44ab 4568 +2d70 2d31 44ab 44ac +2d32 2d33 44aa 4567 +2d71 2d32 44aa 44ab +2d33 2d34 44a9 4566 +2d72 2d33 44a9 44aa +2d34 2d35 44a8 4565 +2d73 2d34 44a8 44a9 +2d35 2d36 44a7 4564 +2d74 2d35 44a7 44a8 +2d36 2d37 44a6 4563 +2d75 2d36 44a6 44a7 +2d37 2d38 44a5 4562 +2d76 2d37 44a5 44a6 +2d38 2d39 44a4 4561 +2d77 2d38 44a4 44a5 +2d39 2d3a 44a3 4560 +2d78 2d39 44a3 44a4 +2d3a 2d3b 44a2 455f +2d79 2d3a 44a2 44a3 +2d3b 2d3c 44a1 455e +2d7a 2d3b 44a1 44a2 +2d3c 2d3d 44a0 455d +2d7b 2d3c 44a0 44a1 +2d3d 2d3e 449f 455c +2d7c 2d3d 449f 44a0 +2d3e 2d3f 449e 455b +2d7d 2d3e 449e 449f +2d3f 2d40 449d 455a +2d7e 2d3f 449d 449e +2d40 2d41 449c 4559 +2d7f 2d40 449c 449d +2d41 2d42 449b 4558 +2d80 2d41 449b 449c +2d42 2d43 449a 4557 +2d81 2d42 449a 449b +2d43 2d44 4499 4556 +2d82 2d43 4499 449a +2d44 2d45 4498 4555 +2d83 2d44 4498 4499 +2d45 2d46 4497 4554 +2d84 2d45 4497 4498 +2d46 2d47 4496 4553 +2d85 2d46 4496 4497 +2d47 2d48 4495 4552 +2d86 2d47 4495 4496 +2d48 2d49 4494 4551 +2d87 2d48 4494 4495 +2d49 2d4a 4493 4550 +2d88 2d49 4493 4494 +2d4a 2d4b 4492 454f +2d89 2d4a 4492 4493 +2d4b 2d4c 4491 454e +2d8a 2d4b 4491 4492 +2d4c 2d4d 4490 454d +2d8b 2d4c 4490 4491 +2d4d 2d4e 448f 454c +2d8c 2d4d 448f 4490 +2d4e 2d4f 448e 454b +2d8d 2d4e 448e 448f +2d4f 2d50 448d 454a +2d8e 2d4f 448d 448e +2d50 2d51 448c 4549 +2d8f 2d50 448c 448d +2d90 2d51 448b 448c +2d52 2d53 440c 44c9 +2d91 2d52 440c 440d +2d53 2d54 440b 44c8 +2d92 2d53 440b 440c +2d54 2d55 440a 44c7 +2d93 2d54 440a 440b +2d55 2d56 4409 44c6 +2d94 2d55 4409 440a +2d56 2d57 4408 44c5 +2d95 2d56 4408 4409 +2d57 2d58 4407 44c4 +2d96 2d57 4407 4408 +2d58 2d59 4406 44c3 +2d97 2d58 4406 4407 +2d59 2d5a 4405 44c2 +2d98 2d59 4405 4406 +2d5a 2d5b 4404 44c1 +2d99 2d5a 4404 4405 +2d5b 2d5c 4403 44c0 +2d9a 2d5b 4403 4404 +2d5c 2d5d 4402 44bf +2d9b 2d5c 4402 4403 +2d5d 2d5e 4401 44be +2d9c 2d5d 4401 4402 +2d5e 2d5f 4400 44bd +2d9d 2d5e 4400 4401 +2d5f 2d60 43ff 44bc +2d9e 2d5f 43ff 4400 +2d60 2d61 43fe 44bb +2d9f 2d60 43fe 43ff +2d61 2d62 43fd 44ba +2da0 2d61 43fd 43fe +2d62 2d63 43fc 44b9 +2da1 2d62 43fc 43fd +2d63 2d64 43fb 44b8 +2da2 2d63 43fb 43fc +2d64 2d65 43fa 44b7 +2da3 2d64 43fa 43fb +2d65 2d66 43f9 44b6 +2da4 2d65 43f9 43fa +2d66 2d67 43f8 44b5 +2da5 2d66 43f8 43f9 +2d67 2d68 43f7 44b4 +2da6 2d67 43f7 43f8 +2d68 2d69 43f6 44b3 +2da7 2d68 43f6 43f7 +2d69 2d6a 43f5 44b2 +2da8 2d69 43f5 43f6 +2d6a 2d6b 43f4 44b1 +2da9 2d6a 43f4 43f5 +2d6b 2d6c 43f3 44b0 +2daa 2d6b 43f3 43f4 +2d6c 2d6d 43f2 44af +2dab 2d6c 43f2 43f3 +2d6d 2d6e 43f1 44ae +2dac 2d6d 43f1 43f2 +2d6e 2d6f 43f0 44ad +2dad 2d6e 43f0 43f1 +2d6f 2d70 43ef 44ac +2dae 2d6f 43ef 43f0 +2d70 2d71 43ee 44ab +2daf 2d70 43ee 43ef +2d71 2d72 43ed 44aa +2db0 2d71 43ed 43ee +2d72 2d73 43ec 44a9 +2db1 2d72 43ec 43ed +2d73 2d74 43eb 44a8 +2db2 2d73 43eb 43ec +2d74 2d75 43ea 44a7 +2db3 2d74 43ea 43eb +2d75 2d76 43e9 44a6 +2db4 2d75 43e9 43ea +2d76 2d77 43e8 44a5 +2db5 2d76 43e8 43e9 +2d77 2d78 43e7 44a4 +2db6 2d77 43e7 43e8 +2d78 2d79 43e6 44a3 +2db7 2d78 43e6 43e7 +2d79 2d7a 43e5 44a2 +2db8 2d79 43e5 43e6 +2d7a 2d7b 43e4 44a1 +2db9 2d7a 43e4 43e5 +2d7b 2d7c 43e3 44a0 +2dba 2d7b 43e3 43e4 +2d7c 2d7d 43e2 449f +2dbb 2d7c 43e2 43e3 +2d7d 2d7e 43e1 449e +2dbc 2d7d 43e1 43e2 +2d7e 2d7f 43e0 449d +2dbd 2d7e 43e0 43e1 +2d7f 2d80 43df 449c +2dbe 2d7f 43df 43e0 +2d80 2d81 43de 449b +2dbf 2d80 43de 43df +2d81 2d82 43dd 449a +2dc0 2d81 43dd 43de +2d82 2d83 43dc 4499 +2dc1 2d82 43dc 43dd +2d83 2d84 43db 4498 +2dc2 2d83 43db 43dc +2d84 2d85 43da 4497 +2dc3 2d84 43da 43db +2d85 2d86 43d9 4496 +2dc4 2d85 43d9 43da +2d86 2d87 43d8 4495 +2dc5 2d86 43d8 43d9 +2d87 2d88 43d7 4494 +2dc6 2d87 43d7 43d8 +2d88 2d89 43d6 4493 +2dc7 2d88 43d6 43d7 +2d89 2d8a 43d5 4492 +2dc8 2d89 43d5 43d6 +2d8a 2d8b 43d4 4491 +2dc9 2d8a 43d4 43d5 +2d8b 2d8c 43d3 4490 +2dca 2d8b 43d3 43d4 +2d8c 2d8d 43d2 448f +2dcb 2d8c 43d2 43d3 +2d8d 2d8e 43d1 448e +2dcc 2d8d 43d1 43d2 +2d8e 2d8f 43d0 448d +2dcd 2d8e 43d0 43d1 +2d8f 2d90 43cf 448c +2dce 2d8f 43cf 43d0 +2dcf 2d90 43ce 43cf +2d91 2d92 434f 440c +2dd0 2d91 434f 4350 +2d92 2d93 434e 440b +2dd1 2d92 434e 434f +2d93 2d94 434d 440a +2dd2 2d93 434d 434e +2d94 2d95 434c 4409 +2dd3 2d94 434c 434d +2d95 2d96 434b 4408 +2dd4 2d95 434b 434c +2d96 2d97 434a 4407 +2dd5 2d96 434a 434b +2d97 2d98 4349 4406 +2dd6 2d97 4349 434a +2d98 2d99 4348 4405 +2dd7 2d98 4348 4349 +2d99 2d9a 4347 4404 +2dd8 2d99 4347 4348 +2d9a 2d9b 4346 4403 +2dd9 2d9a 4346 4347 +2d9b 2d9c 4345 4402 +2dda 2d9b 4345 4346 +2d9c 2d9d 4344 4401 +2ddb 2d9c 4344 4345 +2d9d 2d9e 4343 4400 +2ddc 2d9d 4343 4344 +2d9e 2d9f 4342 43ff +2ddd 2d9e 4342 4343 +2d9f 2da0 4341 43fe +2dde 2d9f 4341 4342 +2da0 2da1 4340 43fd +2ddf 2da0 4340 4341 +2da1 2da2 433f 43fc +2de0 2da1 433f 4340 +2da2 2da3 433e 43fb +2de1 2da2 433e 433f +2da3 2da4 433d 43fa +2de2 2da3 433d 433e +2da4 2da5 433c 43f9 +2de3 2da4 433c 433d +2da5 2da6 433b 43f8 +2de4 2da5 433b 433c +2da6 2da7 433a 43f7 +2de5 2da6 433a 433b +2da7 2da8 4339 43f6 +2de6 2da7 4339 433a +2da8 2da9 4338 43f5 +2de7 2da8 4338 4339 +2da9 2daa 4337 43f4 +2de8 2da9 4337 4338 +2daa 2dab 4336 43f3 +2de9 2daa 4336 4337 +2dab 2dac 4335 43f2 +2dea 2dab 4335 4336 +2dac 2dad 4334 43f1 +2deb 2dac 4334 4335 +2dad 2dae 4333 43f0 +2dec 2dad 4333 4334 +2dae 2daf 4332 43ef +2ded 2dae 4332 4333 +2daf 2db0 4331 43ee +2dee 2daf 4331 4332 +2db0 2db1 4330 43ed +2def 2db0 4330 4331 +2db1 2db2 432f 43ec +2df0 2db1 432f 4330 +2db2 2db3 432e 43eb +2df1 2db2 432e 432f +2db3 2db4 432d 43ea +2df2 2db3 432d 432e +2db4 2db5 432c 43e9 +2df3 2db4 432c 432d +2db5 2db6 432b 43e8 +2df4 2db5 432b 432c +2db6 2db7 432a 43e7 +2df5 2db6 432a 432b +2db7 2db8 4329 43e6 +2df6 2db7 4329 432a +2db8 2db9 4328 43e5 +2df7 2db8 4328 4329 +2db9 2dba 4327 43e4 +2df8 2db9 4327 4328 +2dba 2dbb 4326 43e3 +2df9 2dba 4326 4327 +2dbb 2dbc 4325 43e2 +2dfa 2dbb 4325 4326 +2dbc 2dbd 4324 43e1 +2dfb 2dbc 4324 4325 +2dbd 2dbe 4323 43e0 +2dfc 2dbd 4323 4324 +2dbe 2dbf 4322 43df +2dfd 2dbe 4322 4323 +2dbf 2dc0 4321 43de +2dfe 2dbf 4321 4322 +2dc0 2dc1 4320 43dd +2dff 2dc0 4320 4321 +2dc1 2dc2 431f 43dc +2e00 2dc1 431f 4320 +2dc2 2dc3 431e 43db +2e01 2dc2 431e 431f +2dc3 2dc4 431d 43da +2e02 2dc3 431d 431e +2dc4 2dc5 431c 43d9 +2e03 2dc4 431c 431d +2dc5 2dc6 431b 43d8 +2e04 2dc5 431b 431c +2dc6 2dc7 431a 43d7 +2e05 2dc6 431a 431b +2dc7 2dc8 4319 43d6 +2e06 2dc7 4319 431a +2dc8 2dc9 4318 43d5 +2e07 2dc8 4318 4319 +2dc9 2dca 4317 43d4 +2e08 2dc9 4317 4318 +2dca 2dcb 4316 43d3 +2e09 2dca 4316 4317 +2dcb 2dcc 4315 43d2 +2e0a 2dcb 4315 4316 +2dcc 2dcd 4314 43d1 +2e0b 2dcc 4314 4315 +2dcd 2dce 4313 43d0 +2e0c 2dcd 4313 4314 +2dce 2dcf 4312 43cf +2e0d 2dce 4312 4313 +2e0e 2dcf 4311 4312 +2dd0 2dd1 4292 434f +2e0f 2dd0 4292 4293 +2dd1 2dd2 4291 434e +2e10 2dd1 4291 4292 +2dd2 2dd3 4290 434d +2e11 2dd2 4290 4291 +2dd3 2dd4 428f 434c +2e12 2dd3 428f 4290 +2dd4 2dd5 428e 434b +2e13 2dd4 428e 428f +2dd5 2dd6 428d 434a +2e14 2dd5 428d 428e +2dd6 2dd7 428c 4349 +2e15 2dd6 428c 428d +2dd7 2dd8 428b 4348 +2e16 2dd7 428b 428c +2dd8 2dd9 428a 4347 +2e17 2dd8 428a 428b +2dd9 2dda 4289 4346 +2e18 2dd9 4289 428a +2dda 2ddb 4288 4345 +2e19 2dda 4288 4289 +2ddb 2ddc 4287 4344 +2e1a 2ddb 4287 4288 +2ddc 2ddd 4286 4343 +2e1b 2ddc 4286 4287 +2ddd 2dde 4285 4342 +2e1c 2ddd 4285 4286 +2dde 2ddf 4284 4341 +2e1d 2dde 4284 4285 +2ddf 2de0 4283 4340 +2e1e 2ddf 4283 4284 +2de0 2de1 4282 433f +2e1f 2de0 4282 4283 +2de1 2de2 4281 433e +2e20 2de1 4281 4282 +2de2 2de3 4280 433d +2e21 2de2 4280 4281 +2de3 2de4 427f 433c +2e22 2de3 427f 4280 +2de4 2de5 427e 433b +2e23 2de4 427e 427f +2de5 2de6 427d 433a +2e24 2de5 427d 427e +2de6 2de7 427c 4339 +2e25 2de6 427c 427d +2de7 2de8 427b 4338 +2e26 2de7 427b 427c +2de8 2de9 427a 4337 +2e27 2de8 427a 427b +2de9 2dea 4279 4336 +2e28 2de9 4279 427a +2dea 2deb 4278 4335 +2e29 2dea 4278 4279 +2deb 2dec 4277 4334 +2e2a 2deb 4277 4278 +2dec 2ded 4276 4333 +2e2b 2dec 4276 4277 +2ded 2dee 4275 4332 +2e2c 2ded 4275 4276 +2dee 2def 4274 4331 +2e2d 2dee 4274 4275 +2def 2df0 4273 4330 +2e2e 2def 4273 4274 +2df0 2df1 4272 432f +2e2f 2df0 4272 4273 +2df1 2df2 4271 432e +2e30 2df1 4271 4272 +2df2 2df3 4270 432d +2e31 2df2 4270 4271 +2df3 2df4 426f 432c +2e32 2df3 426f 4270 +2df4 2df5 426e 432b +2e33 2df4 426e 426f +2df5 2df6 426d 432a +2e34 2df5 426d 426e +2df6 2df7 426c 4329 +2e35 2df6 426c 426d +2df7 2df8 426b 4328 +2e36 2df7 426b 426c +2df8 2df9 426a 4327 +2e37 2df8 426a 426b +2df9 2dfa 4269 4326 +2e38 2df9 4269 426a +2dfa 2dfb 4268 4325 +2e39 2dfa 4268 4269 +2dfb 2dfc 4267 4324 +2e3a 2dfb 4267 4268 +2dfc 2dfd 4266 4323 +2e3b 2dfc 4266 4267 +2dfd 2dfe 4265 4322 +2e3c 2dfd 4265 4266 +2dfe 2dff 4264 4321 +2e3d 2dfe 4264 4265 +2dff 2e00 4263 4320 +2e3e 2dff 4263 4264 +2e00 2e01 4262 431f +2e3f 2e00 4262 4263 +2e01 2e02 4261 431e +2e40 2e01 4261 4262 +2e02 2e03 4260 431d +2e41 2e02 4260 4261 +2e03 2e04 425f 431c +2e42 2e03 425f 4260 +2e04 2e05 425e 431b +2e43 2e04 425e 425f +2e05 2e06 425d 431a +2e44 2e05 425d 425e +2e06 2e07 425c 4319 +2e45 2e06 425c 425d +2e07 2e08 425b 4318 +2e46 2e07 425b 425c +2e08 2e09 425a 4317 +2e47 2e08 425a 425b +2e09 2e0a 4259 4316 +2e48 2e09 4259 425a +2e0a 2e0b 4258 4315 +2e49 2e0a 4258 4259 +2e0b 2e0c 4257 4314 +2e4a 2e0b 4257 4258 +2e0c 2e0d 4256 4313 +2e4b 2e0c 4256 4257 +2e0d 2e0e 4255 4312 +2e4c 2e0d 4255 4256 +2e4d 2e0e 4254 4255 +2e0f 2e10 41d5 4292 +2e4e 2e0f 41d5 41d6 +2e10 2e11 41d4 4291 +2e4f 2e10 41d4 41d5 +2e11 2e12 41d3 4290 +2e50 2e11 41d3 41d4 +2e12 2e13 41d2 428f +2e51 2e12 41d2 41d3 +2e13 2e14 41d1 428e +2e52 2e13 41d1 41d2 +2e14 2e15 41d0 428d +2e53 2e14 41d0 41d1 +2e15 2e16 41cf 428c +2e54 2e15 41cf 41d0 +2e16 2e17 41ce 428b +2e55 2e16 41ce 41cf +2e17 2e18 41cd 428a +2e56 2e17 41cd 41ce +2e18 2e19 41cc 4289 +2e57 2e18 41cc 41cd +2e19 2e1a 41cb 4288 +2e58 2e19 41cb 41cc +2e1a 2e1b 41ca 4287 +2e59 2e1a 41ca 41cb +2e1b 2e1c 41c9 4286 +2e5a 2e1b 41c9 41ca +2e1c 2e1d 41c8 4285 +2e5b 2e1c 41c8 41c9 +2e1d 2e1e 41c7 4284 +2e5c 2e1d 41c7 41c8 +2e1e 2e1f 41c6 4283 +2e5d 2e1e 41c6 41c7 +2e1f 2e20 41c5 4282 +2e5e 2e1f 41c5 41c6 +2e20 2e21 41c4 4281 +2e5f 2e20 41c4 41c5 +2e21 2e22 41c3 4280 +2e60 2e21 41c3 41c4 +2e22 2e23 41c2 427f +2e61 2e22 41c2 41c3 +2e23 2e24 41c1 427e +2e62 2e23 41c1 41c2 +2e24 2e25 41c0 427d +2e63 2e24 41c0 41c1 +2e25 2e26 41bf 427c +2e64 2e25 41bf 41c0 +2e26 2e27 41be 427b +2e65 2e26 41be 41bf +2e27 2e28 41bd 427a +2e66 2e27 41bd 41be +2e28 2e29 41bc 4279 +2e67 2e28 41bc 41bd +2e29 2e2a 41bb 4278 +2e68 2e29 41bb 41bc +2e2a 2e2b 41ba 4277 +2e69 2e2a 41ba 41bb +2e2b 2e2c 41b9 4276 +2e6a 2e2b 41b9 41ba +2e2c 2e2d 41b8 4275 +2e6b 2e2c 41b8 41b9 +2e2d 2e2e 41b7 4274 +2e6c 2e2d 41b7 41b8 +2e2e 2e2f 41b6 4273 +2e6d 2e2e 41b6 41b7 +2e2f 2e30 41b5 4272 +2e6e 2e2f 41b5 41b6 +2e30 2e31 41b4 4271 +2e6f 2e30 41b4 41b5 +2e31 2e32 41b3 4270 +2e70 2e31 41b3 41b4 +2e32 2e33 41b2 426f +2e71 2e32 41b2 41b3 +2e33 2e34 41b1 426e +2e72 2e33 41b1 41b2 +2e34 2e35 41b0 426d +2e73 2e34 41b0 41b1 +2e35 2e36 41af 426c +2e74 2e35 41af 41b0 +2e36 2e37 41ae 426b +2e75 2e36 41ae 41af +2e37 2e38 41ad 426a +2e76 2e37 41ad 41ae +2e38 2e39 41ac 4269 +2e77 2e38 41ac 41ad +2e39 2e3a 41ab 4268 +2e78 2e39 41ab 41ac +2e3a 2e3b 41aa 4267 +2e79 2e3a 41aa 41ab +2e3b 2e3c 41a9 4266 +2e7a 2e3b 41a9 41aa +2e3c 2e3d 41a8 4265 +2e7b 2e3c 41a8 41a9 +2e3d 2e3e 41a7 4264 +2e7c 2e3d 41a7 41a8 +2e3e 2e3f 41a6 4263 +2e7d 2e3e 41a6 41a7 +2e3f 2e40 41a5 4262 +2e7e 2e3f 41a5 41a6 +2e40 2e41 41a4 4261 +2e7f 2e40 41a4 41a5 +2e41 2e42 41a3 4260 +2e80 2e41 41a3 41a4 +2e42 2e43 41a2 425f +2e81 2e42 41a2 41a3 +2e43 2e44 41a1 425e +2e82 2e43 41a1 41a2 +2e44 2e45 41a0 425d +2e83 2e44 41a0 41a1 +2e45 2e46 419f 425c +2e84 2e45 419f 41a0 +2e46 2e47 419e 425b +2e85 2e46 419e 419f +2e47 2e48 419d 425a +2e86 2e47 419d 419e +2e48 2e49 419c 4259 +2e87 2e48 419c 419d +2e49 2e4a 419b 4258 +2e88 2e49 419b 419c +2e4a 2e4b 419a 4257 +2e89 2e4a 419a 419b +2e4b 2e4c 4199 4256 +2e8a 2e4b 4199 419a +2e4c 2e4d 4198 4255 +2e8b 2e4c 4198 4199 +2e8c 2e4d 4197 4198 +2e4e 2e4f 4118 41d5 +2e8d 2e4e 4118 4119 +2e4f 2e50 4117 41d4 +2e8e 2e4f 4117 4118 +2e50 2e51 4116 41d3 +2e8f 2e50 4116 4117 +2e51 2e52 4115 41d2 +2e90 2e51 4115 4116 +2e52 2e53 4114 41d1 +2e91 2e52 4114 4115 +2e53 2e54 4113 41d0 +2e92 2e53 4113 4114 +2e54 2e55 4112 41cf +2e93 2e54 4112 4113 +2e55 2e56 4111 41ce +2e94 2e55 4111 4112 +2e56 2e57 4110 41cd +2e95 2e56 4110 4111 +2e57 2e58 410f 41cc +2e96 2e57 410f 4110 +2e58 2e59 410e 41cb +2e97 2e58 410e 410f +2e59 2e5a 410d 41ca +2e98 2e59 410d 410e +2e5a 2e5b 410c 41c9 +2e99 2e5a 410c 410d +2e5b 2e5c 410b 41c8 +2e9a 2e5b 410b 410c +2e5c 2e5d 410a 41c7 +2e9b 2e5c 410a 410b +2e5d 2e5e 4109 41c6 +2e9c 2e5d 4109 410a +2e5e 2e5f 4108 41c5 +2e9d 2e5e 4108 4109 +2e5f 2e60 4107 41c4 +2e9e 2e5f 4107 4108 +2e60 2e61 4106 41c3 +2e9f 2e60 4106 4107 +2e61 2e62 4105 41c2 +2ea0 2e61 4105 4106 +2e62 2e63 4104 41c1 +2ea1 2e62 4104 4105 +2e63 2e64 4103 41c0 +2ea2 2e63 4103 4104 +2e64 2e65 4102 41bf +2ea3 2e64 4102 4103 +2e65 2e66 4101 41be +2ea4 2e65 4101 4102 +2e66 2e67 4100 41bd +2ea5 2e66 4100 4101 +2e67 2e68 40ff 41bc +2ea6 2e67 40ff 4100 +2e68 2e69 40fe 41bb +2ea7 2e68 40fe 40ff +2e69 2e6a 40fd 41ba +2ea8 2e69 40fd 40fe +2e6a 2e6b 40fc 41b9 +2ea9 2e6a 40fc 40fd +2e6b 2e6c 40fb 41b8 +2eaa 2e6b 40fb 40fc +2e6c 2e6d 40fa 41b7 +2eab 2e6c 40fa 40fb +2e6d 2e6e 40f9 41b6 +2eac 2e6d 40f9 40fa +2e6e 2e6f 40f8 41b5 +2ead 2e6e 40f8 40f9 +2e6f 2e70 40f7 41b4 +2eae 2e6f 40f7 40f8 +2e70 2e71 40f6 41b3 +2eaf 2e70 40f6 40f7 +2e71 2e72 40f5 41b2 +2eb0 2e71 40f5 40f6 +2e72 2e73 40f4 41b1 +2eb1 2e72 40f4 40f5 +2e73 2e74 40f3 41b0 +2eb2 2e73 40f3 40f4 +2e74 2e75 40f2 41af +2eb3 2e74 40f2 40f3 +2e75 2e76 40f1 41ae +2eb4 2e75 40f1 40f2 +2e76 2e77 40f0 41ad +2eb5 2e76 40f0 40f1 +2e77 2e78 40ef 41ac +2eb6 2e77 40ef 40f0 +2e78 2e79 40ee 41ab +2eb7 2e78 40ee 40ef +2e79 2e7a 40ed 41aa +2eb8 2e79 40ed 40ee +2e7a 2e7b 40ec 41a9 +2eb9 2e7a 40ec 40ed +2e7b 2e7c 40eb 41a8 +2eba 2e7b 40eb 40ec +2e7c 2e7d 40ea 41a7 +2ebb 2e7c 40ea 40eb +2e7d 2e7e 40e9 41a6 +2ebc 2e7d 40e9 40ea +2e7e 2e7f 40e8 41a5 +2ebd 2e7e 40e8 40e9 +2e7f 2e80 40e7 41a4 +2ebe 2e7f 40e7 40e8 +2e80 2e81 40e6 41a3 +2ebf 2e80 40e6 40e7 +2e81 2e82 40e5 41a2 +2ec0 2e81 40e5 40e6 +2e82 2e83 40e4 41a1 +2ec1 2e82 40e4 40e5 +2e83 2e84 40e3 41a0 +2ec2 2e83 40e3 40e4 +2e84 2e85 40e2 419f +2ec3 2e84 40e2 40e3 +2e85 2e86 40e1 419e +2ec4 2e85 40e1 40e2 +2e86 2e87 40e0 419d +2ec5 2e86 40e0 40e1 +2e87 2e88 40df 419c +2ec6 2e87 40df 40e0 +2e88 2e89 40de 419b +2ec7 2e88 40de 40df +2e89 2e8a 40dd 419a +2ec8 2e89 40dd 40de +2e8a 2e8b 40dc 4199 +2ec9 2e8a 40dc 40dd +2e8b 2e8c 40db 4198 +2eca 2e8b 40db 40dc +2ecb 2e8c 40da 40db +2e8d 2e8e 405b 4118 +2ecc 2e8d 405b 405c +2e8e 2e8f 405a 4117 +2ecd 2e8e 405a 405b +2e8f 2e90 4059 4116 +2ece 2e8f 4059 405a +2e90 2e91 4058 4115 +2ecf 2e90 4058 4059 +2e91 2e92 4057 4114 +2ed0 2e91 4057 4058 +2e92 2e93 4056 4113 +2ed1 2e92 4056 4057 +2e93 2e94 4055 4112 +2ed2 2e93 4055 4056 +2e94 2e95 4054 4111 +2ed3 2e94 4054 4055 +2e95 2e96 4053 4110 +2ed4 2e95 4053 4054 +2e96 2e97 4052 410f +2ed5 2e96 4052 4053 +2e97 2e98 4051 410e +2ed6 2e97 4051 4052 +2e98 2e99 4050 410d +2ed7 2e98 4050 4051 +2e99 2e9a 404f 410c +2ed8 2e99 404f 4050 +2e9a 2e9b 404e 410b +2ed9 2e9a 404e 404f +2e9b 2e9c 404d 410a +2eda 2e9b 404d 404e +2e9c 2e9d 404c 4109 +2edb 2e9c 404c 404d +2e9d 2e9e 404b 4108 +2edc 2e9d 404b 404c +2e9e 2e9f 404a 4107 +2edd 2e9e 404a 404b +2e9f 2ea0 4049 4106 +2ede 2e9f 4049 404a +2ea0 2ea1 4048 4105 +2edf 2ea0 4048 4049 +2ea1 2ea2 4047 4104 +2ee0 2ea1 4047 4048 +2ea2 2ea3 4046 4103 +2ee1 2ea2 4046 4047 +2ea3 2ea4 4045 4102 +2ee2 2ea3 4045 4046 +2ea4 2ea5 4044 4101 +2ee3 2ea4 4044 4045 +2ea5 2ea6 4043 4100 +2ee4 2ea5 4043 4044 +2ea6 2ea7 4042 40ff +2ee5 2ea6 4042 4043 +2ea7 2ea8 4041 40fe +2ee6 2ea7 4041 4042 +2ea8 2ea9 4040 40fd +2ee7 2ea8 4040 4041 +2ea9 2eaa 403f 40fc +2ee8 2ea9 403f 4040 +2eaa 2eab 403e 40fb +2ee9 2eaa 403e 403f +2eab 2eac 403d 40fa +2eea 2eab 403d 403e +2eac 2ead 403c 40f9 +2eeb 2eac 403c 403d +2ead 2eae 403b 40f8 +2eec 2ead 403b 403c +2eae 2eaf 403a 40f7 +2eed 2eae 403a 403b +2eaf 2eb0 4039 40f6 +2eee 2eaf 4039 403a +2eb0 2eb1 4038 40f5 +2eef 2eb0 4038 4039 +2eb1 2eb2 4037 40f4 +2ef0 2eb1 4037 4038 +2eb2 2eb3 4036 40f3 +2ef1 2eb2 4036 4037 +2eb3 2eb4 4035 40f2 +2ef2 2eb3 4035 4036 +2eb4 2eb5 4034 40f1 +2ef3 2eb4 4034 4035 +2eb5 2eb6 4033 40f0 +2ef4 2eb5 4033 4034 +2eb6 2eb7 4032 40ef +2ef5 2eb6 4032 4033 +2eb7 2eb8 4031 40ee +2ef6 2eb7 4031 4032 +2eb8 2eb9 4030 40ed +2ef7 2eb8 4030 4031 +2eb9 2eba 402f 40ec +2ef8 2eb9 402f 4030 +2eba 2ebb 402e 40eb +2ef9 2eba 402e 402f +2ebb 2ebc 402d 40ea +2efa 2ebb 402d 402e +2ebc 2ebd 402c 40e9 +2efb 2ebc 402c 402d +2ebd 2ebe 402b 40e8 +2efc 2ebd 402b 402c +2ebe 2ebf 402a 40e7 +2efd 2ebe 402a 402b +2ebf 2ec0 4029 40e6 +2efe 2ebf 4029 402a +2ec0 2ec1 4028 40e5 +2eff 2ec0 4028 4029 +2ec1 2ec2 4027 40e4 +2f00 2ec1 4027 4028 +2ec2 2ec3 4026 40e3 +2f01 2ec2 4026 4027 +2ec3 2ec4 4025 40e2 +2f02 2ec3 4025 4026 +2ec4 2ec5 4024 40e1 +2f03 2ec4 4024 4025 +2ec5 2ec6 4023 40e0 +2f04 2ec5 4023 4024 +2ec6 2ec7 4022 40df +2f05 2ec6 4022 4023 +2ec7 2ec8 4021 40de +2f06 2ec7 4021 4022 +2ec8 2ec9 4020 40dd +2f07 2ec8 4020 4021 +2ec9 2eca 401f 40dc +2f08 2ec9 401f 4020 +2eca 2ecb 401e 40db +2f09 2eca 401e 401f +2f0a 2ecb 401d 401e +2ecc 2ecd 3f9e 405b +2f0b 2ecc 3f9e 3f9f +2ecd 2ece 3f9d 405a +2f0c 2ecd 3f9d 3f9e +2ece 2ecf 3f9c 4059 +2f0d 2ece 3f9c 3f9d +2ecf 2ed0 3f9b 4058 +2f0e 2ecf 3f9b 3f9c +2ed0 2ed1 3f9a 4057 +2f0f 2ed0 3f9a 3f9b +2ed1 2ed2 3f99 4056 +2f10 2ed1 3f99 3f9a +2ed2 2ed3 3f98 4055 +2f11 2ed2 3f98 3f99 +2ed3 2ed4 3f97 4054 +2f12 2ed3 3f97 3f98 +2ed4 2ed5 3f96 4053 +2f13 2ed4 3f96 3f97 +2ed5 2ed6 3f95 4052 +2f14 2ed5 3f95 3f96 +2ed6 2ed7 3f94 4051 +2f15 2ed6 3f94 3f95 +2ed7 2ed8 3f93 4050 +2f16 2ed7 3f93 3f94 +2ed8 2ed9 3f92 404f +2f17 2ed8 3f92 3f93 +2ed9 2eda 3f91 404e +2f18 2ed9 3f91 3f92 +2eda 2edb 3f90 404d +2f19 2eda 3f90 3f91 +2edb 2edc 3f8f 404c +2f1a 2edb 3f8f 3f90 +2edc 2edd 3f8e 404b +2f1b 2edc 3f8e 3f8f +2edd 2ede 3f8d 404a +2f1c 2edd 3f8d 3f8e +2ede 2edf 3f8c 4049 +2f1d 2ede 3f8c 3f8d +2edf 2ee0 3f8b 4048 +2f1e 2edf 3f8b 3f8c +2ee0 2ee1 3f8a 4047 +2f1f 2ee0 3f8a 3f8b +2ee1 2ee2 3f89 4046 +2f20 2ee1 3f89 3f8a +2ee2 2ee3 3f88 4045 +2f21 2ee2 3f88 3f89 +2ee3 2ee4 3f87 4044 +2f22 2ee3 3f87 3f88 +2ee4 2ee5 3f86 4043 +2f23 2ee4 3f86 3f87 +2ee5 2ee6 3f85 4042 +2f24 2ee5 3f85 3f86 +2ee6 2ee7 3f84 4041 +2f25 2ee6 3f84 3f85 +2ee7 2ee8 3f83 4040 +2f26 2ee7 3f83 3f84 +2ee8 2ee9 3f82 403f +2f27 2ee8 3f82 3f83 +2ee9 2eea 3f81 403e +2f28 2ee9 3f81 3f82 +2eea 2eeb 3f80 403d +2f29 2eea 3f80 3f81 +2eeb 2eec 3f7f 403c +2f2a 2eeb 3f7f 3f80 +2eec 2eed 3f7e 403b +2f2b 2eec 3f7e 3f7f +2eed 2eee 3f7d 403a +2f2c 2eed 3f7d 3f7e +2eee 2eef 3f7c 4039 +2f2d 2eee 3f7c 3f7d +2eef 2ef0 3f7b 4038 +2f2e 2eef 3f7b 3f7c +2ef0 2ef1 3f7a 4037 +2f2f 2ef0 3f7a 3f7b +2ef1 2ef2 3f79 4036 +2f30 2ef1 3f79 3f7a +2ef2 2ef3 3f78 4035 +2f31 2ef2 3f78 3f79 +2ef3 2ef4 3f77 4034 +2f32 2ef3 3f77 3f78 +2ef4 2ef5 3f76 4033 +2f33 2ef4 3f76 3f77 +2ef5 2ef6 3f75 4032 +2f34 2ef5 3f75 3f76 +2ef6 2ef7 3f74 4031 +2f35 2ef6 3f74 3f75 +2ef7 2ef8 3f73 4030 +2f36 2ef7 3f73 3f74 +2ef8 2ef9 3f72 402f +2f37 2ef8 3f72 3f73 +2ef9 2efa 3f71 402e +2f38 2ef9 3f71 3f72 +2efa 2efb 3f70 402d +2f39 2efa 3f70 3f71 +2efb 2efc 3f6f 402c +2f3a 2efb 3f6f 3f70 +2efc 2efd 3f6e 402b +2f3b 2efc 3f6e 3f6f +2efd 2efe 3f6d 402a +2f3c 2efd 3f6d 3f6e +2efe 2eff 3f6c 4029 +2f3d 2efe 3f6c 3f6d +2eff 2f00 3f6b 4028 +2f3e 2eff 3f6b 3f6c +2f00 2f01 3f6a 4027 +2f3f 2f00 3f6a 3f6b +2f01 2f02 3f69 4026 +2f40 2f01 3f69 3f6a +2f02 2f03 3f68 4025 +2f41 2f02 3f68 3f69 +2f03 2f04 3f67 4024 +2f42 2f03 3f67 3f68 +2f04 2f05 3f66 4023 +2f43 2f04 3f66 3f67 +2f05 2f06 3f65 4022 +2f44 2f05 3f65 3f66 +2f06 2f07 3f64 4021 +2f45 2f06 3f64 3f65 +2f07 2f08 3f63 4020 +2f46 2f07 3f63 3f64 +2f08 2f09 3f62 401f +2f47 2f08 3f62 3f63 +2f09 2f0a 3f61 401e +2f48 2f09 3f61 3f62 +2f49 2f0a 3f60 3f61 +2f0b 2f0c 3ee1 3f9e +2f4a 2f0b 3ee1 3ee2 +2f0c 2f0d 3ee0 3f9d +2f4b 2f0c 3ee0 3ee1 +2f0d 2f0e 3edf 3f9c +2f4c 2f0d 3edf 3ee0 +2f0e 2f0f 3ede 3f9b +2f4d 2f0e 3ede 3edf +2f0f 2f10 3edd 3f9a +2f4e 2f0f 3edd 3ede +2f10 2f11 3edc 3f99 +2f4f 2f10 3edc 3edd +2f11 2f12 3edb 3f98 +2f50 2f11 3edb 3edc +2f12 2f13 3eda 3f97 +2f51 2f12 3eda 3edb +2f13 2f14 3ed9 3f96 +2f52 2f13 3ed9 3eda +2f14 2f15 3ed8 3f95 +2f53 2f14 3ed8 3ed9 +2f15 2f16 3ed7 3f94 +2f54 2f15 3ed7 3ed8 +2f16 2f17 3ed6 3f93 +2f55 2f16 3ed6 3ed7 +2f17 2f18 3ed5 3f92 +2f56 2f17 3ed5 3ed6 +2f18 2f19 3ed4 3f91 +2f57 2f18 3ed4 3ed5 +2f19 2f1a 3ed3 3f90 +2f58 2f19 3ed3 3ed4 +2f1a 2f1b 3ed2 3f8f +2f59 2f1a 3ed2 3ed3 +2f1b 2f1c 3ed1 3f8e +2f5a 2f1b 3ed1 3ed2 +2f1c 2f1d 3ed0 3f8d +2f5b 2f1c 3ed0 3ed1 +2f1d 2f1e 3ecf 3f8c +2f5c 2f1d 3ecf 3ed0 +2f1e 2f1f 3ece 3f8b +2f5d 2f1e 3ece 3ecf +2f1f 2f20 3ecd 3f8a +2f5e 2f1f 3ecd 3ece +2f20 2f21 3ecc 3f89 +2f5f 2f20 3ecc 3ecd +2f21 2f22 3ecb 3f88 +2f60 2f21 3ecb 3ecc +2f22 2f23 3eca 3f87 +2f61 2f22 3eca 3ecb +2f23 2f24 3ec9 3f86 +2f62 2f23 3ec9 3eca +2f24 2f25 3ec8 3f85 +2f63 2f24 3ec8 3ec9 +2f25 2f26 3ec7 3f84 +2f64 2f25 3ec7 3ec8 +2f26 2f27 3ec6 3f83 +2f65 2f26 3ec6 3ec7 +2f27 2f28 3ec5 3f82 +2f66 2f27 3ec5 3ec6 +2f28 2f29 3ec4 3f81 +2f67 2f28 3ec4 3ec5 +2f29 2f2a 3ec3 3f80 +2f68 2f29 3ec3 3ec4 +2f2a 2f2b 3ec2 3f7f +2f69 2f2a 3ec2 3ec3 +2f2b 2f2c 3ec1 3f7e +2f6a 2f2b 3ec1 3ec2 +2f2c 2f2d 3ec0 3f7d +2f6b 2f2c 3ec0 3ec1 +2f2d 2f2e 3ebf 3f7c +2f6c 2f2d 3ebf 3ec0 +2f2e 2f2f 3ebe 3f7b +2f6d 2f2e 3ebe 3ebf +2f2f 2f30 3ebd 3f7a +2f6e 2f2f 3ebd 3ebe +2f30 2f31 3ebc 3f79 +2f6f 2f30 3ebc 3ebd +2f31 2f32 3ebb 3f78 +2f70 2f31 3ebb 3ebc +2f32 2f33 3eba 3f77 +2f71 2f32 3eba 3ebb +2f33 2f34 3eb9 3f76 +2f72 2f33 3eb9 3eba +2f34 2f35 3eb8 3f75 +2f73 2f34 3eb8 3eb9 +2f35 2f36 3eb7 3f74 +2f74 2f35 3eb7 3eb8 +2f36 2f37 3eb6 3f73 +2f75 2f36 3eb6 3eb7 +2f37 2f38 3eb5 3f72 +2f76 2f37 3eb5 3eb6 +2f38 2f39 3eb4 3f71 +2f77 2f38 3eb4 3eb5 +2f39 2f3a 3eb3 3f70 +2f78 2f39 3eb3 3eb4 +2f3a 2f3b 3eb2 3f6f +2f79 2f3a 3eb2 3eb3 +2f3b 2f3c 3eb1 3f6e +2f7a 2f3b 3eb1 3eb2 +2f3c 2f3d 3eb0 3f6d +2f7b 2f3c 3eb0 3eb1 +2f3d 2f3e 3eaf 3f6c +2f7c 2f3d 3eaf 3eb0 +2f3e 2f3f 3eae 3f6b +2f7d 2f3e 3eae 3eaf +2f3f 2f40 3ead 3f6a +2f7e 2f3f 3ead 3eae +2f40 2f41 3eac 3f69 +2f7f 2f40 3eac 3ead +2f41 2f42 3eab 3f68 +2f80 2f41 3eab 3eac +2f42 2f43 3eaa 3f67 +2f81 2f42 3eaa 3eab +2f43 2f44 3ea9 3f66 +2f82 2f43 3ea9 3eaa +2f44 2f45 3ea8 3f65 +2f83 2f44 3ea8 3ea9 +2f45 2f46 3ea7 3f64 +2f84 2f45 3ea7 3ea8 +2f46 2f47 3ea6 3f63 +2f85 2f46 3ea6 3ea7 +2f47 2f48 3ea5 3f62 +2f86 2f47 3ea5 3ea6 +2f48 2f49 3ea4 3f61 +2f87 2f48 3ea4 3ea5 +2f88 2f49 3ea3 3ea4 +2f4a 2f4b 3e24 3ee1 +2f89 2f4a 3e24 3e25 +2f4b 2f4c 3e23 3ee0 +2f8a 2f4b 3e23 3e24 +2f4c 2f4d 3e22 3edf +2f8b 2f4c 3e22 3e23 +2f4d 2f4e 3e21 3ede +2f8c 2f4d 3e21 3e22 +2f4e 2f4f 3e20 3edd +2f8d 2f4e 3e20 3e21 +2f4f 2f50 3e1f 3edc +2f8e 2f4f 3e1f 3e20 +2f50 2f51 3e1e 3edb +2f8f 2f50 3e1e 3e1f +2f51 2f52 3e1d 3eda +2f90 2f51 3e1d 3e1e +2f52 2f53 3e1c 3ed9 +2f91 2f52 3e1c 3e1d +2f53 2f54 3e1b 3ed8 +2f92 2f53 3e1b 3e1c +2f54 2f55 3e1a 3ed7 +2f93 2f54 3e1a 3e1b +2f55 2f56 3e19 3ed6 +2f94 2f55 3e19 3e1a +2f56 2f57 3e18 3ed5 +2f95 2f56 3e18 3e19 +2f57 2f58 3e17 3ed4 +2f96 2f57 3e17 3e18 +2f58 2f59 3e16 3ed3 +2f97 2f58 3e16 3e17 +2f59 2f5a 3e15 3ed2 +2f98 2f59 3e15 3e16 +2f5a 2f5b 3e14 3ed1 +2f99 2f5a 3e14 3e15 +2f5b 2f5c 3e13 3ed0 +2f9a 2f5b 3e13 3e14 +2f5c 2f5d 3e12 3ecf +2f9b 2f5c 3e12 3e13 +2f5d 2f5e 3e11 3ece +2f9c 2f5d 3e11 3e12 +2f5e 2f5f 3e10 3ecd +2f9d 2f5e 3e10 3e11 +2f5f 2f60 3e0f 3ecc +2f9e 2f5f 3e0f 3e10 +2f60 2f61 3e0e 3ecb +2f9f 2f60 3e0e 3e0f +2f61 2f62 3e0d 3eca +2fa0 2f61 3e0d 3e0e +2f62 2f63 3e0c 3ec9 +2fa1 2f62 3e0c 3e0d +2f63 2f64 3e0b 3ec8 +2fa2 2f63 3e0b 3e0c +2f64 2f65 3e0a 3ec7 +2fa3 2f64 3e0a 3e0b +2f65 2f66 3e09 3ec6 +2fa4 2f65 3e09 3e0a +2f66 2f67 3e08 3ec5 +2fa5 2f66 3e08 3e09 +2f67 2f68 3e07 3ec4 +2fa6 2f67 3e07 3e08 +2f68 2f69 3e06 3ec3 +2fa7 2f68 3e06 3e07 +2f69 2f6a 3e05 3ec2 +2fa8 2f69 3e05 3e06 +2f6a 2f6b 3e04 3ec1 +2fa9 2f6a 3e04 3e05 +2f6b 2f6c 3e03 3ec0 +2faa 2f6b 3e03 3e04 +2f6c 2f6d 3e02 3ebf +2fab 2f6c 3e02 3e03 +2f6d 2f6e 3e01 3ebe +2fac 2f6d 3e01 3e02 +2f6e 2f6f 3e00 3ebd +2fad 2f6e 3e00 3e01 +2f6f 2f70 3dff 3ebc +2fae 2f6f 3dff 3e00 +2f70 2f71 3dfe 3ebb +2faf 2f70 3dfe 3dff +2f71 2f72 3dfd 3eba +2fb0 2f71 3dfd 3dfe +2f72 2f73 3dfc 3eb9 +2fb1 2f72 3dfc 3dfd +2f73 2f74 3dfb 3eb8 +2fb2 2f73 3dfb 3dfc +2f74 2f75 3dfa 3eb7 +2fb3 2f74 3dfa 3dfb +2f75 2f76 3df9 3eb6 +2fb4 2f75 3df9 3dfa +2f76 2f77 3df8 3eb5 +2fb5 2f76 3df8 3df9 +2f77 2f78 3df7 3eb4 +2fb6 2f77 3df7 3df8 +2f78 2f79 3df6 3eb3 +2fb7 2f78 3df6 3df7 +2f79 2f7a 3df5 3eb2 +2fb8 2f79 3df5 3df6 +2f7a 2f7b 3df4 3eb1 +2fb9 2f7a 3df4 3df5 +2f7b 2f7c 3df3 3eb0 +2fba 2f7b 3df3 3df4 +2f7c 2f7d 3df2 3eaf +2fbb 2f7c 3df2 3df3 +2f7d 2f7e 3df1 3eae +2fbc 2f7d 3df1 3df2 +2f7e 2f7f 3df0 3ead +2fbd 2f7e 3df0 3df1 +2f7f 2f80 3def 3eac +2fbe 2f7f 3def 3df0 +2f80 2f81 3dee 3eab +2fbf 2f80 3dee 3def +2f81 2f82 3ded 3eaa +2fc0 2f81 3ded 3dee +2f82 2f83 3dec 3ea9 +2fc1 2f82 3dec 3ded +2f83 2f84 3deb 3ea8 +2fc2 2f83 3deb 3dec +2f84 2f85 3dea 3ea7 +2fc3 2f84 3dea 3deb +2f85 2f86 3de9 3ea6 +2fc4 2f85 3de9 3dea +2f86 2f87 3de8 3ea5 +2fc5 2f86 3de8 3de9 +2f87 2f88 3de7 3ea4 +2fc6 2f87 3de7 3de8 +2fc7 2f88 3de6 3de7 +2f89 2f8a 3d67 3e24 +2fc8 2f89 3d67 3d68 +2f8a 2f8b 3d66 3e23 +2fc9 2f8a 3d66 3d67 +2f8b 2f8c 3d65 3e22 +2fca 2f8b 3d65 3d66 +2f8c 2f8d 3d64 3e21 +2fcb 2f8c 3d64 3d65 +2f8d 2f8e 3d63 3e20 +2fcc 2f8d 3d63 3d64 +2f8e 2f8f 3d62 3e1f +2fcd 2f8e 3d62 3d63 +2f8f 2f90 3d61 3e1e +2fce 2f8f 3d61 3d62 +2f90 2f91 3d60 3e1d +2fcf 2f90 3d60 3d61 +2f91 2f92 3d5f 3e1c +2fd0 2f91 3d5f 3d60 +2f92 2f93 3d5e 3e1b +2fd1 2f92 3d5e 3d5f +2f93 2f94 3d5d 3e1a +2fd2 2f93 3d5d 3d5e +2f94 2f95 3d5c 3e19 +2fd3 2f94 3d5c 3d5d +2f95 2f96 3d5b 3e18 +2fd4 2f95 3d5b 3d5c +2f96 2f97 3d5a 3e17 +2fd5 2f96 3d5a 3d5b +2f97 2f98 3d59 3e16 +2fd6 2f97 3d59 3d5a +2f98 2f99 3d58 3e15 +2fd7 2f98 3d58 3d59 +2f99 2f9a 3d57 3e14 +2fd8 2f99 3d57 3d58 +2f9a 2f9b 3d56 3e13 +2fd9 2f9a 3d56 3d57 +2f9b 2f9c 3d55 3e12 +2fda 2f9b 3d55 3d56 +2f9c 2f9d 3d54 3e11 +2fdb 2f9c 3d54 3d55 +2f9d 2f9e 3d53 3e10 +2fdc 2f9d 3d53 3d54 +2f9e 2f9f 3d52 3e0f +2fdd 2f9e 3d52 3d53 +2f9f 2fa0 3d51 3e0e +2fde 2f9f 3d51 3d52 +2fa0 2fa1 3d50 3e0d +2fdf 2fa0 3d50 3d51 +2fa1 2fa2 3d4f 3e0c +2fe0 2fa1 3d4f 3d50 +2fa2 2fa3 3d4e 3e0b +2fe1 2fa2 3d4e 3d4f +2fa3 2fa4 3d4d 3e0a +2fe2 2fa3 3d4d 3d4e +2fa4 2fa5 3d4c 3e09 +2fe3 2fa4 3d4c 3d4d +2fa5 2fa6 3d4b 3e08 +2fe4 2fa5 3d4b 3d4c +2fa6 2fa7 3d4a 3e07 +2fe5 2fa6 3d4a 3d4b +2fa7 2fa8 3d49 3e06 +2fe6 2fa7 3d49 3d4a +2fa8 2fa9 3d48 3e05 +2fe7 2fa8 3d48 3d49 +2fa9 2faa 3d47 3e04 +2fe8 2fa9 3d47 3d48 +2faa 2fab 3d46 3e03 +2fe9 2faa 3d46 3d47 +2fab 2fac 3d45 3e02 +2fea 2fab 3d45 3d46 +2fac 2fad 3d44 3e01 +2feb 2fac 3d44 3d45 +2fad 2fae 3d43 3e00 +2fec 2fad 3d43 3d44 +2fae 2faf 3d42 3dff +2fed 2fae 3d42 3d43 +2faf 2fb0 3d41 3dfe +2fee 2faf 3d41 3d42 +2fb0 2fb1 3d40 3dfd +2fef 2fb0 3d40 3d41 +2fb1 2fb2 3d3f 3dfc +2ff0 2fb1 3d3f 3d40 +2fb2 2fb3 3d3e 3dfb +2ff1 2fb2 3d3e 3d3f +2fb3 2fb4 3d3d 3dfa +2ff2 2fb3 3d3d 3d3e +2fb4 2fb5 3d3c 3df9 +2ff3 2fb4 3d3c 3d3d +2fb5 2fb6 3d3b 3df8 +2ff4 2fb5 3d3b 3d3c +2fb6 2fb7 3d3a 3df7 +2ff5 2fb6 3d3a 3d3b +2fb7 2fb8 3d39 3df6 +2ff6 2fb7 3d39 3d3a +2fb8 2fb9 3d38 3df5 +2ff7 2fb8 3d38 3d39 +2fb9 2fba 3d37 3df4 +2ff8 2fb9 3d37 3d38 +2fba 2fbb 3d36 3df3 +2ff9 2fba 3d36 3d37 +2fbb 2fbc 3d35 3df2 +2ffa 2fbb 3d35 3d36 +2fbc 2fbd 3d34 3df1 +2ffb 2fbc 3d34 3d35 +2fbd 2fbe 3d33 3df0 +2ffc 2fbd 3d33 3d34 +2fbe 2fbf 3d32 3def +2ffd 2fbe 3d32 3d33 +2fbf 2fc0 3d31 3dee +2ffe 2fbf 3d31 3d32 +2fc0 2fc1 3d30 3ded +2fff 2fc0 3d30 3d31 +2fc1 2fc2 3d2f 3dec +3000 2fc1 3d2f 3d30 +2fc2 2fc3 3d2e 3deb +3001 2fc2 3d2e 3d2f +2fc3 2fc4 3d2d 3dea +3002 2fc3 3d2d 3d2e +2fc4 2fc5 3d2c 3de9 +3003 2fc4 3d2c 3d2d +2fc5 2fc6 3d2b 3de8 +3004 2fc5 3d2b 3d2c +2fc6 2fc7 3d2a 3de7 +3005 2fc6 3d2a 3d2b +3006 2fc7 3d29 3d2a +2fc8 2fc9 3caa 3d67 +3007 2fc8 3caa 3cab +2fc9 2fca 3ca9 3d66 +3008 2fc9 3ca9 3caa +2fca 2fcb 3ca8 3d65 +3009 2fca 3ca8 3ca9 +2fcb 2fcc 3ca7 3d64 +300a 2fcb 3ca7 3ca8 +2fcc 2fcd 3ca6 3d63 +300b 2fcc 3ca6 3ca7 +2fcd 2fce 3ca5 3d62 +300c 2fcd 3ca5 3ca6 +2fce 2fcf 3ca4 3d61 +300d 2fce 3ca4 3ca5 +2fcf 2fd0 3ca3 3d60 +300e 2fcf 3ca3 3ca4 +2fd0 2fd1 3ca2 3d5f +300f 2fd0 3ca2 3ca3 +2fd1 2fd2 3ca1 3d5e +3010 2fd1 3ca1 3ca2 +2fd2 2fd3 3ca0 3d5d +3011 2fd2 3ca0 3ca1 +2fd3 2fd4 3c9f 3d5c +3012 2fd3 3c9f 3ca0 +2fd4 2fd5 3c9e 3d5b +3013 2fd4 3c9e 3c9f +2fd5 2fd6 3c9d 3d5a +3014 2fd5 3c9d 3c9e +2fd6 2fd7 3c9c 3d59 +3015 2fd6 3c9c 3c9d +2fd7 2fd8 3c9b 3d58 +3016 2fd7 3c9b 3c9c +2fd8 2fd9 3c9a 3d57 +3017 2fd8 3c9a 3c9b +2fd9 2fda 3c99 3d56 +3018 2fd9 3c99 3c9a +2fda 2fdb 3c98 3d55 +3019 2fda 3c98 3c99 +2fdb 2fdc 3c97 3d54 +301a 2fdb 3c97 3c98 +2fdc 2fdd 3c96 3d53 +301b 2fdc 3c96 3c97 +2fdd 2fde 3c95 3d52 +301c 2fdd 3c95 3c96 +2fde 2fdf 3c94 3d51 +301d 2fde 3c94 3c95 +2fdf 2fe0 3c93 3d50 +301e 2fdf 3c93 3c94 +2fe0 2fe1 3c92 3d4f +301f 2fe0 3c92 3c93 +2fe1 2fe2 3c91 3d4e +3020 2fe1 3c91 3c92 +2fe2 2fe3 3c90 3d4d +3021 2fe2 3c90 3c91 +2fe3 2fe4 3c8f 3d4c +3022 2fe3 3c8f 3c90 +2fe4 2fe5 3c8e 3d4b +3023 2fe4 3c8e 3c8f +2fe5 2fe6 3c8d 3d4a +3024 2fe5 3c8d 3c8e +2fe6 2fe7 3c8c 3d49 +3025 2fe6 3c8c 3c8d +2fe7 2fe8 3c8b 3d48 +3026 2fe7 3c8b 3c8c +2fe8 2fe9 3c8a 3d47 +3027 2fe8 3c8a 3c8b +2fe9 2fea 3c89 3d46 +3028 2fe9 3c89 3c8a +2fea 2feb 3c88 3d45 +3029 2fea 3c88 3c89 +2feb 2fec 3c87 3d44 +302a 2feb 3c87 3c88 +2fec 2fed 3c86 3d43 +302b 2fec 3c86 3c87 +2fed 2fee 3c85 3d42 +302c 2fed 3c85 3c86 +2fee 2fef 3c84 3d41 +302d 2fee 3c84 3c85 +2fef 2ff0 3c83 3d40 +302e 2fef 3c83 3c84 +2ff0 2ff1 3c82 3d3f +302f 2ff0 3c82 3c83 +2ff1 2ff2 3c81 3d3e +3030 2ff1 3c81 3c82 +2ff2 2ff3 3c80 3d3d +3031 2ff2 3c80 3c81 +2ff3 2ff4 3c7f 3d3c +3032 2ff3 3c7f 3c80 +2ff4 2ff5 3c7e 3d3b +3033 2ff4 3c7e 3c7f +2ff5 2ff6 3c7d 3d3a +3034 2ff5 3c7d 3c7e +2ff6 2ff7 3c7c 3d39 +3035 2ff6 3c7c 3c7d +2ff7 2ff8 3c7b 3d38 +3036 2ff7 3c7b 3c7c +2ff8 2ff9 3c7a 3d37 +3037 2ff8 3c7a 3c7b +2ff9 2ffa 3c79 3d36 +3038 2ff9 3c79 3c7a +2ffa 2ffb 3c78 3d35 +3039 2ffa 3c78 3c79 +2ffb 2ffc 3c77 3d34 +303a 2ffb 3c77 3c78 +2ffc 2ffd 3c76 3d33 +303b 2ffc 3c76 3c77 +2ffd 2ffe 3c75 3d32 +303c 2ffd 3c75 3c76 +2ffe 2fff 3c74 3d31 +303d 2ffe 3c74 3c75 +2fff 3000 3c73 3d30 +303e 2fff 3c73 3c74 +3000 3001 3c72 3d2f +303f 3000 3c72 3c73 +3001 3002 3c71 3d2e +3040 3001 3c71 3c72 +3002 3003 3c70 3d2d +3041 3002 3c70 3c71 +3003 3004 3c6f 3d2c +3042 3003 3c6f 3c70 +3004 3005 3c6e 3d2b +3043 3004 3c6e 3c6f +3005 3006 3c6d 3d2a +3044 3005 3c6d 3c6e +3045 3006 3c6c 3c6d +3007 3008 3bed 3caa +3046 3007 3bed 3bee +3008 3009 3bec 3ca9 +3047 3008 3bec 3bed +3009 300a 3beb 3ca8 +3048 3009 3beb 3bec +300a 300b 3bea 3ca7 +3049 300a 3bea 3beb +300b 300c 3be9 3ca6 +304a 300b 3be9 3bea +300c 300d 3be8 3ca5 +304b 300c 3be8 3be9 +300d 300e 3be7 3ca4 +304c 300d 3be7 3be8 +300e 300f 3be6 3ca3 +304d 300e 3be6 3be7 +300f 3010 3be5 3ca2 +304e 300f 3be5 3be6 +3010 3011 3be4 3ca1 +304f 3010 3be4 3be5 +3011 3012 3be3 3ca0 +3050 3011 3be3 3be4 +3012 3013 3be2 3c9f +3051 3012 3be2 3be3 +3013 3014 3be1 3c9e +3052 3013 3be1 3be2 +3014 3015 3be0 3c9d +3053 3014 3be0 3be1 +3015 3016 3bdf 3c9c +3054 3015 3bdf 3be0 +3016 3017 3bde 3c9b +3055 3016 3bde 3bdf +3017 3018 3bdd 3c9a +3056 3017 3bdd 3bde +3018 3019 3bdc 3c99 +3057 3018 3bdc 3bdd +3019 301a 3bdb 3c98 +3058 3019 3bdb 3bdc +301a 301b 3bda 3c97 +3059 301a 3bda 3bdb +301b 301c 3bd9 3c96 +305a 301b 3bd9 3bda +301c 301d 3bd8 3c95 +305b 301c 3bd8 3bd9 +301d 301e 3bd7 3c94 +305c 301d 3bd7 3bd8 +301e 301f 3bd6 3c93 +305d 301e 3bd6 3bd7 +301f 3020 3bd5 3c92 +305e 301f 3bd5 3bd6 +3020 3021 3bd4 3c91 +305f 3020 3bd4 3bd5 +3021 3022 3bd3 3c90 +3060 3021 3bd3 3bd4 +3022 3023 3bd2 3c8f +3061 3022 3bd2 3bd3 +3023 3024 3bd1 3c8e +3062 3023 3bd1 3bd2 +3024 3025 3bd0 3c8d +3063 3024 3bd0 3bd1 +3025 3026 3bcf 3c8c +3064 3025 3bcf 3bd0 +3026 3027 3bce 3c8b +3065 3026 3bce 3bcf +3027 3028 3bcd 3c8a +3066 3027 3bcd 3bce +3028 3029 3bcc 3c89 +3067 3028 3bcc 3bcd +3029 302a 3bcb 3c88 +3068 3029 3bcb 3bcc +302a 302b 3bca 3c87 +3069 302a 3bca 3bcb +302b 302c 3bc9 3c86 +306a 302b 3bc9 3bca +302c 302d 3bc8 3c85 +306b 302c 3bc8 3bc9 +302d 302e 3bc7 3c84 +306c 302d 3bc7 3bc8 +302e 302f 3bc6 3c83 +306d 302e 3bc6 3bc7 +302f 3030 3bc5 3c82 +306e 302f 3bc5 3bc6 +3030 3031 3bc4 3c81 +306f 3030 3bc4 3bc5 +3031 3032 3bc3 3c80 +3070 3031 3bc3 3bc4 +3032 3033 3bc2 3c7f +3071 3032 3bc2 3bc3 +3033 3034 3bc1 3c7e +3072 3033 3bc1 3bc2 +3034 3035 3bc0 3c7d +3073 3034 3bc0 3bc1 +3035 3036 3bbf 3c7c +3074 3035 3bbf 3bc0 +3036 3037 3bbe 3c7b +3075 3036 3bbe 3bbf +3037 3038 3bbd 3c7a +3076 3037 3bbd 3bbe +3038 3039 3bbc 3c79 +3077 3038 3bbc 3bbd +3039 303a 3bbb 3c78 +3078 3039 3bbb 3bbc +303a 303b 3bba 3c77 +3079 303a 3bba 3bbb +303b 303c 3bb9 3c76 +307a 303b 3bb9 3bba +303c 303d 3bb8 3c75 +307b 303c 3bb8 3bb9 +303d 303e 3bb7 3c74 +307c 303d 3bb7 3bb8 +303e 303f 3bb6 3c73 +307d 303e 3bb6 3bb7 +303f 3040 3bb5 3c72 +307e 303f 3bb5 3bb6 +3040 3041 3bb4 3c71 +307f 3040 3bb4 3bb5 +3041 3042 3bb3 3c70 +3080 3041 3bb3 3bb4 +3042 3043 3bb2 3c6f +3081 3042 3bb2 3bb3 +3043 3044 3bb1 3c6e +3082 3043 3bb1 3bb2 +3044 3045 3bb0 3c6d +3083 3044 3bb0 3bb1 +3084 3045 3baf 3bb0 +3046 3047 3b30 3bed +3085 3046 3b30 3b31 +3047 3048 3b2f 3bec +3086 3047 3b2f 3b30 +3048 3049 3b2e 3beb +3087 3048 3b2e 3b2f +3049 304a 3b2d 3bea +3088 3049 3b2d 3b2e +304a 304b 3b2c 3be9 +3089 304a 3b2c 3b2d +304b 304c 3b2b 3be8 +308a 304b 3b2b 3b2c +304c 304d 3b2a 3be7 +308b 304c 3b2a 3b2b +304d 304e 3b29 3be6 +308c 304d 3b29 3b2a +304e 304f 3b28 3be5 +308d 304e 3b28 3b29 +304f 3050 3b27 3be4 +308e 304f 3b27 3b28 +3050 3051 3b26 3be3 +308f 3050 3b26 3b27 +3051 3052 3b25 3be2 +3090 3051 3b25 3b26 +3052 3053 3b24 3be1 +3091 3052 3b24 3b25 +3053 3054 3b23 3be0 +3092 3053 3b23 3b24 +3054 3055 3b22 3bdf +3093 3054 3b22 3b23 +3055 3056 3b21 3bde +3094 3055 3b21 3b22 +3056 3057 3b20 3bdd +3095 3056 3b20 3b21 +3057 3058 3b1f 3bdc +3096 3057 3b1f 3b20 +3058 3059 3b1e 3bdb +3097 3058 3b1e 3b1f +3059 305a 3b1d 3bda +3098 3059 3b1d 3b1e +305a 305b 3b1c 3bd9 +3099 305a 3b1c 3b1d +305b 305c 3b1b 3bd8 +309a 305b 3b1b 3b1c +305c 305d 3b1a 3bd7 +309b 305c 3b1a 3b1b +305d 305e 3b19 3bd6 +309c 305d 3b19 3b1a +305e 305f 3b18 3bd5 +309d 305e 3b18 3b19 +305f 3060 3b17 3bd4 +309e 305f 3b17 3b18 +3060 3061 3b16 3bd3 +309f 3060 3b16 3b17 +3061 3062 3b15 3bd2 +30a0 3061 3b15 3b16 +3062 3063 3b14 3bd1 +30a1 3062 3b14 3b15 +3063 3064 3b13 3bd0 +30a2 3063 3b13 3b14 +3064 3065 3b12 3bcf +30a3 3064 3b12 3b13 +3065 3066 3b11 3bce +30a4 3065 3b11 3b12 +3066 3067 3b10 3bcd +30a5 3066 3b10 3b11 +3067 3068 3b0f 3bcc +30a6 3067 3b0f 3b10 +3068 3069 3b0e 3bcb +30a7 3068 3b0e 3b0f +3069 306a 3b0d 3bca +30a8 3069 3b0d 3b0e +306a 306b 3b0c 3bc9 +30a9 306a 3b0c 3b0d +306b 306c 3b0b 3bc8 +30aa 306b 3b0b 3b0c +306c 306d 3b0a 3bc7 +30ab 306c 3b0a 3b0b +306d 306e 3b09 3bc6 +30ac 306d 3b09 3b0a +306e 306f 3b08 3bc5 +30ad 306e 3b08 3b09 +306f 3070 3b07 3bc4 +30ae 306f 3b07 3b08 +3070 3071 3b06 3bc3 +30af 3070 3b06 3b07 +3071 3072 3b05 3bc2 +30b0 3071 3b05 3b06 +3072 3073 3b04 3bc1 +30b1 3072 3b04 3b05 +3073 3074 3b03 3bc0 +30b2 3073 3b03 3b04 +3074 3075 3b02 3bbf +30b3 3074 3b02 3b03 +3075 3076 3b01 3bbe +30b4 3075 3b01 3b02 +3076 3077 3b00 3bbd +30b5 3076 3b00 3b01 +3077 3078 3aff 3bbc +30b6 3077 3aff 3b00 +3078 3079 3afe 3bbb +30b7 3078 3afe 3aff +3079 307a 3afd 3bba +30b8 3079 3afd 3afe +307a 307b 3afc 3bb9 +30b9 307a 3afc 3afd +307b 307c 3afb 3bb8 +30ba 307b 3afb 3afc +307c 307d 3afa 3bb7 +30bb 307c 3afa 3afb +307d 307e 3af9 3bb6 +30bc 307d 3af9 3afa +307e 307f 3af8 3bb5 +30bd 307e 3af8 3af9 +307f 3080 3af7 3bb4 +30be 307f 3af7 3af8 +3080 3081 3af6 3bb3 +30bf 3080 3af6 3af7 +3081 3082 3af5 3bb2 +30c0 3081 3af5 3af6 +3082 3083 3af4 3bb1 +30c1 3082 3af4 3af5 +3083 3084 3af3 3bb0 +30c2 3083 3af3 3af4 +30c3 3084 3af2 3af3 +3085 3086 3a73 3b30 +30c4 3085 3a73 3a74 +3086 3087 3a72 3b2f +30c5 3086 3a72 3a73 +3087 3088 3a71 3b2e +30c6 3087 3a71 3a72 +3088 3089 3a70 3b2d +30c7 3088 3a70 3a71 +3089 308a 3a6f 3b2c +30c8 3089 3a6f 3a70 +308a 308b 3a6e 3b2b +30c9 308a 3a6e 3a6f +308b 308c 3a6d 3b2a +30ca 308b 3a6d 3a6e +308c 308d 3a6c 3b29 +30cb 308c 3a6c 3a6d +308d 308e 3a6b 3b28 +30cc 308d 3a6b 3a6c +308e 308f 3a6a 3b27 +30cd 308e 3a6a 3a6b +308f 3090 3a69 3b26 +30ce 308f 3a69 3a6a +3090 3091 3a68 3b25 +30cf 3090 3a68 3a69 +3091 3092 3a67 3b24 +30d0 3091 3a67 3a68 +3092 3093 3a66 3b23 +30d1 3092 3a66 3a67 +3093 3094 3a65 3b22 +30d2 3093 3a65 3a66 +3094 3095 3a64 3b21 +30d3 3094 3a64 3a65 +3095 3096 3a63 3b20 +30d4 3095 3a63 3a64 +3096 3097 3a62 3b1f +30d5 3096 3a62 3a63 +3097 3098 3a61 3b1e +30d6 3097 3a61 3a62 +3098 3099 3a60 3b1d +30d7 3098 3a60 3a61 +3099 309a 3a5f 3b1c +30d8 3099 3a5f 3a60 +309a 309b 3a5e 3b1b +30d9 309a 3a5e 3a5f +309b 309c 3a5d 3b1a +30da 309b 3a5d 3a5e +309c 309d 3a5c 3b19 +30db 309c 3a5c 3a5d +309d 309e 3a5b 3b18 +30dc 309d 3a5b 3a5c +309e 309f 3a5a 3b17 +30dd 309e 3a5a 3a5b +309f 30a0 3a59 3b16 +30de 309f 3a59 3a5a +30a0 30a1 3a58 3b15 +30df 30a0 3a58 3a59 +30a1 30a2 3a57 3b14 +30e0 30a1 3a57 3a58 +30a2 30a3 3a56 3b13 +30e1 30a2 3a56 3a57 +30a3 30a4 3a55 3b12 +30e2 30a3 3a55 3a56 +30a4 30a5 3a54 3b11 +30e3 30a4 3a54 3a55 +30a5 30a6 3a53 3b10 +30e4 30a5 3a53 3a54 +30a6 30a7 3a52 3b0f +30e5 30a6 3a52 3a53 +30a7 30a8 3a51 3b0e +30e6 30a7 3a51 3a52 +30a8 30a9 3a50 3b0d +30e7 30a8 3a50 3a51 +30a9 30aa 3a4f 3b0c +30e8 30a9 3a4f 3a50 +30aa 30ab 3a4e 3b0b +30e9 30aa 3a4e 3a4f +30ab 30ac 3a4d 3b0a +30ea 30ab 3a4d 3a4e +30ac 30ad 3a4c 3b09 +30eb 30ac 3a4c 3a4d +30ad 30ae 3a4b 3b08 +30ec 30ad 3a4b 3a4c +30ae 30af 3a4a 3b07 +30ed 30ae 3a4a 3a4b +30af 30b0 3a49 3b06 +30ee 30af 3a49 3a4a +30b0 30b1 3a48 3b05 +30ef 30b0 3a48 3a49 +30b1 30b2 3a47 3b04 +30f0 30b1 3a47 3a48 +30b2 30b3 3a46 3b03 +30f1 30b2 3a46 3a47 +30b3 30b4 3a45 3b02 +30f2 30b3 3a45 3a46 +30b4 30b5 3a44 3b01 +30f3 30b4 3a44 3a45 +30b5 30b6 3a43 3b00 +30f4 30b5 3a43 3a44 +30b6 30b7 3a42 3aff +30f5 30b6 3a42 3a43 +30b7 30b8 3a41 3afe +30f6 30b7 3a41 3a42 +30b8 30b9 3a40 3afd +30f7 30b8 3a40 3a41 +30b9 30ba 3a3f 3afc +30f8 30b9 3a3f 3a40 +30ba 30bb 3a3e 3afb +30f9 30ba 3a3e 3a3f +30bb 30bc 3a3d 3afa +30fa 30bb 3a3d 3a3e +30bc 30bd 3a3c 3af9 +30fb 30bc 3a3c 3a3d +30bd 30be 3a3b 3af8 +30fc 30bd 3a3b 3a3c +30be 30bf 3a3a 3af7 +30fd 30be 3a3a 3a3b +30bf 30c0 3a39 3af6 +30fe 30bf 3a39 3a3a +30c0 30c1 3a38 3af5 +30ff 30c0 3a38 3a39 +30c1 30c2 3a37 3af4 +3100 30c1 3a37 3a38 +30c2 30c3 3a36 3af3 +3101 30c2 3a36 3a37 +3102 30c3 3a35 3a36 +30c4 30c5 39b6 3a73 +3103 30c4 39b6 39b7 +30c5 30c6 39b5 3a72 +3104 30c5 39b5 39b6 +30c6 30c7 39b4 3a71 +3105 30c6 39b4 39b5 +30c7 30c8 39b3 3a70 +3106 30c7 39b3 39b4 +30c8 30c9 39b2 3a6f +3107 30c8 39b2 39b3 +30c9 30ca 39b1 3a6e +3108 30c9 39b1 39b2 +30ca 30cb 39b0 3a6d +3109 30ca 39b0 39b1 +30cb 30cc 39af 3a6c +310a 30cb 39af 39b0 +30cc 30cd 39ae 3a6b +310b 30cc 39ae 39af +30cd 30ce 39ad 3a6a +310c 30cd 39ad 39ae +30ce 30cf 39ac 3a69 +310d 30ce 39ac 39ad +30cf 30d0 39ab 3a68 +310e 30cf 39ab 39ac +30d0 30d1 39aa 3a67 +310f 30d0 39aa 39ab +30d1 30d2 39a9 3a66 +3110 30d1 39a9 39aa +30d2 30d3 39a8 3a65 +3111 30d2 39a8 39a9 +30d3 30d4 39a7 3a64 +3112 30d3 39a7 39a8 +30d4 30d5 39a6 3a63 +3113 30d4 39a6 39a7 +30d5 30d6 39a5 3a62 +3114 30d5 39a5 39a6 +30d6 30d7 39a4 3a61 +3115 30d6 39a4 39a5 +30d7 30d8 39a3 3a60 +3116 30d7 39a3 39a4 +30d8 30d9 39a2 3a5f +3117 30d8 39a2 39a3 +30d9 30da 39a1 3a5e +3118 30d9 39a1 39a2 +30da 30db 39a0 3a5d +3119 30da 39a0 39a1 +30db 30dc 399f 3a5c +311a 30db 399f 39a0 +30dc 30dd 399e 3a5b +311b 30dc 399e 399f +30dd 30de 399d 3a5a +311c 30dd 399d 399e +30de 30df 399c 3a59 +311d 30de 399c 399d +30df 30e0 399b 3a58 +311e 30df 399b 399c +30e0 30e1 399a 3a57 +311f 30e0 399a 399b +30e1 30e2 3999 3a56 +3120 30e1 3999 399a +30e2 30e3 3998 3a55 +3121 30e2 3998 3999 +30e3 30e4 3997 3a54 +3122 30e3 3997 3998 +30e4 30e5 3996 3a53 +3123 30e4 3996 3997 +30e5 30e6 3995 3a52 +3124 30e5 3995 3996 +30e6 30e7 3994 3a51 +3125 30e6 3994 3995 +30e7 30e8 3993 3a50 +3126 30e7 3993 3994 +30e8 30e9 3992 3a4f +3127 30e8 3992 3993 +30e9 30ea 3991 3a4e +3128 30e9 3991 3992 +30ea 30eb 3990 3a4d +3129 30ea 3990 3991 +30eb 30ec 398f 3a4c +312a 30eb 398f 3990 +30ec 30ed 398e 3a4b +312b 30ec 398e 398f +30ed 30ee 398d 3a4a +312c 30ed 398d 398e +30ee 30ef 398c 3a49 +312d 30ee 398c 398d +30ef 30f0 398b 3a48 +312e 30ef 398b 398c +30f0 30f1 398a 3a47 +312f 30f0 398a 398b +30f1 30f2 3989 3a46 +3130 30f1 3989 398a +30f2 30f3 3988 3a45 +3131 30f2 3988 3989 +30f3 30f4 3987 3a44 +3132 30f3 3987 3988 +30f4 30f5 3986 3a43 +3133 30f4 3986 3987 +30f5 30f6 3985 3a42 +3134 30f5 3985 3986 +30f6 30f7 3984 3a41 +3135 30f6 3984 3985 +30f7 30f8 3983 3a40 +3136 30f7 3983 3984 +30f8 30f9 3982 3a3f +3137 30f8 3982 3983 +30f9 30fa 3981 3a3e +3138 30f9 3981 3982 +30fa 30fb 3980 3a3d +3139 30fa 3980 3981 +30fb 30fc 397f 3a3c +313a 30fb 397f 3980 +30fc 30fd 397e 3a3b +313b 30fc 397e 397f +30fd 30fe 397d 3a3a +313c 30fd 397d 397e +30fe 30ff 397c 3a39 +313d 30fe 397c 397d +30ff 3100 397b 3a38 +313e 30ff 397b 397c +3100 3101 397a 3a37 +313f 3100 397a 397b +3101 3102 3979 3a36 +3140 3101 3979 397a +3141 3102 3978 3979 +3103 3104 38f9 39b6 +3142 3103 38f9 38fa +3104 3105 38f8 39b5 +3143 3104 38f8 38f9 +3105 3106 38f7 39b4 +3144 3105 38f7 38f8 +3106 3107 38f6 39b3 +3145 3106 38f6 38f7 +3107 3108 38f5 39b2 +3146 3107 38f5 38f6 +3108 3109 38f4 39b1 +3147 3108 38f4 38f5 +3109 310a 38f3 39b0 +3148 3109 38f3 38f4 +310a 310b 38f2 39af +3149 310a 38f2 38f3 +310b 310c 38f1 39ae +314a 310b 38f1 38f2 +310c 310d 38f0 39ad +314b 310c 38f0 38f1 +310d 310e 38ef 39ac +314c 310d 38ef 38f0 +310e 310f 38ee 39ab +314d 310e 38ee 38ef +310f 3110 38ed 39aa +314e 310f 38ed 38ee +3110 3111 38ec 39a9 +314f 3110 38ec 38ed +3111 3112 38eb 39a8 +3150 3111 38eb 38ec +3112 3113 38ea 39a7 +3151 3112 38ea 38eb +3113 3114 38e9 39a6 +3152 3113 38e9 38ea +3114 3115 38e8 39a5 +3153 3114 38e8 38e9 +3115 3116 38e7 39a4 +3154 3115 38e7 38e8 +3116 3117 38e6 39a3 +3155 3116 38e6 38e7 +3117 3118 38e5 39a2 +3156 3117 38e5 38e6 +3118 3119 38e4 39a1 +3157 3118 38e4 38e5 +3119 311a 38e3 39a0 +3158 3119 38e3 38e4 +311a 311b 38e2 399f +3159 311a 38e2 38e3 +311b 311c 38e1 399e +315a 311b 38e1 38e2 +311c 311d 38e0 399d +315b 311c 38e0 38e1 +311d 311e 38df 399c +315c 311d 38df 38e0 +311e 311f 38de 399b +315d 311e 38de 38df +311f 3120 38dd 399a +315e 311f 38dd 38de +3120 3121 38dc 3999 +315f 3120 38dc 38dd +3121 3122 38db 3998 +3160 3121 38db 38dc +3122 3123 38da 3997 +3161 3122 38da 38db +3123 3124 38d9 3996 +3162 3123 38d9 38da +3124 3125 38d8 3995 +3163 3124 38d8 38d9 +3125 3126 38d7 3994 +3164 3125 38d7 38d8 +3126 3127 38d6 3993 +3165 3126 38d6 38d7 +3127 3128 38d5 3992 +3166 3127 38d5 38d6 +3128 3129 38d4 3991 +3167 3128 38d4 38d5 +3129 312a 38d3 3990 +3168 3129 38d3 38d4 +312a 312b 38d2 398f +3169 312a 38d2 38d3 +312b 312c 38d1 398e +316a 312b 38d1 38d2 +312c 312d 38d0 398d +316b 312c 38d0 38d1 +312d 312e 38cf 398c +316c 312d 38cf 38d0 +312e 312f 38ce 398b +316d 312e 38ce 38cf +312f 3130 38cd 398a +316e 312f 38cd 38ce +3130 3131 38cc 3989 +316f 3130 38cc 38cd +3131 3132 38cb 3988 +3170 3131 38cb 38cc +3132 3133 38ca 3987 +3171 3132 38ca 38cb +3133 3134 38c9 3986 +3172 3133 38c9 38ca +3134 3135 38c8 3985 +3173 3134 38c8 38c9 +3135 3136 38c7 3984 +3174 3135 38c7 38c8 +3136 3137 38c6 3983 +3175 3136 38c6 38c7 +3137 3138 38c5 3982 +3176 3137 38c5 38c6 +3138 3139 38c4 3981 +3177 3138 38c4 38c5 +3139 313a 38c3 3980 +3178 3139 38c3 38c4 +313a 313b 38c2 397f +3179 313a 38c2 38c3 +313b 313c 38c1 397e +317a 313b 38c1 38c2 +313c 313d 38c0 397d +317b 313c 38c0 38c1 +313d 313e 38bf 397c +317c 313d 38bf 38c0 +313e 313f 38be 397b +317d 313e 38be 38bf +313f 3140 38bd 397a +317e 313f 38bd 38be +3140 3141 38bc 3979 +317f 3140 38bc 38bd +3180 3141 38bb 38bc +3142 3143 383c 38f9 +3181 3142 383c 383d +3143 3144 383b 38f8 +3182 3143 383b 383c +3144 3145 383a 38f7 +3183 3144 383a 383b +3145 3146 3839 38f6 +3184 3145 3839 383a +3146 3147 3838 38f5 +3185 3146 3838 3839 +3147 3148 3837 38f4 +3186 3147 3837 3838 +3148 3149 3836 38f3 +3187 3148 3836 3837 +3149 314a 3835 38f2 +3188 3149 3835 3836 +314a 314b 3834 38f1 +3189 314a 3834 3835 +314b 314c 3833 38f0 +318a 314b 3833 3834 +314c 314d 3832 38ef +318b 314c 3832 3833 +314d 314e 3831 38ee +318c 314d 3831 3832 +314e 314f 3830 38ed +318d 314e 3830 3831 +314f 3150 382f 38ec +318e 314f 382f 3830 +3150 3151 382e 38eb +318f 3150 382e 382f +3151 3152 382d 38ea +3190 3151 382d 382e +3152 3153 382c 38e9 +3191 3152 382c 382d +3153 3154 382b 38e8 +3192 3153 382b 382c +3154 3155 382a 38e7 +3193 3154 382a 382b +3155 3156 3829 38e6 +3194 3155 3829 382a +3156 3157 3828 38e5 +3195 3156 3828 3829 +3157 3158 3827 38e4 +3196 3157 3827 3828 +3158 3159 3826 38e3 +3197 3158 3826 3827 +3159 315a 3825 38e2 +3198 3159 3825 3826 +315a 315b 3824 38e1 +3199 315a 3824 3825 +315b 315c 3823 38e0 +319a 315b 3823 3824 +315c 315d 3822 38df +319b 315c 3822 3823 +315d 315e 3821 38de +319c 315d 3821 3822 +315e 315f 3820 38dd +319d 315e 3820 3821 +315f 3160 381f 38dc +319e 315f 381f 3820 +3160 3161 381e 38db +319f 3160 381e 381f +3161 3162 381d 38da +31a0 3161 381d 381e +3162 3163 381c 38d9 +31a1 3162 381c 381d +3163 3164 381b 38d8 +31a2 3163 381b 381c +3164 3165 381a 38d7 +31a3 3164 381a 381b +3165 3166 3819 38d6 +31a4 3165 3819 381a +3166 3167 3818 38d5 +31a5 3166 3818 3819 +3167 3168 3817 38d4 +31a6 3167 3817 3818 +3168 3169 3816 38d3 +31a7 3168 3816 3817 +3169 316a 3815 38d2 +31a8 3169 3815 3816 +316a 316b 3814 38d1 +31a9 316a 3814 3815 +316b 316c 3813 38d0 +31aa 316b 3813 3814 +316c 316d 3812 38cf +31ab 316c 3812 3813 +316d 316e 3811 38ce +31ac 316d 3811 3812 +316e 316f 3810 38cd +31ad 316e 3810 3811 +316f 3170 380f 38cc +31ae 316f 380f 3810 +3170 3171 380e 38cb +31af 3170 380e 380f +3171 3172 380d 38ca +31b0 3171 380d 380e +3172 3173 380c 38c9 +31b1 3172 380c 380d +3173 3174 380b 38c8 +31b2 3173 380b 380c +3174 3175 380a 38c7 +31b3 3174 380a 380b +3175 3176 3809 38c6 +31b4 3175 3809 380a +3176 3177 3808 38c5 +31b5 3176 3808 3809 +3177 3178 3807 38c4 +31b6 3177 3807 3808 +3178 3179 3806 38c3 +31b7 3178 3806 3807 +3179 317a 3805 38c2 +31b8 3179 3805 3806 +317a 317b 3804 38c1 +31b9 317a 3804 3805 +317b 317c 3803 38c0 +31ba 317b 3803 3804 +317c 317d 3802 38bf +31bb 317c 3802 3803 +317d 317e 3801 38be +31bc 317d 3801 3802 +317e 317f 3800 38bd +31bd 317e 3800 3801 +317f 3180 37ff 38bc +31be 317f 37ff 3800 +31bf 3180 37fe 37ff +3181 3182 377f 383c +31c0 3181 377f 3780 +3182 3183 377e 383b +31c1 3182 377e 377f +3183 3184 377d 383a +31c2 3183 377d 377e +3184 3185 377c 3839 +31c3 3184 377c 377d +3185 3186 377b 3838 +31c4 3185 377b 377c +3186 3187 377a 3837 +31c5 3186 377a 377b +3187 3188 3779 3836 +31c6 3187 3779 377a +3188 3189 3778 3835 +31c7 3188 3778 3779 +3189 318a 3777 3834 +31c8 3189 3777 3778 +318a 318b 3776 3833 +31c9 318a 3776 3777 +318b 318c 3775 3832 +31ca 318b 3775 3776 +318c 318d 3774 3831 +31cb 318c 3774 3775 +318d 318e 3773 3830 +31cc 318d 3773 3774 +318e 318f 3772 382f +31cd 318e 3772 3773 +318f 3190 3771 382e +31ce 318f 3771 3772 +3190 3191 3770 382d +31cf 3190 3770 3771 +3191 3192 376f 382c +31d0 3191 376f 3770 +3192 3193 376e 382b +31d1 3192 376e 376f +3193 3194 376d 382a +31d2 3193 376d 376e +3194 3195 376c 3829 +31d3 3194 376c 376d +3195 3196 376b 3828 +31d4 3195 376b 376c +3196 3197 376a 3827 +31d5 3196 376a 376b +3197 3198 3769 3826 +31d6 3197 3769 376a +3198 3199 3768 3825 +31d7 3198 3768 3769 +3199 319a 3767 3824 +31d8 3199 3767 3768 +319a 319b 3766 3823 +31d9 319a 3766 3767 +319b 319c 3765 3822 +31da 319b 3765 3766 +319c 319d 3764 3821 +31db 319c 3764 3765 +319d 319e 3763 3820 +31dc 319d 3763 3764 +319e 319f 3762 381f +31dd 319e 3762 3763 +319f 31a0 3761 381e +31de 319f 3761 3762 +31a0 31a1 3760 381d +31df 31a0 3760 3761 +31a1 31a2 375f 381c +31e0 31a1 375f 3760 +31a2 31a3 375e 381b +31e1 31a2 375e 375f +31a3 31a4 375d 381a +31e2 31a3 375d 375e +31a4 31a5 375c 3819 +31e3 31a4 375c 375d +31a5 31a6 375b 3818 +31e4 31a5 375b 375c +31a6 31a7 375a 3817 +31e5 31a6 375a 375b +31a7 31a8 3759 3816 +31e6 31a7 3759 375a +31a8 31a9 3758 3815 +31e7 31a8 3758 3759 +31a9 31aa 3757 3814 +31e8 31a9 3757 3758 +31aa 31ab 3756 3813 +31e9 31aa 3756 3757 +31ab 31ac 3755 3812 +31ea 31ab 3755 3756 +31ac 31ad 3754 3811 +31eb 31ac 3754 3755 +31ad 31ae 3753 3810 +31ec 31ad 3753 3754 +31ae 31af 3752 380f +31ed 31ae 3752 3753 +31af 31b0 3751 380e +31ee 31af 3751 3752 +31b0 31b1 3750 380d +31ef 31b0 3750 3751 +31b1 31b2 374f 380c +31f0 31b1 374f 3750 +31b2 31b3 374e 380b +31f1 31b2 374e 374f +31b3 31b4 374d 380a +31f2 31b3 374d 374e +31b4 31b5 374c 3809 +31f3 31b4 374c 374d +31b5 31b6 374b 3808 +31f4 31b5 374b 374c +31b6 31b7 374a 3807 +31f5 31b6 374a 374b +31b7 31b8 3749 3806 +31f6 31b7 3749 374a +31b8 31b9 3748 3805 +31f7 31b8 3748 3749 +31b9 31ba 3747 3804 +31f8 31b9 3747 3748 +31ba 31bb 3746 3803 +31f9 31ba 3746 3747 +31bb 31bc 3745 3802 +31fa 31bb 3745 3746 +31bc 31bd 3744 3801 +31fb 31bc 3744 3745 +31bd 31be 3743 3800 +31fc 31bd 3743 3744 +31be 31bf 3742 37ff +31fd 31be 3742 3743 +31fe 31bf 3741 3742 +31c0 31c1 36c2 377f +31c1 31c2 36c1 377e +31c2 31c3 36c0 377d +31c3 31c4 36bf 377c +31c4 31c5 36be 377b +31c5 31c6 36bd 377a +31c6 31c7 36bc 3779 +31c7 31c8 36bb 3778 +31c8 31c9 36ba 3777 +31c9 31ca 36b9 3776 +31ca 31cb 36b8 3775 +31cb 31cc 36b7 3774 +31cc 31cd 36b6 3773 +31cd 31ce 36b5 3772 +31ce 31cf 36b4 3771 +31cf 31d0 36b3 3770 +31d0 31d1 36b2 376f +31d1 31d2 36b1 376e +31d2 31d3 36b0 376d +31d3 31d4 36af 376c +31d4 31d5 36ae 376b +31d5 31d6 36ad 376a +31d6 31d7 36ac 3769 +31d7 31d8 36ab 3768 +31d8 31d9 36aa 3767 +31d9 31da 36a9 3766 +31da 31db 36a8 3765 +31db 31dc 36a7 3764 +31dc 31dd 36a6 3763 +31dd 31de 36a5 3762 +31de 31df 36a4 3761 +31df 31e0 36a3 3760 +31e0 31e1 36a2 375f +31e1 31e2 36a1 375e +31e2 31e3 36a0 375d +31e3 31e4 369f 375c +31e4 31e5 369e 375b +31e5 31e6 369d 375a +31e6 31e7 369c 3759 +31e7 31e8 369b 3758 +31e8 31e9 369a 3757 +31e9 31ea 3699 3756 +31ea 31eb 3698 3755 +31eb 31ec 3697 3754 +31ec 31ed 3696 3753 +31ed 31ee 3695 3752 +31ee 31ef 3694 3751 +31ef 31f0 3693 3750 +31f0 31f1 3692 374f +31f1 31f2 3691 374e +31f2 31f3 3690 374d +31f3 31f4 368f 374c +31f4 31f5 368e 374b +31f5 31f6 368d 374a +31f6 31f7 368c 3749 +31f7 31f8 368b 3748 +31f8 31f9 368a 3747 +31f9 31fa 3689 3746 +31fa 31fb 3688 3745 +31fb 31fc 3687 3744 +31fc 31fd 3686 3743 +31fd 31fe 3685 3742 +3200 31ff 365a 3717 +31ff 3209 3716 3717 +3201 3200 365b 3718 +3200 320a 3717 3718 +3202 3201 365c 3719 +3201 320b 3718 3719 +3203 3202 365d 371a +3202 320c 3719 371a +3204 3203 365e 371b +3203 320d 371a 371b +3205 3204 365f 371c +3204 320e 371b 371c +3206 3205 3660 371d +3205 320f 371c 371d +3207 3206 3661 371e +3206 3210 371d 371e +3208 3207 3662 371f +3207 3211 371e 371f +3208 3212 371f 3720 +320a 3209 3717 37d4 +3209 3213 37d3 37d4 +320b 320a 3718 37d5 +320a 3214 37d4 37d5 +320c 320b 3719 37d6 +320b 3215 37d5 37d6 +320d 320c 371a 37d7 +320c 3216 37d6 37d7 +320e 320d 371b 37d8 +320d 3217 37d7 37d8 +320f 320e 371c 37d9 +320e 3218 37d8 37d9 +3210 320f 371d 37da +320f 3219 37d9 37da +3211 3210 371e 37db +3210 321a 37da 37db +3212 3211 371f 37dc +3211 321b 37db 37dc +3212 321c 37dc 37dd +3214 3213 37d4 3891 +3213 321d 3890 3891 +3215 3214 37d5 3892 +3214 321e 3891 3892 +3216 3215 37d6 3893 +3215 321f 3892 3893 +3217 3216 37d7 3894 +3216 3220 3893 3894 +3218 3217 37d8 3895 +3217 3221 3894 3895 +3219 3218 37d9 3896 +3218 3222 3895 3896 +321a 3219 37da 3897 +3219 3223 3896 3897 +321b 321a 37db 3898 +321a 3224 3897 3898 +321c 321b 37dc 3899 +321b 3225 3898 3899 +321c 3226 3899 389a +321e 321d 3891 394e +321d 3227 394d 394e +321f 321e 3892 394f +321e 3228 394e 394f +3220 321f 3893 3950 +321f 3229 394f 3950 +3221 3220 3894 3951 +3220 322a 3950 3951 +3222 3221 3895 3952 +3221 322b 3951 3952 +3223 3222 3896 3953 +3222 322c 3952 3953 +3224 3223 3897 3954 +3223 322d 3953 3954 +3225 3224 3898 3955 +3224 322e 3954 3955 +3226 3225 3899 3956 +3225 322f 3955 3956 +3226 3230 3956 3957 +3228 3227 394e 3a0b +3227 3231 3a0a 3a0b +3229 3228 394f 3a0c +3228 3232 3a0b 3a0c +322a 3229 3950 3a0d +3229 3233 3a0c 3a0d +322b 322a 3951 3a0e +322a 3234 3a0d 3a0e +322c 322b 3952 3a0f +322b 3235 3a0e 3a0f +322d 322c 3953 3a10 +322c 3236 3a0f 3a10 +322e 322d 3954 3a11 +322d 3237 3a10 3a11 +322f 322e 3955 3a12 +322e 3238 3a11 3a12 +3230 322f 3956 3a13 +322f 3239 3a12 3a13 +3230 323a 3a13 3a14 +3232 3231 3a0b 3ac8 +3231 323b 3ac7 3ac8 +3233 3232 3a0c 3ac9 +3232 323c 3ac8 3ac9 +3234 3233 3a0d 3aca +3233 323d 3ac9 3aca +3235 3234 3a0e 3acb +3234 323e 3aca 3acb +3236 3235 3a0f 3acc +3235 323f 3acb 3acc +3237 3236 3a10 3acd +3236 3240 3acc 3acd +3238 3237 3a11 3ace +3237 3241 3acd 3ace +3239 3238 3a12 3acf +3238 3242 3ace 3acf +323a 3239 3a13 3ad0 +3239 3243 3acf 3ad0 +323a 3244 3ad0 3ad1 +323c 323b 3ac8 3b85 +323b 3245 3b84 3b85 +323d 323c 3ac9 3b86 +323c 3246 3b85 3b86 +323e 323d 3aca 3b87 +323d 3247 3b86 3b87 +323f 323e 3acb 3b88 +323e 3248 3b87 3b88 +3240 323f 3acc 3b89 +323f 3249 3b88 3b89 +3241 3240 3acd 3b8a +3240 324a 3b89 3b8a +3242 3241 3ace 3b8b +3241 324b 3b8a 3b8b +3243 3242 3acf 3b8c +3242 324c 3b8b 3b8c +3244 3243 3ad0 3b8d +3243 324d 3b8c 3b8d +3244 324e 3b8d 3b8e +3246 3245 3b85 3c42 +3245 324f 3c41 3c42 +3247 3246 3b86 3c43 +3246 3250 3c42 3c43 +3248 3247 3b87 3c44 +3247 3251 3c43 3c44 +3249 3248 3b88 3c45 +3248 3252 3c44 3c45 +324a 3249 3b89 3c46 +3249 3253 3c45 3c46 +324b 324a 3b8a 3c47 +324a 3254 3c46 3c47 +324c 324b 3b8b 3c48 +324b 3255 3c47 3c48 +324d 324c 3b8c 3c49 +324c 3256 3c48 3c49 +324e 324d 3b8d 3c4a +324d 3257 3c49 3c4a +324e 3258 3c4a 3c4b +3250 324f 3c42 3cff +324f 3259 3cfe 3cff +3251 3250 3c43 3d00 +3250 325a 3cff 3d00 +3252 3251 3c44 3d01 +3251 325b 3d00 3d01 +3253 3252 3c45 3d02 +3252 325c 3d01 3d02 +3254 3253 3c46 3d03 +3253 325d 3d02 3d03 +3255 3254 3c47 3d04 +3254 325e 3d03 3d04 +3256 3255 3c48 3d05 +3255 325f 3d04 3d05 +3257 3256 3c49 3d06 +3256 3260 3d05 3d06 +3258 3257 3c4a 3d07 +3257 3261 3d06 3d07 +3258 3262 3d07 3d08 +325a 3259 3cff 3dbc +3259 3263 3dbb 3dbc +325b 325a 3d00 3dbd +325a 3264 3dbc 3dbd +325c 325b 3d01 3dbe +325b 3265 3dbd 3dbe +325d 325c 3d02 3dbf +325c 3266 3dbe 3dbf +325e 325d 3d03 3dc0 +325d 3267 3dbf 3dc0 +325f 325e 3d04 3dc1 +325e 3268 3dc0 3dc1 +3260 325f 3d05 3dc2 +325f 3269 3dc1 3dc2 +3261 3260 3d06 3dc3 +3260 326a 3dc2 3dc3 +3262 3261 3d07 3dc4 +3261 326b 3dc3 3dc4 +3262 326c 3dc4 3dc5 +3264 3263 3dbc 3e79 +3263 326d 3e78 3e79 +3265 3264 3dbd 3e7a +3264 326e 3e79 3e7a +3266 3265 3dbe 3e7b +3265 326f 3e7a 3e7b +3267 3266 3dbf 3e7c +3266 3270 3e7b 3e7c +3268 3267 3dc0 3e7d +3267 3271 3e7c 3e7d +3269 3268 3dc1 3e7e +3268 3272 3e7d 3e7e +326a 3269 3dc2 3e7f +3269 3273 3e7e 3e7f +326b 326a 3dc3 3e80 +326a 3274 3e7f 3e80 +326c 326b 3dc4 3e81 +326b 3275 3e80 3e81 +326c 3276 3e81 3e82 +326e 326d 3e79 3f36 +326d 3277 3f35 3f36 +326f 326e 3e7a 3f37 +326e 3278 3f36 3f37 +3270 326f 3e7b 3f38 +326f 3279 3f37 3f38 +3271 3270 3e7c 3f39 +3270 327a 3f38 3f39 +3272 3271 3e7d 3f3a +3271 327b 3f39 3f3a +3273 3272 3e7e 3f3b +3272 327c 3f3a 3f3b +3274 3273 3e7f 3f3c +3273 327d 3f3b 3f3c +3275 3274 3e80 3f3d +3274 327e 3f3c 3f3d +3276 3275 3e81 3f3e +3275 327f 3f3d 3f3e +3276 3280 3f3e 3f3f +3278 3277 3f36 3ff3 +3277 3281 3ff2 3ff3 +3279 3278 3f37 3ff4 +3278 3282 3ff3 3ff4 +327a 3279 3f38 3ff5 +3279 3283 3ff4 3ff5 +327b 327a 3f39 3ff6 +327a 3284 3ff5 3ff6 +327c 327b 3f3a 3ff7 +327b 3285 3ff6 3ff7 +327d 327c 3f3b 3ff8 +327c 3286 3ff7 3ff8 +327e 327d 3f3c 3ff9 +327d 3287 3ff8 3ff9 +327f 327e 3f3d 3ffa +327e 3288 3ff9 3ffa +3280 327f 3f3e 3ffb +327f 3289 3ffa 3ffb +3280 328a 3ffb 3ffc +3282 3281 3ff3 40b0 +3281 328b 40af 40b0 +3283 3282 3ff4 40b1 +3282 328c 40b0 40b1 +3284 3283 3ff5 40b2 +3283 328d 40b1 40b2 +3285 3284 3ff6 40b3 +3284 328e 40b2 40b3 +3286 3285 3ff7 40b4 +3285 328f 40b3 40b4 +3287 3286 3ff8 40b5 +3286 3290 40b4 40b5 +3288 3287 3ff9 40b6 +3287 3291 40b5 40b6 +3289 3288 3ffa 40b7 +3288 3292 40b6 40b7 +328a 3289 3ffb 40b8 +3289 3293 40b7 40b8 +328a 3294 40b8 40b9 +328c 328b 40b0 416d +328b 3295 416c 416d +328d 328c 40b1 416e +328c 3296 416d 416e +328e 328d 40b2 416f +328d 3297 416e 416f +328f 328e 40b3 4170 +328e 3298 416f 4170 +3290 328f 40b4 4171 +328f 3299 4170 4171 +3291 3290 40b5 4172 +3290 329a 4171 4172 +3292 3291 40b6 4173 +3291 329b 4172 4173 +3293 3292 40b7 4174 +3292 329c 4173 4174 +3294 3293 40b8 4175 +3293 329d 4174 4175 +3294 329e 4175 4176 +3296 3295 416d 422a +3295 329f 4229 422a +3297 3296 416e 422b +3296 32a0 422a 422b +3298 3297 416f 422c +3297 32a1 422b 422c +3299 3298 4170 422d +3298 32a2 422c 422d +329a 3299 4171 422e +3299 32a3 422d 422e +329b 329a 4172 422f +329a 32a4 422e 422f +329c 329b 4173 4230 +329b 32a5 422f 4230 +329d 329c 4174 4231 +329c 32a6 4230 4231 +329e 329d 4175 4232 +329d 32a7 4231 4232 +329e 32a8 4232 4233 +32a0 329f 422a 42e7 +329f 32a9 42e6 42e7 +32a1 32a0 422b 42e8 +32a0 32aa 42e7 42e8 +32a2 32a1 422c 42e9 +32a1 32ab 42e8 42e9 +32a3 32a2 422d 42ea +32a2 32ac 42e9 42ea +32a4 32a3 422e 42eb +32a3 32ad 42ea 42eb +32a5 32a4 422f 42ec +32a4 32ae 42eb 42ec +32a6 32a5 4230 42ed +32a5 32af 42ec 42ed +32a7 32a6 4231 42ee +32a6 32b0 42ed 42ee +32a8 32a7 4232 42ef +32a7 32b1 42ee 42ef +32a8 32b2 42ef 42f0 +32aa 32a9 42e7 43a4 +32a9 32b3 43a3 43a4 +32ab 32aa 42e8 43a5 +32aa 32b4 43a4 43a5 +32ac 32ab 42e9 43a6 +32ab 32b5 43a5 43a6 +32ad 32ac 42ea 43a7 +32ac 32b6 43a6 43a7 +32ae 32ad 42eb 43a8 +32ad 32b7 43a7 43a8 +32af 32ae 42ec 43a9 +32ae 32b8 43a8 43a9 +32b0 32af 42ed 43aa +32af 32b9 43a9 43aa +32b1 32b0 42ee 43ab +32b0 32ba 43aa 43ab +32b2 32b1 42ef 43ac +32b1 32bb 43ab 43ac +32b2 32bc 43ac 43ad +32b4 32b3 43a4 4461 +32b3 32bd 4460 4461 +32b5 32b4 43a5 4462 +32b4 32be 4461 4462 +32b6 32b5 43a6 4463 +32b5 32bf 4462 4463 +32b7 32b6 43a7 4464 +32b6 32c0 4463 4464 +32b8 32b7 43a8 4465 +32b7 32c1 4464 4465 +32b9 32b8 43a9 4466 +32b8 32c2 4465 4466 +32ba 32b9 43aa 4467 +32b9 32c3 4466 4467 +32bb 32ba 43ab 4468 +32ba 32c4 4467 4468 +32bc 32bb 43ac 4469 +32bb 32c5 4468 4469 +32bc 32c6 4469 446a +32be 32bd 4461 451e +32bd 32c7 451d 451e +32bf 32be 4462 451f +32be 32c8 451e 451f +32c0 32bf 4463 4520 +32bf 32c9 451f 4520 +32c1 32c0 4464 4521 +32c0 32ca 4520 4521 +32c2 32c1 4465 4522 +32c1 32cb 4521 4522 +32c3 32c2 4466 4523 +32c2 32cc 4522 4523 +32c4 32c3 4467 4524 +32c3 32cd 4523 4524 +32c5 32c4 4468 4525 +32c4 32ce 4524 4525 +32c6 32c5 4469 4526 +32c5 32cf 4525 4526 +32c6 32d0 4526 4527 +32c8 32c7 451e 45db +32c7 32d1 45da 45db +32c9 32c8 451f 45dc +32c8 32d2 45db 45dc +32ca 32c9 4520 45dd +32c9 32d3 45dc 45dd +32cb 32ca 4521 45de +32ca 32d4 45dd 45de +32cc 32cb 4522 45df +32cb 32d5 45de 45df +32cd 32cc 4523 45e0 +32cc 32d6 45df 45e0 +32ce 32cd 4524 45e1 +32cd 32d7 45e0 45e1 +32cf 32ce 4525 45e2 +32ce 32d8 45e1 45e2 +32d0 32cf 4526 45e3 +32cf 32d9 45e2 45e3 +32d0 32da 45e3 45e4 +32d2 32d1 45db 4698 +32d1 32db 4697 4698 +32d3 32d2 45dc 4699 +32d2 32dc 4698 4699 +32d4 32d3 45dd 469a +32d3 32dd 4699 469a +32d5 32d4 45de 469b +32d4 32de 469a 469b +32d6 32d5 45df 469c +32d5 32df 469b 469c +32d7 32d6 45e0 469d +32d6 32e0 469c 469d +32d8 32d7 45e1 469e +32d7 32e1 469d 469e +32d9 32d8 45e2 469f +32d8 32e2 469e 469f +32da 32d9 45e3 46a0 +32d9 32e3 469f 46a0 +32da 32e4 46a0 46a1 +32dc 32db 4698 4755 +32db 32e5 4754 4755 +32dd 32dc 4699 4756 +32dc 32e6 4755 4756 +32de 32dd 469a 4757 +32dd 32e7 4756 4757 +32df 32de 469b 4758 +32de 32e8 4757 4758 +32e0 32df 469c 4759 +32df 32e9 4758 4759 +32e1 32e0 469d 475a +32e0 32ea 4759 475a +32e2 32e1 469e 475b +32e1 32eb 475a 475b +32e3 32e2 469f 475c +32e2 32ec 475b 475c +32e4 32e3 46a0 475d +32e3 32ed 475c 475d +32e4 32ee 475d 475e +32e6 32e5 4755 4812 +32e5 32ef 4811 4812 +32e7 32e6 4756 4813 +32e6 32f0 4812 4813 +32e8 32e7 4757 4814 +32e7 32f1 4813 4814 +32e9 32e8 4758 4815 +32e8 32f2 4814 4815 +32ea 32e9 4759 4816 +32e9 32f3 4815 4816 +32eb 32ea 475a 4817 +32ea 32f4 4816 4817 +32ec 32eb 475b 4818 +32eb 32f5 4817 4818 +32ed 32ec 475c 4819 +32ec 32f6 4818 4819 +32ee 32ed 475d 481a +32ed 32f7 4819 481a +32ee 32f8 481a 481b +32f0 32ef 4812 48cf +32ef 32f9 48ce 48cf +32f1 32f0 4813 48d0 +32f0 32fa 48cf 48d0 +32f2 32f1 4814 48d1 +32f1 32fb 48d0 48d1 +32f3 32f2 4815 48d2 +32f2 32fc 48d1 48d2 +32f4 32f3 4816 48d3 +32f3 32fd 48d2 48d3 +32f5 32f4 4817 48d4 +32f4 32fe 48d3 48d4 +32f6 32f5 4818 48d5 +32f5 32ff 48d4 48d5 +32f7 32f6 4819 48d6 +32f6 3300 48d5 48d6 +32f8 32f7 481a 48d7 +32f7 3301 48d6 48d7 +32f8 3302 48d7 48d8 +32fa 32f9 48cf 498c +32f9 3303 498b 498c +32fb 32fa 48d0 498d +32fa 3304 498c 498d +32fc 32fb 48d1 498e +32fb 3305 498d 498e +32fd 32fc 48d2 498f +32fc 3306 498e 498f +32fe 32fd 48d3 4990 +32fd 3307 498f 4990 +32ff 32fe 48d4 4991 +32fe 3308 4990 4991 +3300 32ff 48d5 4992 +32ff 3309 4991 4992 +3301 3300 48d6 4993 +3300 330a 4992 4993 +3302 3301 48d7 4994 +3301 330b 4993 4994 +3302 330c 4994 4995 +3304 3303 498c 4a49 +3303 330d 4a48 4a49 +3305 3304 498d 4a4a +3304 330e 4a49 4a4a +3306 3305 498e 4a4b +3305 330f 4a4a 4a4b +3307 3306 498f 4a4c +3306 3310 4a4b 4a4c +3308 3307 4990 4a4d +3307 3311 4a4c 4a4d +3309 3308 4991 4a4e +3308 3312 4a4d 4a4e +330a 3309 4992 4a4f +3309 3313 4a4e 4a4f +330b 330a 4993 4a50 +330a 3314 4a4f 4a50 +330c 330b 4994 4a51 +330b 3315 4a50 4a51 +330c 3316 4a51 4a52 +330e 330d 4a49 4b06 +330d 3317 4b05 4b06 +330f 330e 4a4a 4b07 +330e 3318 4b06 4b07 +3310 330f 4a4b 4b08 +330f 3319 4b07 4b08 +3311 3310 4a4c 4b09 +3310 331a 4b08 4b09 +3312 3311 4a4d 4b0a +3311 331b 4b09 4b0a +3313 3312 4a4e 4b0b +3312 331c 4b0a 4b0b +3314 3313 4a4f 4b0c +3313 331d 4b0b 4b0c +3315 3314 4a50 4b0d +3314 331e 4b0c 4b0d +3316 3315 4a51 4b0e +3315 331f 4b0d 4b0e +3316 3320 4b0e 4b0f +3318 3317 4b06 4bc3 +3319 3318 4b07 4bc4 +331a 3319 4b08 4bc5 +331b 331a 4b09 4bc6 +331c 331b 4b0a 4bc7 +331d 331c 4b0b 4bc8 +331e 331d 4b0c 4bc9 +331f 331e 4b0d 4bca +3320 331f 4b0e 4bcb +3322 3321 3612 36cf +3321 3368 36ce 36cf +3323 3322 3613 36d0 +3322 3369 36cf 36d0 +3324 3323 3614 36d1 +3323 336a 36d0 36d1 +3325 3324 3615 36d2 +3324 336b 36d1 36d2 +3326 3325 3616 36d3 +3325 336c 36d2 36d3 +3327 3326 3617 36d4 +3326 336d 36d3 36d4 +3328 3327 3618 36d5 +3327 336e 36d4 36d5 +3329 3328 3619 36d6 +3328 336f 36d5 36d6 +332a 3329 361a 36d7 +3329 3370 36d6 36d7 +332b 332a 361b 36d8 +332a 3371 36d7 36d8 +332c 332b 361c 36d9 +332b 3372 36d8 36d9 +332d 332c 361d 36da +332c 3373 36d9 36da +332e 332d 361e 36db +332d 3374 36da 36db +332f 332e 361f 36dc +332e 3375 36db 36dc +3330 332f 3620 36dd +332f 3376 36dc 36dd +3331 3330 3621 36de +3330 3377 36dd 36de +3332 3331 3622 36df +3331 3378 36de 36df +3333 3332 3623 36e0 +3332 3379 36df 36e0 +3334 3333 3624 36e1 +3333 337a 36e0 36e1 +3335 3334 3625 36e2 +3334 337b 36e1 36e2 +3336 3335 3626 36e3 +3335 337c 36e2 36e3 +3337 3336 3627 36e4 +3336 337d 36e3 36e4 +3338 3337 3628 36e5 +3337 337e 36e4 36e5 +3339 3338 3629 36e6 +3338 337f 36e5 36e6 +333a 3339 362a 36e7 +3339 3380 36e6 36e7 +333b 333a 362b 36e8 +333a 3381 36e7 36e8 +333c 333b 362c 36e9 +333b 3382 36e8 36e9 +333d 333c 362d 36ea +333c 3383 36e9 36ea +333e 333d 362e 36eb +333d 3384 36ea 36eb +333f 333e 362f 36ec +333e 3385 36eb 36ec +3340 333f 3630 36ed +333f 3386 36ec 36ed +3341 3340 3631 36ee +3340 3387 36ed 36ee +3342 3341 3632 36ef +3341 3388 36ee 36ef +3343 3342 3633 36f0 +3342 3389 36ef 36f0 +3344 3343 3634 36f1 +3343 338a 36f0 36f1 +3345 3344 3635 36f2 +3344 338b 36f1 36f2 +3346 3345 3636 36f3 +3345 338c 36f2 36f3 +3347 3346 3637 36f4 +3346 338d 36f3 36f4 +3348 3347 3638 36f5 +3347 338e 36f4 36f5 +3349 3348 3639 36f6 +3348 338f 36f5 36f6 +334a 3349 363a 36f7 +3349 3390 36f6 36f7 +334b 334a 363b 36f8 +334a 3391 36f7 36f8 +334c 334b 363c 36f9 +334b 3392 36f8 36f9 +334d 334c 363d 36fa +334c 3393 36f9 36fa +334e 334d 363e 36fb +334d 3394 36fa 36fb +334f 334e 363f 36fc +334e 3395 36fb 36fc +3350 334f 3640 36fd +334f 3396 36fc 36fd +3351 3350 3641 36fe +3350 3397 36fd 36fe +3352 3351 3642 36ff +3351 3398 36fe 36ff +3353 3352 3643 3700 +3352 3399 36ff 3700 +3354 3353 3644 3701 +3353 339a 3700 3701 +3355 3354 3645 3702 +3354 339b 3701 3702 +3356 3355 3646 3703 +3355 339c 3702 3703 +3357 3356 3647 3704 +3356 339d 3703 3704 +3358 3357 3648 3705 +3357 339e 3704 3705 +3359 3358 3649 3706 +3358 339f 3705 3706 +335a 3359 364a 3707 +3359 33a0 3706 3707 +335b 335a 364b 3708 +335a 33a1 3707 3708 +335c 335b 364c 3709 +335b 33a2 3708 3709 +335d 335c 364d 370a +335c 33a3 3709 370a +335e 335d 364e 370b +335d 33a4 370a 370b +335f 335e 364f 370c +335e 33a5 370b 370c +3360 335f 3650 370d +335f 33a6 370c 370d +3361 3360 3651 370e +3360 33a7 370d 370e +3362 3361 3652 370f +3361 33a8 370e 370f +3363 3362 3653 3710 +3362 33a9 370f 3710 +3364 3363 3654 3711 +3363 33aa 3710 3711 +3365 3364 3655 3712 +3364 33ab 3711 3712 +3366 3365 3656 3713 +3365 33ac 3712 3713 +3367 3366 3657 3714 +3366 33ad 3713 3714 +3367 33ae 3714 3715 +3369 3368 36cf 378c +3368 33af 378b 378c +336a 3369 36d0 378d +3369 33b0 378c 378d +336b 336a 36d1 378e +336a 33b1 378d 378e +336c 336b 36d2 378f +336b 33b2 378e 378f +336d 336c 36d3 3790 +336c 33b3 378f 3790 +336e 336d 36d4 3791 +336d 33b4 3790 3791 +336f 336e 36d5 3792 +336e 33b5 3791 3792 +3370 336f 36d6 3793 +336f 33b6 3792 3793 +3371 3370 36d7 3794 +3370 33b7 3793 3794 +3372 3371 36d8 3795 +3371 33b8 3794 3795 +3373 3372 36d9 3796 +3372 33b9 3795 3796 +3374 3373 36da 3797 +3373 33ba 3796 3797 +3375 3374 36db 3798 +3374 33bb 3797 3798 +3376 3375 36dc 3799 +3375 33bc 3798 3799 +3377 3376 36dd 379a +3376 33bd 3799 379a +3378 3377 36de 379b +3377 33be 379a 379b +3379 3378 36df 379c +3378 33bf 379b 379c +337a 3379 36e0 379d +3379 33c0 379c 379d +337b 337a 36e1 379e +337a 33c1 379d 379e +337c 337b 36e2 379f +337b 33c2 379e 379f +337d 337c 36e3 37a0 +337c 33c3 379f 37a0 +337e 337d 36e4 37a1 +337d 33c4 37a0 37a1 +337f 337e 36e5 37a2 +337e 33c5 37a1 37a2 +3380 337f 36e6 37a3 +337f 33c6 37a2 37a3 +3381 3380 36e7 37a4 +3380 33c7 37a3 37a4 +3382 3381 36e8 37a5 +3381 33c8 37a4 37a5 +3383 3382 36e9 37a6 +3382 33c9 37a5 37a6 +3384 3383 36ea 37a7 +3383 33ca 37a6 37a7 +3385 3384 36eb 37a8 +3384 33cb 37a7 37a8 +3386 3385 36ec 37a9 +3385 33cc 37a8 37a9 +3387 3386 36ed 37aa +3386 33cd 37a9 37aa +3388 3387 36ee 37ab +3387 33ce 37aa 37ab +3389 3388 36ef 37ac +3388 33cf 37ab 37ac +338a 3389 36f0 37ad +3389 33d0 37ac 37ad +338b 338a 36f1 37ae +338a 33d1 37ad 37ae +338c 338b 36f2 37af +338b 33d2 37ae 37af +338d 338c 36f3 37b0 +338c 33d3 37af 37b0 +338e 338d 36f4 37b1 +338d 33d4 37b0 37b1 +338f 338e 36f5 37b2 +338e 33d5 37b1 37b2 +3390 338f 36f6 37b3 +338f 33d6 37b2 37b3 +3391 3390 36f7 37b4 +3390 33d7 37b3 37b4 +3392 3391 36f8 37b5 +3391 33d8 37b4 37b5 +3393 3392 36f9 37b6 +3392 33d9 37b5 37b6 +3394 3393 36fa 37b7 +3393 33da 37b6 37b7 +3395 3394 36fb 37b8 +3394 33db 37b7 37b8 +3396 3395 36fc 37b9 +3395 33dc 37b8 37b9 +3397 3396 36fd 37ba +3396 33dd 37b9 37ba +3398 3397 36fe 37bb +3397 33de 37ba 37bb +3399 3398 36ff 37bc +3398 33df 37bb 37bc +339a 3399 3700 37bd +3399 33e0 37bc 37bd +339b 339a 3701 37be +339a 33e1 37bd 37be +339c 339b 3702 37bf +339b 33e2 37be 37bf +339d 339c 3703 37c0 +339c 33e3 37bf 37c0 +339e 339d 3704 37c1 +339d 33e4 37c0 37c1 +339f 339e 3705 37c2 +339e 33e5 37c1 37c2 +33a0 339f 3706 37c3 +339f 33e6 37c2 37c3 +33a1 33a0 3707 37c4 +33a0 33e7 37c3 37c4 +33a2 33a1 3708 37c5 +33a1 33e8 37c4 37c5 +33a3 33a2 3709 37c6 +33a2 33e9 37c5 37c6 +33a4 33a3 370a 37c7 +33a3 33ea 37c6 37c7 +33a5 33a4 370b 37c8 +33a4 33eb 37c7 37c8 +33a6 33a5 370c 37c9 +33a5 33ec 37c8 37c9 +33a7 33a6 370d 37ca +33a6 33ed 37c9 37ca +33a8 33a7 370e 37cb +33a7 33ee 37ca 37cb +33a9 33a8 370f 37cc +33a8 33ef 37cb 37cc +33aa 33a9 3710 37cd +33a9 33f0 37cc 37cd +33ab 33aa 3711 37ce +33aa 33f1 37cd 37ce +33ac 33ab 3712 37cf +33ab 33f2 37ce 37cf +33ad 33ac 3713 37d0 +33ac 33f3 37cf 37d0 +33ae 33ad 3714 37d1 +33ad 33f4 37d0 37d1 +33ae 33f5 37d1 37d2 +33b0 33af 378c 3849 +33af 33f6 3848 3849 +33b1 33b0 378d 384a +33b0 33f7 3849 384a +33b2 33b1 378e 384b +33b1 33f8 384a 384b +33b3 33b2 378f 384c +33b2 33f9 384b 384c +33b4 33b3 3790 384d +33b3 33fa 384c 384d +33b5 33b4 3791 384e +33b4 33fb 384d 384e +33b6 33b5 3792 384f +33b5 33fc 384e 384f +33b7 33b6 3793 3850 +33b6 33fd 384f 3850 +33b8 33b7 3794 3851 +33b7 33fe 3850 3851 +33b9 33b8 3795 3852 +33b8 33ff 3851 3852 +33ba 33b9 3796 3853 +33b9 3400 3852 3853 +33bb 33ba 3797 3854 +33ba 3401 3853 3854 +33bc 33bb 3798 3855 +33bb 3402 3854 3855 +33bd 33bc 3799 3856 +33bc 3403 3855 3856 +33be 33bd 379a 3857 +33bd 3404 3856 3857 +33bf 33be 379b 3858 +33be 3405 3857 3858 +33c0 33bf 379c 3859 +33bf 3406 3858 3859 +33c1 33c0 379d 385a +33c0 3407 3859 385a +33c2 33c1 379e 385b +33c1 3408 385a 385b +33c3 33c2 379f 385c +33c2 3409 385b 385c +33c4 33c3 37a0 385d +33c3 340a 385c 385d +33c5 33c4 37a1 385e +33c4 340b 385d 385e +33c6 33c5 37a2 385f +33c5 340c 385e 385f +33c7 33c6 37a3 3860 +33c6 340d 385f 3860 +33c8 33c7 37a4 3861 +33c7 340e 3860 3861 +33c9 33c8 37a5 3862 +33c8 340f 3861 3862 +33ca 33c9 37a6 3863 +33c9 3410 3862 3863 +33cb 33ca 37a7 3864 +33ca 3411 3863 3864 +33cc 33cb 37a8 3865 +33cb 3412 3864 3865 +33cd 33cc 37a9 3866 +33cc 3413 3865 3866 +33ce 33cd 37aa 3867 +33cd 3414 3866 3867 +33cf 33ce 37ab 3868 +33ce 3415 3867 3868 +33d0 33cf 37ac 3869 +33cf 3416 3868 3869 +33d1 33d0 37ad 386a +33d0 3417 3869 386a +33d2 33d1 37ae 386b +33d1 3418 386a 386b +33d3 33d2 37af 386c +33d2 3419 386b 386c +33d4 33d3 37b0 386d +33d3 341a 386c 386d +33d5 33d4 37b1 386e +33d4 341b 386d 386e +33d6 33d5 37b2 386f +33d5 341c 386e 386f +33d7 33d6 37b3 3870 +33d6 341d 386f 3870 +33d8 33d7 37b4 3871 +33d7 341e 3870 3871 +33d9 33d8 37b5 3872 +33d8 341f 3871 3872 +33da 33d9 37b6 3873 +33d9 3420 3872 3873 +33db 33da 37b7 3874 +33da 3421 3873 3874 +33dc 33db 37b8 3875 +33db 3422 3874 3875 +33dd 33dc 37b9 3876 +33dc 3423 3875 3876 +33de 33dd 37ba 3877 +33dd 3424 3876 3877 +33df 33de 37bb 3878 +33de 3425 3877 3878 +33e0 33df 37bc 3879 +33df 3426 3878 3879 +33e1 33e0 37bd 387a +33e0 3427 3879 387a +33e2 33e1 37be 387b +33e1 3428 387a 387b +33e3 33e2 37bf 387c +33e2 3429 387b 387c +33e4 33e3 37c0 387d +33e3 342a 387c 387d +33e5 33e4 37c1 387e +33e4 342b 387d 387e +33e6 33e5 37c2 387f +33e5 342c 387e 387f +33e7 33e6 37c3 3880 +33e6 342d 387f 3880 +33e8 33e7 37c4 3881 +33e7 342e 3880 3881 +33e9 33e8 37c5 3882 +33e8 342f 3881 3882 +33ea 33e9 37c6 3883 +33e9 3430 3882 3883 +33eb 33ea 37c7 3884 +33ea 3431 3883 3884 +33ec 33eb 37c8 3885 +33eb 3432 3884 3885 +33ed 33ec 37c9 3886 +33ec 3433 3885 3886 +33ee 33ed 37ca 3887 +33ed 3434 3886 3887 +33ef 33ee 37cb 3888 +33ee 3435 3887 3888 +33f0 33ef 37cc 3889 +33ef 3436 3888 3889 +33f1 33f0 37cd 388a +33f0 3437 3889 388a +33f2 33f1 37ce 388b +33f1 3438 388a 388b +33f3 33f2 37cf 388c +33f2 3439 388b 388c +33f4 33f3 37d0 388d +33f3 343a 388c 388d +33f5 33f4 37d1 388e +33f4 343b 388d 388e +33f5 343c 388e 388f +33f7 33f6 3849 3906 +33f6 343d 3905 3906 +33f8 33f7 384a 3907 +33f7 343e 3906 3907 +33f9 33f8 384b 3908 +33f8 343f 3907 3908 +33fa 33f9 384c 3909 +33f9 3440 3908 3909 +33fb 33fa 384d 390a +33fa 3441 3909 390a +33fc 33fb 384e 390b +33fb 3442 390a 390b +33fd 33fc 384f 390c +33fc 3443 390b 390c +33fe 33fd 3850 390d +33fd 3444 390c 390d +33ff 33fe 3851 390e +33fe 3445 390d 390e +3400 33ff 3852 390f +33ff 3446 390e 390f +3401 3400 3853 3910 +3400 3447 390f 3910 +3402 3401 3854 3911 +3401 3448 3910 3911 +3403 3402 3855 3912 +3402 3449 3911 3912 +3404 3403 3856 3913 +3403 344a 3912 3913 +3405 3404 3857 3914 +3404 344b 3913 3914 +3406 3405 3858 3915 +3405 344c 3914 3915 +3407 3406 3859 3916 +3406 344d 3915 3916 +3408 3407 385a 3917 +3407 344e 3916 3917 +3409 3408 385b 3918 +3408 344f 3917 3918 +340a 3409 385c 3919 +3409 3450 3918 3919 +340b 340a 385d 391a +340a 3451 3919 391a +340c 340b 385e 391b +340b 3452 391a 391b +340d 340c 385f 391c +340c 3453 391b 391c +340e 340d 3860 391d +340d 3454 391c 391d +340f 340e 3861 391e +340e 3455 391d 391e +3410 340f 3862 391f +340f 3456 391e 391f +3411 3410 3863 3920 +3410 3457 391f 3920 +3412 3411 3864 3921 +3411 3458 3920 3921 +3413 3412 3865 3922 +3412 3459 3921 3922 +3414 3413 3866 3923 +3413 345a 3922 3923 +3415 3414 3867 3924 +3414 345b 3923 3924 +3416 3415 3868 3925 +3415 345c 3924 3925 +3417 3416 3869 3926 +3416 345d 3925 3926 +3418 3417 386a 3927 +3417 345e 3926 3927 +3419 3418 386b 3928 +3418 345f 3927 3928 +341a 3419 386c 3929 +3419 3460 3928 3929 +341b 341a 386d 392a +341a 3461 3929 392a +341c 341b 386e 392b +341b 3462 392a 392b +341d 341c 386f 392c +341c 3463 392b 392c +341e 341d 3870 392d +341d 3464 392c 392d +341f 341e 3871 392e +341e 3465 392d 392e +3420 341f 3872 392f +341f 3466 392e 392f +3421 3420 3873 3930 +3420 3467 392f 3930 +3422 3421 3874 3931 +3421 3468 3930 3931 +3423 3422 3875 3932 +3422 3469 3931 3932 +3424 3423 3876 3933 +3423 346a 3932 3933 +3425 3424 3877 3934 +3424 346b 3933 3934 +3426 3425 3878 3935 +3425 346c 3934 3935 +3427 3426 3879 3936 +3426 346d 3935 3936 +3428 3427 387a 3937 +3427 346e 3936 3937 +3429 3428 387b 3938 +3428 346f 3937 3938 +342a 3429 387c 3939 +3429 3470 3938 3939 +342b 342a 387d 393a +342a 3471 3939 393a +342c 342b 387e 393b +342b 3472 393a 393b +342d 342c 387f 393c +342c 3473 393b 393c +342e 342d 3880 393d +342d 3474 393c 393d +342f 342e 3881 393e +342e 3475 393d 393e +3430 342f 3882 393f +342f 3476 393e 393f +3431 3430 3883 3940 +3430 3477 393f 3940 +3432 3431 3884 3941 +3431 3478 3940 3941 +3433 3432 3885 3942 +3432 3479 3941 3942 +3434 3433 3886 3943 +3433 347a 3942 3943 +3435 3434 3887 3944 +3434 347b 3943 3944 +3436 3435 3888 3945 +3435 347c 3944 3945 +3437 3436 3889 3946 +3436 347d 3945 3946 +3438 3437 388a 3947 +3437 347e 3946 3947 +3439 3438 388b 3948 +3438 347f 3947 3948 +343a 3439 388c 3949 +3439 3480 3948 3949 +343b 343a 388d 394a +343a 3481 3949 394a +343c 343b 388e 394b +343b 3482 394a 394b +343c 3483 394b 394c +343e 343d 3906 39c3 +343d 3484 39c2 39c3 +343f 343e 3907 39c4 +343e 3485 39c3 39c4 +3440 343f 3908 39c5 +343f 3486 39c4 39c5 +3441 3440 3909 39c6 +3440 3487 39c5 39c6 +3442 3441 390a 39c7 +3441 3488 39c6 39c7 +3443 3442 390b 39c8 +3442 3489 39c7 39c8 +3444 3443 390c 39c9 +3443 348a 39c8 39c9 +3445 3444 390d 39ca +3444 348b 39c9 39ca +3446 3445 390e 39cb +3445 348c 39ca 39cb +3447 3446 390f 39cc +3446 348d 39cb 39cc +3448 3447 3910 39cd +3447 348e 39cc 39cd +3449 3448 3911 39ce +3448 348f 39cd 39ce +344a 3449 3912 39cf +3449 3490 39ce 39cf +344b 344a 3913 39d0 +344a 3491 39cf 39d0 +344c 344b 3914 39d1 +344b 3492 39d0 39d1 +344d 344c 3915 39d2 +344c 3493 39d1 39d2 +344e 344d 3916 39d3 +344d 3494 39d2 39d3 +344f 344e 3917 39d4 +344e 3495 39d3 39d4 +3450 344f 3918 39d5 +344f 3496 39d4 39d5 +3451 3450 3919 39d6 +3450 3497 39d5 39d6 +3452 3451 391a 39d7 +3451 3498 39d6 39d7 +3453 3452 391b 39d8 +3452 3499 39d7 39d8 +3454 3453 391c 39d9 +3453 349a 39d8 39d9 +3455 3454 391d 39da +3454 349b 39d9 39da +3456 3455 391e 39db +3455 349c 39da 39db +3457 3456 391f 39dc +3456 349d 39db 39dc +3458 3457 3920 39dd +3457 349e 39dc 39dd +3459 3458 3921 39de +3458 349f 39dd 39de +345a 3459 3922 39df +3459 34a0 39de 39df +345b 345a 3923 39e0 +345a 34a1 39df 39e0 +345c 345b 3924 39e1 +345b 34a2 39e0 39e1 +345d 345c 3925 39e2 +345c 34a3 39e1 39e2 +345e 345d 3926 39e3 +345d 34a4 39e2 39e3 +345f 345e 3927 39e4 +345e 34a5 39e3 39e4 +3460 345f 3928 39e5 +345f 34a6 39e4 39e5 +3461 3460 3929 39e6 +3460 34a7 39e5 39e6 +3462 3461 392a 39e7 +3461 34a8 39e6 39e7 +3463 3462 392b 39e8 +3462 34a9 39e7 39e8 +3464 3463 392c 39e9 +3463 34aa 39e8 39e9 +3465 3464 392d 39ea +3464 34ab 39e9 39ea +3466 3465 392e 39eb +3465 34ac 39ea 39eb +3467 3466 392f 39ec +3466 34ad 39eb 39ec +3468 3467 3930 39ed +3467 34ae 39ec 39ed +3469 3468 3931 39ee +3468 34af 39ed 39ee +346a 3469 3932 39ef +3469 34b0 39ee 39ef +346b 346a 3933 39f0 +346a 34b1 39ef 39f0 +346c 346b 3934 39f1 +346b 34b2 39f0 39f1 +346d 346c 3935 39f2 +346c 34b3 39f1 39f2 +346e 346d 3936 39f3 +346d 34b4 39f2 39f3 +346f 346e 3937 39f4 +346e 34b5 39f3 39f4 +3470 346f 3938 39f5 +346f 34b6 39f4 39f5 +3471 3470 3939 39f6 +3470 34b7 39f5 39f6 +3472 3471 393a 39f7 +3471 34b8 39f6 39f7 +3473 3472 393b 39f8 +3472 34b9 39f7 39f8 +3474 3473 393c 39f9 +3473 34ba 39f8 39f9 +3475 3474 393d 39fa +3474 34bb 39f9 39fa +3476 3475 393e 39fb +3475 34bc 39fa 39fb +3477 3476 393f 39fc +3476 34bd 39fb 39fc +3478 3477 3940 39fd +3477 34be 39fc 39fd +3479 3478 3941 39fe +3478 34bf 39fd 39fe +347a 3479 3942 39ff +3479 34c0 39fe 39ff +347b 347a 3943 3a00 +347a 34c1 39ff 3a00 +347c 347b 3944 3a01 +347b 34c2 3a00 3a01 +347d 347c 3945 3a02 +347c 34c3 3a01 3a02 +347e 347d 3946 3a03 +347d 34c4 3a02 3a03 +347f 347e 3947 3a04 +347e 34c5 3a03 3a04 +3480 347f 3948 3a05 +347f 34c6 3a04 3a05 +3481 3480 3949 3a06 +3480 34c7 3a05 3a06 +3482 3481 394a 3a07 +3481 34c8 3a06 3a07 +3483 3482 394b 3a08 +3482 34c9 3a07 3a08 +3483 34ca 3a08 3a09 +3485 3484 39c3 3a80 +3484 34cb 3a7f 3a80 +3486 3485 39c4 3a81 +3485 34cc 3a80 3a81 +3487 3486 39c5 3a82 +3486 34cd 3a81 3a82 +3488 3487 39c6 3a83 +3487 34ce 3a82 3a83 +3489 3488 39c7 3a84 +3488 34cf 3a83 3a84 +348a 3489 39c8 3a85 +3489 34d0 3a84 3a85 +348b 348a 39c9 3a86 +348a 34d1 3a85 3a86 +348c 348b 39ca 3a87 +348b 34d2 3a86 3a87 +348d 348c 39cb 3a88 +348c 34d3 3a87 3a88 +348e 348d 39cc 3a89 +348d 34d4 3a88 3a89 +348f 348e 39cd 3a8a +348e 34d5 3a89 3a8a +3490 348f 39ce 3a8b +348f 34d6 3a8a 3a8b +3491 3490 39cf 3a8c +3490 34d7 3a8b 3a8c +3492 3491 39d0 3a8d +3491 34d8 3a8c 3a8d +3493 3492 39d1 3a8e +3492 34d9 3a8d 3a8e +3494 3493 39d2 3a8f +3493 34da 3a8e 3a8f +3495 3494 39d3 3a90 +3494 34db 3a8f 3a90 +3496 3495 39d4 3a91 +3495 34dc 3a90 3a91 +3497 3496 39d5 3a92 +3496 34dd 3a91 3a92 +3498 3497 39d6 3a93 +3497 34de 3a92 3a93 +3499 3498 39d7 3a94 +3498 34df 3a93 3a94 +349a 3499 39d8 3a95 +3499 34e0 3a94 3a95 +349b 349a 39d9 3a96 +349a 34e1 3a95 3a96 +349c 349b 39da 3a97 +349b 34e2 3a96 3a97 +349d 349c 39db 3a98 +349c 34e3 3a97 3a98 +349e 349d 39dc 3a99 +349d 34e4 3a98 3a99 +349f 349e 39dd 3a9a +349e 34e5 3a99 3a9a +34a0 349f 39de 3a9b +349f 34e6 3a9a 3a9b +34a1 34a0 39df 3a9c +34a0 34e7 3a9b 3a9c +34a2 34a1 39e0 3a9d +34a1 34e8 3a9c 3a9d +34a3 34a2 39e1 3a9e +34a2 34e9 3a9d 3a9e +34a4 34a3 39e2 3a9f +34a3 34ea 3a9e 3a9f +34a5 34a4 39e3 3aa0 +34a4 34eb 3a9f 3aa0 +34a6 34a5 39e4 3aa1 +34a5 34ec 3aa0 3aa1 +34a7 34a6 39e5 3aa2 +34a6 34ed 3aa1 3aa2 +34a8 34a7 39e6 3aa3 +34a7 34ee 3aa2 3aa3 +34a9 34a8 39e7 3aa4 +34a8 34ef 3aa3 3aa4 +34aa 34a9 39e8 3aa5 +34a9 34f0 3aa4 3aa5 +34ab 34aa 39e9 3aa6 +34aa 34f1 3aa5 3aa6 +34ac 34ab 39ea 3aa7 +34ab 34f2 3aa6 3aa7 +34ad 34ac 39eb 3aa8 +34ac 34f3 3aa7 3aa8 +34ae 34ad 39ec 3aa9 +34ad 34f4 3aa8 3aa9 +34af 34ae 39ed 3aaa +34ae 34f5 3aa9 3aaa +34b0 34af 39ee 3aab +34af 34f6 3aaa 3aab +34b1 34b0 39ef 3aac +34b0 34f7 3aab 3aac +34b2 34b1 39f0 3aad +34b1 34f8 3aac 3aad +34b3 34b2 39f1 3aae +34b2 34f9 3aad 3aae +34b4 34b3 39f2 3aaf +34b3 34fa 3aae 3aaf +34b5 34b4 39f3 3ab0 +34b4 34fb 3aaf 3ab0 +34b6 34b5 39f4 3ab1 +34b5 34fc 3ab0 3ab1 +34b7 34b6 39f5 3ab2 +34b6 34fd 3ab1 3ab2 +34b8 34b7 39f6 3ab3 +34b7 34fe 3ab2 3ab3 +34b9 34b8 39f7 3ab4 +34b8 34ff 3ab3 3ab4 +34ba 34b9 39f8 3ab5 +34b9 3500 3ab4 3ab5 +34bb 34ba 39f9 3ab6 +34ba 3501 3ab5 3ab6 +34bc 34bb 39fa 3ab7 +34bb 3502 3ab6 3ab7 +34bd 34bc 39fb 3ab8 +34bc 3503 3ab7 3ab8 +34be 34bd 39fc 3ab9 +34bd 3504 3ab8 3ab9 +34bf 34be 39fd 3aba +34be 3505 3ab9 3aba +34c0 34bf 39fe 3abb +34bf 3506 3aba 3abb +34c1 34c0 39ff 3abc +34c0 3507 3abb 3abc +34c2 34c1 3a00 3abd +34c1 3508 3abc 3abd +34c3 34c2 3a01 3abe +34c2 3509 3abd 3abe +34c4 34c3 3a02 3abf +34c3 350a 3abe 3abf +34c5 34c4 3a03 3ac0 +34c4 350b 3abf 3ac0 +34c6 34c5 3a04 3ac1 +34c5 350c 3ac0 3ac1 +34c7 34c6 3a05 3ac2 +34c6 350d 3ac1 3ac2 +34c8 34c7 3a06 3ac3 +34c7 350e 3ac2 3ac3 +34c9 34c8 3a07 3ac4 +34c8 350f 3ac3 3ac4 +34ca 34c9 3a08 3ac5 +34c9 3510 3ac4 3ac5 +34ca 3511 3ac5 3ac6 +34cc 34cb 3a80 3b3d +34cb 3512 3b3c 3b3d +34cd 34cc 3a81 3b3e +34cc 3513 3b3d 3b3e +34ce 34cd 3a82 3b3f +34cd 3514 3b3e 3b3f +34cf 34ce 3a83 3b40 +34ce 3515 3b3f 3b40 +34d0 34cf 3a84 3b41 +34cf 3516 3b40 3b41 +34d1 34d0 3a85 3b42 +34d0 3517 3b41 3b42 +34d2 34d1 3a86 3b43 +34d1 3518 3b42 3b43 +34d3 34d2 3a87 3b44 +34d2 3519 3b43 3b44 +34d4 34d3 3a88 3b45 +34d3 351a 3b44 3b45 +34d5 34d4 3a89 3b46 +34d4 351b 3b45 3b46 +34d6 34d5 3a8a 3b47 +34d5 351c 3b46 3b47 +34d7 34d6 3a8b 3b48 +34d6 351d 3b47 3b48 +34d8 34d7 3a8c 3b49 +34d7 351e 3b48 3b49 +34d9 34d8 3a8d 3b4a +34d8 351f 3b49 3b4a +34da 34d9 3a8e 3b4b +34d9 3520 3b4a 3b4b +34db 34da 3a8f 3b4c +34da 3521 3b4b 3b4c +34dc 34db 3a90 3b4d +34db 3522 3b4c 3b4d +34dd 34dc 3a91 3b4e +34dc 3523 3b4d 3b4e +34de 34dd 3a92 3b4f +34dd 3524 3b4e 3b4f +34df 34de 3a93 3b50 +34de 3525 3b4f 3b50 +34e0 34df 3a94 3b51 +34df 3526 3b50 3b51 +34e1 34e0 3a95 3b52 +34e0 3527 3b51 3b52 +34e2 34e1 3a96 3b53 +34e1 3528 3b52 3b53 +34e3 34e2 3a97 3b54 +34e2 3529 3b53 3b54 +34e4 34e3 3a98 3b55 +34e3 352a 3b54 3b55 +34e5 34e4 3a99 3b56 +34e4 352b 3b55 3b56 +34e6 34e5 3a9a 3b57 +34e5 352c 3b56 3b57 +34e7 34e6 3a9b 3b58 +34e6 352d 3b57 3b58 +34e8 34e7 3a9c 3b59 +34e7 352e 3b58 3b59 +34e9 34e8 3a9d 3b5a +34e8 352f 3b59 3b5a +34ea 34e9 3a9e 3b5b +34e9 3530 3b5a 3b5b +34eb 34ea 3a9f 3b5c +34ea 3531 3b5b 3b5c +34ec 34eb 3aa0 3b5d +34eb 3532 3b5c 3b5d +34ed 34ec 3aa1 3b5e +34ec 3533 3b5d 3b5e +34ee 34ed 3aa2 3b5f +34ed 3534 3b5e 3b5f +34ef 34ee 3aa3 3b60 +34ee 3535 3b5f 3b60 +34f0 34ef 3aa4 3b61 +34ef 3536 3b60 3b61 +34f1 34f0 3aa5 3b62 +34f0 3537 3b61 3b62 +34f2 34f1 3aa6 3b63 +34f1 3538 3b62 3b63 +34f3 34f2 3aa7 3b64 +34f2 3539 3b63 3b64 +34f4 34f3 3aa8 3b65 +34f3 353a 3b64 3b65 +34f5 34f4 3aa9 3b66 +34f4 353b 3b65 3b66 +34f6 34f5 3aaa 3b67 +34f5 353c 3b66 3b67 +34f7 34f6 3aab 3b68 +34f6 353d 3b67 3b68 +34f8 34f7 3aac 3b69 +34f7 353e 3b68 3b69 +34f9 34f8 3aad 3b6a +34f8 353f 3b69 3b6a +34fa 34f9 3aae 3b6b +34f9 3540 3b6a 3b6b +34fb 34fa 3aaf 3b6c +34fa 3541 3b6b 3b6c +34fc 34fb 3ab0 3b6d +34fb 3542 3b6c 3b6d +34fd 34fc 3ab1 3b6e +34fc 3543 3b6d 3b6e +34fe 34fd 3ab2 3b6f +34fd 3544 3b6e 3b6f +34ff 34fe 3ab3 3b70 +34fe 3545 3b6f 3b70 +3500 34ff 3ab4 3b71 +34ff 3546 3b70 3b71 +3501 3500 3ab5 3b72 +3500 3547 3b71 3b72 +3502 3501 3ab6 3b73 +3501 3548 3b72 3b73 +3503 3502 3ab7 3b74 +3502 3549 3b73 3b74 +3504 3503 3ab8 3b75 +3503 354a 3b74 3b75 +3505 3504 3ab9 3b76 +3504 354b 3b75 3b76 +3506 3505 3aba 3b77 +3505 354c 3b76 3b77 +3507 3506 3abb 3b78 +3506 354d 3b77 3b78 +3508 3507 3abc 3b79 +3507 354e 3b78 3b79 +3509 3508 3abd 3b7a +3508 354f 3b79 3b7a +350a 3509 3abe 3b7b +3509 3550 3b7a 3b7b +350b 350a 3abf 3b7c +350a 3551 3b7b 3b7c +350c 350b 3ac0 3b7d +350b 3552 3b7c 3b7d +350d 350c 3ac1 3b7e +350c 3553 3b7d 3b7e +350e 350d 3ac2 3b7f +350d 3554 3b7e 3b7f +350f 350e 3ac3 3b80 +350e 3555 3b7f 3b80 +3510 350f 3ac4 3b81 +350f 3556 3b80 3b81 +3511 3510 3ac5 3b82 +3510 3557 3b81 3b82 +3511 3558 3b82 3b83 +3513 3512 3b3d 3bfa +3512 3559 3bf9 3bfa +3514 3513 3b3e 3bfb +3513 355a 3bfa 3bfb +3515 3514 3b3f 3bfc +3514 355b 3bfb 3bfc +3516 3515 3b40 3bfd +3515 355c 3bfc 3bfd +3517 3516 3b41 3bfe +3516 355d 3bfd 3bfe +3518 3517 3b42 3bff +3517 355e 3bfe 3bff +3519 3518 3b43 3c00 +3518 355f 3bff 3c00 +351a 3519 3b44 3c01 +3519 3560 3c00 3c01 +351b 351a 3b45 3c02 +351a 3561 3c01 3c02 +351c 351b 3b46 3c03 +351b 3562 3c02 3c03 +351d 351c 3b47 3c04 +351c 3563 3c03 3c04 +351e 351d 3b48 3c05 +351d 3564 3c04 3c05 +351f 351e 3b49 3c06 +351e 3565 3c05 3c06 +3520 351f 3b4a 3c07 +351f 3566 3c06 3c07 +3521 3520 3b4b 3c08 +3520 3567 3c07 3c08 +3522 3521 3b4c 3c09 +3521 3568 3c08 3c09 +3523 3522 3b4d 3c0a +3522 3569 3c09 3c0a +3524 3523 3b4e 3c0b +3523 356a 3c0a 3c0b +3525 3524 3b4f 3c0c +3524 356b 3c0b 3c0c +3526 3525 3b50 3c0d +3525 356c 3c0c 3c0d +3527 3526 3b51 3c0e +3526 356d 3c0d 3c0e +3528 3527 3b52 3c0f +3527 356e 3c0e 3c0f +3529 3528 3b53 3c10 +3528 356f 3c0f 3c10 +352a 3529 3b54 3c11 +3529 3570 3c10 3c11 +352b 352a 3b55 3c12 +352a 3571 3c11 3c12 +352c 352b 3b56 3c13 +352b 3572 3c12 3c13 +352d 352c 3b57 3c14 +352c 3573 3c13 3c14 +352e 352d 3b58 3c15 +352d 3574 3c14 3c15 +352f 352e 3b59 3c16 +352e 3575 3c15 3c16 +3530 352f 3b5a 3c17 +352f 3576 3c16 3c17 +3531 3530 3b5b 3c18 +3530 3577 3c17 3c18 +3532 3531 3b5c 3c19 +3531 3578 3c18 3c19 +3533 3532 3b5d 3c1a +3532 3579 3c19 3c1a +3534 3533 3b5e 3c1b +3533 357a 3c1a 3c1b +3535 3534 3b5f 3c1c +3534 357b 3c1b 3c1c +3536 3535 3b60 3c1d +3535 357c 3c1c 3c1d +3537 3536 3b61 3c1e +3536 357d 3c1d 3c1e +3538 3537 3b62 3c1f +3537 357e 3c1e 3c1f +3539 3538 3b63 3c20 +3538 357f 3c1f 3c20 +353a 3539 3b64 3c21 +3539 3580 3c20 3c21 +353b 353a 3b65 3c22 +353a 3581 3c21 3c22 +353c 353b 3b66 3c23 +353b 3582 3c22 3c23 +353d 353c 3b67 3c24 +353c 3583 3c23 3c24 +353e 353d 3b68 3c25 +353d 3584 3c24 3c25 +353f 353e 3b69 3c26 +353e 3585 3c25 3c26 +3540 353f 3b6a 3c27 +353f 3586 3c26 3c27 +3541 3540 3b6b 3c28 +3540 3587 3c27 3c28 +3542 3541 3b6c 3c29 +3541 3588 3c28 3c29 +3543 3542 3b6d 3c2a +3542 3589 3c29 3c2a +3544 3543 3b6e 3c2b +3543 358a 3c2a 3c2b +3545 3544 3b6f 3c2c +3544 358b 3c2b 3c2c +3546 3545 3b70 3c2d +3545 358c 3c2c 3c2d +3547 3546 3b71 3c2e +3546 358d 3c2d 3c2e +3548 3547 3b72 3c2f +3547 358e 3c2e 3c2f +3549 3548 3b73 3c30 +3548 358f 3c2f 3c30 +354a 3549 3b74 3c31 +3549 3590 3c30 3c31 +354b 354a 3b75 3c32 +354a 3591 3c31 3c32 +354c 354b 3b76 3c33 +354b 3592 3c32 3c33 +354d 354c 3b77 3c34 +354c 3593 3c33 3c34 +354e 354d 3b78 3c35 +354d 3594 3c34 3c35 +354f 354e 3b79 3c36 +354e 3595 3c35 3c36 +3550 354f 3b7a 3c37 +354f 3596 3c36 3c37 +3551 3550 3b7b 3c38 +3550 3597 3c37 3c38 +3552 3551 3b7c 3c39 +3551 3598 3c38 3c39 +3553 3552 3b7d 3c3a +3552 3599 3c39 3c3a +3554 3553 3b7e 3c3b +3553 359a 3c3a 3c3b +3555 3554 3b7f 3c3c +3554 359b 3c3b 3c3c +3556 3555 3b80 3c3d +3555 359c 3c3c 3c3d +3557 3556 3b81 3c3e +3556 359d 3c3d 3c3e +3558 3557 3b82 3c3f +3557 359e 3c3e 3c3f +3558 359f 3c3f 3c40 +355a 3559 3bfa 3cb7 +3559 35a0 3cb6 3cb7 +355b 355a 3bfb 3cb8 +355a 35a1 3cb7 3cb8 +355c 355b 3bfc 3cb9 +355b 35a2 3cb8 3cb9 +355d 355c 3bfd 3cba +355c 35a3 3cb9 3cba +355e 355d 3bfe 3cbb +355d 35a4 3cba 3cbb +355f 355e 3bff 3cbc +355e 35a5 3cbb 3cbc +3560 355f 3c00 3cbd +355f 35a6 3cbc 3cbd +3561 3560 3c01 3cbe +3560 35a7 3cbd 3cbe +3562 3561 3c02 3cbf +3561 35a8 3cbe 3cbf +3563 3562 3c03 3cc0 +3562 35a9 3cbf 3cc0 +3564 3563 3c04 3cc1 +3563 35aa 3cc0 3cc1 +3565 3564 3c05 3cc2 +3564 35ab 3cc1 3cc2 +3566 3565 3c06 3cc3 +3565 35ac 3cc2 3cc3 +3567 3566 3c07 3cc4 +3566 35ad 3cc3 3cc4 +3568 3567 3c08 3cc5 +3567 35ae 3cc4 3cc5 +3569 3568 3c09 3cc6 +3568 35af 3cc5 3cc6 +356a 3569 3c0a 3cc7 +3569 35b0 3cc6 3cc7 +356b 356a 3c0b 3cc8 +356a 35b1 3cc7 3cc8 +356c 356b 3c0c 3cc9 +356b 35b2 3cc8 3cc9 +356d 356c 3c0d 3cca +356c 35b3 3cc9 3cca +356e 356d 3c0e 3ccb +356d 35b4 3cca 3ccb +356f 356e 3c0f 3ccc +356e 35b5 3ccb 3ccc +3570 356f 3c10 3ccd +356f 35b6 3ccc 3ccd +3571 3570 3c11 3cce +3570 35b7 3ccd 3cce +3572 3571 3c12 3ccf +3571 35b8 3cce 3ccf +3573 3572 3c13 3cd0 +3572 35b9 3ccf 3cd0 +3574 3573 3c14 3cd1 +3573 35ba 3cd0 3cd1 +3575 3574 3c15 3cd2 +3574 35bb 3cd1 3cd2 +3576 3575 3c16 3cd3 +3575 35bc 3cd2 3cd3 +3577 3576 3c17 3cd4 +3576 35bd 3cd3 3cd4 +3578 3577 3c18 3cd5 +3577 35be 3cd4 3cd5 +3579 3578 3c19 3cd6 +3578 35bf 3cd5 3cd6 +357a 3579 3c1a 3cd7 +3579 35c0 3cd6 3cd7 +357b 357a 3c1b 3cd8 +357a 35c1 3cd7 3cd8 +357c 357b 3c1c 3cd9 +357b 35c2 3cd8 3cd9 +357d 357c 3c1d 3cda +357c 35c3 3cd9 3cda +357e 357d 3c1e 3cdb +357d 35c4 3cda 3cdb +357f 357e 3c1f 3cdc +357e 35c5 3cdb 3cdc +3580 357f 3c20 3cdd +357f 35c6 3cdc 3cdd +3581 3580 3c21 3cde +3580 35c7 3cdd 3cde +3582 3581 3c22 3cdf +3581 35c8 3cde 3cdf +3583 3582 3c23 3ce0 +3582 35c9 3cdf 3ce0 +3584 3583 3c24 3ce1 +3583 35ca 3ce0 3ce1 +3585 3584 3c25 3ce2 +3584 35cb 3ce1 3ce2 +3586 3585 3c26 3ce3 +3585 35cc 3ce2 3ce3 +3587 3586 3c27 3ce4 +3586 35cd 3ce3 3ce4 +3588 3587 3c28 3ce5 +3587 35ce 3ce4 3ce5 +3589 3588 3c29 3ce6 +3588 35cf 3ce5 3ce6 +358a 3589 3c2a 3ce7 +3589 35d0 3ce6 3ce7 +358b 358a 3c2b 3ce8 +358a 35d1 3ce7 3ce8 +358c 358b 3c2c 3ce9 +358b 35d2 3ce8 3ce9 +358d 358c 3c2d 3cea +358c 35d3 3ce9 3cea +358e 358d 3c2e 3ceb +358d 35d4 3cea 3ceb +358f 358e 3c2f 3cec +358e 35d5 3ceb 3cec +3590 358f 3c30 3ced +358f 35d6 3cec 3ced +3591 3590 3c31 3cee +3590 35d7 3ced 3cee +3592 3591 3c32 3cef +3591 35d8 3cee 3cef +3593 3592 3c33 3cf0 +3592 35d9 3cef 3cf0 +3594 3593 3c34 3cf1 +3593 35da 3cf0 3cf1 +3595 3594 3c35 3cf2 +3594 35db 3cf1 3cf2 +3596 3595 3c36 3cf3 +3595 35dc 3cf2 3cf3 +3597 3596 3c37 3cf4 +3596 35dd 3cf3 3cf4 +3598 3597 3c38 3cf5 +3597 35de 3cf4 3cf5 +3599 3598 3c39 3cf6 +3598 35df 3cf5 3cf6 +359a 3599 3c3a 3cf7 +3599 35e0 3cf6 3cf7 +359b 359a 3c3b 3cf8 +359a 35e1 3cf7 3cf8 +359c 359b 3c3c 3cf9 +359b 35e2 3cf8 3cf9 +359d 359c 3c3d 3cfa +359c 35e3 3cf9 3cfa +359e 359d 3c3e 3cfb +359d 35e4 3cfa 3cfb +359f 359e 3c3f 3cfc +359e 35e5 3cfb 3cfc +359f 35e6 3cfc 3cfd +35a1 35a0 3cb7 3d74 +35a0 35e7 3d73 3d74 +35a2 35a1 3cb8 3d75 +35a1 35e8 3d74 3d75 +35a3 35a2 3cb9 3d76 +35a2 35e9 3d75 3d76 +35a4 35a3 3cba 3d77 +35a3 35ea 3d76 3d77 +35a5 35a4 3cbb 3d78 +35a4 35eb 3d77 3d78 +35a6 35a5 3cbc 3d79 +35a5 35ec 3d78 3d79 +35a7 35a6 3cbd 3d7a +35a6 35ed 3d79 3d7a +35a8 35a7 3cbe 3d7b +35a7 35ee 3d7a 3d7b +35a9 35a8 3cbf 3d7c +35a8 35ef 3d7b 3d7c +35aa 35a9 3cc0 3d7d +35a9 35f0 3d7c 3d7d +35ab 35aa 3cc1 3d7e +35aa 35f1 3d7d 3d7e +35ac 35ab 3cc2 3d7f +35ab 35f2 3d7e 3d7f +35ad 35ac 3cc3 3d80 +35ac 35f3 3d7f 3d80 +35ae 35ad 3cc4 3d81 +35ad 35f4 3d80 3d81 +35af 35ae 3cc5 3d82 +35ae 35f5 3d81 3d82 +35b0 35af 3cc6 3d83 +35af 35f6 3d82 3d83 +35b1 35b0 3cc7 3d84 +35b0 35f7 3d83 3d84 +35b2 35b1 3cc8 3d85 +35b1 35f8 3d84 3d85 +35b3 35b2 3cc9 3d86 +35b2 35f9 3d85 3d86 +35b4 35b3 3cca 3d87 +35b3 35fa 3d86 3d87 +35b5 35b4 3ccb 3d88 +35b4 35fb 3d87 3d88 +35b6 35b5 3ccc 3d89 +35b5 35fc 3d88 3d89 +35b7 35b6 3ccd 3d8a +35b6 35fd 3d89 3d8a +35b8 35b7 3cce 3d8b +35b7 35fe 3d8a 3d8b +35b9 35b8 3ccf 3d8c +35b8 35ff 3d8b 3d8c +35ba 35b9 3cd0 3d8d +35b9 3600 3d8c 3d8d +35bb 35ba 3cd1 3d8e +35ba 3601 3d8d 3d8e +35bc 35bb 3cd2 3d8f +35bb 3602 3d8e 3d8f +35bd 35bc 3cd3 3d90 +35bc 3603 3d8f 3d90 +35be 35bd 3cd4 3d91 +35bd 3604 3d90 3d91 +35bf 35be 3cd5 3d92 +35be 3605 3d91 3d92 +35c0 35bf 3cd6 3d93 +35bf 3606 3d92 3d93 +35c1 35c0 3cd7 3d94 +35c0 3607 3d93 3d94 +35c2 35c1 3cd8 3d95 +35c1 3608 3d94 3d95 +35c3 35c2 3cd9 3d96 +35c2 3609 3d95 3d96 +35c4 35c3 3cda 3d97 +35c3 360a 3d96 3d97 +35c5 35c4 3cdb 3d98 +35c4 360b 3d97 3d98 +35c6 35c5 3cdc 3d99 +35c5 360c 3d98 3d99 +35c7 35c6 3cdd 3d9a +35c6 360d 3d99 3d9a +35c8 35c7 3cde 3d9b +35c7 360e 3d9a 3d9b +35c9 35c8 3cdf 3d9c +35c8 360f 3d9b 3d9c +35ca 35c9 3ce0 3d9d +35c9 3610 3d9c 3d9d +35cb 35ca 3ce1 3d9e +35ca 3611 3d9d 3d9e +35cc 35cb 3ce2 3d9f +35cb 3612 3d9e 3d9f +35cd 35cc 3ce3 3da0 +35cc 3613 3d9f 3da0 +35ce 35cd 3ce4 3da1 +35cd 3614 3da0 3da1 +35cf 35ce 3ce5 3da2 +35ce 3615 3da1 3da2 +35d0 35cf 3ce6 3da3 +35cf 3616 3da2 3da3 +35d1 35d0 3ce7 3da4 +35d0 3617 3da3 3da4 +35d2 35d1 3ce8 3da5 +35d1 3618 3da4 3da5 +35d3 35d2 3ce9 3da6 +35d2 3619 3da5 3da6 +35d4 35d3 3cea 3da7 +35d3 361a 3da6 3da7 +35d5 35d4 3ceb 3da8 +35d4 361b 3da7 3da8 +35d6 35d5 3cec 3da9 +35d5 361c 3da8 3da9 +35d7 35d6 3ced 3daa +35d6 361d 3da9 3daa +35d8 35d7 3cee 3dab +35d7 361e 3daa 3dab +35d9 35d8 3cef 3dac +35d8 361f 3dab 3dac +35da 35d9 3cf0 3dad +35d9 3620 3dac 3dad +35db 35da 3cf1 3dae +35da 3621 3dad 3dae +35dc 35db 3cf2 3daf +35db 3622 3dae 3daf +35dd 35dc 3cf3 3db0 +35dc 3623 3daf 3db0 +35de 35dd 3cf4 3db1 +35dd 3624 3db0 3db1 +35df 35de 3cf5 3db2 +35de 3625 3db1 3db2 +35e0 35df 3cf6 3db3 +35df 3626 3db2 3db3 +35e1 35e0 3cf7 3db4 +35e0 3627 3db3 3db4 +35e2 35e1 3cf8 3db5 +35e1 3628 3db4 3db5 +35e3 35e2 3cf9 3db6 +35e2 3629 3db5 3db6 +35e4 35e3 3cfa 3db7 +35e3 362a 3db6 3db7 +35e5 35e4 3cfb 3db8 +35e4 362b 3db7 3db8 +35e6 35e5 3cfc 3db9 +35e5 362c 3db8 3db9 +35e6 362d 3db9 3dba +35e8 35e7 3d74 3e31 +35e7 362e 3e30 3e31 +35e9 35e8 3d75 3e32 +35e8 362f 3e31 3e32 +35ea 35e9 3d76 3e33 +35e9 3630 3e32 3e33 +35eb 35ea 3d77 3e34 +35ea 3631 3e33 3e34 +35ec 35eb 3d78 3e35 +35eb 3632 3e34 3e35 +35ed 35ec 3d79 3e36 +35ec 3633 3e35 3e36 +35ee 35ed 3d7a 3e37 +35ed 3634 3e36 3e37 +35ef 35ee 3d7b 3e38 +35ee 3635 3e37 3e38 +35f0 35ef 3d7c 3e39 +35ef 3636 3e38 3e39 +35f1 35f0 3d7d 3e3a +35f0 3637 3e39 3e3a +35f2 35f1 3d7e 3e3b +35f1 3638 3e3a 3e3b +35f3 35f2 3d7f 3e3c +35f2 3639 3e3b 3e3c +35f4 35f3 3d80 3e3d +35f3 363a 3e3c 3e3d +35f5 35f4 3d81 3e3e +35f4 363b 3e3d 3e3e +35f6 35f5 3d82 3e3f +35f5 363c 3e3e 3e3f +35f7 35f6 3d83 3e40 +35f6 363d 3e3f 3e40 +35f8 35f7 3d84 3e41 +35f7 363e 3e40 3e41 +35f9 35f8 3d85 3e42 +35f8 363f 3e41 3e42 +35fa 35f9 3d86 3e43 +35f9 3640 3e42 3e43 +35fb 35fa 3d87 3e44 +35fa 3641 3e43 3e44 +35fc 35fb 3d88 3e45 +35fb 3642 3e44 3e45 +35fd 35fc 3d89 3e46 +35fc 3643 3e45 3e46 +35fe 35fd 3d8a 3e47 +35fd 3644 3e46 3e47 +35ff 35fe 3d8b 3e48 +35fe 3645 3e47 3e48 +3600 35ff 3d8c 3e49 +35ff 3646 3e48 3e49 +3601 3600 3d8d 3e4a +3600 3647 3e49 3e4a +3602 3601 3d8e 3e4b +3601 3648 3e4a 3e4b +3603 3602 3d8f 3e4c +3602 3649 3e4b 3e4c +3604 3603 3d90 3e4d +3603 364a 3e4c 3e4d +3605 3604 3d91 3e4e +3604 364b 3e4d 3e4e +3606 3605 3d92 3e4f +3605 364c 3e4e 3e4f +3607 3606 3d93 3e50 +3606 364d 3e4f 3e50 +3608 3607 3d94 3e51 +3607 364e 3e50 3e51 +3609 3608 3d95 3e52 +3608 364f 3e51 3e52 +360a 3609 3d96 3e53 +3609 3650 3e52 3e53 +360b 360a 3d97 3e54 +360a 3651 3e53 3e54 +360c 360b 3d98 3e55 +360b 3652 3e54 3e55 +360d 360c 3d99 3e56 +360c 3653 3e55 3e56 +360e 360d 3d9a 3e57 +360d 3654 3e56 3e57 +360f 360e 3d9b 3e58 +360e 3655 3e57 3e58 +3610 360f 3d9c 3e59 +360f 3656 3e58 3e59 +3611 3610 3d9d 3e5a +3610 3657 3e59 3e5a +3612 3611 3d9e 3e5b +3611 3658 3e5a 3e5b +3613 3612 3d9f 3e5c +3612 3659 3e5b 3e5c +3614 3613 3da0 3e5d +3613 365a 3e5c 3e5d +3615 3614 3da1 3e5e +3614 365b 3e5d 3e5e +3616 3615 3da2 3e5f +3615 365c 3e5e 3e5f +3617 3616 3da3 3e60 +3616 365d 3e5f 3e60 +3618 3617 3da4 3e61 +3617 365e 3e60 3e61 +3619 3618 3da5 3e62 +3618 365f 3e61 3e62 +361a 3619 3da6 3e63 +3619 3660 3e62 3e63 +361b 361a 3da7 3e64 +361a 3661 3e63 3e64 +361c 361b 3da8 3e65 +361b 3662 3e64 3e65 +361d 361c 3da9 3e66 +361c 3663 3e65 3e66 +361e 361d 3daa 3e67 +361d 3664 3e66 3e67 +361f 361e 3dab 3e68 +361e 3665 3e67 3e68 +3620 361f 3dac 3e69 +361f 3666 3e68 3e69 +3621 3620 3dad 3e6a +3620 3667 3e69 3e6a +3622 3621 3dae 3e6b +3621 3668 3e6a 3e6b +3623 3622 3daf 3e6c +3622 3669 3e6b 3e6c +3624 3623 3db0 3e6d +3623 366a 3e6c 3e6d +3625 3624 3db1 3e6e +3624 366b 3e6d 3e6e +3626 3625 3db2 3e6f +3625 366c 3e6e 3e6f +3627 3626 3db3 3e70 +3626 366d 3e6f 3e70 +3628 3627 3db4 3e71 +3627 366e 3e70 3e71 +3629 3628 3db5 3e72 +3628 366f 3e71 3e72 +362a 3629 3db6 3e73 +3629 3670 3e72 3e73 +362b 362a 3db7 3e74 +362a 3671 3e73 3e74 +362c 362b 3db8 3e75 +362b 3672 3e74 3e75 +362d 362c 3db9 3e76 +362c 3673 3e75 3e76 +362d 3674 3e76 3e77 +362f 362e 3e31 3eee +362e 3675 3eed 3eee +3630 362f 3e32 3eef +362f 3676 3eee 3eef +3631 3630 3e33 3ef0 +3630 3677 3eef 3ef0 +3632 3631 3e34 3ef1 +3631 3678 3ef0 3ef1 +3633 3632 3e35 3ef2 +3632 3679 3ef1 3ef2 +3634 3633 3e36 3ef3 +3633 367a 3ef2 3ef3 +3635 3634 3e37 3ef4 +3634 367b 3ef3 3ef4 +3636 3635 3e38 3ef5 +3635 367c 3ef4 3ef5 +3637 3636 3e39 3ef6 +3636 367d 3ef5 3ef6 +3638 3637 3e3a 3ef7 +3637 367e 3ef6 3ef7 +3639 3638 3e3b 3ef8 +3638 367f 3ef7 3ef8 +363a 3639 3e3c 3ef9 +3639 3680 3ef8 3ef9 +363b 363a 3e3d 3efa +363a 3681 3ef9 3efa +363c 363b 3e3e 3efb +363b 3682 3efa 3efb +363d 363c 3e3f 3efc +363c 3683 3efb 3efc +363e 363d 3e40 3efd +363d 3684 3efc 3efd +363f 363e 3e41 3efe +363e 3685 3efd 3efe +3640 363f 3e42 3eff +363f 3686 3efe 3eff +3641 3640 3e43 3f00 +3640 3687 3eff 3f00 +3642 3641 3e44 3f01 +3641 3688 3f00 3f01 +3643 3642 3e45 3f02 +3642 3689 3f01 3f02 +3644 3643 3e46 3f03 +3643 368a 3f02 3f03 +3645 3644 3e47 3f04 +3644 368b 3f03 3f04 +3646 3645 3e48 3f05 +3645 368c 3f04 3f05 +3647 3646 3e49 3f06 +3646 368d 3f05 3f06 +3648 3647 3e4a 3f07 +3647 368e 3f06 3f07 +3649 3648 3e4b 3f08 +3648 368f 3f07 3f08 +364a 3649 3e4c 3f09 +3649 3690 3f08 3f09 +364b 364a 3e4d 3f0a +364a 3691 3f09 3f0a +364c 364b 3e4e 3f0b +364b 3692 3f0a 3f0b +364d 364c 3e4f 3f0c +364c 3693 3f0b 3f0c +364e 364d 3e50 3f0d +364d 3694 3f0c 3f0d +364f 364e 3e51 3f0e +364e 3695 3f0d 3f0e +3650 364f 3e52 3f0f +364f 3696 3f0e 3f0f +3651 3650 3e53 3f10 +3650 3697 3f0f 3f10 +3652 3651 3e54 3f11 +3651 3698 3f10 3f11 +3653 3652 3e55 3f12 +3652 3699 3f11 3f12 +3654 3653 3e56 3f13 +3653 369a 3f12 3f13 +3655 3654 3e57 3f14 +3654 369b 3f13 3f14 +3656 3655 3e58 3f15 +3655 369c 3f14 3f15 +3657 3656 3e59 3f16 +3656 369d 3f15 3f16 +3658 3657 3e5a 3f17 +3657 369e 3f16 3f17 +3659 3658 3e5b 3f18 +3658 369f 3f17 3f18 +365a 3659 3e5c 3f19 +3659 36a0 3f18 3f19 +365b 365a 3e5d 3f1a +365a 36a1 3f19 3f1a +365c 365b 3e5e 3f1b +365b 36a2 3f1a 3f1b +365d 365c 3e5f 3f1c +365c 36a3 3f1b 3f1c +365e 365d 3e60 3f1d +365d 36a4 3f1c 3f1d +365f 365e 3e61 3f1e +365e 36a5 3f1d 3f1e +3660 365f 3e62 3f1f +365f 36a6 3f1e 3f1f +3661 3660 3e63 3f20 +3660 36a7 3f1f 3f20 +3662 3661 3e64 3f21 +3661 36a8 3f20 3f21 +3663 3662 3e65 3f22 +3662 36a9 3f21 3f22 +3664 3663 3e66 3f23 +3663 36aa 3f22 3f23 +3665 3664 3e67 3f24 +3664 36ab 3f23 3f24 +3666 3665 3e68 3f25 +3665 36ac 3f24 3f25 +3667 3666 3e69 3f26 +3666 36ad 3f25 3f26 +3668 3667 3e6a 3f27 +3667 36ae 3f26 3f27 +3669 3668 3e6b 3f28 +3668 36af 3f27 3f28 +366a 3669 3e6c 3f29 +3669 36b0 3f28 3f29 +366b 366a 3e6d 3f2a +366a 36b1 3f29 3f2a +366c 366b 3e6e 3f2b +366b 36b2 3f2a 3f2b +366d 366c 3e6f 3f2c +366c 36b3 3f2b 3f2c +366e 366d 3e70 3f2d +366d 36b4 3f2c 3f2d +366f 366e 3e71 3f2e +366e 36b5 3f2d 3f2e +3670 366f 3e72 3f2f +366f 36b6 3f2e 3f2f +3671 3670 3e73 3f30 +3670 36b7 3f2f 3f30 +3672 3671 3e74 3f31 +3671 36b8 3f30 3f31 +3673 3672 3e75 3f32 +3672 36b9 3f31 3f32 +3674 3673 3e76 3f33 +3673 36ba 3f32 3f33 +3674 36bb 3f33 3f34 +3676 3675 3eee 3fab +3675 36bc 3faa 3fab +3677 3676 3eef 3fac +3676 36bd 3fab 3fac +3678 3677 3ef0 3fad +3677 36be 3fac 3fad +3679 3678 3ef1 3fae +3678 36bf 3fad 3fae +367a 3679 3ef2 3faf +3679 36c0 3fae 3faf +367b 367a 3ef3 3fb0 +367a 36c1 3faf 3fb0 +367c 367b 3ef4 3fb1 +367b 36c2 3fb0 3fb1 +367d 367c 3ef5 3fb2 +367c 36c3 3fb1 3fb2 +367e 367d 3ef6 3fb3 +367d 36c4 3fb2 3fb3 +367f 367e 3ef7 3fb4 +367e 36c5 3fb3 3fb4 +3680 367f 3ef8 3fb5 +367f 36c6 3fb4 3fb5 +3681 3680 3ef9 3fb6 +3680 36c7 3fb5 3fb6 +3682 3681 3efa 3fb7 +3681 36c8 3fb6 3fb7 +3683 3682 3efb 3fb8 +3682 36c9 3fb7 3fb8 +3684 3683 3efc 3fb9 +3683 36ca 3fb8 3fb9 +3685 3684 3efd 3fba +3684 36cb 3fb9 3fba +3686 3685 3efe 3fbb +3685 36cc 3fba 3fbb +3687 3686 3eff 3fbc +3686 36cd 3fbb 3fbc +3688 3687 3f00 3fbd +3687 36ce 3fbc 3fbd +3689 3688 3f01 3fbe +3688 36cf 3fbd 3fbe +368a 3689 3f02 3fbf +3689 36d0 3fbe 3fbf +368b 368a 3f03 3fc0 +368a 36d1 3fbf 3fc0 +368c 368b 3f04 3fc1 +368b 36d2 3fc0 3fc1 +368d 368c 3f05 3fc2 +368c 36d3 3fc1 3fc2 +368e 368d 3f06 3fc3 +368d 36d4 3fc2 3fc3 +368f 368e 3f07 3fc4 +368e 36d5 3fc3 3fc4 +3690 368f 3f08 3fc5 +368f 36d6 3fc4 3fc5 +3691 3690 3f09 3fc6 +3690 36d7 3fc5 3fc6 +3692 3691 3f0a 3fc7 +3691 36d8 3fc6 3fc7 +3693 3692 3f0b 3fc8 +3692 36d9 3fc7 3fc8 +3694 3693 3f0c 3fc9 +3693 36da 3fc8 3fc9 +3695 3694 3f0d 3fca +3694 36db 3fc9 3fca +3696 3695 3f0e 3fcb +3695 36dc 3fca 3fcb +3697 3696 3f0f 3fcc +3696 36dd 3fcb 3fcc +3698 3697 3f10 3fcd +3697 36de 3fcc 3fcd +3699 3698 3f11 3fce +3698 36df 3fcd 3fce +369a 3699 3f12 3fcf +3699 36e0 3fce 3fcf +369b 369a 3f13 3fd0 +369a 36e1 3fcf 3fd0 +369c 369b 3f14 3fd1 +369b 36e2 3fd0 3fd1 +369d 369c 3f15 3fd2 +369c 36e3 3fd1 3fd2 +369e 369d 3f16 3fd3 +369d 36e4 3fd2 3fd3 +369f 369e 3f17 3fd4 +369e 36e5 3fd3 3fd4 +36a0 369f 3f18 3fd5 +369f 36e6 3fd4 3fd5 +36a1 36a0 3f19 3fd6 +36a0 36e7 3fd5 3fd6 +36a2 36a1 3f1a 3fd7 +36a1 36e8 3fd6 3fd7 +36a3 36a2 3f1b 3fd8 +36a2 36e9 3fd7 3fd8 +36a4 36a3 3f1c 3fd9 +36a3 36ea 3fd8 3fd9 +36a5 36a4 3f1d 3fda +36a4 36eb 3fd9 3fda +36a6 36a5 3f1e 3fdb +36a5 36ec 3fda 3fdb +36a7 36a6 3f1f 3fdc +36a6 36ed 3fdb 3fdc +36a8 36a7 3f20 3fdd +36a7 36ee 3fdc 3fdd +36a9 36a8 3f21 3fde +36a8 36ef 3fdd 3fde +36aa 36a9 3f22 3fdf +36a9 36f0 3fde 3fdf +36ab 36aa 3f23 3fe0 +36aa 36f1 3fdf 3fe0 +36ac 36ab 3f24 3fe1 +36ab 36f2 3fe0 3fe1 +36ad 36ac 3f25 3fe2 +36ac 36f3 3fe1 3fe2 +36ae 36ad 3f26 3fe3 +36ad 36f4 3fe2 3fe3 +36af 36ae 3f27 3fe4 +36ae 36f5 3fe3 3fe4 +36b0 36af 3f28 3fe5 +36af 36f6 3fe4 3fe5 +36b1 36b0 3f29 3fe6 +36b0 36f7 3fe5 3fe6 +36b2 36b1 3f2a 3fe7 +36b1 36f8 3fe6 3fe7 +36b3 36b2 3f2b 3fe8 +36b2 36f9 3fe7 3fe8 +36b4 36b3 3f2c 3fe9 +36b3 36fa 3fe8 3fe9 +36b5 36b4 3f2d 3fea +36b4 36fb 3fe9 3fea +36b6 36b5 3f2e 3feb +36b5 36fc 3fea 3feb +36b7 36b6 3f2f 3fec +36b6 36fd 3feb 3fec +36b8 36b7 3f30 3fed +36b7 36fe 3fec 3fed +36b9 36b8 3f31 3fee +36b8 36ff 3fed 3fee +36ba 36b9 3f32 3fef +36b9 3700 3fee 3fef +36bb 36ba 3f33 3ff0 +36ba 3701 3fef 3ff0 +36bb 3702 3ff0 3ff1 +36bd 36bc 3fab 4068 +36bc 3703 4067 4068 +36be 36bd 3fac 4069 +36bd 3704 4068 4069 +36bf 36be 3fad 406a +36be 3705 4069 406a +36c0 36bf 3fae 406b +36bf 3706 406a 406b +36c1 36c0 3faf 406c +36c0 3707 406b 406c +36c2 36c1 3fb0 406d +36c1 3708 406c 406d +36c3 36c2 3fb1 406e +36c2 3709 406d 406e +36c4 36c3 3fb2 406f +36c3 370a 406e 406f +36c5 36c4 3fb3 4070 +36c4 370b 406f 4070 +36c6 36c5 3fb4 4071 +36c5 370c 4070 4071 +36c7 36c6 3fb5 4072 +36c6 370d 4071 4072 +36c8 36c7 3fb6 4073 +36c7 370e 4072 4073 +36c9 36c8 3fb7 4074 +36c8 370f 4073 4074 +36ca 36c9 3fb8 4075 +36c9 3710 4074 4075 +36cb 36ca 3fb9 4076 +36ca 3711 4075 4076 +36cc 36cb 3fba 4077 +36cb 3712 4076 4077 +36cd 36cc 3fbb 4078 +36cc 3713 4077 4078 +36ce 36cd 3fbc 4079 +36cd 3714 4078 4079 +36cf 36ce 3fbd 407a +36ce 3715 4079 407a +36d0 36cf 3fbe 407b +36cf 3716 407a 407b +36d1 36d0 3fbf 407c +36d0 3717 407b 407c +36d2 36d1 3fc0 407d +36d1 3718 407c 407d +36d3 36d2 3fc1 407e +36d2 3719 407d 407e +36d4 36d3 3fc2 407f +36d3 371a 407e 407f +36d5 36d4 3fc3 4080 +36d4 371b 407f 4080 +36d6 36d5 3fc4 4081 +36d5 371c 4080 4081 +36d7 36d6 3fc5 4082 +36d6 371d 4081 4082 +36d8 36d7 3fc6 4083 +36d7 371e 4082 4083 +36d9 36d8 3fc7 4084 +36d8 371f 4083 4084 +36da 36d9 3fc8 4085 +36d9 3720 4084 4085 +36db 36da 3fc9 4086 +36da 3721 4085 4086 +36dc 36db 3fca 4087 +36db 3722 4086 4087 +36dd 36dc 3fcb 4088 +36dc 3723 4087 4088 +36de 36dd 3fcc 4089 +36dd 3724 4088 4089 +36df 36de 3fcd 408a +36de 3725 4089 408a +36e0 36df 3fce 408b +36df 3726 408a 408b +36e1 36e0 3fcf 408c +36e0 3727 408b 408c +36e2 36e1 3fd0 408d +36e1 3728 408c 408d +36e3 36e2 3fd1 408e +36e2 3729 408d 408e +36e4 36e3 3fd2 408f +36e3 372a 408e 408f +36e5 36e4 3fd3 4090 +36e4 372b 408f 4090 +36e6 36e5 3fd4 4091 +36e5 372c 4090 4091 +36e7 36e6 3fd5 4092 +36e6 372d 4091 4092 +36e8 36e7 3fd6 4093 +36e7 372e 4092 4093 +36e9 36e8 3fd7 4094 +36e8 372f 4093 4094 +36ea 36e9 3fd8 4095 +36e9 3730 4094 4095 +36eb 36ea 3fd9 4096 +36ea 3731 4095 4096 +36ec 36eb 3fda 4097 +36eb 3732 4096 4097 +36ed 36ec 3fdb 4098 +36ec 3733 4097 4098 +36ee 36ed 3fdc 4099 +36ed 3734 4098 4099 +36ef 36ee 3fdd 409a +36ee 3735 4099 409a +36f0 36ef 3fde 409b +36ef 3736 409a 409b +36f1 36f0 3fdf 409c +36f0 3737 409b 409c +36f2 36f1 3fe0 409d +36f1 3738 409c 409d +36f3 36f2 3fe1 409e +36f2 3739 409d 409e +36f4 36f3 3fe2 409f +36f3 373a 409e 409f +36f5 36f4 3fe3 40a0 +36f4 373b 409f 40a0 +36f6 36f5 3fe4 40a1 +36f5 373c 40a0 40a1 +36f7 36f6 3fe5 40a2 +36f6 373d 40a1 40a2 +36f8 36f7 3fe6 40a3 +36f7 373e 40a2 40a3 +36f9 36f8 3fe7 40a4 +36f8 373f 40a3 40a4 +36fa 36f9 3fe8 40a5 +36f9 3740 40a4 40a5 +36fb 36fa 3fe9 40a6 +36fa 3741 40a5 40a6 +36fc 36fb 3fea 40a7 +36fb 3742 40a6 40a7 +36fd 36fc 3feb 40a8 +36fc 3743 40a7 40a8 +36fe 36fd 3fec 40a9 +36fd 3744 40a8 40a9 +36ff 36fe 3fed 40aa +36fe 3745 40a9 40aa +3700 36ff 3fee 40ab +36ff 3746 40aa 40ab +3701 3700 3fef 40ac +3700 3747 40ab 40ac +3702 3701 3ff0 40ad +3701 3748 40ac 40ad +3702 3749 40ad 40ae +3704 3703 4068 4125 +3703 374a 4124 4125 +3705 3704 4069 4126 +3704 374b 4125 4126 +3706 3705 406a 4127 +3705 374c 4126 4127 +3707 3706 406b 4128 +3706 374d 4127 4128 +3708 3707 406c 4129 +3707 374e 4128 4129 +3709 3708 406d 412a +3708 374f 4129 412a +370a 3709 406e 412b +3709 3750 412a 412b +370b 370a 406f 412c +370a 3751 412b 412c +370c 370b 4070 412d +370b 3752 412c 412d +370d 370c 4071 412e +370c 3753 412d 412e +370e 370d 4072 412f +370d 3754 412e 412f +370f 370e 4073 4130 +370e 3755 412f 4130 +3710 370f 4074 4131 +370f 3756 4130 4131 +3711 3710 4075 4132 +3710 3757 4131 4132 +3712 3711 4076 4133 +3711 3758 4132 4133 +3713 3712 4077 4134 +3712 3759 4133 4134 +3714 3713 4078 4135 +3713 375a 4134 4135 +3715 3714 4079 4136 +3714 375b 4135 4136 +3716 3715 407a 4137 +3715 375c 4136 4137 +3717 3716 407b 4138 +3716 375d 4137 4138 +3718 3717 407c 4139 +3717 375e 4138 4139 +3719 3718 407d 413a +3718 375f 4139 413a +371a 3719 407e 413b +3719 3760 413a 413b +371b 371a 407f 413c +371a 3761 413b 413c +371c 371b 4080 413d +371b 3762 413c 413d +371d 371c 4081 413e +371c 3763 413d 413e +371e 371d 4082 413f +371d 3764 413e 413f +371f 371e 4083 4140 +371e 3765 413f 4140 +3720 371f 4084 4141 +371f 3766 4140 4141 +3721 3720 4085 4142 +3720 3767 4141 4142 +3722 3721 4086 4143 +3721 3768 4142 4143 +3723 3722 4087 4144 +3722 3769 4143 4144 +3724 3723 4088 4145 +3723 376a 4144 4145 +3725 3724 4089 4146 +3724 376b 4145 4146 +3726 3725 408a 4147 +3725 376c 4146 4147 +3727 3726 408b 4148 +3726 376d 4147 4148 +3728 3727 408c 4149 +3727 376e 4148 4149 +3729 3728 408d 414a +3728 376f 4149 414a +372a 3729 408e 414b +3729 3770 414a 414b +372b 372a 408f 414c +372a 3771 414b 414c +372c 372b 4090 414d +372b 3772 414c 414d +372d 372c 4091 414e +372c 3773 414d 414e +372e 372d 4092 414f +372d 3774 414e 414f +372f 372e 4093 4150 +372e 3775 414f 4150 +3730 372f 4094 4151 +372f 3776 4150 4151 +3731 3730 4095 4152 +3730 3777 4151 4152 +3732 3731 4096 4153 +3731 3778 4152 4153 +3733 3732 4097 4154 +3732 3779 4153 4154 +3734 3733 4098 4155 +3733 377a 4154 4155 +3735 3734 4099 4156 +3734 377b 4155 4156 +3736 3735 409a 4157 +3735 377c 4156 4157 +3737 3736 409b 4158 +3736 377d 4157 4158 +3738 3737 409c 4159 +3737 377e 4158 4159 +3739 3738 409d 415a +3738 377f 4159 415a +373a 3739 409e 415b +3739 3780 415a 415b +373b 373a 409f 415c +373a 3781 415b 415c +373c 373b 40a0 415d +373b 3782 415c 415d +373d 373c 40a1 415e +373c 3783 415d 415e +373e 373d 40a2 415f +373d 3784 415e 415f +373f 373e 40a3 4160 +373e 3785 415f 4160 +3740 373f 40a4 4161 +373f 3786 4160 4161 +3741 3740 40a5 4162 +3740 3787 4161 4162 +3742 3741 40a6 4163 +3741 3788 4162 4163 +3743 3742 40a7 4164 +3742 3789 4163 4164 +3744 3743 40a8 4165 +3743 378a 4164 4165 +3745 3744 40a9 4166 +3744 378b 4165 4166 +3746 3745 40aa 4167 +3745 378c 4166 4167 +3747 3746 40ab 4168 +3746 378d 4167 4168 +3748 3747 40ac 4169 +3747 378e 4168 4169 +3749 3748 40ad 416a +3748 378f 4169 416a +3749 3790 416a 416b +374b 374a 4125 41e2 +374a 3791 41e1 41e2 +374c 374b 4126 41e3 +374b 3792 41e2 41e3 +374d 374c 4127 41e4 +374c 3793 41e3 41e4 +374e 374d 4128 41e5 +374d 3794 41e4 41e5 +374f 374e 4129 41e6 +374e 3795 41e5 41e6 +3750 374f 412a 41e7 +374f 3796 41e6 41e7 +3751 3750 412b 41e8 +3750 3797 41e7 41e8 +3752 3751 412c 41e9 +3751 3798 41e8 41e9 +3753 3752 412d 41ea +3752 3799 41e9 41ea +3754 3753 412e 41eb +3753 379a 41ea 41eb +3755 3754 412f 41ec +3754 379b 41eb 41ec +3756 3755 4130 41ed +3755 379c 41ec 41ed +3757 3756 4131 41ee +3756 379d 41ed 41ee +3758 3757 4132 41ef +3757 379e 41ee 41ef +3759 3758 4133 41f0 +3758 379f 41ef 41f0 +375a 3759 4134 41f1 +3759 37a0 41f0 41f1 +375b 375a 4135 41f2 +375a 37a1 41f1 41f2 +375c 375b 4136 41f3 +375b 37a2 41f2 41f3 +375d 375c 4137 41f4 +375c 37a3 41f3 41f4 +375e 375d 4138 41f5 +375d 37a4 41f4 41f5 +375f 375e 4139 41f6 +375e 37a5 41f5 41f6 +3760 375f 413a 41f7 +375f 37a6 41f6 41f7 +3761 3760 413b 41f8 +3760 37a7 41f7 41f8 +3762 3761 413c 41f9 +3761 37a8 41f8 41f9 +3763 3762 413d 41fa +3762 37a9 41f9 41fa +3764 3763 413e 41fb +3763 37aa 41fa 41fb +3765 3764 413f 41fc +3764 37ab 41fb 41fc +3766 3765 4140 41fd +3765 37ac 41fc 41fd +3767 3766 4141 41fe +3766 37ad 41fd 41fe +3768 3767 4142 41ff +3767 37ae 41fe 41ff +3769 3768 4143 4200 +3768 37af 41ff 4200 +376a 3769 4144 4201 +3769 37b0 4200 4201 +376b 376a 4145 4202 +376a 37b1 4201 4202 +376c 376b 4146 4203 +376b 37b2 4202 4203 +376d 376c 4147 4204 +376c 37b3 4203 4204 +376e 376d 4148 4205 +376d 37b4 4204 4205 +376f 376e 4149 4206 +376e 37b5 4205 4206 +3770 376f 414a 4207 +376f 37b6 4206 4207 +3771 3770 414b 4208 +3770 37b7 4207 4208 +3772 3771 414c 4209 +3771 37b8 4208 4209 +3773 3772 414d 420a +3772 37b9 4209 420a +3774 3773 414e 420b +3773 37ba 420a 420b +3775 3774 414f 420c +3774 37bb 420b 420c +3776 3775 4150 420d +3775 37bc 420c 420d +3777 3776 4151 420e +3776 37bd 420d 420e +3778 3777 4152 420f +3777 37be 420e 420f +3779 3778 4153 4210 +3778 37bf 420f 4210 +377a 3779 4154 4211 +3779 37c0 4210 4211 +377b 377a 4155 4212 +377a 37c1 4211 4212 +377c 377b 4156 4213 +377b 37c2 4212 4213 +377d 377c 4157 4214 +377c 37c3 4213 4214 +377e 377d 4158 4215 +377d 37c4 4214 4215 +377f 377e 4159 4216 +377e 37c5 4215 4216 +3780 377f 415a 4217 +377f 37c6 4216 4217 +3781 3780 415b 4218 +3780 37c7 4217 4218 +3782 3781 415c 4219 +3781 37c8 4218 4219 +3783 3782 415d 421a +3782 37c9 4219 421a +3784 3783 415e 421b +3783 37ca 421a 421b +3785 3784 415f 421c +3784 37cb 421b 421c +3786 3785 4160 421d +3785 37cc 421c 421d +3787 3786 4161 421e +3786 37cd 421d 421e +3788 3787 4162 421f +3787 37ce 421e 421f +3789 3788 4163 4220 +3788 37cf 421f 4220 +378a 3789 4164 4221 +3789 37d0 4220 4221 +378b 378a 4165 4222 +378a 37d1 4221 4222 +378c 378b 4166 4223 +378b 37d2 4222 4223 +378d 378c 4167 4224 +378c 37d3 4223 4224 +378e 378d 4168 4225 +378d 37d4 4224 4225 +378f 378e 4169 4226 +378e 37d5 4225 4226 +3790 378f 416a 4227 +378f 37d6 4226 4227 +3790 37d7 4227 4228 +3792 3791 41e2 429f +3791 37d8 429e 429f +3793 3792 41e3 42a0 +3792 37d9 429f 42a0 +3794 3793 41e4 42a1 +3793 37da 42a0 42a1 +3795 3794 41e5 42a2 +3794 37db 42a1 42a2 +3796 3795 41e6 42a3 +3795 37dc 42a2 42a3 +3797 3796 41e7 42a4 +3796 37dd 42a3 42a4 +3798 3797 41e8 42a5 +3797 37de 42a4 42a5 +3799 3798 41e9 42a6 +3798 37df 42a5 42a6 +379a 3799 41ea 42a7 +3799 37e0 42a6 42a7 +379b 379a 41eb 42a8 +379a 37e1 42a7 42a8 +379c 379b 41ec 42a9 +379b 37e2 42a8 42a9 +379d 379c 41ed 42aa +379c 37e3 42a9 42aa +379e 379d 41ee 42ab +379d 37e4 42aa 42ab +379f 379e 41ef 42ac +379e 37e5 42ab 42ac +37a0 379f 41f0 42ad +379f 37e6 42ac 42ad +37a1 37a0 41f1 42ae +37a0 37e7 42ad 42ae +37a2 37a1 41f2 42af +37a1 37e8 42ae 42af +37a3 37a2 41f3 42b0 +37a2 37e9 42af 42b0 +37a4 37a3 41f4 42b1 +37a3 37ea 42b0 42b1 +37a5 37a4 41f5 42b2 +37a4 37eb 42b1 42b2 +37a6 37a5 41f6 42b3 +37a5 37ec 42b2 42b3 +37a7 37a6 41f7 42b4 +37a6 37ed 42b3 42b4 +37a8 37a7 41f8 42b5 +37a7 37ee 42b4 42b5 +37a9 37a8 41f9 42b6 +37a8 37ef 42b5 42b6 +37aa 37a9 41fa 42b7 +37a9 37f0 42b6 42b7 +37ab 37aa 41fb 42b8 +37aa 37f1 42b7 42b8 +37ac 37ab 41fc 42b9 +37ab 37f2 42b8 42b9 +37ad 37ac 41fd 42ba +37ac 37f3 42b9 42ba +37ae 37ad 41fe 42bb +37ad 37f4 42ba 42bb +37af 37ae 41ff 42bc +37ae 37f5 42bb 42bc +37b0 37af 4200 42bd +37af 37f6 42bc 42bd +37b1 37b0 4201 42be +37b0 37f7 42bd 42be +37b2 37b1 4202 42bf +37b1 37f8 42be 42bf +37b3 37b2 4203 42c0 +37b2 37f9 42bf 42c0 +37b4 37b3 4204 42c1 +37b3 37fa 42c0 42c1 +37b5 37b4 4205 42c2 +37b4 37fb 42c1 42c2 +37b6 37b5 4206 42c3 +37b5 37fc 42c2 42c3 +37b7 37b6 4207 42c4 +37b6 37fd 42c3 42c4 +37b8 37b7 4208 42c5 +37b7 37fe 42c4 42c5 +37b9 37b8 4209 42c6 +37b8 37ff 42c5 42c6 +37ba 37b9 420a 42c7 +37b9 3800 42c6 42c7 +37bb 37ba 420b 42c8 +37ba 3801 42c7 42c8 +37bc 37bb 420c 42c9 +37bb 3802 42c8 42c9 +37bd 37bc 420d 42ca +37bc 3803 42c9 42ca +37be 37bd 420e 42cb +37bd 3804 42ca 42cb +37bf 37be 420f 42cc +37be 3805 42cb 42cc +37c0 37bf 4210 42cd +37bf 3806 42cc 42cd +37c1 37c0 4211 42ce +37c0 3807 42cd 42ce +37c2 37c1 4212 42cf +37c1 3808 42ce 42cf +37c3 37c2 4213 42d0 +37c2 3809 42cf 42d0 +37c4 37c3 4214 42d1 +37c3 380a 42d0 42d1 +37c5 37c4 4215 42d2 +37c4 380b 42d1 42d2 +37c6 37c5 4216 42d3 +37c5 380c 42d2 42d3 +37c7 37c6 4217 42d4 +37c6 380d 42d3 42d4 +37c8 37c7 4218 42d5 +37c7 380e 42d4 42d5 +37c9 37c8 4219 42d6 +37c8 380f 42d5 42d6 +37ca 37c9 421a 42d7 +37c9 3810 42d6 42d7 +37cb 37ca 421b 42d8 +37ca 3811 42d7 42d8 +37cc 37cb 421c 42d9 +37cb 3812 42d8 42d9 +37cd 37cc 421d 42da +37cc 3813 42d9 42da +37ce 37cd 421e 42db +37cd 3814 42da 42db +37cf 37ce 421f 42dc +37ce 3815 42db 42dc +37d0 37cf 4220 42dd +37cf 3816 42dc 42dd +37d1 37d0 4221 42de +37d0 3817 42dd 42de +37d2 37d1 4222 42df +37d1 3818 42de 42df +37d3 37d2 4223 42e0 +37d2 3819 42df 42e0 +37d4 37d3 4224 42e1 +37d3 381a 42e0 42e1 +37d5 37d4 4225 42e2 +37d4 381b 42e1 42e2 +37d6 37d5 4226 42e3 +37d5 381c 42e2 42e3 +37d7 37d6 4227 42e4 +37d6 381d 42e3 42e4 +37d7 381e 42e4 42e5 +37d9 37d8 429f 435c +37d8 381f 435b 435c +37da 37d9 42a0 435d +37d9 3820 435c 435d +37db 37da 42a1 435e +37da 3821 435d 435e +37dc 37db 42a2 435f +37db 3822 435e 435f +37dd 37dc 42a3 4360 +37dc 3823 435f 4360 +37de 37dd 42a4 4361 +37dd 3824 4360 4361 +37df 37de 42a5 4362 +37de 3825 4361 4362 +37e0 37df 42a6 4363 +37df 3826 4362 4363 +37e1 37e0 42a7 4364 +37e0 3827 4363 4364 +37e2 37e1 42a8 4365 +37e1 3828 4364 4365 +37e3 37e2 42a9 4366 +37e2 3829 4365 4366 +37e4 37e3 42aa 4367 +37e3 382a 4366 4367 +37e5 37e4 42ab 4368 +37e4 382b 4367 4368 +37e6 37e5 42ac 4369 +37e5 382c 4368 4369 +37e7 37e6 42ad 436a +37e6 382d 4369 436a +37e8 37e7 42ae 436b +37e7 382e 436a 436b +37e9 37e8 42af 436c +37e8 382f 436b 436c +37ea 37e9 42b0 436d +37e9 3830 436c 436d +37eb 37ea 42b1 436e +37ea 3831 436d 436e +37ec 37eb 42b2 436f +37eb 3832 436e 436f +37ed 37ec 42b3 4370 +37ec 3833 436f 4370 +37ee 37ed 42b4 4371 +37ed 3834 4370 4371 +37ef 37ee 42b5 4372 +37ee 3835 4371 4372 +37f0 37ef 42b6 4373 +37ef 3836 4372 4373 +37f1 37f0 42b7 4374 +37f0 3837 4373 4374 +37f2 37f1 42b8 4375 +37f1 3838 4374 4375 +37f3 37f2 42b9 4376 +37f2 3839 4375 4376 +37f4 37f3 42ba 4377 +37f3 383a 4376 4377 +37f5 37f4 42bb 4378 +37f4 383b 4377 4378 +37f6 37f5 42bc 4379 +37f5 383c 4378 4379 +37f7 37f6 42bd 437a +37f6 383d 4379 437a +37f8 37f7 42be 437b +37f7 383e 437a 437b +37f9 37f8 42bf 437c +37f8 383f 437b 437c +37fa 37f9 42c0 437d +37f9 3840 437c 437d +37fb 37fa 42c1 437e +37fa 3841 437d 437e +37fc 37fb 42c2 437f +37fb 3842 437e 437f +37fd 37fc 42c3 4380 +37fc 3843 437f 4380 +37fe 37fd 42c4 4381 +37fd 3844 4380 4381 +37ff 37fe 42c5 4382 +37fe 3845 4381 4382 +3800 37ff 42c6 4383 +37ff 3846 4382 4383 +3801 3800 42c7 4384 +3800 3847 4383 4384 +3802 3801 42c8 4385 +3801 3848 4384 4385 +3803 3802 42c9 4386 +3802 3849 4385 4386 +3804 3803 42ca 4387 +3803 384a 4386 4387 +3805 3804 42cb 4388 +3804 384b 4387 4388 +3806 3805 42cc 4389 +3805 384c 4388 4389 +3807 3806 42cd 438a +3806 384d 4389 438a +3808 3807 42ce 438b +3807 384e 438a 438b +3809 3808 42cf 438c +3808 384f 438b 438c +380a 3809 42d0 438d +3809 3850 438c 438d +380b 380a 42d1 438e +380a 3851 438d 438e +380c 380b 42d2 438f +380b 3852 438e 438f +380d 380c 42d3 4390 +380c 3853 438f 4390 +380e 380d 42d4 4391 +380d 3854 4390 4391 +380f 380e 42d5 4392 +380e 3855 4391 4392 +3810 380f 42d6 4393 +380f 3856 4392 4393 +3811 3810 42d7 4394 +3810 3857 4393 4394 +3812 3811 42d8 4395 +3811 3858 4394 4395 +3813 3812 42d9 4396 +3812 3859 4395 4396 +3814 3813 42da 4397 +3813 385a 4396 4397 +3815 3814 42db 4398 +3814 385b 4397 4398 +3816 3815 42dc 4399 +3815 385c 4398 4399 +3817 3816 42dd 439a +3816 385d 4399 439a +3818 3817 42de 439b +3817 385e 439a 439b +3819 3818 42df 439c +3818 385f 439b 439c +381a 3819 42e0 439d +3819 3860 439c 439d +381b 381a 42e1 439e +381a 3861 439d 439e +381c 381b 42e2 439f +381b 3862 439e 439f +381d 381c 42e3 43a0 +381c 3863 439f 43a0 +381e 381d 42e4 43a1 +381d 3864 43a0 43a1 +381e 3865 43a1 43a2 +3820 381f 435c 4419 +381f 3866 4418 4419 +3821 3820 435d 441a +3820 3867 4419 441a +3822 3821 435e 441b +3821 3868 441a 441b +3823 3822 435f 441c +3822 3869 441b 441c +3824 3823 4360 441d +3823 386a 441c 441d +3825 3824 4361 441e +3824 386b 441d 441e +3826 3825 4362 441f +3825 386c 441e 441f +3827 3826 4363 4420 +3826 386d 441f 4420 +3828 3827 4364 4421 +3827 386e 4420 4421 +3829 3828 4365 4422 +3828 386f 4421 4422 +382a 3829 4366 4423 +3829 3870 4422 4423 +382b 382a 4367 4424 +382a 3871 4423 4424 +382c 382b 4368 4425 +382b 3872 4424 4425 +382d 382c 4369 4426 +382c 3873 4425 4426 +382e 382d 436a 4427 +382d 3874 4426 4427 +382f 382e 436b 4428 +382e 3875 4427 4428 +3830 382f 436c 4429 +382f 3876 4428 4429 +3831 3830 436d 442a +3830 3877 4429 442a +3832 3831 436e 442b +3831 3878 442a 442b +3833 3832 436f 442c +3832 3879 442b 442c +3834 3833 4370 442d +3833 387a 442c 442d +3835 3834 4371 442e +3834 387b 442d 442e +3836 3835 4372 442f +3835 387c 442e 442f +3837 3836 4373 4430 +3836 387d 442f 4430 +3838 3837 4374 4431 +3837 387e 4430 4431 +3839 3838 4375 4432 +3838 387f 4431 4432 +383a 3839 4376 4433 +3839 3880 4432 4433 +383b 383a 4377 4434 +383a 3881 4433 4434 +383c 383b 4378 4435 +383b 3882 4434 4435 +383d 383c 4379 4436 +383c 3883 4435 4436 +383e 383d 437a 4437 +383d 3884 4436 4437 +383f 383e 437b 4438 +383e 3885 4437 4438 +3840 383f 437c 4439 +383f 3886 4438 4439 +3841 3840 437d 443a +3840 3887 4439 443a +3842 3841 437e 443b +3841 3888 443a 443b +3843 3842 437f 443c +3842 3889 443b 443c +3844 3843 4380 443d +3843 388a 443c 443d +3845 3844 4381 443e +3844 388b 443d 443e +3846 3845 4382 443f +3845 388c 443e 443f +3847 3846 4383 4440 +3846 388d 443f 4440 +3848 3847 4384 4441 +3847 388e 4440 4441 +3849 3848 4385 4442 +3848 388f 4441 4442 +384a 3849 4386 4443 +3849 3890 4442 4443 +384b 384a 4387 4444 +384a 3891 4443 4444 +384c 384b 4388 4445 +384b 3892 4444 4445 +384d 384c 4389 4446 +384c 3893 4445 4446 +384e 384d 438a 4447 +384d 3894 4446 4447 +384f 384e 438b 4448 +384e 3895 4447 4448 +3850 384f 438c 4449 +384f 3896 4448 4449 +3851 3850 438d 444a +3850 3897 4449 444a +3852 3851 438e 444b +3851 3898 444a 444b +3853 3852 438f 444c +3852 3899 444b 444c +3854 3853 4390 444d +3853 389a 444c 444d +3855 3854 4391 444e +3854 389b 444d 444e +3856 3855 4392 444f +3855 389c 444e 444f +3857 3856 4393 4450 +3856 389d 444f 4450 +3858 3857 4394 4451 +3857 389e 4450 4451 +3859 3858 4395 4452 +3858 389f 4451 4452 +385a 3859 4396 4453 +3859 38a0 4452 4453 +385b 385a 4397 4454 +385a 38a1 4453 4454 +385c 385b 4398 4455 +385b 38a2 4454 4455 +385d 385c 4399 4456 +385c 38a3 4455 4456 +385e 385d 439a 4457 +385d 38a4 4456 4457 +385f 385e 439b 4458 +385e 38a5 4457 4458 +3860 385f 439c 4459 +385f 38a6 4458 4459 +3861 3860 439d 445a +3860 38a7 4459 445a +3862 3861 439e 445b +3861 38a8 445a 445b +3863 3862 439f 445c +3862 38a9 445b 445c +3864 3863 43a0 445d +3863 38aa 445c 445d +3865 3864 43a1 445e +3864 38ab 445d 445e +3865 38ac 445e 445f +3867 3866 4419 44d6 +3866 38ad 44d5 44d6 +3868 3867 441a 44d7 +3867 38ae 44d6 44d7 +3869 3868 441b 44d8 +3868 38af 44d7 44d8 +386a 3869 441c 44d9 +3869 38b0 44d8 44d9 +386b 386a 441d 44da +386a 38b1 44d9 44da +386c 386b 441e 44db +386b 38b2 44da 44db +386d 386c 441f 44dc +386c 38b3 44db 44dc +386e 386d 4420 44dd +386d 38b4 44dc 44dd +386f 386e 4421 44de +386e 38b5 44dd 44de +3870 386f 4422 44df +386f 38b6 44de 44df +3871 3870 4423 44e0 +3870 38b7 44df 44e0 +3872 3871 4424 44e1 +3871 38b8 44e0 44e1 +3873 3872 4425 44e2 +3872 38b9 44e1 44e2 +3874 3873 4426 44e3 +3873 38ba 44e2 44e3 +3875 3874 4427 44e4 +3874 38bb 44e3 44e4 +3876 3875 4428 44e5 +3875 38bc 44e4 44e5 +3877 3876 4429 44e6 +3876 38bd 44e5 44e6 +3878 3877 442a 44e7 +3877 38be 44e6 44e7 +3879 3878 442b 44e8 +3878 38bf 44e7 44e8 +387a 3879 442c 44e9 +3879 38c0 44e8 44e9 +387b 387a 442d 44ea +387a 38c1 44e9 44ea +387c 387b 442e 44eb +387b 38c2 44ea 44eb +387d 387c 442f 44ec +387c 38c3 44eb 44ec +387e 387d 4430 44ed +387d 38c4 44ec 44ed +387f 387e 4431 44ee +387e 38c5 44ed 44ee +3880 387f 4432 44ef +387f 38c6 44ee 44ef +3881 3880 4433 44f0 +3880 38c7 44ef 44f0 +3882 3881 4434 44f1 +3881 38c8 44f0 44f1 +3883 3882 4435 44f2 +3882 38c9 44f1 44f2 +3884 3883 4436 44f3 +3883 38ca 44f2 44f3 +3885 3884 4437 44f4 +3884 38cb 44f3 44f4 +3886 3885 4438 44f5 +3885 38cc 44f4 44f5 +3887 3886 4439 44f6 +3886 38cd 44f5 44f6 +3888 3887 443a 44f7 +3887 38ce 44f6 44f7 +3889 3888 443b 44f8 +3888 38cf 44f7 44f8 +388a 3889 443c 44f9 +3889 38d0 44f8 44f9 +388b 388a 443d 44fa +388a 38d1 44f9 44fa +388c 388b 443e 44fb +388b 38d2 44fa 44fb +388d 388c 443f 44fc +388c 38d3 44fb 44fc +388e 388d 4440 44fd +388d 38d4 44fc 44fd +388f 388e 4441 44fe +388e 38d5 44fd 44fe +3890 388f 4442 44ff +388f 38d6 44fe 44ff +3891 3890 4443 4500 +3890 38d7 44ff 4500 +3892 3891 4444 4501 +3891 38d8 4500 4501 +3893 3892 4445 4502 +3892 38d9 4501 4502 +3894 3893 4446 4503 +3893 38da 4502 4503 +3895 3894 4447 4504 +3894 38db 4503 4504 +3896 3895 4448 4505 +3895 38dc 4504 4505 +3897 3896 4449 4506 +3896 38dd 4505 4506 +3898 3897 444a 4507 +3897 38de 4506 4507 +3899 3898 444b 4508 +3898 38df 4507 4508 +389a 3899 444c 4509 +3899 38e0 4508 4509 +389b 389a 444d 450a +389a 38e1 4509 450a +389c 389b 444e 450b +389b 38e2 450a 450b +389d 389c 444f 450c +389c 38e3 450b 450c +389e 389d 4450 450d +389d 38e4 450c 450d +389f 389e 4451 450e +389e 38e5 450d 450e +38a0 389f 4452 450f +389f 38e6 450e 450f +38a1 38a0 4453 4510 +38a0 38e7 450f 4510 +38a2 38a1 4454 4511 +38a1 38e8 4510 4511 +38a3 38a2 4455 4512 +38a2 38e9 4511 4512 +38a4 38a3 4456 4513 +38a3 38ea 4512 4513 +38a5 38a4 4457 4514 +38a4 38eb 4513 4514 +38a6 38a5 4458 4515 +38a5 38ec 4514 4515 +38a7 38a6 4459 4516 +38a6 38ed 4515 4516 +38a8 38a7 445a 4517 +38a7 38ee 4516 4517 +38a9 38a8 445b 4518 +38a8 38ef 4517 4518 +38aa 38a9 445c 4519 +38a9 38f0 4518 4519 +38ab 38aa 445d 451a +38aa 38f1 4519 451a +38ac 38ab 445e 451b +38ab 38f2 451a 451b +38ac 38f3 451b 451c +38ae 38ad 44d6 4593 +38ad 38f4 4592 4593 +38af 38ae 44d7 4594 +38ae 38f5 4593 4594 +38b0 38af 44d8 4595 +38af 38f6 4594 4595 +38b1 38b0 44d9 4596 +38b0 38f7 4595 4596 +38b2 38b1 44da 4597 +38b1 38f8 4596 4597 +38b3 38b2 44db 4598 +38b2 38f9 4597 4598 +38b4 38b3 44dc 4599 +38b3 38fa 4598 4599 +38b5 38b4 44dd 459a +38b4 38fb 4599 459a +38b6 38b5 44de 459b +38b5 38fc 459a 459b +38b7 38b6 44df 459c +38b6 38fd 459b 459c +38b8 38b7 44e0 459d +38b7 38fe 459c 459d +38b9 38b8 44e1 459e +38b8 38ff 459d 459e +38ba 38b9 44e2 459f +38b9 3900 459e 459f +38bb 38ba 44e3 45a0 +38ba 3901 459f 45a0 +38bc 38bb 44e4 45a1 +38bb 3902 45a0 45a1 +38bd 38bc 44e5 45a2 +38bc 3903 45a1 45a2 +38be 38bd 44e6 45a3 +38bd 3904 45a2 45a3 +38bf 38be 44e7 45a4 +38be 3905 45a3 45a4 +38c0 38bf 44e8 45a5 +38bf 3906 45a4 45a5 +38c1 38c0 44e9 45a6 +38c0 3907 45a5 45a6 +38c2 38c1 44ea 45a7 +38c1 3908 45a6 45a7 +38c3 38c2 44eb 45a8 +38c2 3909 45a7 45a8 +38c4 38c3 44ec 45a9 +38c3 390a 45a8 45a9 +38c5 38c4 44ed 45aa +38c4 390b 45a9 45aa +38c6 38c5 44ee 45ab +38c5 390c 45aa 45ab +38c7 38c6 44ef 45ac +38c6 390d 45ab 45ac +38c8 38c7 44f0 45ad +38c7 390e 45ac 45ad +38c9 38c8 44f1 45ae +38c8 390f 45ad 45ae +38ca 38c9 44f2 45af +38c9 3910 45ae 45af +38cb 38ca 44f3 45b0 +38ca 3911 45af 45b0 +38cc 38cb 44f4 45b1 +38cb 3912 45b0 45b1 +38cd 38cc 44f5 45b2 +38cc 3913 45b1 45b2 +38ce 38cd 44f6 45b3 +38cd 3914 45b2 45b3 +38cf 38ce 44f7 45b4 +38ce 3915 45b3 45b4 +38d0 38cf 44f8 45b5 +38cf 3916 45b4 45b5 +38d1 38d0 44f9 45b6 +38d0 3917 45b5 45b6 +38d2 38d1 44fa 45b7 +38d1 3918 45b6 45b7 +38d3 38d2 44fb 45b8 +38d2 3919 45b7 45b8 +38d4 38d3 44fc 45b9 +38d3 391a 45b8 45b9 +38d5 38d4 44fd 45ba +38d4 391b 45b9 45ba +38d6 38d5 44fe 45bb +38d5 391c 45ba 45bb +38d7 38d6 44ff 45bc +38d6 391d 45bb 45bc +38d8 38d7 4500 45bd +38d7 391e 45bc 45bd +38d9 38d8 4501 45be +38d8 391f 45bd 45be +38da 38d9 4502 45bf +38d9 3920 45be 45bf +38db 38da 4503 45c0 +38da 3921 45bf 45c0 +38dc 38db 4504 45c1 +38db 3922 45c0 45c1 +38dd 38dc 4505 45c2 +38dc 3923 45c1 45c2 +38de 38dd 4506 45c3 +38dd 3924 45c2 45c3 +38df 38de 4507 45c4 +38de 3925 45c3 45c4 +38e0 38df 4508 45c5 +38df 3926 45c4 45c5 +38e1 38e0 4509 45c6 +38e0 3927 45c5 45c6 +38e2 38e1 450a 45c7 +38e1 3928 45c6 45c7 +38e3 38e2 450b 45c8 +38e2 3929 45c7 45c8 +38e4 38e3 450c 45c9 +38e3 392a 45c8 45c9 +38e5 38e4 450d 45ca +38e4 392b 45c9 45ca +38e6 38e5 450e 45cb +38e5 392c 45ca 45cb +38e7 38e6 450f 45cc +38e6 392d 45cb 45cc +38e8 38e7 4510 45cd +38e7 392e 45cc 45cd +38e9 38e8 4511 45ce +38e8 392f 45cd 45ce +38ea 38e9 4512 45cf +38e9 3930 45ce 45cf +38eb 38ea 4513 45d0 +38ea 3931 45cf 45d0 +38ec 38eb 4514 45d1 +38eb 3932 45d0 45d1 +38ed 38ec 4515 45d2 +38ec 3933 45d1 45d2 +38ee 38ed 4516 45d3 +38ed 3934 45d2 45d3 +38ef 38ee 4517 45d4 +38ee 3935 45d3 45d4 +38f0 38ef 4518 45d5 +38ef 3936 45d4 45d5 +38f1 38f0 4519 45d6 +38f0 3937 45d5 45d6 +38f2 38f1 451a 45d7 +38f1 3938 45d6 45d7 +38f3 38f2 451b 45d8 +38f2 3939 45d7 45d8 +38f3 393a 45d8 45d9 +38f5 38f4 4593 4650 +38f4 393b 464f 4650 +38f6 38f5 4594 4651 +38f5 393c 4650 4651 +38f7 38f6 4595 4652 +38f6 393d 4651 4652 +38f8 38f7 4596 4653 +38f7 393e 4652 4653 +38f9 38f8 4597 4654 +38f8 393f 4653 4654 +38fa 38f9 4598 4655 +38f9 3940 4654 4655 +38fb 38fa 4599 4656 +38fa 3941 4655 4656 +38fc 38fb 459a 4657 +38fb 3942 4656 4657 +38fd 38fc 459b 4658 +38fc 3943 4657 4658 +38fe 38fd 459c 4659 +38fd 3944 4658 4659 +38ff 38fe 459d 465a +38fe 3945 4659 465a +3900 38ff 459e 465b +38ff 3946 465a 465b +3901 3900 459f 465c +3900 3947 465b 465c +3902 3901 45a0 465d +3901 3948 465c 465d +3903 3902 45a1 465e +3902 3949 465d 465e +3904 3903 45a2 465f +3903 394a 465e 465f +3905 3904 45a3 4660 +3904 394b 465f 4660 +3906 3905 45a4 4661 +3905 394c 4660 4661 +3907 3906 45a5 4662 +3906 394d 4661 4662 +3908 3907 45a6 4663 +3907 394e 4662 4663 +3909 3908 45a7 4664 +3908 394f 4663 4664 +390a 3909 45a8 4665 +3909 3950 4664 4665 +390b 390a 45a9 4666 +390a 3951 4665 4666 +390c 390b 45aa 4667 +390b 3952 4666 4667 +390d 390c 45ab 4668 +390c 3953 4667 4668 +390e 390d 45ac 4669 +390d 3954 4668 4669 +390f 390e 45ad 466a +390e 3955 4669 466a +3910 390f 45ae 466b +390f 3956 466a 466b +3911 3910 45af 466c +3910 3957 466b 466c +3912 3911 45b0 466d +3911 3958 466c 466d +3913 3912 45b1 466e +3912 3959 466d 466e +3914 3913 45b2 466f +3913 395a 466e 466f +3915 3914 45b3 4670 +3914 395b 466f 4670 +3916 3915 45b4 4671 +3915 395c 4670 4671 +3917 3916 45b5 4672 +3916 395d 4671 4672 +3918 3917 45b6 4673 +3917 395e 4672 4673 +3919 3918 45b7 4674 +3918 395f 4673 4674 +391a 3919 45b8 4675 +3919 3960 4674 4675 +391b 391a 45b9 4676 +391a 3961 4675 4676 +391c 391b 45ba 4677 +391b 3962 4676 4677 +391d 391c 45bb 4678 +391c 3963 4677 4678 +391e 391d 45bc 4679 +391d 3964 4678 4679 +391f 391e 45bd 467a +391e 3965 4679 467a +3920 391f 45be 467b +391f 3966 467a 467b +3921 3920 45bf 467c +3920 3967 467b 467c +3922 3921 45c0 467d +3921 3968 467c 467d +3923 3922 45c1 467e +3922 3969 467d 467e +3924 3923 45c2 467f +3923 396a 467e 467f +3925 3924 45c3 4680 +3924 396b 467f 4680 +3926 3925 45c4 4681 +3925 396c 4680 4681 +3927 3926 45c5 4682 +3926 396d 4681 4682 +3928 3927 45c6 4683 +3927 396e 4682 4683 +3929 3928 45c7 4684 +3928 396f 4683 4684 +392a 3929 45c8 4685 +3929 3970 4684 4685 +392b 392a 45c9 4686 +392a 3971 4685 4686 +392c 392b 45ca 4687 +392b 3972 4686 4687 +392d 392c 45cb 4688 +392c 3973 4687 4688 +392e 392d 45cc 4689 +392d 3974 4688 4689 +392f 392e 45cd 468a +392e 3975 4689 468a +3930 392f 45ce 468b +392f 3976 468a 468b +3931 3930 45cf 468c +3930 3977 468b 468c +3932 3931 45d0 468d +3931 3978 468c 468d +3933 3932 45d1 468e +3932 3979 468d 468e +3934 3933 45d2 468f +3933 397a 468e 468f +3935 3934 45d3 4690 +3934 397b 468f 4690 +3936 3935 45d4 4691 +3935 397c 4690 4691 +3937 3936 45d5 4692 +3936 397d 4691 4692 +3938 3937 45d6 4693 +3937 397e 4692 4693 +3939 3938 45d7 4694 +3938 397f 4693 4694 +393a 3939 45d8 4695 +3939 3980 4694 4695 +393a 3981 4695 4696 +393c 393b 4650 470d +393b 3982 470c 470d +393d 393c 4651 470e +393c 3983 470d 470e +393e 393d 4652 470f +393d 3984 470e 470f +393f 393e 4653 4710 +393e 3985 470f 4710 +3940 393f 4654 4711 +393f 3986 4710 4711 +3941 3940 4655 4712 +3940 3987 4711 4712 +3942 3941 4656 4713 +3941 3988 4712 4713 +3943 3942 4657 4714 +3942 3989 4713 4714 +3944 3943 4658 4715 +3943 398a 4714 4715 +3945 3944 4659 4716 +3944 398b 4715 4716 +3946 3945 465a 4717 +3945 398c 4716 4717 +3947 3946 465b 4718 +3946 398d 4717 4718 +3948 3947 465c 4719 +3947 398e 4718 4719 +3949 3948 465d 471a +3948 398f 4719 471a +394a 3949 465e 471b +3949 3990 471a 471b +394b 394a 465f 471c +394a 3991 471b 471c +394c 394b 4660 471d +394b 3992 471c 471d +394d 394c 4661 471e +394c 3993 471d 471e +394e 394d 4662 471f +394d 3994 471e 471f +394f 394e 4663 4720 +394e 3995 471f 4720 +3950 394f 4664 4721 +394f 3996 4720 4721 +3951 3950 4665 4722 +3950 3997 4721 4722 +3952 3951 4666 4723 +3951 3998 4722 4723 +3953 3952 4667 4724 +3952 3999 4723 4724 +3954 3953 4668 4725 +3953 399a 4724 4725 +3955 3954 4669 4726 +3954 399b 4725 4726 +3956 3955 466a 4727 +3955 399c 4726 4727 +3957 3956 466b 4728 +3956 399d 4727 4728 +3958 3957 466c 4729 +3957 399e 4728 4729 +3959 3958 466d 472a +3958 399f 4729 472a +395a 3959 466e 472b +3959 39a0 472a 472b +395b 395a 466f 472c +395a 39a1 472b 472c +395c 395b 4670 472d +395b 39a2 472c 472d +395d 395c 4671 472e +395c 39a3 472d 472e +395e 395d 4672 472f +395d 39a4 472e 472f +395f 395e 4673 4730 +395e 39a5 472f 4730 +3960 395f 4674 4731 +395f 39a6 4730 4731 +3961 3960 4675 4732 +3960 39a7 4731 4732 +3962 3961 4676 4733 +3961 39a8 4732 4733 +3963 3962 4677 4734 +3962 39a9 4733 4734 +3964 3963 4678 4735 +3963 39aa 4734 4735 +3965 3964 4679 4736 +3964 39ab 4735 4736 +3966 3965 467a 4737 +3965 39ac 4736 4737 +3967 3966 467b 4738 +3966 39ad 4737 4738 +3968 3967 467c 4739 +3967 39ae 4738 4739 +3969 3968 467d 473a +3968 39af 4739 473a +396a 3969 467e 473b +3969 39b0 473a 473b +396b 396a 467f 473c +396a 39b1 473b 473c +396c 396b 4680 473d +396b 39b2 473c 473d +396d 396c 4681 473e +396c 39b3 473d 473e +396e 396d 4682 473f +396d 39b4 473e 473f +396f 396e 4683 4740 +396e 39b5 473f 4740 +3970 396f 4684 4741 +396f 39b6 4740 4741 +3971 3970 4685 4742 +3970 39b7 4741 4742 +3972 3971 4686 4743 +3971 39b8 4742 4743 +3973 3972 4687 4744 +3972 39b9 4743 4744 +3974 3973 4688 4745 +3973 39ba 4744 4745 +3975 3974 4689 4746 +3974 39bb 4745 4746 +3976 3975 468a 4747 +3975 39bc 4746 4747 +3977 3976 468b 4748 +3976 39bd 4747 4748 +3978 3977 468c 4749 +3977 39be 4748 4749 +3979 3978 468d 474a +3978 39bf 4749 474a +397a 3979 468e 474b +3979 39c0 474a 474b +397b 397a 468f 474c +397a 39c1 474b 474c +397c 397b 4690 474d +397b 39c2 474c 474d +397d 397c 4691 474e +397c 39c3 474d 474e +397e 397d 4692 474f +397d 39c4 474e 474f +397f 397e 4693 4750 +397e 39c5 474f 4750 +3980 397f 4694 4751 +397f 39c6 4750 4751 +3981 3980 4695 4752 +3980 39c7 4751 4752 +3981 39c8 4752 4753 +3983 3982 470d 47ca +3982 39c9 47c9 47ca +3984 3983 470e 47cb +3983 39ca 47ca 47cb +3985 3984 470f 47cc +3984 39cb 47cb 47cc +3986 3985 4710 47cd +3985 39cc 47cc 47cd +3987 3986 4711 47ce +3986 39cd 47cd 47ce +3988 3987 4712 47cf +3987 39ce 47ce 47cf +3989 3988 4713 47d0 +3988 39cf 47cf 47d0 +398a 3989 4714 47d1 +3989 39d0 47d0 47d1 +398b 398a 4715 47d2 +398a 39d1 47d1 47d2 +398c 398b 4716 47d3 +398b 39d2 47d2 47d3 +398d 398c 4717 47d4 +398c 39d3 47d3 47d4 +398e 398d 4718 47d5 +398d 39d4 47d4 47d5 +398f 398e 4719 47d6 +398e 39d5 47d5 47d6 +3990 398f 471a 47d7 +398f 39d6 47d6 47d7 +3991 3990 471b 47d8 +3990 39d7 47d7 47d8 +3992 3991 471c 47d9 +3991 39d8 47d8 47d9 +3993 3992 471d 47da +3992 39d9 47d9 47da +3994 3993 471e 47db +3993 39da 47da 47db +3995 3994 471f 47dc +3994 39db 47db 47dc +3996 3995 4720 47dd +3995 39dc 47dc 47dd +3997 3996 4721 47de +3996 39dd 47dd 47de +3998 3997 4722 47df +3997 39de 47de 47df +3999 3998 4723 47e0 +3998 39df 47df 47e0 +399a 3999 4724 47e1 +3999 39e0 47e0 47e1 +399b 399a 4725 47e2 +399a 39e1 47e1 47e2 +399c 399b 4726 47e3 +399b 39e2 47e2 47e3 +399d 399c 4727 47e4 +399c 39e3 47e3 47e4 +399e 399d 4728 47e5 +399d 39e4 47e4 47e5 +399f 399e 4729 47e6 +399e 39e5 47e5 47e6 +39a0 399f 472a 47e7 +399f 39e6 47e6 47e7 +39a1 39a0 472b 47e8 +39a0 39e7 47e7 47e8 +39a2 39a1 472c 47e9 +39a1 39e8 47e8 47e9 +39a3 39a2 472d 47ea +39a2 39e9 47e9 47ea +39a4 39a3 472e 47eb +39a3 39ea 47ea 47eb +39a5 39a4 472f 47ec +39a4 39eb 47eb 47ec +39a6 39a5 4730 47ed +39a5 39ec 47ec 47ed +39a7 39a6 4731 47ee +39a6 39ed 47ed 47ee +39a8 39a7 4732 47ef +39a7 39ee 47ee 47ef +39a9 39a8 4733 47f0 +39a8 39ef 47ef 47f0 +39aa 39a9 4734 47f1 +39a9 39f0 47f0 47f1 +39ab 39aa 4735 47f2 +39aa 39f1 47f1 47f2 +39ac 39ab 4736 47f3 +39ab 39f2 47f2 47f3 +39ad 39ac 4737 47f4 +39ac 39f3 47f3 47f4 +39ae 39ad 4738 47f5 +39ad 39f4 47f4 47f5 +39af 39ae 4739 47f6 +39ae 39f5 47f5 47f6 +39b0 39af 473a 47f7 +39af 39f6 47f6 47f7 +39b1 39b0 473b 47f8 +39b0 39f7 47f7 47f8 +39b2 39b1 473c 47f9 +39b1 39f8 47f8 47f9 +39b3 39b2 473d 47fa +39b2 39f9 47f9 47fa +39b4 39b3 473e 47fb +39b3 39fa 47fa 47fb +39b5 39b4 473f 47fc +39b4 39fb 47fb 47fc +39b6 39b5 4740 47fd +39b5 39fc 47fc 47fd +39b7 39b6 4741 47fe +39b6 39fd 47fd 47fe +39b8 39b7 4742 47ff +39b7 39fe 47fe 47ff +39b9 39b8 4743 4800 +39b8 39ff 47ff 4800 +39ba 39b9 4744 4801 +39b9 3a00 4800 4801 +39bb 39ba 4745 4802 +39ba 3a01 4801 4802 +39bc 39bb 4746 4803 +39bb 3a02 4802 4803 +39bd 39bc 4747 4804 +39bc 3a03 4803 4804 +39be 39bd 4748 4805 +39bd 3a04 4804 4805 +39bf 39be 4749 4806 +39be 3a05 4805 4806 +39c0 39bf 474a 4807 +39bf 3a06 4806 4807 +39c1 39c0 474b 4808 +39c0 3a07 4807 4808 +39c2 39c1 474c 4809 +39c1 3a08 4808 4809 +39c3 39c2 474d 480a +39c2 3a09 4809 480a +39c4 39c3 474e 480b +39c3 3a0a 480a 480b +39c5 39c4 474f 480c +39c4 3a0b 480b 480c +39c6 39c5 4750 480d +39c5 3a0c 480c 480d +39c7 39c6 4751 480e +39c6 3a0d 480d 480e +39c8 39c7 4752 480f +39c7 3a0e 480e 480f +39c8 3a0f 480f 4810 +39ca 39c9 47ca 4887 +39c9 3a10 4886 4887 +39cb 39ca 47cb 4888 +39ca 3a11 4887 4888 +39cc 39cb 47cc 4889 +39cb 3a12 4888 4889 +39cd 39cc 47cd 488a +39cc 3a13 4889 488a +39ce 39cd 47ce 488b +39cd 3a14 488a 488b +39cf 39ce 47cf 488c +39ce 3a15 488b 488c +39d0 39cf 47d0 488d +39cf 3a16 488c 488d +39d1 39d0 47d1 488e +39d0 3a17 488d 488e +39d2 39d1 47d2 488f +39d1 3a18 488e 488f +39d3 39d2 47d3 4890 +39d2 3a19 488f 4890 +39d4 39d3 47d4 4891 +39d3 3a1a 4890 4891 +39d5 39d4 47d5 4892 +39d4 3a1b 4891 4892 +39d6 39d5 47d6 4893 +39d5 3a1c 4892 4893 +39d7 39d6 47d7 4894 +39d6 3a1d 4893 4894 +39d8 39d7 47d8 4895 +39d7 3a1e 4894 4895 +39d9 39d8 47d9 4896 +39d8 3a1f 4895 4896 +39da 39d9 47da 4897 +39d9 3a20 4896 4897 +39db 39da 47db 4898 +39da 3a21 4897 4898 +39dc 39db 47dc 4899 +39db 3a22 4898 4899 +39dd 39dc 47dd 489a +39dc 3a23 4899 489a +39de 39dd 47de 489b +39dd 3a24 489a 489b +39df 39de 47df 489c +39de 3a25 489b 489c +39e0 39df 47e0 489d +39df 3a26 489c 489d +39e1 39e0 47e1 489e +39e0 3a27 489d 489e +39e2 39e1 47e2 489f +39e1 3a28 489e 489f +39e3 39e2 47e3 48a0 +39e2 3a29 489f 48a0 +39e4 39e3 47e4 48a1 +39e3 3a2a 48a0 48a1 +39e5 39e4 47e5 48a2 +39e4 3a2b 48a1 48a2 +39e6 39e5 47e6 48a3 +39e5 3a2c 48a2 48a3 +39e7 39e6 47e7 48a4 +39e6 3a2d 48a3 48a4 +39e8 39e7 47e8 48a5 +39e7 3a2e 48a4 48a5 +39e9 39e8 47e9 48a6 +39e8 3a2f 48a5 48a6 +39ea 39e9 47ea 48a7 +39e9 3a30 48a6 48a7 +39eb 39ea 47eb 48a8 +39ea 3a31 48a7 48a8 +39ec 39eb 47ec 48a9 +39eb 3a32 48a8 48a9 +39ed 39ec 47ed 48aa +39ec 3a33 48a9 48aa +39ee 39ed 47ee 48ab +39ed 3a34 48aa 48ab +39ef 39ee 47ef 48ac +39ee 3a35 48ab 48ac +39f0 39ef 47f0 48ad +39ef 3a36 48ac 48ad +39f1 39f0 47f1 48ae +39f0 3a37 48ad 48ae +39f2 39f1 47f2 48af +39f1 3a38 48ae 48af +39f3 39f2 47f3 48b0 +39f2 3a39 48af 48b0 +39f4 39f3 47f4 48b1 +39f3 3a3a 48b0 48b1 +39f5 39f4 47f5 48b2 +39f4 3a3b 48b1 48b2 +39f6 39f5 47f6 48b3 +39f5 3a3c 48b2 48b3 +39f7 39f6 47f7 48b4 +39f6 3a3d 48b3 48b4 +39f8 39f7 47f8 48b5 +39f7 3a3e 48b4 48b5 +39f9 39f8 47f9 48b6 +39f8 3a3f 48b5 48b6 +39fa 39f9 47fa 48b7 +39f9 3a40 48b6 48b7 +39fb 39fa 47fb 48b8 +39fa 3a41 48b7 48b8 +39fc 39fb 47fc 48b9 +39fb 3a42 48b8 48b9 +39fd 39fc 47fd 48ba +39fc 3a43 48b9 48ba +39fe 39fd 47fe 48bb +39fd 3a44 48ba 48bb +39ff 39fe 47ff 48bc +39fe 3a45 48bb 48bc +3a00 39ff 4800 48bd +39ff 3a46 48bc 48bd +3a01 3a00 4801 48be +3a00 3a47 48bd 48be +3a02 3a01 4802 48bf +3a01 3a48 48be 48bf +3a03 3a02 4803 48c0 +3a02 3a49 48bf 48c0 +3a04 3a03 4804 48c1 +3a03 3a4a 48c0 48c1 +3a05 3a04 4805 48c2 +3a04 3a4b 48c1 48c2 +3a06 3a05 4806 48c3 +3a05 3a4c 48c2 48c3 +3a07 3a06 4807 48c4 +3a06 3a4d 48c3 48c4 +3a08 3a07 4808 48c5 +3a07 3a4e 48c4 48c5 +3a09 3a08 4809 48c6 +3a08 3a4f 48c5 48c6 +3a0a 3a09 480a 48c7 +3a09 3a50 48c6 48c7 +3a0b 3a0a 480b 48c8 +3a0a 3a51 48c7 48c8 +3a0c 3a0b 480c 48c9 +3a0b 3a52 48c8 48c9 +3a0d 3a0c 480d 48ca +3a0c 3a53 48c9 48ca +3a0e 3a0d 480e 48cb +3a0d 3a54 48ca 48cb +3a0f 3a0e 480f 48cc +3a0e 3a55 48cb 48cc +3a0f 3a56 48cc 48cd +3a11 3a10 4887 4944 +3a10 3a57 4943 4944 +3a12 3a11 4888 4945 +3a11 3a58 4944 4945 +3a13 3a12 4889 4946 +3a12 3a59 4945 4946 +3a14 3a13 488a 4947 +3a13 3a5a 4946 4947 +3a15 3a14 488b 4948 +3a14 3a5b 4947 4948 +3a16 3a15 488c 4949 +3a15 3a5c 4948 4949 +3a17 3a16 488d 494a +3a16 3a5d 4949 494a +3a18 3a17 488e 494b +3a17 3a5e 494a 494b +3a19 3a18 488f 494c +3a18 3a5f 494b 494c +3a1a 3a19 4890 494d +3a19 3a60 494c 494d +3a1b 3a1a 4891 494e +3a1a 3a61 494d 494e +3a1c 3a1b 4892 494f +3a1b 3a62 494e 494f +3a1d 3a1c 4893 4950 +3a1c 3a63 494f 4950 +3a1e 3a1d 4894 4951 +3a1d 3a64 4950 4951 +3a1f 3a1e 4895 4952 +3a1e 3a65 4951 4952 +3a20 3a1f 4896 4953 +3a1f 3a66 4952 4953 +3a21 3a20 4897 4954 +3a20 3a67 4953 4954 +3a22 3a21 4898 4955 +3a21 3a68 4954 4955 +3a23 3a22 4899 4956 +3a22 3a69 4955 4956 +3a24 3a23 489a 4957 +3a23 3a6a 4956 4957 +3a25 3a24 489b 4958 +3a24 3a6b 4957 4958 +3a26 3a25 489c 4959 +3a25 3a6c 4958 4959 +3a27 3a26 489d 495a +3a26 3a6d 4959 495a +3a28 3a27 489e 495b +3a27 3a6e 495a 495b +3a29 3a28 489f 495c +3a28 3a6f 495b 495c +3a2a 3a29 48a0 495d +3a29 3a70 495c 495d +3a2b 3a2a 48a1 495e +3a2a 3a71 495d 495e +3a2c 3a2b 48a2 495f +3a2b 3a72 495e 495f +3a2d 3a2c 48a3 4960 +3a2c 3a73 495f 4960 +3a2e 3a2d 48a4 4961 +3a2d 3a74 4960 4961 +3a2f 3a2e 48a5 4962 +3a2e 3a75 4961 4962 +3a30 3a2f 48a6 4963 +3a2f 3a76 4962 4963 +3a31 3a30 48a7 4964 +3a30 3a77 4963 4964 +3a32 3a31 48a8 4965 +3a31 3a78 4964 4965 +3a33 3a32 48a9 4966 +3a32 3a79 4965 4966 +3a34 3a33 48aa 4967 +3a33 3a7a 4966 4967 +3a35 3a34 48ab 4968 +3a34 3a7b 4967 4968 +3a36 3a35 48ac 4969 +3a35 3a7c 4968 4969 +3a37 3a36 48ad 496a +3a36 3a7d 4969 496a +3a38 3a37 48ae 496b +3a37 3a7e 496a 496b +3a39 3a38 48af 496c +3a38 3a7f 496b 496c +3a3a 3a39 48b0 496d +3a39 3a80 496c 496d +3a3b 3a3a 48b1 496e +3a3a 3a81 496d 496e +3a3c 3a3b 48b2 496f +3a3b 3a82 496e 496f +3a3d 3a3c 48b3 4970 +3a3c 3a83 496f 4970 +3a3e 3a3d 48b4 4971 +3a3d 3a84 4970 4971 +3a3f 3a3e 48b5 4972 +3a3e 3a85 4971 4972 +3a40 3a3f 48b6 4973 +3a3f 3a86 4972 4973 +3a41 3a40 48b7 4974 +3a40 3a87 4973 4974 +3a42 3a41 48b8 4975 +3a41 3a88 4974 4975 +3a43 3a42 48b9 4976 +3a42 3a89 4975 4976 +3a44 3a43 48ba 4977 +3a43 3a8a 4976 4977 +3a45 3a44 48bb 4978 +3a44 3a8b 4977 4978 +3a46 3a45 48bc 4979 +3a45 3a8c 4978 4979 +3a47 3a46 48bd 497a +3a46 3a8d 4979 497a +3a48 3a47 48be 497b +3a47 3a8e 497a 497b +3a49 3a48 48bf 497c +3a48 3a8f 497b 497c +3a4a 3a49 48c0 497d +3a49 3a90 497c 497d +3a4b 3a4a 48c1 497e +3a4a 3a91 497d 497e +3a4c 3a4b 48c2 497f +3a4b 3a92 497e 497f +3a4d 3a4c 48c3 4980 +3a4c 3a93 497f 4980 +3a4e 3a4d 48c4 4981 +3a4d 3a94 4980 4981 +3a4f 3a4e 48c5 4982 +3a4e 3a95 4981 4982 +3a50 3a4f 48c6 4983 +3a4f 3a96 4982 4983 +3a51 3a50 48c7 4984 +3a50 3a97 4983 4984 +3a52 3a51 48c8 4985 +3a51 3a98 4984 4985 +3a53 3a52 48c9 4986 +3a52 3a99 4985 4986 +3a54 3a53 48ca 4987 +3a53 3a9a 4986 4987 +3a55 3a54 48cb 4988 +3a54 3a9b 4987 4988 +3a56 3a55 48cc 4989 +3a55 3a9c 4988 4989 +3a56 3a9d 4989 498a +3a58 3a57 4944 4a01 +3a57 3a9e 4a00 4a01 +3a59 3a58 4945 4a02 +3a58 3a9f 4a01 4a02 +3a5a 3a59 4946 4a03 +3a59 3aa0 4a02 4a03 +3a5b 3a5a 4947 4a04 +3a5a 3aa1 4a03 4a04 +3a5c 3a5b 4948 4a05 +3a5b 3aa2 4a04 4a05 +3a5d 3a5c 4949 4a06 +3a5c 3aa3 4a05 4a06 +3a5e 3a5d 494a 4a07 +3a5d 3aa4 4a06 4a07 +3a5f 3a5e 494b 4a08 +3a5e 3aa5 4a07 4a08 +3a60 3a5f 494c 4a09 +3a5f 3aa6 4a08 4a09 +3a61 3a60 494d 4a0a +3a60 3aa7 4a09 4a0a +3a62 3a61 494e 4a0b +3a61 3aa8 4a0a 4a0b +3a63 3a62 494f 4a0c +3a62 3aa9 4a0b 4a0c +3a64 3a63 4950 4a0d +3a63 3aaa 4a0c 4a0d +3a65 3a64 4951 4a0e +3a64 3aab 4a0d 4a0e +3a66 3a65 4952 4a0f +3a65 3aac 4a0e 4a0f +3a67 3a66 4953 4a10 +3a66 3aad 4a0f 4a10 +3a68 3a67 4954 4a11 +3a67 3aae 4a10 4a11 +3a69 3a68 4955 4a12 +3a68 3aaf 4a11 4a12 +3a6a 3a69 4956 4a13 +3a69 3ab0 4a12 4a13 +3a6b 3a6a 4957 4a14 +3a6a 3ab1 4a13 4a14 +3a6c 3a6b 4958 4a15 +3a6b 3ab2 4a14 4a15 +3a6d 3a6c 4959 4a16 +3a6c 3ab3 4a15 4a16 +3a6e 3a6d 495a 4a17 +3a6d 3ab4 4a16 4a17 +3a6f 3a6e 495b 4a18 +3a6e 3ab5 4a17 4a18 +3a70 3a6f 495c 4a19 +3a6f 3ab6 4a18 4a19 +3a71 3a70 495d 4a1a +3a70 3ab7 4a19 4a1a +3a72 3a71 495e 4a1b +3a71 3ab8 4a1a 4a1b +3a73 3a72 495f 4a1c +3a72 3ab9 4a1b 4a1c +3a74 3a73 4960 4a1d +3a73 3aba 4a1c 4a1d +3a75 3a74 4961 4a1e +3a74 3abb 4a1d 4a1e +3a76 3a75 4962 4a1f +3a75 3abc 4a1e 4a1f +3a77 3a76 4963 4a20 +3a76 3abd 4a1f 4a20 +3a78 3a77 4964 4a21 +3a77 3abe 4a20 4a21 +3a79 3a78 4965 4a22 +3a78 3abf 4a21 4a22 +3a7a 3a79 4966 4a23 +3a79 3ac0 4a22 4a23 +3a7b 3a7a 4967 4a24 +3a7a 3ac1 4a23 4a24 +3a7c 3a7b 4968 4a25 +3a7b 3ac2 4a24 4a25 +3a7d 3a7c 4969 4a26 +3a7c 3ac3 4a25 4a26 +3a7e 3a7d 496a 4a27 +3a7d 3ac4 4a26 4a27 +3a7f 3a7e 496b 4a28 +3a7e 3ac5 4a27 4a28 +3a80 3a7f 496c 4a29 +3a7f 3ac6 4a28 4a29 +3a81 3a80 496d 4a2a +3a80 3ac7 4a29 4a2a +3a82 3a81 496e 4a2b +3a81 3ac8 4a2a 4a2b +3a83 3a82 496f 4a2c +3a82 3ac9 4a2b 4a2c +3a84 3a83 4970 4a2d +3a83 3aca 4a2c 4a2d +3a85 3a84 4971 4a2e +3a84 3acb 4a2d 4a2e +3a86 3a85 4972 4a2f +3a85 3acc 4a2e 4a2f +3a87 3a86 4973 4a30 +3a86 3acd 4a2f 4a30 +3a88 3a87 4974 4a31 +3a87 3ace 4a30 4a31 +3a89 3a88 4975 4a32 +3a88 3acf 4a31 4a32 +3a8a 3a89 4976 4a33 +3a89 3ad0 4a32 4a33 +3a8b 3a8a 4977 4a34 +3a8a 3ad1 4a33 4a34 +3a8c 3a8b 4978 4a35 +3a8b 3ad2 4a34 4a35 +3a8d 3a8c 4979 4a36 +3a8c 3ad3 4a35 4a36 +3a8e 3a8d 497a 4a37 +3a8d 3ad4 4a36 4a37 +3a8f 3a8e 497b 4a38 +3a8e 3ad5 4a37 4a38 +3a90 3a8f 497c 4a39 +3a8f 3ad6 4a38 4a39 +3a91 3a90 497d 4a3a +3a90 3ad7 4a39 4a3a +3a92 3a91 497e 4a3b +3a91 3ad8 4a3a 4a3b +3a93 3a92 497f 4a3c +3a92 3ad9 4a3b 4a3c +3a94 3a93 4980 4a3d +3a93 3ada 4a3c 4a3d +3a95 3a94 4981 4a3e +3a94 3adb 4a3d 4a3e +3a96 3a95 4982 4a3f +3a95 3adc 4a3e 4a3f +3a97 3a96 4983 4a40 +3a96 3add 4a3f 4a40 +3a98 3a97 4984 4a41 +3a97 3ade 4a40 4a41 +3a99 3a98 4985 4a42 +3a98 3adf 4a41 4a42 +3a9a 3a99 4986 4a43 +3a99 3ae0 4a42 4a43 +3a9b 3a9a 4987 4a44 +3a9a 3ae1 4a43 4a44 +3a9c 3a9b 4988 4a45 +3a9b 3ae2 4a44 4a45 +3a9d 3a9c 4989 4a46 +3a9c 3ae3 4a45 4a46 +3a9d 3ae4 4a46 4a47 +3a9f 3a9e 4a01 4abe +3a9e 3ae5 4abd 4abe +3aa0 3a9f 4a02 4abf +3a9f 3ae6 4abe 4abf +3aa1 3aa0 4a03 4ac0 +3aa0 3ae7 4abf 4ac0 +3aa2 3aa1 4a04 4ac1 +3aa1 3ae8 4ac0 4ac1 +3aa3 3aa2 4a05 4ac2 +3aa2 3ae9 4ac1 4ac2 +3aa4 3aa3 4a06 4ac3 +3aa3 3aea 4ac2 4ac3 +3aa5 3aa4 4a07 4ac4 +3aa4 3aeb 4ac3 4ac4 +3aa6 3aa5 4a08 4ac5 +3aa5 3aec 4ac4 4ac5 +3aa7 3aa6 4a09 4ac6 +3aa6 3aed 4ac5 4ac6 +3aa8 3aa7 4a0a 4ac7 +3aa7 3aee 4ac6 4ac7 +3aa9 3aa8 4a0b 4ac8 +3aa8 3aef 4ac7 4ac8 +3aaa 3aa9 4a0c 4ac9 +3aa9 3af0 4ac8 4ac9 +3aab 3aaa 4a0d 4aca +3aaa 3af1 4ac9 4aca +3aac 3aab 4a0e 4acb +3aab 3af2 4aca 4acb +3aad 3aac 4a0f 4acc +3aac 3af3 4acb 4acc +3aae 3aad 4a10 4acd +3aad 3af4 4acc 4acd +3aaf 3aae 4a11 4ace +3aae 3af5 4acd 4ace +3ab0 3aaf 4a12 4acf +3aaf 3af6 4ace 4acf +3ab1 3ab0 4a13 4ad0 +3ab0 3af7 4acf 4ad0 +3ab2 3ab1 4a14 4ad1 +3ab1 3af8 4ad0 4ad1 +3ab3 3ab2 4a15 4ad2 +3ab2 3af9 4ad1 4ad2 +3ab4 3ab3 4a16 4ad3 +3ab3 3afa 4ad2 4ad3 +3ab5 3ab4 4a17 4ad4 +3ab4 3afb 4ad3 4ad4 +3ab6 3ab5 4a18 4ad5 +3ab5 3afc 4ad4 4ad5 +3ab7 3ab6 4a19 4ad6 +3ab6 3afd 4ad5 4ad6 +3ab8 3ab7 4a1a 4ad7 +3ab7 3afe 4ad6 4ad7 +3ab9 3ab8 4a1b 4ad8 +3ab8 3aff 4ad7 4ad8 +3aba 3ab9 4a1c 4ad9 +3ab9 3b00 4ad8 4ad9 +3abb 3aba 4a1d 4ada +3aba 3b01 4ad9 4ada +3abc 3abb 4a1e 4adb +3abb 3b02 4ada 4adb +3abd 3abc 4a1f 4adc +3abc 3b03 4adb 4adc +3abe 3abd 4a20 4add +3abd 3b04 4adc 4add +3abf 3abe 4a21 4ade +3abe 3b05 4add 4ade +3ac0 3abf 4a22 4adf +3abf 3b06 4ade 4adf +3ac1 3ac0 4a23 4ae0 +3ac0 3b07 4adf 4ae0 +3ac2 3ac1 4a24 4ae1 +3ac1 3b08 4ae0 4ae1 +3ac3 3ac2 4a25 4ae2 +3ac2 3b09 4ae1 4ae2 +3ac4 3ac3 4a26 4ae3 +3ac3 3b0a 4ae2 4ae3 +3ac5 3ac4 4a27 4ae4 +3ac4 3b0b 4ae3 4ae4 +3ac6 3ac5 4a28 4ae5 +3ac5 3b0c 4ae4 4ae5 +3ac7 3ac6 4a29 4ae6 +3ac6 3b0d 4ae5 4ae6 +3ac8 3ac7 4a2a 4ae7 +3ac7 3b0e 4ae6 4ae7 +3ac9 3ac8 4a2b 4ae8 +3ac8 3b0f 4ae7 4ae8 +3aca 3ac9 4a2c 4ae9 +3ac9 3b10 4ae8 4ae9 +3acb 3aca 4a2d 4aea +3aca 3b11 4ae9 4aea +3acc 3acb 4a2e 4aeb +3acb 3b12 4aea 4aeb +3acd 3acc 4a2f 4aec +3acc 3b13 4aeb 4aec +3ace 3acd 4a30 4aed +3acd 3b14 4aec 4aed +3acf 3ace 4a31 4aee +3ace 3b15 4aed 4aee +3ad0 3acf 4a32 4aef +3acf 3b16 4aee 4aef +3ad1 3ad0 4a33 4af0 +3ad0 3b17 4aef 4af0 +3ad2 3ad1 4a34 4af1 +3ad1 3b18 4af0 4af1 +3ad3 3ad2 4a35 4af2 +3ad2 3b19 4af1 4af2 +3ad4 3ad3 4a36 4af3 +3ad3 3b1a 4af2 4af3 +3ad5 3ad4 4a37 4af4 +3ad4 3b1b 4af3 4af4 +3ad6 3ad5 4a38 4af5 +3ad5 3b1c 4af4 4af5 +3ad7 3ad6 4a39 4af6 +3ad6 3b1d 4af5 4af6 +3ad8 3ad7 4a3a 4af7 +3ad7 3b1e 4af6 4af7 +3ad9 3ad8 4a3b 4af8 +3ad8 3b1f 4af7 4af8 +3ada 3ad9 4a3c 4af9 +3ad9 3b20 4af8 4af9 +3adb 3ada 4a3d 4afa +3ada 3b21 4af9 4afa +3adc 3adb 4a3e 4afb +3adb 3b22 4afa 4afb +3add 3adc 4a3f 4afc +3adc 3b23 4afb 4afc +3ade 3add 4a40 4afd +3add 3b24 4afc 4afd +3adf 3ade 4a41 4afe +3ade 3b25 4afd 4afe +3ae0 3adf 4a42 4aff +3adf 3b26 4afe 4aff +3ae1 3ae0 4a43 4b00 +3ae0 3b27 4aff 4b00 +3ae2 3ae1 4a44 4b01 +3ae1 3b28 4b00 4b01 +3ae3 3ae2 4a45 4b02 +3ae2 3b29 4b01 4b02 +3ae4 3ae3 4a46 4b03 +3ae3 3b2a 4b02 4b03 +3ae4 3b2b 4b03 4b04 +3ae6 3ae5 4abe 4b7b +3ae7 3ae6 4abf 4b7c +3ae8 3ae7 4ac0 4b7d +3ae9 3ae8 4ac1 4b7e +3aea 3ae9 4ac2 4b7f +3aeb 3aea 4ac3 4b80 +3aec 3aeb 4ac4 4b81 +3aed 3aec 4ac5 4b82 +3aee 3aed 4ac6 4b83 +3aef 3aee 4ac7 4b84 +3af0 3aef 4ac8 4b85 +3af1 3af0 4ac9 4b86 +3af2 3af1 4aca 4b87 +3af3 3af2 4acb 4b88 +3af4 3af3 4acc 4b89 +3af5 3af4 4acd 4b8a +3af6 3af5 4ace 4b8b +3af7 3af6 4acf 4b8c +3af8 3af7 4ad0 4b8d +3af9 3af8 4ad1 4b8e +3afa 3af9 4ad2 4b8f +3afb 3afa 4ad3 4b90 +3afc 3afb 4ad4 4b91 +3afd 3afc 4ad5 4b92 +3afe 3afd 4ad6 4b93 +3aff 3afe 4ad7 4b94 +3b00 3aff 4ad8 4b95 +3b01 3b00 4ad9 4b96 +3b02 3b01 4ada 4b97 +3b03 3b02 4adb 4b98 +3b04 3b03 4adc 4b99 +3b05 3b04 4add 4b9a +3b06 3b05 4ade 4b9b +3b07 3b06 4adf 4b9c +3b08 3b07 4ae0 4b9d +3b09 3b08 4ae1 4b9e +3b0a 3b09 4ae2 4b9f +3b0b 3b0a 4ae3 4ba0 +3b0c 3b0b 4ae4 4ba1 +3b0d 3b0c 4ae5 4ba2 +3b0e 3b0d 4ae6 4ba3 +3b0f 3b0e 4ae7 4ba4 +3b10 3b0f 4ae8 4ba5 +3b11 3b10 4ae9 4ba6 +3b12 3b11 4aea 4ba7 +3b13 3b12 4aeb 4ba8 +3b14 3b13 4aec 4ba9 +3b15 3b14 4aed 4baa +3b16 3b15 4aee 4bab +3b17 3b16 4aef 4bac +3b18 3b17 4af0 4bad +3b19 3b18 4af1 4bae +3b1a 3b19 4af2 4baf +3b1b 3b1a 4af3 4bb0 +3b1c 3b1b 4af4 4bb1 +3b1d 3b1c 4af5 4bb2 +3b1e 3b1d 4af6 4bb3 +3b1f 3b1e 4af7 4bb4 +3b20 3b1f 4af8 4bb5 +3b21 3b20 4af9 4bb6 +3b22 3b21 4afa 4bb7 +3b23 3b22 4afb 4bb8 +3b24 3b23 4afc 4bb9 +3b25 3b24 4afd 4bba +3b26 3b25 4afe 4bbb +3b27 3b26 4aff 4bbc +3b28 3b27 4b00 4bbd +3b29 3b28 4b01 4bbe +3b2a 3b29 4b02 4bbf +3b2b 3b2a 4b03 4bc0 +3b2c 3b2d 3789 378a +3b2c 3b49 36cc 3789 +3b2d 3b2e 3846 3847 +3b2d 3b4a 3789 3846 +3b2e 3b2f 3903 3904 +3b2e 3b4b 3846 3903 +3b2f 3b30 39c0 39c1 +3b2f 3b4c 3903 39c0 +3b30 3b31 3a7d 3a7e +3b30 3b4d 39c0 3a7d +3b31 3b32 3b3a 3b3b +3b31 3b4e 3a7d 3b3a +3b32 3b33 3bf7 3bf8 +3b32 3b4f 3b3a 3bf7 +3b33 3b34 3cb4 3cb5 +3b33 3b50 3bf7 3cb4 +3b34 3b35 3d71 3d72 +3b34 3b51 3cb4 3d71 +3b35 3b36 3e2e 3e2f +3b35 3b52 3d71 3e2e +3b36 3b37 3eeb 3eec +3b36 3b53 3e2e 3eeb +3b37 3b38 3fa8 3fa9 +3b37 3b54 3eeb 3fa8 +3b38 3b39 4065 4066 +3b38 3b55 3fa8 4065 +3b39 3b3a 4122 4123 +3b39 3b56 4065 4122 +3b3a 3b3b 41df 41e0 +3b3a 3b57 4122 41df +3b3b 3b3c 429c 429d +3b3b 3b58 41df 429c +3b3c 3b3d 4359 435a +3b3c 3b59 429c 4359 +3b3d 3b3e 4416 4417 +3b3d 3b5a 4359 4416 +3b3e 3b3f 44d3 44d4 +3b3e 3b5b 4416 44d3 +3b3f 3b40 4590 4591 +3b3f 3b5c 44d3 4590 +3b40 3b41 464d 464e +3b40 3b5d 4590 464d +3b41 3b42 470a 470b +3b41 3b5e 464d 470a +3b42 3b43 47c7 47c8 +3b42 3b5f 470a 47c7 +3b43 3b44 4884 4885 +3b43 3b60 47c7 4884 +3b44 3b45 4941 4942 +3b44 3b61 4884 4941 +3b45 3b46 49fe 49ff +3b45 3b62 4941 49fe +3b46 3b47 4abb 4abc +3b46 3b63 49fe 4abb +3b47 3b48 4b78 4b79 +3b47 3b64 4abb 4b78 +3b48 3b65 4b78 4c35 +3b49 3b4a 3788 3789 +3b49 3b66 36cb 3788 +3b4a 3b4b 3845 3846 +3b4a 3b67 3788 3845 +3b4b 3b4c 3902 3903 +3b4b 3b68 3845 3902 +3b4c 3b4d 39bf 39c0 +3b4c 3b69 3902 39bf +3b4d 3b4e 3a7c 3a7d +3b4d 3b6a 39bf 3a7c +3b4e 3b4f 3b39 3b3a +3b4e 3b6b 3a7c 3b39 +3b4f 3b50 3bf6 3bf7 +3b4f 3b6c 3b39 3bf6 +3b50 3b51 3cb3 3cb4 +3b50 3b6d 3bf6 3cb3 +3b51 3b52 3d70 3d71 +3b51 3b6e 3cb3 3d70 +3b52 3b53 3e2d 3e2e +3b52 3b6f 3d70 3e2d +3b53 3b54 3eea 3eeb +3b53 3b70 3e2d 3eea +3b54 3b55 3fa7 3fa8 +3b54 3b71 3eea 3fa7 +3b55 3b56 4064 4065 +3b55 3b72 3fa7 4064 +3b56 3b57 4121 4122 +3b56 3b73 4064 4121 +3b57 3b58 41de 41df +3b57 3b74 4121 41de +3b58 3b59 429b 429c +3b58 3b75 41de 429b +3b59 3b5a 4358 4359 +3b59 3b76 429b 4358 +3b5a 3b5b 4415 4416 +3b5a 3b77 4358 4415 +3b5b 3b5c 44d2 44d3 +3b5b 3b78 4415 44d2 +3b5c 3b5d 458f 4590 +3b5c 3b79 44d2 458f +3b5d 3b5e 464c 464d +3b5d 3b7a 458f 464c +3b5e 3b5f 4709 470a +3b5e 3b7b 464c 4709 +3b5f 3b60 47c6 47c7 +3b5f 3b7c 4709 47c6 +3b60 3b61 4883 4884 +3b60 3b7d 47c6 4883 +3b61 3b62 4940 4941 +3b61 3b7e 4883 4940 +3b62 3b63 49fd 49fe +3b62 3b7f 4940 49fd +3b63 3b64 4aba 4abb +3b63 3b80 49fd 4aba +3b64 3b65 4b77 4b78 +3b64 3b81 4aba 4b77 +3b65 3b82 4b77 4c34 +3b66 3b67 3787 3788 +3b66 3b83 36ca 3787 +3b67 3b68 3844 3845 +3b67 3b84 3787 3844 +3b68 3b69 3901 3902 +3b68 3b85 3844 3901 +3b69 3b6a 39be 39bf +3b69 3b86 3901 39be +3b6a 3b6b 3a7b 3a7c +3b6a 3b87 39be 3a7b +3b6b 3b6c 3b38 3b39 +3b6b 3b88 3a7b 3b38 +3b6c 3b6d 3bf5 3bf6 +3b6c 3b89 3b38 3bf5 +3b6d 3b6e 3cb2 3cb3 +3b6d 3b8a 3bf5 3cb2 +3b6e 3b6f 3d6f 3d70 +3b6e 3b8b 3cb2 3d6f +3b6f 3b70 3e2c 3e2d +3b6f 3b8c 3d6f 3e2c +3b70 3b71 3ee9 3eea +3b70 3b8d 3e2c 3ee9 +3b71 3b72 3fa6 3fa7 +3b71 3b8e 3ee9 3fa6 +3b72 3b73 4063 4064 +3b72 3b8f 3fa6 4063 +3b73 3b74 4120 4121 +3b73 3b90 4063 4120 +3b74 3b75 41dd 41de +3b74 3b91 4120 41dd +3b75 3b76 429a 429b +3b75 3b92 41dd 429a +3b76 3b77 4357 4358 +3b76 3b93 429a 4357 +3b77 3b78 4414 4415 +3b77 3b94 4357 4414 +3b78 3b79 44d1 44d2 +3b78 3b95 4414 44d1 +3b79 3b7a 458e 458f +3b79 3b96 44d1 458e +3b7a 3b7b 464b 464c +3b7a 3b97 458e 464b +3b7b 3b7c 4708 4709 +3b7b 3b98 464b 4708 +3b7c 3b7d 47c5 47c6 +3b7c 3b99 4708 47c5 +3b7d 3b7e 4882 4883 +3b7d 3b9a 47c5 4882 +3b7e 3b7f 493f 4940 +3b7e 3b9b 4882 493f +3b7f 3b80 49fc 49fd +3b7f 3b9c 493f 49fc +3b80 3b81 4ab9 4aba +3b80 3b9d 49fc 4ab9 +3b81 3b82 4b76 4b77 +3b81 3b9e 4ab9 4b76 +3b82 3b9f 4b76 4c33 +3b83 3b84 3786 3787 +3b83 3ba0 36c9 3786 +3b84 3b85 3843 3844 +3b84 3ba1 3786 3843 +3b85 3b86 3900 3901 +3b85 3ba2 3843 3900 +3b86 3b87 39bd 39be +3b86 3ba3 3900 39bd +3b87 3b88 3a7a 3a7b +3b87 3ba4 39bd 3a7a +3b88 3b89 3b37 3b38 +3b88 3ba5 3a7a 3b37 +3b89 3b8a 3bf4 3bf5 +3b89 3ba6 3b37 3bf4 +3b8a 3b8b 3cb1 3cb2 +3b8a 3ba7 3bf4 3cb1 +3b8b 3b8c 3d6e 3d6f +3b8b 3ba8 3cb1 3d6e +3b8c 3b8d 3e2b 3e2c +3b8c 3ba9 3d6e 3e2b +3b8d 3b8e 3ee8 3ee9 +3b8d 3baa 3e2b 3ee8 +3b8e 3b8f 3fa5 3fa6 +3b8e 3bab 3ee8 3fa5 +3b8f 3b90 4062 4063 +3b8f 3bac 3fa5 4062 +3b90 3b91 411f 4120 +3b90 3bad 4062 411f +3b91 3b92 41dc 41dd +3b91 3bae 411f 41dc +3b92 3b93 4299 429a +3b92 3baf 41dc 4299 +3b93 3b94 4356 4357 +3b93 3bb0 4299 4356 +3b94 3b95 4413 4414 +3b94 3bb1 4356 4413 +3b95 3b96 44d0 44d1 +3b95 3bb2 4413 44d0 +3b96 3b97 458d 458e +3b96 3bb3 44d0 458d +3b97 3b98 464a 464b +3b97 3bb4 458d 464a +3b98 3b99 4707 4708 +3b98 3bb5 464a 4707 +3b99 3b9a 47c4 47c5 +3b99 3bb6 4707 47c4 +3b9a 3b9b 4881 4882 +3b9a 3bb7 47c4 4881 +3b9b 3b9c 493e 493f +3b9b 3bb8 4881 493e +3b9c 3b9d 49fb 49fc +3b9c 3bb9 493e 49fb +3b9d 3b9e 4ab8 4ab9 +3b9d 3bba 49fb 4ab8 +3b9e 3b9f 4b75 4b76 +3b9e 3bbb 4ab8 4b75 +3b9f 3bbc 4b75 4c32 +3ba0 3ba1 3785 3786 +3ba0 3bbd 36c8 3785 +3ba1 3ba2 3842 3843 +3ba1 3bbe 3785 3842 +3ba2 3ba3 38ff 3900 +3ba2 3bbf 3842 38ff +3ba3 3ba4 39bc 39bd +3ba3 3bc0 38ff 39bc +3ba4 3ba5 3a79 3a7a +3ba4 3bc1 39bc 3a79 +3ba5 3ba6 3b36 3b37 +3ba5 3bc2 3a79 3b36 +3ba6 3ba7 3bf3 3bf4 +3ba6 3bc3 3b36 3bf3 +3ba7 3ba8 3cb0 3cb1 +3ba7 3bc4 3bf3 3cb0 +3ba8 3ba9 3d6d 3d6e +3ba8 3bc5 3cb0 3d6d +3ba9 3baa 3e2a 3e2b +3ba9 3bc6 3d6d 3e2a +3baa 3bab 3ee7 3ee8 +3baa 3bc7 3e2a 3ee7 +3bab 3bac 3fa4 3fa5 +3bab 3bc8 3ee7 3fa4 +3bac 3bad 4061 4062 +3bac 3bc9 3fa4 4061 +3bad 3bae 411e 411f +3bad 3bca 4061 411e +3bae 3baf 41db 41dc +3bae 3bcb 411e 41db +3baf 3bb0 4298 4299 +3baf 3bcc 41db 4298 +3bb0 3bb1 4355 4356 +3bb0 3bcd 4298 4355 +3bb1 3bb2 4412 4413 +3bb1 3bce 4355 4412 +3bb2 3bb3 44cf 44d0 +3bb2 3bcf 4412 44cf +3bb3 3bb4 458c 458d +3bb3 3bd0 44cf 458c +3bb4 3bb5 4649 464a +3bb4 3bd1 458c 4649 +3bb5 3bb6 4706 4707 +3bb5 3bd2 4649 4706 +3bb6 3bb7 47c3 47c4 +3bb6 3bd3 4706 47c3 +3bb7 3bb8 4880 4881 +3bb7 3bd4 47c3 4880 +3bb8 3bb9 493d 493e +3bb8 3bd5 4880 493d +3bb9 3bba 49fa 49fb +3bb9 3bd6 493d 49fa +3bba 3bbb 4ab7 4ab8 +3bba 3bd7 49fa 4ab7 +3bbb 3bbc 4b74 4b75 +3bbb 3bd8 4ab7 4b74 +3bbc 3bd9 4b74 4c31 +3bbd 3bbe 3784 3785 +3bbd 3bda 36c7 3784 +3bbe 3bbf 3841 3842 +3bbe 3bdb 3784 3841 +3bbf 3bc0 38fe 38ff +3bbf 3bdc 3841 38fe +3bc0 3bc1 39bb 39bc +3bc0 3bdd 38fe 39bb +3bc1 3bc2 3a78 3a79 +3bc1 3bde 39bb 3a78 +3bc2 3bc3 3b35 3b36 +3bc2 3bdf 3a78 3b35 +3bc3 3bc4 3bf2 3bf3 +3bc3 3be0 3b35 3bf2 +3bc4 3bc5 3caf 3cb0 +3bc4 3be1 3bf2 3caf +3bc5 3bc6 3d6c 3d6d +3bc5 3be2 3caf 3d6c +3bc6 3bc7 3e29 3e2a +3bc6 3be3 3d6c 3e29 +3bc7 3bc8 3ee6 3ee7 +3bc7 3be4 3e29 3ee6 +3bc8 3bc9 3fa3 3fa4 +3bc8 3be5 3ee6 3fa3 +3bc9 3bca 4060 4061 +3bc9 3be6 3fa3 4060 +3bca 3bcb 411d 411e +3bca 3be7 4060 411d +3bcb 3bcc 41da 41db +3bcb 3be8 411d 41da +3bcc 3bcd 4297 4298 +3bcc 3be9 41da 4297 +3bcd 3bce 4354 4355 +3bcd 3bea 4297 4354 +3bce 3bcf 4411 4412 +3bce 3beb 4354 4411 +3bcf 3bd0 44ce 44cf +3bcf 3bec 4411 44ce +3bd0 3bd1 458b 458c +3bd0 3bed 44ce 458b +3bd1 3bd2 4648 4649 +3bd1 3bee 458b 4648 +3bd2 3bd3 4705 4706 +3bd2 3bef 4648 4705 +3bd3 3bd4 47c2 47c3 +3bd3 3bf0 4705 47c2 +3bd4 3bd5 487f 4880 +3bd4 3bf1 47c2 487f +3bd5 3bd6 493c 493d +3bd5 3bf2 487f 493c +3bd6 3bd7 49f9 49fa +3bd6 3bf3 493c 49f9 +3bd7 3bd8 4ab6 4ab7 +3bd7 3bf4 49f9 4ab6 +3bd8 3bd9 4b73 4b74 +3bd8 3bf5 4ab6 4b73 +3bd9 3bf6 4b73 4c30 +3bda 3bdb 3783 3784 +3bda 3bf7 36c6 3783 +3bdb 3bdc 3840 3841 +3bdb 3bf8 3783 3840 +3bdc 3bdd 38fd 38fe +3bdc 3bf9 3840 38fd +3bdd 3bde 39ba 39bb +3bdd 3bfa 38fd 39ba +3bde 3bdf 3a77 3a78 +3bde 3bfb 39ba 3a77 +3bdf 3be0 3b34 3b35 +3bdf 3bfc 3a77 3b34 +3be0 3be1 3bf1 3bf2 +3be0 3bfd 3b34 3bf1 +3be1 3be2 3cae 3caf +3be1 3bfe 3bf1 3cae +3be2 3be3 3d6b 3d6c +3be2 3bff 3cae 3d6b +3be3 3be4 3e28 3e29 +3be3 3c00 3d6b 3e28 +3be4 3be5 3ee5 3ee6 +3be4 3c01 3e28 3ee5 +3be5 3be6 3fa2 3fa3 +3be5 3c02 3ee5 3fa2 +3be6 3be7 405f 4060 +3be6 3c03 3fa2 405f +3be7 3be8 411c 411d +3be7 3c04 405f 411c +3be8 3be9 41d9 41da +3be8 3c05 411c 41d9 +3be9 3bea 4296 4297 +3be9 3c06 41d9 4296 +3bea 3beb 4353 4354 +3bea 3c07 4296 4353 +3beb 3bec 4410 4411 +3beb 3c08 4353 4410 +3bec 3bed 44cd 44ce +3bec 3c09 4410 44cd +3bed 3bee 458a 458b +3bed 3c0a 44cd 458a +3bee 3bef 4647 4648 +3bee 3c0b 458a 4647 +3bef 3bf0 4704 4705 +3bef 3c0c 4647 4704 +3bf0 3bf1 47c1 47c2 +3bf0 3c0d 4704 47c1 +3bf1 3bf2 487e 487f +3bf1 3c0e 47c1 487e +3bf2 3bf3 493b 493c +3bf2 3c0f 487e 493b +3bf3 3bf4 49f8 49f9 +3bf3 3c10 493b 49f8 +3bf4 3bf5 4ab5 4ab6 +3bf4 3c11 49f8 4ab5 +3bf5 3bf6 4b72 4b73 +3bf5 3c12 4ab5 4b72 +3bf6 3c13 4b72 4c2f +3bf7 3bf8 3782 3783 +3bf7 3c14 36c5 3782 +3bf8 3bf9 383f 3840 +3bf8 3c15 3782 383f +3bf9 3bfa 38fc 38fd +3bf9 3c16 383f 38fc +3bfa 3bfb 39b9 39ba +3bfa 3c17 38fc 39b9 +3bfb 3bfc 3a76 3a77 +3bfb 3c18 39b9 3a76 +3bfc 3bfd 3b33 3b34 +3bfc 3c19 3a76 3b33 +3bfd 3bfe 3bf0 3bf1 +3bfd 3c1a 3b33 3bf0 +3bfe 3bff 3cad 3cae +3bfe 3c1b 3bf0 3cad +3bff 3c00 3d6a 3d6b +3bff 3c1c 3cad 3d6a +3c00 3c01 3e27 3e28 +3c00 3c1d 3d6a 3e27 +3c01 3c02 3ee4 3ee5 +3c01 3c1e 3e27 3ee4 +3c02 3c03 3fa1 3fa2 +3c02 3c1f 3ee4 3fa1 +3c03 3c04 405e 405f +3c03 3c20 3fa1 405e +3c04 3c05 411b 411c +3c04 3c21 405e 411b +3c05 3c06 41d8 41d9 +3c05 3c22 411b 41d8 +3c06 3c07 4295 4296 +3c06 3c23 41d8 4295 +3c07 3c08 4352 4353 +3c07 3c24 4295 4352 +3c08 3c09 440f 4410 +3c08 3c25 4352 440f +3c09 3c0a 44cc 44cd +3c09 3c26 440f 44cc +3c0a 3c0b 4589 458a +3c0a 3c27 44cc 4589 +3c0b 3c0c 4646 4647 +3c0b 3c28 4589 4646 +3c0c 3c0d 4703 4704 +3c0c 3c29 4646 4703 +3c0d 3c0e 47c0 47c1 +3c0d 3c2a 4703 47c0 +3c0e 3c0f 487d 487e +3c0e 3c2b 47c0 487d +3c0f 3c10 493a 493b +3c0f 3c2c 487d 493a +3c10 3c11 49f7 49f8 +3c10 3c2d 493a 49f7 +3c11 3c12 4ab4 4ab5 +3c11 3c2e 49f7 4ab4 +3c12 3c13 4b71 4b72 +3c12 3c2f 4ab4 4b71 +3c13 3c30 4b71 4c2e +3c14 3c15 3781 3782 +3c15 3c16 383e 383f +3c16 3c17 38fb 38fc +3c17 3c18 39b8 39b9 +3c18 3c19 3a75 3a76 +3c19 3c1a 3b32 3b33 +3c1a 3c1b 3bef 3bf0 +3c1b 3c1c 3cac 3cad +3c1c 3c1d 3d69 3d6a +3c1d 3c1e 3e26 3e27 +3c1e 3c1f 3ee3 3ee4 +3c1f 3c20 3fa0 3fa1 +3c20 3c21 405d 405e +3c21 3c22 411a 411b +3c22 3c23 41d7 41d8 +3c23 3c24 4294 4295 +3c24 3c25 4351 4352 +3c25 3c26 440e 440f +3c26 3c27 44cb 44cc +3c27 3c28 4588 4589 +3c28 3c29 4645 4646 +3c29 3c2a 4702 4703 +3c2a 3c2b 47bf 47c0 +3c2b 3c2c 487c 487d +3c2c 3c2d 4939 493a +3c2d 3c2e 49f6 49f7 +3c2e 3c2f 4ab3 4ab4 +3c2f 3c30 4b70 4b71 +3c31 3c32 12a5 12a6 +3c53 3c31 1196 12a6 +3c32 3c33 13b5 13b6 +3c54 3c32 12a6 13b6 +3c33 3c34 14c5 14c6 +3c55 3c33 13b6 14c6 +3c34 3c35 15d5 15d6 +3c56 3c34 14c6 15d6 +3c35 3c36 16e5 16e6 +3c57 3c35 15d6 16e6 +3c36 3c37 17f5 17f6 +3c58 3c36 16e6 17f6 +3c37 3c38 1905 1906 +3c59 3c37 17f6 1906 +3c38 3c39 1a15 1a16 +3c5a 3c38 1906 1a16 +3c39 3c3a 1b25 1b26 +3c5b 3c39 1a16 1b26 +3c3a 3c3b 1c35 1c36 +3c5c 3c3a 1b26 1c36 +3c3b 3c3c 1d45 1d46 +3c5d 3c3b 1c36 1d46 +3c3c 3c3d 1e55 1e56 +3c5e 3c3c 1d46 1e56 +3c3d 3c3e 1f65 1f66 +3c5f 3c3d 1e56 1f66 +3c3e 3c3f 2075 2076 +3c60 3c3e 1f66 2076 +3c3f 3c40 2185 2186 +3c61 3c3f 2076 2186 +3c40 3c41 2295 2296 +3c62 3c40 2186 2296 +3c41 3c42 23a5 23a6 +3c63 3c41 2296 23a6 +3c42 3c43 24b5 24b6 +3c64 3c42 23a6 24b6 +3c43 3c44 25c5 25c6 +3c65 3c43 24b6 25c6 +3c44 3c45 26d5 26d6 +3c66 3c44 25c6 26d6 +3c45 3c46 27e5 27e6 +3c67 3c45 26d6 27e6 +3c46 3c47 28f5 28f6 +3c68 3c46 27e6 28f6 +3c47 3c48 2a05 2a06 +3c69 3c47 28f6 2a06 +3c48 3c49 2b15 2b16 +3c6a 3c48 2a06 2b16 +3c49 3c4a 2c25 2c26 +3c6b 3c49 2b16 2c26 +3c4a 3c4b 2d35 2d36 +3c6c 3c4a 2c26 2d36 +3c4b 3c4c 2e45 2e46 +3c6d 3c4b 2d36 2e46 +3c4c 3c4d 2f55 2f56 +3c6e 3c4c 2e46 2f56 +3c4d 3c4e 3065 3066 +3c6f 3c4d 2f56 3066 +3c4e 3c4f 3175 3176 +3c70 3c4e 3066 3176 +3c4f 3c50 3285 3286 +3c71 3c4f 3176 3286 +3c50 3c51 3395 3396 +3c72 3c50 3286 3396 +3c51 3c52 34a5 34a6 +3c73 3c51 3396 34a6 +3c74 3c52 34a6 35b6 +3c53 3c54 12a6 12a7 +3c75 3c53 1197 12a7 +3c54 3c55 13b6 13b7 +3c76 3c54 12a7 13b7 +3c55 3c56 14c6 14c7 +3c77 3c55 13b7 14c7 +3c56 3c57 15d6 15d7 +3c78 3c56 14c7 15d7 +3c57 3c58 16e6 16e7 +3c79 3c57 15d7 16e7 +3c58 3c59 17f6 17f7 +3c7a 3c58 16e7 17f7 +3c59 3c5a 1906 1907 +3c7b 3c59 17f7 1907 +3c5a 3c5b 1a16 1a17 +3c7c 3c5a 1907 1a17 +3c5b 3c5c 1b26 1b27 +3c7d 3c5b 1a17 1b27 +3c5c 3c5d 1c36 1c37 +3c7e 3c5c 1b27 1c37 +3c5d 3c5e 1d46 1d47 +3c7f 3c5d 1c37 1d47 +3c5e 3c5f 1e56 1e57 +3c80 3c5e 1d47 1e57 +3c5f 3c60 1f66 1f67 +3c81 3c5f 1e57 1f67 +3c60 3c61 2076 2077 +3c82 3c60 1f67 2077 +3c61 3c62 2186 2187 +3c83 3c61 2077 2187 +3c62 3c63 2296 2297 +3c84 3c62 2187 2297 +3c63 3c64 23a6 23a7 +3c85 3c63 2297 23a7 +3c64 3c65 24b6 24b7 +3c86 3c64 23a7 24b7 +3c65 3c66 25c6 25c7 +3c87 3c65 24b7 25c7 +3c66 3c67 26d6 26d7 +3c88 3c66 25c7 26d7 +3c67 3c68 27e6 27e7 +3c89 3c67 26d7 27e7 +3c68 3c69 28f6 28f7 +3c8a 3c68 27e7 28f7 +3c69 3c6a 2a06 2a07 +3c8b 3c69 28f7 2a07 +3c6a 3c6b 2b16 2b17 +3c8c 3c6a 2a07 2b17 +3c6b 3c6c 2c26 2c27 +3c8d 3c6b 2b17 2c27 +3c6c 3c6d 2d36 2d37 +3c8e 3c6c 2c27 2d37 +3c6d 3c6e 2e46 2e47 +3c8f 3c6d 2d37 2e47 +3c6e 3c6f 2f56 2f57 +3c90 3c6e 2e47 2f57 +3c6f 3c70 3066 3067 +3c91 3c6f 2f57 3067 +3c70 3c71 3176 3177 +3c92 3c70 3067 3177 +3c71 3c72 3286 3287 +3c93 3c71 3177 3287 +3c72 3c73 3396 3397 +3c94 3c72 3287 3397 +3c73 3c74 34a6 34a7 +3c95 3c73 3397 34a7 +3c96 3c74 34a7 35b7 +3c75 3c76 12a7 12a8 +3c97 3c75 1198 12a8 +3c76 3c77 13b7 13b8 +3c98 3c76 12a8 13b8 +3c77 3c78 14c7 14c8 +3c99 3c77 13b8 14c8 +3c78 3c79 15d7 15d8 +3c9a 3c78 14c8 15d8 +3c79 3c7a 16e7 16e8 +3c9b 3c79 15d8 16e8 +3c7a 3c7b 17f7 17f8 +3c9c 3c7a 16e8 17f8 +3c7b 3c7c 1907 1908 +3c9d 3c7b 17f8 1908 +3c7c 3c7d 1a17 1a18 +3c9e 3c7c 1908 1a18 +3c7d 3c7e 1b27 1b28 +3c9f 3c7d 1a18 1b28 +3c7e 3c7f 1c37 1c38 +3ca0 3c7e 1b28 1c38 +3c7f 3c80 1d47 1d48 +3ca1 3c7f 1c38 1d48 +3c80 3c81 1e57 1e58 +3ca2 3c80 1d48 1e58 +3c81 3c82 1f67 1f68 +3ca3 3c81 1e58 1f68 +3c82 3c83 2077 2078 +3ca4 3c82 1f68 2078 +3c83 3c84 2187 2188 +3ca5 3c83 2078 2188 +3c84 3c85 2297 2298 +3ca6 3c84 2188 2298 +3c85 3c86 23a7 23a8 +3ca7 3c85 2298 23a8 +3c86 3c87 24b7 24b8 +3ca8 3c86 23a8 24b8 +3c87 3c88 25c7 25c8 +3ca9 3c87 24b8 25c8 +3c88 3c89 26d7 26d8 +3caa 3c88 25c8 26d8 +3c89 3c8a 27e7 27e8 +3cab 3c89 26d8 27e8 +3c8a 3c8b 28f7 28f8 +3cac 3c8a 27e8 28f8 +3c8b 3c8c 2a07 2a08 +3cad 3c8b 28f8 2a08 +3c8c 3c8d 2b17 2b18 +3cae 3c8c 2a08 2b18 +3c8d 3c8e 2c27 2c28 +3caf 3c8d 2b18 2c28 +3c8e 3c8f 2d37 2d38 +3cb0 3c8e 2c28 2d38 +3c8f 3c90 2e47 2e48 +3cb1 3c8f 2d38 2e48 +3c90 3c91 2f57 2f58 +3cb2 3c90 2e48 2f58 +3c91 3c92 3067 3068 +3cb3 3c91 2f58 3068 +3c92 3c93 3177 3178 +3cb4 3c92 3068 3178 +3c93 3c94 3287 3288 +3cb5 3c93 3178 3288 +3c94 3c95 3397 3398 +3cb6 3c94 3288 3398 +3c95 3c96 34a7 34a8 +3cb7 3c95 3398 34a8 +3cb8 3c96 34a8 35b8 +3c97 3c98 12a8 12a9 +3cb9 3c97 1199 12a9 +3c98 3c99 13b8 13b9 +3cba 3c98 12a9 13b9 +3c99 3c9a 14c8 14c9 +3cbb 3c99 13b9 14c9 +3c9a 3c9b 15d8 15d9 +3cbc 3c9a 14c9 15d9 +3c9b 3c9c 16e8 16e9 +3cbd 3c9b 15d9 16e9 +3c9c 3c9d 17f8 17f9 +3cbe 3c9c 16e9 17f9 +3c9d 3c9e 1908 1909 +3cbf 3c9d 17f9 1909 +3c9e 3c9f 1a18 1a19 +3cc0 3c9e 1909 1a19 +3c9f 3ca0 1b28 1b29 +3cc1 3c9f 1a19 1b29 +3ca0 3ca1 1c38 1c39 +3cc2 3ca0 1b29 1c39 +3ca1 3ca2 1d48 1d49 +3cc3 3ca1 1c39 1d49 +3ca2 3ca3 1e58 1e59 +3cc4 3ca2 1d49 1e59 +3ca3 3ca4 1f68 1f69 +3cc5 3ca3 1e59 1f69 +3ca4 3ca5 2078 2079 +3cc6 3ca4 1f69 2079 +3ca5 3ca6 2188 2189 +3cc7 3ca5 2079 2189 +3ca6 3ca7 2298 2299 +3cc8 3ca6 2189 2299 +3ca7 3ca8 23a8 23a9 +3cc9 3ca7 2299 23a9 +3ca8 3ca9 24b8 24b9 +3cca 3ca8 23a9 24b9 +3ca9 3caa 25c8 25c9 +3ccb 3ca9 24b9 25c9 +3caa 3cab 26d8 26d9 +3ccc 3caa 25c9 26d9 +3cab 3cac 27e8 27e9 +3ccd 3cab 26d9 27e9 +3cac 3cad 28f8 28f9 +3cce 3cac 27e9 28f9 +3cad 3cae 2a08 2a09 +3ccf 3cad 28f9 2a09 +3cae 3caf 2b18 2b19 +3cd0 3cae 2a09 2b19 +3caf 3cb0 2c28 2c29 +3cd1 3caf 2b19 2c29 +3cb0 3cb1 2d38 2d39 +3cd2 3cb0 2c29 2d39 +3cb1 3cb2 2e48 2e49 +3cd3 3cb1 2d39 2e49 +3cb2 3cb3 2f58 2f59 +3cd4 3cb2 2e49 2f59 +3cb3 3cb4 3068 3069 +3cd5 3cb3 2f59 3069 +3cb4 3cb5 3178 3179 +3cd6 3cb4 3069 3179 +3cb5 3cb6 3288 3289 +3cd7 3cb5 3179 3289 +3cb6 3cb7 3398 3399 +3cd8 3cb6 3289 3399 +3cb7 3cb8 34a8 34a9 +3cd9 3cb7 3399 34a9 +3cda 3cb8 34a9 35b9 +3cb9 3cba 12a9 12aa +3cdb 3cb9 119a 12aa +3cba 3cbb 13b9 13ba +3cdc 3cba 12aa 13ba +3cbb 3cbc 14c9 14ca +3cdd 3cbb 13ba 14ca +3cbc 3cbd 15d9 15da +3cde 3cbc 14ca 15da +3cbd 3cbe 16e9 16ea +3cdf 3cbd 15da 16ea +3cbe 3cbf 17f9 17fa +3ce0 3cbe 16ea 17fa +3cbf 3cc0 1909 190a +3ce1 3cbf 17fa 190a +3cc0 3cc1 1a19 1a1a +3ce2 3cc0 190a 1a1a +3cc1 3cc2 1b29 1b2a +3ce3 3cc1 1a1a 1b2a +3cc2 3cc3 1c39 1c3a +3ce4 3cc2 1b2a 1c3a +3cc3 3cc4 1d49 1d4a +3ce5 3cc3 1c3a 1d4a +3cc4 3cc5 1e59 1e5a +3ce6 3cc4 1d4a 1e5a +3cc5 3cc6 1f69 1f6a +3ce7 3cc5 1e5a 1f6a +3cc6 3cc7 2079 207a +3ce8 3cc6 1f6a 207a +3cc7 3cc8 2189 218a +3ce9 3cc7 207a 218a +3cc8 3cc9 2299 229a +3cea 3cc8 218a 229a +3cc9 3cca 23a9 23aa +3ceb 3cc9 229a 23aa +3cca 3ccb 24b9 24ba +3cec 3cca 23aa 24ba +3ccb 3ccc 25c9 25ca +3ced 3ccb 24ba 25ca +3ccc 3ccd 26d9 26da +3cee 3ccc 25ca 26da +3ccd 3cce 27e9 27ea +3cef 3ccd 26da 27ea +3cce 3ccf 28f9 28fa +3cf0 3cce 27ea 28fa +3ccf 3cd0 2a09 2a0a +3cf1 3ccf 28fa 2a0a +3cd0 3cd1 2b19 2b1a +3cf2 3cd0 2a0a 2b1a +3cd1 3cd2 2c29 2c2a +3cf3 3cd1 2b1a 2c2a +3cd2 3cd3 2d39 2d3a +3cf4 3cd2 2c2a 2d3a +3cd3 3cd4 2e49 2e4a +3cf5 3cd3 2d3a 2e4a +3cd4 3cd5 2f59 2f5a +3cf6 3cd4 2e4a 2f5a +3cd5 3cd6 3069 306a +3cf7 3cd5 2f5a 306a +3cd6 3cd7 3179 317a +3cf8 3cd6 306a 317a +3cd7 3cd8 3289 328a +3cf9 3cd7 317a 328a +3cd8 3cd9 3399 339a +3cfa 3cd8 328a 339a +3cd9 3cda 34a9 34aa +3cfb 3cd9 339a 34aa +3cfc 3cda 34aa 35ba +3cdb 3cdc 12aa 12ab +3cfd 3cdb 119b 12ab +3cdc 3cdd 13ba 13bb +3cfe 3cdc 12ab 13bb +3cdd 3cde 14ca 14cb +3cff 3cdd 13bb 14cb +3cde 3cdf 15da 15db +3d00 3cde 14cb 15db +3cdf 3ce0 16ea 16eb +3d01 3cdf 15db 16eb +3ce0 3ce1 17fa 17fb +3d02 3ce0 16eb 17fb +3ce1 3ce2 190a 190b +3d03 3ce1 17fb 190b +3ce2 3ce3 1a1a 1a1b +3d04 3ce2 190b 1a1b +3ce3 3ce4 1b2a 1b2b +3d05 3ce3 1a1b 1b2b +3ce4 3ce5 1c3a 1c3b +3d06 3ce4 1b2b 1c3b +3ce5 3ce6 1d4a 1d4b +3d07 3ce5 1c3b 1d4b +3ce6 3ce7 1e5a 1e5b +3d08 3ce6 1d4b 1e5b +3ce7 3ce8 1f6a 1f6b +3d09 3ce7 1e5b 1f6b +3ce8 3ce9 207a 207b +3d0a 3ce8 1f6b 207b +3ce9 3cea 218a 218b +3d0b 3ce9 207b 218b +3cea 3ceb 229a 229b +3d0c 3cea 218b 229b +3ceb 3cec 23aa 23ab +3d0d 3ceb 229b 23ab +3cec 3ced 24ba 24bb +3d0e 3cec 23ab 24bb +3ced 3cee 25ca 25cb +3d0f 3ced 24bb 25cb +3cee 3cef 26da 26db +3d10 3cee 25cb 26db +3cef 3cf0 27ea 27eb +3d11 3cef 26db 27eb +3cf0 3cf1 28fa 28fb +3d12 3cf0 27eb 28fb +3cf1 3cf2 2a0a 2a0b +3d13 3cf1 28fb 2a0b +3cf2 3cf3 2b1a 2b1b +3d14 3cf2 2a0b 2b1b +3cf3 3cf4 2c2a 2c2b +3d15 3cf3 2b1b 2c2b +3cf4 3cf5 2d3a 2d3b +3d16 3cf4 2c2b 2d3b +3cf5 3cf6 2e4a 2e4b +3d17 3cf5 2d3b 2e4b +3cf6 3cf7 2f5a 2f5b +3d18 3cf6 2e4b 2f5b +3cf7 3cf8 306a 306b +3d19 3cf7 2f5b 306b +3cf8 3cf9 317a 317b +3d1a 3cf8 306b 317b +3cf9 3cfa 328a 328b +3d1b 3cf9 317b 328b +3cfa 3cfb 339a 339b +3d1c 3cfa 328b 339b +3cfb 3cfc 34aa 34ab +3d1d 3cfb 339b 34ab +3d1e 3cfc 34ab 35bb +3cfd 3cfe 12ab 12ac +3d1f 3cfd 119c 12ac +3cfe 3cff 13bb 13bc +3d20 3cfe 12ac 13bc +3cff 3d00 14cb 14cc +3d21 3cff 13bc 14cc +3d00 3d01 15db 15dc +3d22 3d00 14cc 15dc +3d01 3d02 16eb 16ec +3d23 3d01 15dc 16ec +3d02 3d03 17fb 17fc +3d24 3d02 16ec 17fc +3d03 3d04 190b 190c +3d25 3d03 17fc 190c +3d04 3d05 1a1b 1a1c +3d26 3d04 190c 1a1c +3d05 3d06 1b2b 1b2c +3d27 3d05 1a1c 1b2c +3d06 3d07 1c3b 1c3c +3d28 3d06 1b2c 1c3c +3d07 3d08 1d4b 1d4c +3d29 3d07 1c3c 1d4c +3d08 3d09 1e5b 1e5c +3d2a 3d08 1d4c 1e5c +3d09 3d0a 1f6b 1f6c +3d2b 3d09 1e5c 1f6c +3d0a 3d0b 207b 207c +3d2c 3d0a 1f6c 207c +3d0b 3d0c 218b 218c +3d2d 3d0b 207c 218c +3d0c 3d0d 229b 229c +3d2e 3d0c 218c 229c +3d0d 3d0e 23ab 23ac +3d2f 3d0d 229c 23ac +3d0e 3d0f 24bb 24bc +3d30 3d0e 23ac 24bc +3d0f 3d10 25cb 25cc +3d31 3d0f 24bc 25cc +3d10 3d11 26db 26dc +3d32 3d10 25cc 26dc +3d11 3d12 27eb 27ec +3d33 3d11 26dc 27ec +3d12 3d13 28fb 28fc +3d34 3d12 27ec 28fc +3d13 3d14 2a0b 2a0c +3d35 3d13 28fc 2a0c +3d14 3d15 2b1b 2b1c +3d36 3d14 2a0c 2b1c +3d15 3d16 2c2b 2c2c +3d37 3d15 2b1c 2c2c +3d16 3d17 2d3b 2d3c +3d38 3d16 2c2c 2d3c +3d17 3d18 2e4b 2e4c +3d39 3d17 2d3c 2e4c +3d18 3d19 2f5b 2f5c +3d3a 3d18 2e4c 2f5c +3d19 3d1a 306b 306c +3d3b 3d19 2f5c 306c +3d1a 3d1b 317b 317c +3d3c 3d1a 306c 317c +3d1b 3d1c 328b 328c +3d3d 3d1b 317c 328c +3d1c 3d1d 339b 339c +3d3e 3d1c 328c 339c +3d1d 3d1e 34ab 34ac +3d3f 3d1d 339c 34ac +3d40 3d1e 34ac 35bc +3d1f 3d20 12ac 12ad +3d41 3d1f 119d 12ad +3d20 3d21 13bc 13bd +3d42 3d20 12ad 13bd +3d21 3d22 14cc 14cd +3d43 3d21 13bd 14cd +3d22 3d23 15dc 15dd +3d44 3d22 14cd 15dd +3d23 3d24 16ec 16ed +3d45 3d23 15dd 16ed +3d24 3d25 17fc 17fd +3d46 3d24 16ed 17fd +3d25 3d26 190c 190d +3d47 3d25 17fd 190d +3d26 3d27 1a1c 1a1d +3d48 3d26 190d 1a1d +3d27 3d28 1b2c 1b2d +3d49 3d27 1a1d 1b2d +3d28 3d29 1c3c 1c3d +3d4a 3d28 1b2d 1c3d +3d29 3d2a 1d4c 1d4d +3d4b 3d29 1c3d 1d4d +3d2a 3d2b 1e5c 1e5d +3d4c 3d2a 1d4d 1e5d +3d2b 3d2c 1f6c 1f6d +3d4d 3d2b 1e5d 1f6d +3d2c 3d2d 207c 207d +3d4e 3d2c 1f6d 207d +3d2d 3d2e 218c 218d +3d4f 3d2d 207d 218d +3d2e 3d2f 229c 229d +3d50 3d2e 218d 229d +3d2f 3d30 23ac 23ad +3d51 3d2f 229d 23ad +3d30 3d31 24bc 24bd +3d52 3d30 23ad 24bd +3d31 3d32 25cc 25cd +3d53 3d31 24bd 25cd +3d32 3d33 26dc 26dd +3d54 3d32 25cd 26dd +3d33 3d34 27ec 27ed +3d55 3d33 26dd 27ed +3d34 3d35 28fc 28fd +3d56 3d34 27ed 28fd +3d35 3d36 2a0c 2a0d +3d57 3d35 28fd 2a0d +3d36 3d37 2b1c 2b1d +3d58 3d36 2a0d 2b1d +3d37 3d38 2c2c 2c2d +3d59 3d37 2b1d 2c2d +3d38 3d39 2d3c 2d3d +3d5a 3d38 2c2d 2d3d +3d39 3d3a 2e4c 2e4d +3d5b 3d39 2d3d 2e4d +3d3a 3d3b 2f5c 2f5d +3d5c 3d3a 2e4d 2f5d +3d3b 3d3c 306c 306d +3d5d 3d3b 2f5d 306d +3d3c 3d3d 317c 317d +3d5e 3d3c 306d 317d +3d3d 3d3e 328c 328d +3d5f 3d3d 317d 328d +3d3e 3d3f 339c 339d +3d60 3d3e 328d 339d +3d3f 3d40 34ac 34ad +3d61 3d3f 339d 34ad +3d62 3d40 34ad 35bd +3d41 3d42 12ad 12ae +3d63 3d41 119e 12ae +3d42 3d43 13bd 13be +3d64 3d42 12ae 13be +3d43 3d44 14cd 14ce +3d65 3d43 13be 14ce +3d44 3d45 15dd 15de +3d66 3d44 14ce 15de +3d45 3d46 16ed 16ee +3d67 3d45 15de 16ee +3d46 3d47 17fd 17fe +3d68 3d46 16ee 17fe +3d47 3d48 190d 190e +3d69 3d47 17fe 190e +3d48 3d49 1a1d 1a1e +3d6a 3d48 190e 1a1e +3d49 3d4a 1b2d 1b2e +3d6b 3d49 1a1e 1b2e +3d4a 3d4b 1c3d 1c3e +3d6c 3d4a 1b2e 1c3e +3d4b 3d4c 1d4d 1d4e +3d6d 3d4b 1c3e 1d4e +3d4c 3d4d 1e5d 1e5e +3d6e 3d4c 1d4e 1e5e +3d4d 3d4e 1f6d 1f6e +3d6f 3d4d 1e5e 1f6e +3d4e 3d4f 207d 207e +3d70 3d4e 1f6e 207e +3d4f 3d50 218d 218e +3d71 3d4f 207e 218e +3d50 3d51 229d 229e +3d72 3d50 218e 229e +3d51 3d52 23ad 23ae +3d73 3d51 229e 23ae +3d52 3d53 24bd 24be +3d74 3d52 23ae 24be +3d53 3d54 25cd 25ce +3d75 3d53 24be 25ce +3d54 3d55 26dd 26de +3d76 3d54 25ce 26de +3d55 3d56 27ed 27ee +3d77 3d55 26de 27ee +3d56 3d57 28fd 28fe +3d78 3d56 27ee 28fe +3d57 3d58 2a0d 2a0e +3d79 3d57 28fe 2a0e +3d58 3d59 2b1d 2b1e +3d7a 3d58 2a0e 2b1e +3d59 3d5a 2c2d 2c2e +3d7b 3d59 2b1e 2c2e +3d5a 3d5b 2d3d 2d3e +3d7c 3d5a 2c2e 2d3e +3d5b 3d5c 2e4d 2e4e +3d7d 3d5b 2d3e 2e4e +3d5c 3d5d 2f5d 2f5e +3d7e 3d5c 2e4e 2f5e +3d5d 3d5e 306d 306e +3d7f 3d5d 2f5e 306e +3d5e 3d5f 317d 317e +3d80 3d5e 306e 317e +3d5f 3d60 328d 328e +3d81 3d5f 317e 328e +3d60 3d61 339d 339e +3d82 3d60 328e 339e +3d61 3d62 34ad 34ae +3d83 3d61 339e 34ae +3d84 3d62 34ae 35be +3d63 3d64 12ae 12af +3d85 3d63 119f 12af +3d64 3d65 13be 13bf +3d86 3d64 12af 13bf +3d65 3d66 14ce 14cf +3d87 3d65 13bf 14cf +3d66 3d67 15de 15df +3d88 3d66 14cf 15df +3d67 3d68 16ee 16ef +3d89 3d67 15df 16ef +3d68 3d69 17fe 17ff +3d8a 3d68 16ef 17ff +3d69 3d6a 190e 190f +3d8b 3d69 17ff 190f +3d6a 3d6b 1a1e 1a1f +3d8c 3d6a 190f 1a1f +3d6b 3d6c 1b2e 1b2f +3d8d 3d6b 1a1f 1b2f +3d6c 3d6d 1c3e 1c3f +3d8e 3d6c 1b2f 1c3f +3d6d 3d6e 1d4e 1d4f +3d8f 3d6d 1c3f 1d4f +3d6e 3d6f 1e5e 1e5f +3d90 3d6e 1d4f 1e5f +3d6f 3d70 1f6e 1f6f +3d91 3d6f 1e5f 1f6f +3d70 3d71 207e 207f +3d92 3d70 1f6f 207f +3d71 3d72 218e 218f +3d93 3d71 207f 218f +3d72 3d73 229e 229f +3d94 3d72 218f 229f +3d73 3d74 23ae 23af +3d95 3d73 229f 23af +3d74 3d75 24be 24bf +3d96 3d74 23af 24bf +3d75 3d76 25ce 25cf +3d97 3d75 24bf 25cf +3d76 3d77 26de 26df +3d98 3d76 25cf 26df +3d77 3d78 27ee 27ef +3d99 3d77 26df 27ef +3d78 3d79 28fe 28ff +3d9a 3d78 27ef 28ff +3d79 3d7a 2a0e 2a0f +3d9b 3d79 28ff 2a0f +3d7a 3d7b 2b1e 2b1f +3d9c 3d7a 2a0f 2b1f +3d7b 3d7c 2c2e 2c2f +3d9d 3d7b 2b1f 2c2f +3d7c 3d7d 2d3e 2d3f +3d9e 3d7c 2c2f 2d3f +3d7d 3d7e 2e4e 2e4f +3d9f 3d7d 2d3f 2e4f +3d7e 3d7f 2f5e 2f5f +3da0 3d7e 2e4f 2f5f +3d7f 3d80 306e 306f +3da1 3d7f 2f5f 306f +3d80 3d81 317e 317f +3da2 3d80 306f 317f +3d81 3d82 328e 328f +3da3 3d81 317f 328f +3d82 3d83 339e 339f +3da4 3d82 328f 339f +3d83 3d84 34ae 34af +3da5 3d83 339f 34af +3da6 3d84 34af 35bf +3d85 3d86 12af 12b0 +3da7 3d85 11a0 12b0 +3d86 3d87 13bf 13c0 +3da8 3d86 12b0 13c0 +3d87 3d88 14cf 14d0 +3da9 3d87 13c0 14d0 +3d88 3d89 15df 15e0 +3daa 3d88 14d0 15e0 +3d89 3d8a 16ef 16f0 +3dab 3d89 15e0 16f0 +3d8a 3d8b 17ff 1800 +3dac 3d8a 16f0 1800 +3d8b 3d8c 190f 1910 +3dad 3d8b 1800 1910 +3d8c 3d8d 1a1f 1a20 +3dae 3d8c 1910 1a20 +3d8d 3d8e 1b2f 1b30 +3daf 3d8d 1a20 1b30 +3d8e 3d8f 1c3f 1c40 +3db0 3d8e 1b30 1c40 +3d8f 3d90 1d4f 1d50 +3db1 3d8f 1c40 1d50 +3d90 3d91 1e5f 1e60 +3db2 3d90 1d50 1e60 +3d91 3d92 1f6f 1f70 +3db3 3d91 1e60 1f70 +3d92 3d93 207f 2080 +3db4 3d92 1f70 2080 +3d93 3d94 218f 2190 +3db5 3d93 2080 2190 +3d94 3d95 229f 22a0 +3db6 3d94 2190 22a0 +3d95 3d96 23af 23b0 +3db7 3d95 22a0 23b0 +3d96 3d97 24bf 24c0 +3db8 3d96 23b0 24c0 +3d97 3d98 25cf 25d0 +3db9 3d97 24c0 25d0 +3d98 3d99 26df 26e0 +3dba 3d98 25d0 26e0 +3d99 3d9a 27ef 27f0 +3dbb 3d99 26e0 27f0 +3d9a 3d9b 28ff 2900 +3dbc 3d9a 27f0 2900 +3d9b 3d9c 2a0f 2a10 +3dbd 3d9b 2900 2a10 +3d9c 3d9d 2b1f 2b20 +3dbe 3d9c 2a10 2b20 +3d9d 3d9e 2c2f 2c30 +3dbf 3d9d 2b20 2c30 +3d9e 3d9f 2d3f 2d40 +3dc0 3d9e 2c30 2d40 +3d9f 3da0 2e4f 2e50 +3dc1 3d9f 2d40 2e50 +3da0 3da1 2f5f 2f60 +3dc2 3da0 2e50 2f60 +3da1 3da2 306f 3070 +3dc3 3da1 2f60 3070 +3da2 3da3 317f 3180 +3dc4 3da2 3070 3180 +3da3 3da4 328f 3290 +3dc5 3da3 3180 3290 +3da4 3da5 339f 33a0 +3dc6 3da4 3290 33a0 +3da5 3da6 34af 34b0 +3dc7 3da5 33a0 34b0 +3dc8 3da6 34b0 35c0 +3da7 3da8 12b0 12b1 +3dc9 3da7 11a1 12b1 +3da8 3da9 13c0 13c1 +3dca 3da8 12b1 13c1 +3da9 3daa 14d0 14d1 +3dcb 3da9 13c1 14d1 +3daa 3dab 15e0 15e1 +3dcc 3daa 14d1 15e1 +3dab 3dac 16f0 16f1 +3dcd 3dab 15e1 16f1 +3dac 3dad 1800 1801 +3dce 3dac 16f1 1801 +3dad 3dae 1910 1911 +3dcf 3dad 1801 1911 +3dae 3daf 1a20 1a21 +3dd0 3dae 1911 1a21 +3daf 3db0 1b30 1b31 +3dd1 3daf 1a21 1b31 +3db0 3db1 1c40 1c41 +3dd2 3db0 1b31 1c41 +3db1 3db2 1d50 1d51 +3dd3 3db1 1c41 1d51 +3db2 3db3 1e60 1e61 +3dd4 3db2 1d51 1e61 +3db3 3db4 1f70 1f71 +3dd5 3db3 1e61 1f71 +3db4 3db5 2080 2081 +3dd6 3db4 1f71 2081 +3db5 3db6 2190 2191 +3dd7 3db5 2081 2191 +3db6 3db7 22a0 22a1 +3dd8 3db6 2191 22a1 +3db7 3db8 23b0 23b1 +3dd9 3db7 22a1 23b1 +3db8 3db9 24c0 24c1 +3dda 3db8 23b1 24c1 +3db9 3dba 25d0 25d1 +3ddb 3db9 24c1 25d1 +3dba 3dbb 26e0 26e1 +3ddc 3dba 25d1 26e1 +3dbb 3dbc 27f0 27f1 +3ddd 3dbb 26e1 27f1 +3dbc 3dbd 2900 2901 +3dde 3dbc 27f1 2901 +3dbd 3dbe 2a10 2a11 +3ddf 3dbd 2901 2a11 +3dbe 3dbf 2b20 2b21 +3de0 3dbe 2a11 2b21 +3dbf 3dc0 2c30 2c31 +3de1 3dbf 2b21 2c31 +3dc0 3dc1 2d40 2d41 +3de2 3dc0 2c31 2d41 +3dc1 3dc2 2e50 2e51 +3de3 3dc1 2d41 2e51 +3dc2 3dc3 2f60 2f61 +3de4 3dc2 2e51 2f61 +3dc3 3dc4 3070 3071 +3de5 3dc3 2f61 3071 +3dc4 3dc5 3180 3181 +3de6 3dc4 3071 3181 +3dc5 3dc6 3290 3291 +3de7 3dc5 3181 3291 +3dc6 3dc7 33a0 33a1 +3de8 3dc6 3291 33a1 +3dc7 3dc8 34b0 34b1 +3de9 3dc7 33a1 34b1 +3dea 3dc8 34b1 35c1 +3dc9 3dca 12b1 12b2 +3deb 3dc9 11a2 12b2 +3dca 3dcb 13c1 13c2 +3dec 3dca 12b2 13c2 +3dcb 3dcc 14d1 14d2 +3ded 3dcb 13c2 14d2 +3dcc 3dcd 15e1 15e2 +3dee 3dcc 14d2 15e2 +3dcd 3dce 16f1 16f2 +3def 3dcd 15e2 16f2 +3dce 3dcf 1801 1802 +3df0 3dce 16f2 1802 +3dcf 3dd0 1911 1912 +3df1 3dcf 1802 1912 +3dd0 3dd1 1a21 1a22 +3df2 3dd0 1912 1a22 +3dd1 3dd2 1b31 1b32 +3df3 3dd1 1a22 1b32 +3dd2 3dd3 1c41 1c42 +3df4 3dd2 1b32 1c42 +3dd3 3dd4 1d51 1d52 +3df5 3dd3 1c42 1d52 +3dd4 3dd5 1e61 1e62 +3df6 3dd4 1d52 1e62 +3dd5 3dd6 1f71 1f72 +3df7 3dd5 1e62 1f72 +3dd6 3dd7 2081 2082 +3df8 3dd6 1f72 2082 +3dd7 3dd8 2191 2192 +3df9 3dd7 2082 2192 +3dd8 3dd9 22a1 22a2 +3dfa 3dd8 2192 22a2 +3dd9 3dda 23b1 23b2 +3dfb 3dd9 22a2 23b2 +3dda 3ddb 24c1 24c2 +3dfc 3dda 23b2 24c2 +3ddb 3ddc 25d1 25d2 +3dfd 3ddb 24c2 25d2 +3ddc 3ddd 26e1 26e2 +3dfe 3ddc 25d2 26e2 +3ddd 3dde 27f1 27f2 +3dff 3ddd 26e2 27f2 +3dde 3ddf 2901 2902 +3e00 3dde 27f2 2902 +3ddf 3de0 2a11 2a12 +3e01 3ddf 2902 2a12 +3de0 3de1 2b21 2b22 +3e02 3de0 2a12 2b22 +3de1 3de2 2c31 2c32 +3e03 3de1 2b22 2c32 +3de2 3de3 2d41 2d42 +3e04 3de2 2c32 2d42 +3de3 3de4 2e51 2e52 +3e05 3de3 2d42 2e52 +3de4 3de5 2f61 2f62 +3e06 3de4 2e52 2f62 +3de5 3de6 3071 3072 +3e07 3de5 2f62 3072 +3de6 3de7 3181 3182 +3e08 3de6 3072 3182 +3de7 3de8 3291 3292 +3e09 3de7 3182 3292 +3de8 3de9 33a1 33a2 +3e0a 3de8 3292 33a2 +3de9 3dea 34b1 34b2 +3e0b 3de9 33a2 34b2 +3e0c 3dea 34b2 35c2 +3deb 3dec 12b2 12b3 +3e0d 3deb 11a3 12b3 +3dec 3ded 13c2 13c3 +3e0e 3dec 12b3 13c3 +3ded 3dee 14d2 14d3 +3e0f 3ded 13c3 14d3 +3dee 3def 15e2 15e3 +3e10 3dee 14d3 15e3 +3def 3df0 16f2 16f3 +3e11 3def 15e3 16f3 +3df0 3df1 1802 1803 +3e12 3df0 16f3 1803 +3df1 3df2 1912 1913 +3e13 3df1 1803 1913 +3df2 3df3 1a22 1a23 +3e14 3df2 1913 1a23 +3df3 3df4 1b32 1b33 +3e15 3df3 1a23 1b33 +3df4 3df5 1c42 1c43 +3e16 3df4 1b33 1c43 +3df5 3df6 1d52 1d53 +3e17 3df5 1c43 1d53 +3df6 3df7 1e62 1e63 +3e18 3df6 1d53 1e63 +3df7 3df8 1f72 1f73 +3e19 3df7 1e63 1f73 +3df8 3df9 2082 2083 +3e1a 3df8 1f73 2083 +3df9 3dfa 2192 2193 +3e1b 3df9 2083 2193 +3dfa 3dfb 22a2 22a3 +3e1c 3dfa 2193 22a3 +3dfb 3dfc 23b2 23b3 +3e1d 3dfb 22a3 23b3 +3dfc 3dfd 24c2 24c3 +3e1e 3dfc 23b3 24c3 +3dfd 3dfe 25d2 25d3 +3e1f 3dfd 24c3 25d3 +3dfe 3dff 26e2 26e3 +3e20 3dfe 25d3 26e3 +3dff 3e00 27f2 27f3 +3e21 3dff 26e3 27f3 +3e00 3e01 2902 2903 +3e22 3e00 27f3 2903 +3e01 3e02 2a12 2a13 +3e23 3e01 2903 2a13 +3e02 3e03 2b22 2b23 +3e24 3e02 2a13 2b23 +3e03 3e04 2c32 2c33 +3e25 3e03 2b23 2c33 +3e04 3e05 2d42 2d43 +3e26 3e04 2c33 2d43 +3e05 3e06 2e52 2e53 +3e27 3e05 2d43 2e53 +3e06 3e07 2f62 2f63 +3e28 3e06 2e53 2f63 +3e07 3e08 3072 3073 +3e29 3e07 2f63 3073 +3e08 3e09 3182 3183 +3e2a 3e08 3073 3183 +3e09 3e0a 3292 3293 +3e2b 3e09 3183 3293 +3e0a 3e0b 33a2 33a3 +3e2c 3e0a 3293 33a3 +3e0b 3e0c 34b2 34b3 +3e2d 3e0b 33a3 34b3 +3e2e 3e0c 34b3 35c3 +3e0d 3e0e 12b3 12b4 +3e0e 3e0f 13c3 13c4 +3e0f 3e10 14d3 14d4 +3e10 3e11 15e3 15e4 +3e11 3e12 16f3 16f4 +3e12 3e13 1803 1804 +3e13 3e14 1913 1914 +3e14 3e15 1a23 1a24 +3e15 3e16 1b33 1b34 +3e16 3e17 1c43 1c44 +3e17 3e18 1d53 1d54 +3e18 3e19 1e63 1e64 +3e19 3e1a 1f73 1f74 +3e1a 3e1b 2083 2084 +3e1b 3e1c 2193 2194 +3e1c 3e1d 22a3 22a4 +3e1d 3e1e 23b3 23b4 +3e1e 3e1f 24c3 24c4 +3e1f 3e20 25d3 25d4 +3e20 3e21 26e3 26e4 +3e21 3e22 27f3 27f4 +3e22 3e23 2903 2904 +3e23 3e24 2a13 2a14 +3e24 3e25 2b23 2b24 +3e25 3e26 2c33 2c34 +3e26 3e27 2d43 2d44 +3e27 3e28 2e53 2e54 +3e28 3e29 2f63 2f64 +3e29 3e2a 3073 3074 +3e2a 3e2b 3183 3184 +3e2b 3e2c 3293 3294 +3e2c 3e2d 33a3 33a4 +3e2d 3e2e 34b3 34b4 +3e2f 3e30 12b5 12b6 +3e51 3e2f 11a6 12b6 +3e30 3e31 13c5 13c6 +3e52 3e30 12b6 13c6 +3e31 3e32 14d5 14d6 +3e53 3e31 13c6 14d6 +3e32 3e33 15e5 15e6 +3e54 3e32 14d6 15e6 +3e33 3e34 16f5 16f6 +3e55 3e33 15e6 16f6 +3e34 3e35 1805 1806 +3e56 3e34 16f6 1806 +3e35 3e36 1915 1916 +3e57 3e35 1806 1916 +3e36 3e37 1a25 1a26 +3e58 3e36 1916 1a26 +3e37 3e38 1b35 1b36 +3e59 3e37 1a26 1b36 +3e38 3e39 1c45 1c46 +3e5a 3e38 1b36 1c46 +3e39 3e3a 1d55 1d56 +3e5b 3e39 1c46 1d56 +3e3a 3e3b 1e65 1e66 +3e5c 3e3a 1d56 1e66 +3e3b 3e3c 1f75 1f76 +3e5d 3e3b 1e66 1f76 +3e3c 3e3d 2085 2086 +3e5e 3e3c 1f76 2086 +3e3d 3e3e 2195 2196 +3e5f 3e3d 2086 2196 +3e3e 3e3f 22a5 22a6 +3e60 3e3e 2196 22a6 +3e3f 3e40 23b5 23b6 +3e61 3e3f 22a6 23b6 +3e40 3e41 24c5 24c6 +3e62 3e40 23b6 24c6 +3e41 3e42 25d5 25d6 +3e63 3e41 24c6 25d6 +3e42 3e43 26e5 26e6 +3e64 3e42 25d6 26e6 +3e43 3e44 27f5 27f6 +3e65 3e43 26e6 27f6 +3e44 3e45 2905 2906 +3e66 3e44 27f6 2906 +3e45 3e46 2a15 2a16 +3e67 3e45 2906 2a16 +3e46 3e47 2b25 2b26 +3e68 3e46 2a16 2b26 +3e47 3e48 2c35 2c36 +3e69 3e47 2b26 2c36 +3e48 3e49 2d45 2d46 +3e6a 3e48 2c36 2d46 +3e49 3e4a 2e55 2e56 +3e6b 3e49 2d46 2e56 +3e4a 3e4b 2f65 2f66 +3e6c 3e4a 2e56 2f66 +3e4b 3e4c 3075 3076 +3e6d 3e4b 2f66 3076 +3e4c 3e4d 3185 3186 +3e6e 3e4c 3076 3186 +3e4d 3e4e 3295 3296 +3e6f 3e4d 3186 3296 +3e4e 3e4f 33a5 33a6 +3e70 3e4e 3296 33a6 +3e4f 3e50 34b5 34b6 +3e71 3e4f 33a6 34b6 +3e72 3e50 34b6 35c6 +3e51 3e52 12b6 12b7 +3e73 3e51 11a7 12b7 +3e52 3e53 13c6 13c7 +3e74 3e52 12b7 13c7 +3e53 3e54 14d6 14d7 +3e75 3e53 13c7 14d7 +3e54 3e55 15e6 15e7 +3e76 3e54 14d7 15e7 +3e55 3e56 16f6 16f7 +3e77 3e55 15e7 16f7 +3e56 3e57 1806 1807 +3e78 3e56 16f7 1807 +3e57 3e58 1916 1917 +3e79 3e57 1807 1917 +3e58 3e59 1a26 1a27 +3e7a 3e58 1917 1a27 +3e59 3e5a 1b36 1b37 +3e7b 3e59 1a27 1b37 +3e5a 3e5b 1c46 1c47 +3e7c 3e5a 1b37 1c47 +3e5b 3e5c 1d56 1d57 +3e7d 3e5b 1c47 1d57 +3e5c 3e5d 1e66 1e67 +3e7e 3e5c 1d57 1e67 +3e5d 3e5e 1f76 1f77 +3e7f 3e5d 1e67 1f77 +3e5e 3e5f 2086 2087 +3e80 3e5e 1f77 2087 +3e5f 3e60 2196 2197 +3e81 3e5f 2087 2197 +3e60 3e61 22a6 22a7 +3e82 3e60 2197 22a7 +3e61 3e62 23b6 23b7 +3e83 3e61 22a7 23b7 +3e62 3e63 24c6 24c7 +3e84 3e62 23b7 24c7 +3e63 3e64 25d6 25d7 +3e85 3e63 24c7 25d7 +3e64 3e65 26e6 26e7 +3e86 3e64 25d7 26e7 +3e65 3e66 27f6 27f7 +3e87 3e65 26e7 27f7 +3e66 3e67 2906 2907 +3e88 3e66 27f7 2907 +3e67 3e68 2a16 2a17 +3e89 3e67 2907 2a17 +3e68 3e69 2b26 2b27 +3e8a 3e68 2a17 2b27 +3e69 3e6a 2c36 2c37 +3e8b 3e69 2b27 2c37 +3e6a 3e6b 2d46 2d47 +3e8c 3e6a 2c37 2d47 +3e6b 3e6c 2e56 2e57 +3e8d 3e6b 2d47 2e57 +3e6c 3e6d 2f66 2f67 +3e8e 3e6c 2e57 2f67 +3e6d 3e6e 3076 3077 +3e8f 3e6d 2f67 3077 +3e6e 3e6f 3186 3187 +3e90 3e6e 3077 3187 +3e6f 3e70 3296 3297 +3e91 3e6f 3187 3297 +3e70 3e71 33a6 33a7 +3e92 3e70 3297 33a7 +3e71 3e72 34b6 34b7 +3e93 3e71 33a7 34b7 +3e94 3e72 34b7 35c7 +3e73 3e74 12b7 12b8 +3e95 3e73 11a8 12b8 +3e74 3e75 13c7 13c8 +3e96 3e74 12b8 13c8 +3e75 3e76 14d7 14d8 +3e97 3e75 13c8 14d8 +3e76 3e77 15e7 15e8 +3e98 3e76 14d8 15e8 +3e77 3e78 16f7 16f8 +3e99 3e77 15e8 16f8 +3e78 3e79 1807 1808 +3e9a 3e78 16f8 1808 +3e79 3e7a 1917 1918 +3e9b 3e79 1808 1918 +3e7a 3e7b 1a27 1a28 +3e9c 3e7a 1918 1a28 +3e7b 3e7c 1b37 1b38 +3e9d 3e7b 1a28 1b38 +3e7c 3e7d 1c47 1c48 +3e9e 3e7c 1b38 1c48 +3e7d 3e7e 1d57 1d58 +3e9f 3e7d 1c48 1d58 +3e7e 3e7f 1e67 1e68 +3ea0 3e7e 1d58 1e68 +3e7f 3e80 1f77 1f78 +3ea1 3e7f 1e68 1f78 +3e80 3e81 2087 2088 +3ea2 3e80 1f78 2088 +3e81 3e82 2197 2198 +3ea3 3e81 2088 2198 +3e82 3e83 22a7 22a8 +3ea4 3e82 2198 22a8 +3e83 3e84 23b7 23b8 +3ea5 3e83 22a8 23b8 +3e84 3e85 24c7 24c8 +3ea6 3e84 23b8 24c8 +3e85 3e86 25d7 25d8 +3ea7 3e85 24c8 25d8 +3e86 3e87 26e7 26e8 +3ea8 3e86 25d8 26e8 +3e87 3e88 27f7 27f8 +3ea9 3e87 26e8 27f8 +3e88 3e89 2907 2908 +3eaa 3e88 27f8 2908 +3e89 3e8a 2a17 2a18 +3eab 3e89 2908 2a18 +3e8a 3e8b 2b27 2b28 +3eac 3e8a 2a18 2b28 +3e8b 3e8c 2c37 2c38 +3ead 3e8b 2b28 2c38 +3e8c 3e8d 2d47 2d48 +3eae 3e8c 2c38 2d48 +3e8d 3e8e 2e57 2e58 +3eaf 3e8d 2d48 2e58 +3e8e 3e8f 2f67 2f68 +3eb0 3e8e 2e58 2f68 +3e8f 3e90 3077 3078 +3eb1 3e8f 2f68 3078 +3e90 3e91 3187 3188 +3eb2 3e90 3078 3188 +3e91 3e92 3297 3298 +3eb3 3e91 3188 3298 +3e92 3e93 33a7 33a8 +3eb4 3e92 3298 33a8 +3e93 3e94 34b7 34b8 +3eb5 3e93 33a8 34b8 +3eb6 3e94 34b8 35c8 +3e95 3e96 12b8 12b9 +3eb7 3e95 11a9 12b9 +3e96 3e97 13c8 13c9 +3eb8 3e96 12b9 13c9 +3e97 3e98 14d8 14d9 +3eb9 3e97 13c9 14d9 +3e98 3e99 15e8 15e9 +3eba 3e98 14d9 15e9 +3e99 3e9a 16f8 16f9 +3ebb 3e99 15e9 16f9 +3e9a 3e9b 1808 1809 +3ebc 3e9a 16f9 1809 +3e9b 3e9c 1918 1919 +3ebd 3e9b 1809 1919 +3e9c 3e9d 1a28 1a29 +3ebe 3e9c 1919 1a29 +3e9d 3e9e 1b38 1b39 +3ebf 3e9d 1a29 1b39 +3e9e 3e9f 1c48 1c49 +3ec0 3e9e 1b39 1c49 +3e9f 3ea0 1d58 1d59 +3ec1 3e9f 1c49 1d59 +3ea0 3ea1 1e68 1e69 +3ec2 3ea0 1d59 1e69 +3ea1 3ea2 1f78 1f79 +3ec3 3ea1 1e69 1f79 +3ea2 3ea3 2088 2089 +3ec4 3ea2 1f79 2089 +3ea3 3ea4 2198 2199 +3ec5 3ea3 2089 2199 +3ea4 3ea5 22a8 22a9 +3ec6 3ea4 2199 22a9 +3ea5 3ea6 23b8 23b9 +3ec7 3ea5 22a9 23b9 +3ea6 3ea7 24c8 24c9 +3ec8 3ea6 23b9 24c9 +3ea7 3ea8 25d8 25d9 +3ec9 3ea7 24c9 25d9 +3ea8 3ea9 26e8 26e9 +3eca 3ea8 25d9 26e9 +3ea9 3eaa 27f8 27f9 +3ecb 3ea9 26e9 27f9 +3eaa 3eab 2908 2909 +3ecc 3eaa 27f9 2909 +3eab 3eac 2a18 2a19 +3ecd 3eab 2909 2a19 +3eac 3ead 2b28 2b29 +3ece 3eac 2a19 2b29 +3ead 3eae 2c38 2c39 +3ecf 3ead 2b29 2c39 +3eae 3eaf 2d48 2d49 +3ed0 3eae 2c39 2d49 +3eaf 3eb0 2e58 2e59 +3ed1 3eaf 2d49 2e59 +3eb0 3eb1 2f68 2f69 +3ed2 3eb0 2e59 2f69 +3eb1 3eb2 3078 3079 +3ed3 3eb1 2f69 3079 +3eb2 3eb3 3188 3189 +3ed4 3eb2 3079 3189 +3eb3 3eb4 3298 3299 +3ed5 3eb3 3189 3299 +3eb4 3eb5 33a8 33a9 +3ed6 3eb4 3299 33a9 +3eb5 3eb6 34b8 34b9 +3ed7 3eb5 33a9 34b9 +3ed8 3eb6 34b9 35c9 +3eb7 3eb8 12b9 12ba +3ed9 3eb7 11aa 12ba +3eb8 3eb9 13c9 13ca +3eda 3eb8 12ba 13ca +3eb9 3eba 14d9 14da +3edb 3eb9 13ca 14da +3eba 3ebb 15e9 15ea +3edc 3eba 14da 15ea +3ebb 3ebc 16f9 16fa +3edd 3ebb 15ea 16fa +3ebc 3ebd 1809 180a +3ede 3ebc 16fa 180a +3ebd 3ebe 1919 191a +3edf 3ebd 180a 191a +3ebe 3ebf 1a29 1a2a +3ee0 3ebe 191a 1a2a +3ebf 3ec0 1b39 1b3a +3ee1 3ebf 1a2a 1b3a +3ec0 3ec1 1c49 1c4a +3ee2 3ec0 1b3a 1c4a +3ec1 3ec2 1d59 1d5a +3ee3 3ec1 1c4a 1d5a +3ec2 3ec3 1e69 1e6a +3ee4 3ec2 1d5a 1e6a +3ec3 3ec4 1f79 1f7a +3ee5 3ec3 1e6a 1f7a +3ec4 3ec5 2089 208a +3ee6 3ec4 1f7a 208a +3ec5 3ec6 2199 219a +3ee7 3ec5 208a 219a +3ec6 3ec7 22a9 22aa +3ee8 3ec6 219a 22aa +3ec7 3ec8 23b9 23ba +3ee9 3ec7 22aa 23ba +3ec8 3ec9 24c9 24ca +3eea 3ec8 23ba 24ca +3ec9 3eca 25d9 25da +3eeb 3ec9 24ca 25da +3eca 3ecb 26e9 26ea +3eec 3eca 25da 26ea +3ecb 3ecc 27f9 27fa +3eed 3ecb 26ea 27fa +3ecc 3ecd 2909 290a +3eee 3ecc 27fa 290a +3ecd 3ece 2a19 2a1a +3eef 3ecd 290a 2a1a +3ece 3ecf 2b29 2b2a +3ef0 3ece 2a1a 2b2a +3ecf 3ed0 2c39 2c3a +3ef1 3ecf 2b2a 2c3a +3ed0 3ed1 2d49 2d4a +3ef2 3ed0 2c3a 2d4a +3ed1 3ed2 2e59 2e5a +3ef3 3ed1 2d4a 2e5a +3ed2 3ed3 2f69 2f6a +3ef4 3ed2 2e5a 2f6a +3ed3 3ed4 3079 307a +3ef5 3ed3 2f6a 307a +3ed4 3ed5 3189 318a +3ef6 3ed4 307a 318a +3ed5 3ed6 3299 329a +3ef7 3ed5 318a 329a +3ed6 3ed7 33a9 33aa +3ef8 3ed6 329a 33aa +3ed7 3ed8 34b9 34ba +3ef9 3ed7 33aa 34ba +3efa 3ed8 34ba 35ca +3ed9 3eda 12ba 12bb +3efb 3ed9 11ab 12bb +3eda 3edb 13ca 13cb +3efc 3eda 12bb 13cb +3edb 3edc 14da 14db +3efd 3edb 13cb 14db +3edc 3edd 15ea 15eb +3efe 3edc 14db 15eb +3edd 3ede 16fa 16fb +3eff 3edd 15eb 16fb +3ede 3edf 180a 180b +3f00 3ede 16fb 180b +3edf 3ee0 191a 191b +3f01 3edf 180b 191b +3ee0 3ee1 1a2a 1a2b +3f02 3ee0 191b 1a2b +3ee1 3ee2 1b3a 1b3b +3f03 3ee1 1a2b 1b3b +3ee2 3ee3 1c4a 1c4b +3f04 3ee2 1b3b 1c4b +3ee3 3ee4 1d5a 1d5b +3f05 3ee3 1c4b 1d5b +3ee4 3ee5 1e6a 1e6b +3f06 3ee4 1d5b 1e6b +3ee5 3ee6 1f7a 1f7b +3f07 3ee5 1e6b 1f7b +3ee6 3ee7 208a 208b +3f08 3ee6 1f7b 208b +3ee7 3ee8 219a 219b +3f09 3ee7 208b 219b +3ee8 3ee9 22aa 22ab +3f0a 3ee8 219b 22ab +3ee9 3eea 23ba 23bb +3f0b 3ee9 22ab 23bb +3eea 3eeb 24ca 24cb +3f0c 3eea 23bb 24cb +3eeb 3eec 25da 25db +3f0d 3eeb 24cb 25db +3eec 3eed 26ea 26eb +3f0e 3eec 25db 26eb +3eed 3eee 27fa 27fb +3f0f 3eed 26eb 27fb +3eee 3eef 290a 290b +3f10 3eee 27fb 290b +3eef 3ef0 2a1a 2a1b +3f11 3eef 290b 2a1b +3ef0 3ef1 2b2a 2b2b +3f12 3ef0 2a1b 2b2b +3ef1 3ef2 2c3a 2c3b +3f13 3ef1 2b2b 2c3b +3ef2 3ef3 2d4a 2d4b +3f14 3ef2 2c3b 2d4b +3ef3 3ef4 2e5a 2e5b +3f15 3ef3 2d4b 2e5b +3ef4 3ef5 2f6a 2f6b +3f16 3ef4 2e5b 2f6b +3ef5 3ef6 307a 307b +3f17 3ef5 2f6b 307b +3ef6 3ef7 318a 318b +3f18 3ef6 307b 318b +3ef7 3ef8 329a 329b +3f19 3ef7 318b 329b +3ef8 3ef9 33aa 33ab +3f1a 3ef8 329b 33ab +3ef9 3efa 34ba 34bb +3f1b 3ef9 33ab 34bb +3f1c 3efa 34bb 35cb +3efb 3efc 12bb 12bc +3f1d 3efb 11ac 12bc +3efc 3efd 13cb 13cc +3f1e 3efc 12bc 13cc +3efd 3efe 14db 14dc +3f1f 3efd 13cc 14dc +3efe 3eff 15eb 15ec +3f20 3efe 14dc 15ec +3eff 3f00 16fb 16fc +3f21 3eff 15ec 16fc +3f00 3f01 180b 180c +3f22 3f00 16fc 180c +3f01 3f02 191b 191c +3f23 3f01 180c 191c +3f02 3f03 1a2b 1a2c +3f24 3f02 191c 1a2c +3f03 3f04 1b3b 1b3c +3f25 3f03 1a2c 1b3c +3f04 3f05 1c4b 1c4c +3f26 3f04 1b3c 1c4c +3f05 3f06 1d5b 1d5c +3f27 3f05 1c4c 1d5c +3f06 3f07 1e6b 1e6c +3f28 3f06 1d5c 1e6c +3f07 3f08 1f7b 1f7c +3f29 3f07 1e6c 1f7c +3f08 3f09 208b 208c +3f2a 3f08 1f7c 208c +3f09 3f0a 219b 219c +3f2b 3f09 208c 219c +3f0a 3f0b 22ab 22ac +3f2c 3f0a 219c 22ac +3f0b 3f0c 23bb 23bc +3f2d 3f0b 22ac 23bc +3f0c 3f0d 24cb 24cc +3f2e 3f0c 23bc 24cc +3f0d 3f0e 25db 25dc +3f2f 3f0d 24cc 25dc +3f0e 3f0f 26eb 26ec +3f30 3f0e 25dc 26ec +3f0f 3f10 27fb 27fc +3f31 3f0f 26ec 27fc +3f10 3f11 290b 290c +3f32 3f10 27fc 290c +3f11 3f12 2a1b 2a1c +3f33 3f11 290c 2a1c +3f12 3f13 2b2b 2b2c +3f34 3f12 2a1c 2b2c +3f13 3f14 2c3b 2c3c +3f35 3f13 2b2c 2c3c +3f14 3f15 2d4b 2d4c +3f36 3f14 2c3c 2d4c +3f15 3f16 2e5b 2e5c +3f37 3f15 2d4c 2e5c +3f16 3f17 2f6b 2f6c +3f38 3f16 2e5c 2f6c +3f17 3f18 307b 307c +3f39 3f17 2f6c 307c +3f18 3f19 318b 318c +3f3a 3f18 307c 318c +3f19 3f1a 329b 329c +3f3b 3f19 318c 329c +3f1a 3f1b 33ab 33ac +3f3c 3f1a 329c 33ac +3f1b 3f1c 34bb 34bc +3f3d 3f1b 33ac 34bc +3f3e 3f1c 34bc 35cc +3f1d 3f1e 12bc 12bd +3f3f 3f1d 11ad 12bd +3f1e 3f1f 13cc 13cd +3f40 3f1e 12bd 13cd +3f1f 3f20 14dc 14dd +3f41 3f1f 13cd 14dd +3f20 3f21 15ec 15ed +3f42 3f20 14dd 15ed +3f21 3f22 16fc 16fd +3f43 3f21 15ed 16fd +3f22 3f23 180c 180d +3f44 3f22 16fd 180d +3f23 3f24 191c 191d +3f45 3f23 180d 191d +3f24 3f25 1a2c 1a2d +3f46 3f24 191d 1a2d +3f25 3f26 1b3c 1b3d +3f47 3f25 1a2d 1b3d +3f26 3f27 1c4c 1c4d +3f48 3f26 1b3d 1c4d +3f27 3f28 1d5c 1d5d +3f49 3f27 1c4d 1d5d +3f28 3f29 1e6c 1e6d +3f4a 3f28 1d5d 1e6d +3f29 3f2a 1f7c 1f7d +3f4b 3f29 1e6d 1f7d +3f2a 3f2b 208c 208d +3f4c 3f2a 1f7d 208d +3f2b 3f2c 219c 219d +3f4d 3f2b 208d 219d +3f2c 3f2d 22ac 22ad +3f4e 3f2c 219d 22ad +3f2d 3f2e 23bc 23bd +3f4f 3f2d 22ad 23bd +3f2e 3f2f 24cc 24cd +3f50 3f2e 23bd 24cd +3f2f 3f30 25dc 25dd +3f51 3f2f 24cd 25dd +3f30 3f31 26ec 26ed +3f52 3f30 25dd 26ed +3f31 3f32 27fc 27fd +3f53 3f31 26ed 27fd +3f32 3f33 290c 290d +3f54 3f32 27fd 290d +3f33 3f34 2a1c 2a1d +3f55 3f33 290d 2a1d +3f34 3f35 2b2c 2b2d +3f56 3f34 2a1d 2b2d +3f35 3f36 2c3c 2c3d +3f57 3f35 2b2d 2c3d +3f36 3f37 2d4c 2d4d +3f58 3f36 2c3d 2d4d +3f37 3f38 2e5c 2e5d +3f59 3f37 2d4d 2e5d +3f38 3f39 2f6c 2f6d +3f5a 3f38 2e5d 2f6d +3f39 3f3a 307c 307d +3f5b 3f39 2f6d 307d +3f3a 3f3b 318c 318d +3f5c 3f3a 307d 318d +3f3b 3f3c 329c 329d +3f5d 3f3b 318d 329d +3f3c 3f3d 33ac 33ad +3f5e 3f3c 329d 33ad +3f3d 3f3e 34bc 34bd +3f5f 3f3d 33ad 34bd +3f60 3f3e 34bd 35cd +3f3f 3f40 12bd 12be +3f61 3f3f 11ae 12be +3f40 3f41 13cd 13ce +3f62 3f40 12be 13ce +3f41 3f42 14dd 14de +3f63 3f41 13ce 14de +3f42 3f43 15ed 15ee +3f64 3f42 14de 15ee +3f43 3f44 16fd 16fe +3f65 3f43 15ee 16fe +3f44 3f45 180d 180e +3f66 3f44 16fe 180e +3f45 3f46 191d 191e +3f67 3f45 180e 191e +3f46 3f47 1a2d 1a2e +3f68 3f46 191e 1a2e +3f47 3f48 1b3d 1b3e +3f69 3f47 1a2e 1b3e +3f48 3f49 1c4d 1c4e +3f6a 3f48 1b3e 1c4e +3f49 3f4a 1d5d 1d5e +3f6b 3f49 1c4e 1d5e +3f4a 3f4b 1e6d 1e6e +3f6c 3f4a 1d5e 1e6e +3f4b 3f4c 1f7d 1f7e +3f6d 3f4b 1e6e 1f7e +3f4c 3f4d 208d 208e +3f6e 3f4c 1f7e 208e +3f4d 3f4e 219d 219e +3f6f 3f4d 208e 219e +3f4e 3f4f 22ad 22ae +3f70 3f4e 219e 22ae +3f4f 3f50 23bd 23be +3f71 3f4f 22ae 23be +3f50 3f51 24cd 24ce +3f72 3f50 23be 24ce +3f51 3f52 25dd 25de +3f73 3f51 24ce 25de +3f52 3f53 26ed 26ee +3f74 3f52 25de 26ee +3f53 3f54 27fd 27fe +3f75 3f53 26ee 27fe +3f54 3f55 290d 290e +3f76 3f54 27fe 290e +3f55 3f56 2a1d 2a1e +3f77 3f55 290e 2a1e +3f56 3f57 2b2d 2b2e +3f78 3f56 2a1e 2b2e +3f57 3f58 2c3d 2c3e +3f79 3f57 2b2e 2c3e +3f58 3f59 2d4d 2d4e +3f7a 3f58 2c3e 2d4e +3f59 3f5a 2e5d 2e5e +3f7b 3f59 2d4e 2e5e +3f5a 3f5b 2f6d 2f6e +3f7c 3f5a 2e5e 2f6e +3f5b 3f5c 307d 307e +3f7d 3f5b 2f6e 307e +3f5c 3f5d 318d 318e +3f7e 3f5c 307e 318e +3f5d 3f5e 329d 329e +3f7f 3f5d 318e 329e +3f5e 3f5f 33ad 33ae +3f80 3f5e 329e 33ae +3f5f 3f60 34bd 34be +3f81 3f5f 33ae 34be +3f82 3f60 34be 35ce +3f61 3f62 12be 12bf +3f83 3f61 11af 12bf +3f62 3f63 13ce 13cf +3f84 3f62 12bf 13cf +3f63 3f64 14de 14df +3f85 3f63 13cf 14df +3f64 3f65 15ee 15ef +3f86 3f64 14df 15ef +3f65 3f66 16fe 16ff +3f87 3f65 15ef 16ff +3f66 3f67 180e 180f +3f88 3f66 16ff 180f +3f67 3f68 191e 191f +3f89 3f67 180f 191f +3f68 3f69 1a2e 1a2f +3f8a 3f68 191f 1a2f +3f69 3f6a 1b3e 1b3f +3f8b 3f69 1a2f 1b3f +3f6a 3f6b 1c4e 1c4f +3f8c 3f6a 1b3f 1c4f +3f6b 3f6c 1d5e 1d5f +3f8d 3f6b 1c4f 1d5f +3f6c 3f6d 1e6e 1e6f +3f8e 3f6c 1d5f 1e6f +3f6d 3f6e 1f7e 1f7f +3f8f 3f6d 1e6f 1f7f +3f6e 3f6f 208e 208f +3f90 3f6e 1f7f 208f +3f6f 3f70 219e 219f +3f91 3f6f 208f 219f +3f70 3f71 22ae 22af +3f92 3f70 219f 22af +3f71 3f72 23be 23bf +3f93 3f71 22af 23bf +3f72 3f73 24ce 24cf +3f94 3f72 23bf 24cf +3f73 3f74 25de 25df +3f95 3f73 24cf 25df +3f74 3f75 26ee 26ef +3f96 3f74 25df 26ef +3f75 3f76 27fe 27ff +3f97 3f75 26ef 27ff +3f76 3f77 290e 290f +3f98 3f76 27ff 290f +3f77 3f78 2a1e 2a1f +3f99 3f77 290f 2a1f +3f78 3f79 2b2e 2b2f +3f9a 3f78 2a1f 2b2f +3f79 3f7a 2c3e 2c3f +3f9b 3f79 2b2f 2c3f +3f7a 3f7b 2d4e 2d4f +3f9c 3f7a 2c3f 2d4f +3f7b 3f7c 2e5e 2e5f +3f9d 3f7b 2d4f 2e5f +3f7c 3f7d 2f6e 2f6f +3f9e 3f7c 2e5f 2f6f +3f7d 3f7e 307e 307f +3f9f 3f7d 2f6f 307f +3f7e 3f7f 318e 318f +3fa0 3f7e 307f 318f +3f7f 3f80 329e 329f +3fa1 3f7f 318f 329f +3f80 3f81 33ae 33af +3fa2 3f80 329f 33af +3f81 3f82 34be 34bf +3fa3 3f81 33af 34bf +3fa4 3f82 34bf 35cf +3f83 3f84 12bf 12c0 +3fa5 3f83 11b0 12c0 +3f84 3f85 13cf 13d0 +3fa6 3f84 12c0 13d0 +3f85 3f86 14df 14e0 +3fa7 3f85 13d0 14e0 +3f86 3f87 15ef 15f0 +3fa8 3f86 14e0 15f0 +3f87 3f88 16ff 1700 +3fa9 3f87 15f0 1700 +3f88 3f89 180f 1810 +3faa 3f88 1700 1810 +3f89 3f8a 191f 1920 +3fab 3f89 1810 1920 +3f8a 3f8b 1a2f 1a30 +3fac 3f8a 1920 1a30 +3f8b 3f8c 1b3f 1b40 +3fad 3f8b 1a30 1b40 +3f8c 3f8d 1c4f 1c50 +3fae 3f8c 1b40 1c50 +3f8d 3f8e 1d5f 1d60 +3faf 3f8d 1c50 1d60 +3f8e 3f8f 1e6f 1e70 +3fb0 3f8e 1d60 1e70 +3f8f 3f90 1f7f 1f80 +3fb1 3f8f 1e70 1f80 +3f90 3f91 208f 2090 +3fb2 3f90 1f80 2090 +3f91 3f92 219f 21a0 +3fb3 3f91 2090 21a0 +3f92 3f93 22af 22b0 +3fb4 3f92 21a0 22b0 +3f93 3f94 23bf 23c0 +3fb5 3f93 22b0 23c0 +3f94 3f95 24cf 24d0 +3fb6 3f94 23c0 24d0 +3f95 3f96 25df 25e0 +3fb7 3f95 24d0 25e0 +3f96 3f97 26ef 26f0 +3fb8 3f96 25e0 26f0 +3f97 3f98 27ff 2800 +3fb9 3f97 26f0 2800 +3f98 3f99 290f 2910 +3fba 3f98 2800 2910 +3f99 3f9a 2a1f 2a20 +3fbb 3f99 2910 2a20 +3f9a 3f9b 2b2f 2b30 +3fbc 3f9a 2a20 2b30 +3f9b 3f9c 2c3f 2c40 +3fbd 3f9b 2b30 2c40 +3f9c 3f9d 2d4f 2d50 +3fbe 3f9c 2c40 2d50 +3f9d 3f9e 2e5f 2e60 +3fbf 3f9d 2d50 2e60 +3f9e 3f9f 2f6f 2f70 +3fc0 3f9e 2e60 2f70 +3f9f 3fa0 307f 3080 +3fc1 3f9f 2f70 3080 +3fa0 3fa1 318f 3190 +3fc2 3fa0 3080 3190 +3fa1 3fa2 329f 32a0 +3fc3 3fa1 3190 32a0 +3fa2 3fa3 33af 33b0 +3fc4 3fa2 32a0 33b0 +3fa3 3fa4 34bf 34c0 +3fc5 3fa3 33b0 34c0 +3fc6 3fa4 34c0 35d0 +3fa5 3fa6 12c0 12c1 +3fc7 3fa5 11b1 12c1 +3fa6 3fa7 13d0 13d1 +3fc8 3fa6 12c1 13d1 +3fa7 3fa8 14e0 14e1 +3fc9 3fa7 13d1 14e1 +3fa8 3fa9 15f0 15f1 +3fca 3fa8 14e1 15f1 +3fa9 3faa 1700 1701 +3fcb 3fa9 15f1 1701 +3faa 3fab 1810 1811 +3fcc 3faa 1701 1811 +3fab 3fac 1920 1921 +3fcd 3fab 1811 1921 +3fac 3fad 1a30 1a31 +3fce 3fac 1921 1a31 +3fad 3fae 1b40 1b41 +3fcf 3fad 1a31 1b41 +3fae 3faf 1c50 1c51 +3fd0 3fae 1b41 1c51 +3faf 3fb0 1d60 1d61 +3fd1 3faf 1c51 1d61 +3fb0 3fb1 1e70 1e71 +3fd2 3fb0 1d61 1e71 +3fb1 3fb2 1f80 1f81 +3fd3 3fb1 1e71 1f81 +3fb2 3fb3 2090 2091 +3fd4 3fb2 1f81 2091 +3fb3 3fb4 21a0 21a1 +3fd5 3fb3 2091 21a1 +3fb4 3fb5 22b0 22b1 +3fd6 3fb4 21a1 22b1 +3fb5 3fb6 23c0 23c1 +3fd7 3fb5 22b1 23c1 +3fb6 3fb7 24d0 24d1 +3fd8 3fb6 23c1 24d1 +3fb7 3fb8 25e0 25e1 +3fd9 3fb7 24d1 25e1 +3fb8 3fb9 26f0 26f1 +3fda 3fb8 25e1 26f1 +3fb9 3fba 2800 2801 +3fdb 3fb9 26f1 2801 +3fba 3fbb 2910 2911 +3fdc 3fba 2801 2911 +3fbb 3fbc 2a20 2a21 +3fdd 3fbb 2911 2a21 +3fbc 3fbd 2b30 2b31 +3fde 3fbc 2a21 2b31 +3fbd 3fbe 2c40 2c41 +3fdf 3fbd 2b31 2c41 +3fbe 3fbf 2d50 2d51 +3fe0 3fbe 2c41 2d51 +3fbf 3fc0 2e60 2e61 +3fe1 3fbf 2d51 2e61 +3fc0 3fc1 2f70 2f71 +3fe2 3fc0 2e61 2f71 +3fc1 3fc2 3080 3081 +3fe3 3fc1 2f71 3081 +3fc2 3fc3 3190 3191 +3fe4 3fc2 3081 3191 +3fc3 3fc4 32a0 32a1 +3fe5 3fc3 3191 32a1 +3fc4 3fc5 33b0 33b1 +3fe6 3fc4 32a1 33b1 +3fc5 3fc6 34c0 34c1 +3fe7 3fc5 33b1 34c1 +3fe8 3fc6 34c1 35d1 +3fc7 3fc8 12c1 12c2 +3fe9 3fc7 11b2 12c2 +3fc8 3fc9 13d1 13d2 +3fea 3fc8 12c2 13d2 +3fc9 3fca 14e1 14e2 +3feb 3fc9 13d2 14e2 +3fca 3fcb 15f1 15f2 +3fec 3fca 14e2 15f2 +3fcb 3fcc 1701 1702 +3fed 3fcb 15f2 1702 +3fcc 3fcd 1811 1812 +3fee 3fcc 1702 1812 +3fcd 3fce 1921 1922 +3fef 3fcd 1812 1922 +3fce 3fcf 1a31 1a32 +3ff0 3fce 1922 1a32 +3fcf 3fd0 1b41 1b42 +3ff1 3fcf 1a32 1b42 +3fd0 3fd1 1c51 1c52 +3ff2 3fd0 1b42 1c52 +3fd1 3fd2 1d61 1d62 +3ff3 3fd1 1c52 1d62 +3fd2 3fd3 1e71 1e72 +3ff4 3fd2 1d62 1e72 +3fd3 3fd4 1f81 1f82 +3ff5 3fd3 1e72 1f82 +3fd4 3fd5 2091 2092 +3ff6 3fd4 1f82 2092 +3fd5 3fd6 21a1 21a2 +3ff7 3fd5 2092 21a2 +3fd6 3fd7 22b1 22b2 +3ff8 3fd6 21a2 22b2 +3fd7 3fd8 23c1 23c2 +3ff9 3fd7 22b2 23c2 +3fd8 3fd9 24d1 24d2 +3ffa 3fd8 23c2 24d2 +3fd9 3fda 25e1 25e2 +3ffb 3fd9 24d2 25e2 +3fda 3fdb 26f1 26f2 +3ffc 3fda 25e2 26f2 +3fdb 3fdc 2801 2802 +3ffd 3fdb 26f2 2802 +3fdc 3fdd 2911 2912 +3ffe 3fdc 2802 2912 +3fdd 3fde 2a21 2a22 +3fff 3fdd 2912 2a22 +3fde 3fdf 2b31 2b32 +4000 3fde 2a22 2b32 +3fdf 3fe0 2c41 2c42 +4001 3fdf 2b32 2c42 +3fe0 3fe1 2d51 2d52 +4002 3fe0 2c42 2d52 +3fe1 3fe2 2e61 2e62 +4003 3fe1 2d52 2e62 +3fe2 3fe3 2f71 2f72 +4004 3fe2 2e62 2f72 +3fe3 3fe4 3081 3082 +4005 3fe3 2f72 3082 +3fe4 3fe5 3191 3192 +4006 3fe4 3082 3192 +3fe5 3fe6 32a1 32a2 +4007 3fe5 3192 32a2 +3fe6 3fe7 33b1 33b2 +4008 3fe6 32a2 33b2 +3fe7 3fe8 34c1 34c2 +4009 3fe7 33b2 34c2 +400a 3fe8 34c2 35d2 +3fe9 3fea 12c2 12c3 +400b 3fe9 11b3 12c3 +3fea 3feb 13d2 13d3 +400c 3fea 12c3 13d3 +3feb 3fec 14e2 14e3 +400d 3feb 13d3 14e3 +3fec 3fed 15f2 15f3 +400e 3fec 14e3 15f3 +3fed 3fee 1702 1703 +400f 3fed 15f3 1703 +3fee 3fef 1812 1813 +4010 3fee 1703 1813 +3fef 3ff0 1922 1923 +4011 3fef 1813 1923 +3ff0 3ff1 1a32 1a33 +4012 3ff0 1923 1a33 +3ff1 3ff2 1b42 1b43 +4013 3ff1 1a33 1b43 +3ff2 3ff3 1c52 1c53 +4014 3ff2 1b43 1c53 +3ff3 3ff4 1d62 1d63 +4015 3ff3 1c53 1d63 +3ff4 3ff5 1e72 1e73 +4016 3ff4 1d63 1e73 +3ff5 3ff6 1f82 1f83 +4017 3ff5 1e73 1f83 +3ff6 3ff7 2092 2093 +4018 3ff6 1f83 2093 +3ff7 3ff8 21a2 21a3 +4019 3ff7 2093 21a3 +3ff8 3ff9 22b2 22b3 +401a 3ff8 21a3 22b3 +3ff9 3ffa 23c2 23c3 +401b 3ff9 22b3 23c3 +3ffa 3ffb 24d2 24d3 +401c 3ffa 23c3 24d3 +3ffb 3ffc 25e2 25e3 +401d 3ffb 24d3 25e3 +3ffc 3ffd 26f2 26f3 +401e 3ffc 25e3 26f3 +3ffd 3ffe 2802 2803 +401f 3ffd 26f3 2803 +3ffe 3fff 2912 2913 +4020 3ffe 2803 2913 +3fff 4000 2a22 2a23 +4021 3fff 2913 2a23 +4000 4001 2b32 2b33 +4022 4000 2a23 2b33 +4001 4002 2c42 2c43 +4023 4001 2b33 2c43 +4002 4003 2d52 2d53 +4024 4002 2c43 2d53 +4003 4004 2e62 2e63 +4025 4003 2d53 2e63 +4004 4005 2f72 2f73 +4026 4004 2e63 2f73 +4005 4006 3082 3083 +4027 4005 2f73 3083 +4006 4007 3192 3193 +4028 4006 3083 3193 +4007 4008 32a2 32a3 +4029 4007 3193 32a3 +4008 4009 33b2 33b3 +402a 4008 32a3 33b3 +4009 400a 34c2 34c3 +402b 4009 33b3 34c3 +402c 400a 34c3 35d3 +400b 400c 12c3 12c4 +400c 400d 13d3 13d4 +400d 400e 14e3 14e4 +400e 400f 15f3 15f4 +400f 4010 1703 1704 +4010 4011 1813 1814 +4011 4012 1923 1924 +4012 4013 1a33 1a34 +4013 4014 1b43 1b44 +4014 4015 1c53 1c54 +4015 4016 1d63 1d64 +4016 4017 1e73 1e74 +4017 4018 1f83 1f84 +4018 4019 2093 2094 +4019 401a 21a3 21a4 +401a 401b 22b3 22b4 +401b 401c 23c3 23c4 +401c 401d 24d3 24d4 +401d 401e 25e3 25e4 +401e 401f 26f3 26f4 +401f 4020 2803 2804 +4020 4021 2913 2914 +4021 4022 2a23 2a24 +4022 4023 2b33 2b34 +4023 4024 2c43 2c44 +4024 4025 2d53 2d54 +4025 4026 2e63 2e64 +4026 4027 2f73 2f74 +4027 4028 3083 3084 +4028 4029 3193 3194 +4029 402a 32a3 32a4 +402a 402b 33b3 33b4 +402b 402c 34c3 34c4 +402d 402e 12c5 12c6 +404f 402d 11b6 12c6 +402e 402f 13d5 13d6 +4050 402e 12c6 13d6 +402f 4030 14e5 14e6 +4051 402f 13d6 14e6 +4030 4031 15f5 15f6 +4052 4030 14e6 15f6 +4031 4032 1705 1706 +4053 4031 15f6 1706 +4032 4033 1815 1816 +4054 4032 1706 1816 +4033 4034 1925 1926 +4055 4033 1816 1926 +4034 4035 1a35 1a36 +4056 4034 1926 1a36 +4035 4036 1b45 1b46 +4057 4035 1a36 1b46 +4036 4037 1c55 1c56 +4058 4036 1b46 1c56 +4037 4038 1d65 1d66 +4059 4037 1c56 1d66 +4038 4039 1e75 1e76 +405a 4038 1d66 1e76 +4039 403a 1f85 1f86 +405b 4039 1e76 1f86 +403a 403b 2095 2096 +405c 403a 1f86 2096 +403b 403c 21a5 21a6 +405d 403b 2096 21a6 +403c 403d 22b5 22b6 +405e 403c 21a6 22b6 +403d 403e 23c5 23c6 +405f 403d 22b6 23c6 +403e 403f 24d5 24d6 +4060 403e 23c6 24d6 +403f 4040 25e5 25e6 +4061 403f 24d6 25e6 +4040 4041 26f5 26f6 +4062 4040 25e6 26f6 +4041 4042 2805 2806 +4063 4041 26f6 2806 +4042 4043 2915 2916 +4064 4042 2806 2916 +4043 4044 2a25 2a26 +4065 4043 2916 2a26 +4044 4045 2b35 2b36 +4066 4044 2a26 2b36 +4045 4046 2c45 2c46 +4067 4045 2b36 2c46 +4046 4047 2d55 2d56 +4068 4046 2c46 2d56 +4047 4048 2e65 2e66 +4069 4047 2d56 2e66 +4048 4049 2f75 2f76 +406a 4048 2e66 2f76 +4049 404a 3085 3086 +406b 4049 2f76 3086 +404a 404b 3195 3196 +406c 404a 3086 3196 +404b 404c 32a5 32a6 +406d 404b 3196 32a6 +404c 404d 33b5 33b6 +406e 404c 32a6 33b6 +404d 404e 34c5 34c6 +406f 404d 33b6 34c6 +4070 404e 34c6 35d6 +404f 4050 12c6 12c7 +4071 404f 11b7 12c7 +4050 4051 13d6 13d7 +4072 4050 12c7 13d7 +4051 4052 14e6 14e7 +4073 4051 13d7 14e7 +4052 4053 15f6 15f7 +4074 4052 14e7 15f7 +4053 4054 1706 1707 +4075 4053 15f7 1707 +4054 4055 1816 1817 +4076 4054 1707 1817 +4055 4056 1926 1927 +4077 4055 1817 1927 +4056 4057 1a36 1a37 +4078 4056 1927 1a37 +4057 4058 1b46 1b47 +4079 4057 1a37 1b47 +4058 4059 1c56 1c57 +407a 4058 1b47 1c57 +4059 405a 1d66 1d67 +407b 4059 1c57 1d67 +405a 405b 1e76 1e77 +407c 405a 1d67 1e77 +405b 405c 1f86 1f87 +407d 405b 1e77 1f87 +405c 405d 2096 2097 +407e 405c 1f87 2097 +405d 405e 21a6 21a7 +407f 405d 2097 21a7 +405e 405f 22b6 22b7 +4080 405e 21a7 22b7 +405f 4060 23c6 23c7 +4081 405f 22b7 23c7 +4060 4061 24d6 24d7 +4082 4060 23c7 24d7 +4061 4062 25e6 25e7 +4083 4061 24d7 25e7 +4062 4063 26f6 26f7 +4084 4062 25e7 26f7 +4063 4064 2806 2807 +4085 4063 26f7 2807 +4064 4065 2916 2917 +4086 4064 2807 2917 +4065 4066 2a26 2a27 +4087 4065 2917 2a27 +4066 4067 2b36 2b37 +4088 4066 2a27 2b37 +4067 4068 2c46 2c47 +4089 4067 2b37 2c47 +4068 4069 2d56 2d57 +408a 4068 2c47 2d57 +4069 406a 2e66 2e67 +408b 4069 2d57 2e67 +406a 406b 2f76 2f77 +408c 406a 2e67 2f77 +406b 406c 3086 3087 +408d 406b 2f77 3087 +406c 406d 3196 3197 +408e 406c 3087 3197 +406d 406e 32a6 32a7 +408f 406d 3197 32a7 +406e 406f 33b6 33b7 +4090 406e 32a7 33b7 +406f 4070 34c6 34c7 +4091 406f 33b7 34c7 +4092 4070 34c7 35d7 +4071 4072 12c7 12c8 +4093 4071 11b8 12c8 +4072 4073 13d7 13d8 +4094 4072 12c8 13d8 +4073 4074 14e7 14e8 +4095 4073 13d8 14e8 +4074 4075 15f7 15f8 +4096 4074 14e8 15f8 +4075 4076 1707 1708 +4097 4075 15f8 1708 +4076 4077 1817 1818 +4098 4076 1708 1818 +4077 4078 1927 1928 +4099 4077 1818 1928 +4078 4079 1a37 1a38 +409a 4078 1928 1a38 +4079 407a 1b47 1b48 +409b 4079 1a38 1b48 +407a 407b 1c57 1c58 +409c 407a 1b48 1c58 +407b 407c 1d67 1d68 +409d 407b 1c58 1d68 +407c 407d 1e77 1e78 +409e 407c 1d68 1e78 +407d 407e 1f87 1f88 +409f 407d 1e78 1f88 +407e 407f 2097 2098 +40a0 407e 1f88 2098 +407f 4080 21a7 21a8 +40a1 407f 2098 21a8 +4080 4081 22b7 22b8 +40a2 4080 21a8 22b8 +4081 4082 23c7 23c8 +40a3 4081 22b8 23c8 +4082 4083 24d7 24d8 +40a4 4082 23c8 24d8 +4083 4084 25e7 25e8 +40a5 4083 24d8 25e8 +4084 4085 26f7 26f8 +40a6 4084 25e8 26f8 +4085 4086 2807 2808 +40a7 4085 26f8 2808 +4086 4087 2917 2918 +40a8 4086 2808 2918 +4087 4088 2a27 2a28 +40a9 4087 2918 2a28 +4088 4089 2b37 2b38 +40aa 4088 2a28 2b38 +4089 408a 2c47 2c48 +40ab 4089 2b38 2c48 +408a 408b 2d57 2d58 +40ac 408a 2c48 2d58 +408b 408c 2e67 2e68 +40ad 408b 2d58 2e68 +408c 408d 2f77 2f78 +40ae 408c 2e68 2f78 +408d 408e 3087 3088 +40af 408d 2f78 3088 +408e 408f 3197 3198 +40b0 408e 3088 3198 +408f 4090 32a7 32a8 +40b1 408f 3198 32a8 +4090 4091 33b7 33b8 +40b2 4090 32a8 33b8 +4091 4092 34c7 34c8 +40b3 4091 33b8 34c8 +40b4 4092 34c8 35d8 +4093 4094 12c8 12c9 +40b5 4093 11b9 12c9 +4094 4095 13d8 13d9 +40b6 4094 12c9 13d9 +4095 4096 14e8 14e9 +40b7 4095 13d9 14e9 +4096 4097 15f8 15f9 +40b8 4096 14e9 15f9 +4097 4098 1708 1709 +40b9 4097 15f9 1709 +4098 4099 1818 1819 +40ba 4098 1709 1819 +4099 409a 1928 1929 +40bb 4099 1819 1929 +409a 409b 1a38 1a39 +40bc 409a 1929 1a39 +409b 409c 1b48 1b49 +40bd 409b 1a39 1b49 +409c 409d 1c58 1c59 +40be 409c 1b49 1c59 +409d 409e 1d68 1d69 +40bf 409d 1c59 1d69 +409e 409f 1e78 1e79 +40c0 409e 1d69 1e79 +409f 40a0 1f88 1f89 +40c1 409f 1e79 1f89 +40a0 40a1 2098 2099 +40c2 40a0 1f89 2099 +40a1 40a2 21a8 21a9 +40c3 40a1 2099 21a9 +40a2 40a3 22b8 22b9 +40c4 40a2 21a9 22b9 +40a3 40a4 23c8 23c9 +40c5 40a3 22b9 23c9 +40a4 40a5 24d8 24d9 +40c6 40a4 23c9 24d9 +40a5 40a6 25e8 25e9 +40c7 40a5 24d9 25e9 +40a6 40a7 26f8 26f9 +40c8 40a6 25e9 26f9 +40a7 40a8 2808 2809 +40c9 40a7 26f9 2809 +40a8 40a9 2918 2919 +40ca 40a8 2809 2919 +40a9 40aa 2a28 2a29 +40cb 40a9 2919 2a29 +40aa 40ab 2b38 2b39 +40cc 40aa 2a29 2b39 +40ab 40ac 2c48 2c49 +40cd 40ab 2b39 2c49 +40ac 40ad 2d58 2d59 +40ce 40ac 2c49 2d59 +40ad 40ae 2e68 2e69 +40cf 40ad 2d59 2e69 +40ae 40af 2f78 2f79 +40d0 40ae 2e69 2f79 +40af 40b0 3088 3089 +40d1 40af 2f79 3089 +40b0 40b1 3198 3199 +40d2 40b0 3089 3199 +40b1 40b2 32a8 32a9 +40d3 40b1 3199 32a9 +40b2 40b3 33b8 33b9 +40d4 40b2 32a9 33b9 +40b3 40b4 34c8 34c9 +40d5 40b3 33b9 34c9 +40d6 40b4 34c9 35d9 +40b5 40b6 12c9 12ca +40d7 40b5 11ba 12ca +40b6 40b7 13d9 13da +40d8 40b6 12ca 13da +40b7 40b8 14e9 14ea +40d9 40b7 13da 14ea +40b8 40b9 15f9 15fa +40da 40b8 14ea 15fa +40b9 40ba 1709 170a +40db 40b9 15fa 170a +40ba 40bb 1819 181a +40dc 40ba 170a 181a +40bb 40bc 1929 192a +40dd 40bb 181a 192a +40bc 40bd 1a39 1a3a +40de 40bc 192a 1a3a +40bd 40be 1b49 1b4a +40df 40bd 1a3a 1b4a +40be 40bf 1c59 1c5a +40e0 40be 1b4a 1c5a +40bf 40c0 1d69 1d6a +40e1 40bf 1c5a 1d6a +40c0 40c1 1e79 1e7a +40e2 40c0 1d6a 1e7a +40c1 40c2 1f89 1f8a +40e3 40c1 1e7a 1f8a +40c2 40c3 2099 209a +40e4 40c2 1f8a 209a +40c3 40c4 21a9 21aa +40e5 40c3 209a 21aa +40c4 40c5 22b9 22ba +40e6 40c4 21aa 22ba +40c5 40c6 23c9 23ca +40e7 40c5 22ba 23ca +40c6 40c7 24d9 24da +40e8 40c6 23ca 24da +40c7 40c8 25e9 25ea +40e9 40c7 24da 25ea +40c8 40c9 26f9 26fa +40ea 40c8 25ea 26fa +40c9 40ca 2809 280a +40eb 40c9 26fa 280a +40ca 40cb 2919 291a +40ec 40ca 280a 291a +40cb 40cc 2a29 2a2a +40ed 40cb 291a 2a2a +40cc 40cd 2b39 2b3a +40ee 40cc 2a2a 2b3a +40cd 40ce 2c49 2c4a +40ef 40cd 2b3a 2c4a +40ce 40cf 2d59 2d5a +40f0 40ce 2c4a 2d5a +40cf 40d0 2e69 2e6a +40f1 40cf 2d5a 2e6a +40d0 40d1 2f79 2f7a +40f2 40d0 2e6a 2f7a +40d1 40d2 3089 308a +40f3 40d1 2f7a 308a +40d2 40d3 3199 319a +40f4 40d2 308a 319a +40d3 40d4 32a9 32aa +40f5 40d3 319a 32aa +40d4 40d5 33b9 33ba +40f6 40d4 32aa 33ba +40d5 40d6 34c9 34ca +40f7 40d5 33ba 34ca +40f8 40d6 34ca 35da +40d7 40d8 12ca 12cb +40f9 40d7 11bb 12cb +40d8 40d9 13da 13db +40fa 40d8 12cb 13db +40d9 40da 14ea 14eb +40fb 40d9 13db 14eb +40da 40db 15fa 15fb +40fc 40da 14eb 15fb +40db 40dc 170a 170b +40fd 40db 15fb 170b +40dc 40dd 181a 181b +40fe 40dc 170b 181b +40dd 40de 192a 192b +40ff 40dd 181b 192b +40de 40df 1a3a 1a3b +4100 40de 192b 1a3b +40df 40e0 1b4a 1b4b +4101 40df 1a3b 1b4b +40e0 40e1 1c5a 1c5b +4102 40e0 1b4b 1c5b +40e1 40e2 1d6a 1d6b +4103 40e1 1c5b 1d6b +40e2 40e3 1e7a 1e7b +4104 40e2 1d6b 1e7b +40e3 40e4 1f8a 1f8b +4105 40e3 1e7b 1f8b +40e4 40e5 209a 209b +4106 40e4 1f8b 209b +40e5 40e6 21aa 21ab +4107 40e5 209b 21ab +40e6 40e7 22ba 22bb +4108 40e6 21ab 22bb +40e7 40e8 23ca 23cb +4109 40e7 22bb 23cb +40e8 40e9 24da 24db +410a 40e8 23cb 24db +40e9 40ea 25ea 25eb +410b 40e9 24db 25eb +40ea 40eb 26fa 26fb +410c 40ea 25eb 26fb +40eb 40ec 280a 280b +410d 40eb 26fb 280b +40ec 40ed 291a 291b +410e 40ec 280b 291b +40ed 40ee 2a2a 2a2b +410f 40ed 291b 2a2b +40ee 40ef 2b3a 2b3b +4110 40ee 2a2b 2b3b +40ef 40f0 2c4a 2c4b +4111 40ef 2b3b 2c4b +40f0 40f1 2d5a 2d5b +4112 40f0 2c4b 2d5b +40f1 40f2 2e6a 2e6b +4113 40f1 2d5b 2e6b +40f2 40f3 2f7a 2f7b +4114 40f2 2e6b 2f7b +40f3 40f4 308a 308b +4115 40f3 2f7b 308b +40f4 40f5 319a 319b +4116 40f4 308b 319b +40f5 40f6 32aa 32ab +4117 40f5 319b 32ab +40f6 40f7 33ba 33bb +4118 40f6 32ab 33bb +40f7 40f8 34ca 34cb +4119 40f7 33bb 34cb +411a 40f8 34cb 35db +40f9 40fa 12cb 12cc +411b 40f9 11bc 12cc +40fa 40fb 13db 13dc +411c 40fa 12cc 13dc +40fb 40fc 14eb 14ec +411d 40fb 13dc 14ec +40fc 40fd 15fb 15fc +411e 40fc 14ec 15fc +40fd 40fe 170b 170c +411f 40fd 15fc 170c +40fe 40ff 181b 181c +4120 40fe 170c 181c +40ff 4100 192b 192c +4121 40ff 181c 192c +4100 4101 1a3b 1a3c +4122 4100 192c 1a3c +4101 4102 1b4b 1b4c +4123 4101 1a3c 1b4c +4102 4103 1c5b 1c5c +4124 4102 1b4c 1c5c +4103 4104 1d6b 1d6c +4125 4103 1c5c 1d6c +4104 4105 1e7b 1e7c +4126 4104 1d6c 1e7c +4105 4106 1f8b 1f8c +4127 4105 1e7c 1f8c +4106 4107 209b 209c +4128 4106 1f8c 209c +4107 4108 21ab 21ac +4129 4107 209c 21ac +4108 4109 22bb 22bc +412a 4108 21ac 22bc +4109 410a 23cb 23cc +412b 4109 22bc 23cc +410a 410b 24db 24dc +412c 410a 23cc 24dc +410b 410c 25eb 25ec +412d 410b 24dc 25ec +410c 410d 26fb 26fc +412e 410c 25ec 26fc +410d 410e 280b 280c +412f 410d 26fc 280c +410e 410f 291b 291c +4130 410e 280c 291c +410f 4110 2a2b 2a2c +4131 410f 291c 2a2c +4110 4111 2b3b 2b3c +4132 4110 2a2c 2b3c +4111 4112 2c4b 2c4c +4133 4111 2b3c 2c4c +4112 4113 2d5b 2d5c +4134 4112 2c4c 2d5c +4113 4114 2e6b 2e6c +4135 4113 2d5c 2e6c +4114 4115 2f7b 2f7c +4136 4114 2e6c 2f7c +4115 4116 308b 308c +4137 4115 2f7c 308c +4116 4117 319b 319c +4138 4116 308c 319c +4117 4118 32ab 32ac +4139 4117 319c 32ac +4118 4119 33bb 33bc +413a 4118 32ac 33bc +4119 411a 34cb 34cc +413b 4119 33bc 34cc +413c 411a 34cc 35dc +411b 411c 12cc 12cd +413d 411b 11bd 12cd +411c 411d 13dc 13dd +413e 411c 12cd 13dd +411d 411e 14ec 14ed +413f 411d 13dd 14ed +411e 411f 15fc 15fd +4140 411e 14ed 15fd +411f 4120 170c 170d +4141 411f 15fd 170d +4120 4121 181c 181d +4142 4120 170d 181d +4121 4122 192c 192d +4143 4121 181d 192d +4122 4123 1a3c 1a3d +4144 4122 192d 1a3d +4123 4124 1b4c 1b4d +4145 4123 1a3d 1b4d +4124 4125 1c5c 1c5d +4146 4124 1b4d 1c5d +4125 4126 1d6c 1d6d +4147 4125 1c5d 1d6d +4126 4127 1e7c 1e7d +4148 4126 1d6d 1e7d +4127 4128 1f8c 1f8d +4149 4127 1e7d 1f8d +4128 4129 209c 209d +414a 4128 1f8d 209d +4129 412a 21ac 21ad +414b 4129 209d 21ad +412a 412b 22bc 22bd +414c 412a 21ad 22bd +412b 412c 23cc 23cd +414d 412b 22bd 23cd +412c 412d 24dc 24dd +414e 412c 23cd 24dd +412d 412e 25ec 25ed +414f 412d 24dd 25ed +412e 412f 26fc 26fd +4150 412e 25ed 26fd +412f 4130 280c 280d +4151 412f 26fd 280d +4130 4131 291c 291d +4152 4130 280d 291d +4131 4132 2a2c 2a2d +4153 4131 291d 2a2d +4132 4133 2b3c 2b3d +4154 4132 2a2d 2b3d +4133 4134 2c4c 2c4d +4155 4133 2b3d 2c4d +4134 4135 2d5c 2d5d +4156 4134 2c4d 2d5d +4135 4136 2e6c 2e6d +4157 4135 2d5d 2e6d +4136 4137 2f7c 2f7d +4158 4136 2e6d 2f7d +4137 4138 308c 308d +4159 4137 2f7d 308d +4138 4139 319c 319d +415a 4138 308d 319d +4139 413a 32ac 32ad +415b 4139 319d 32ad +413a 413b 33bc 33bd +415c 413a 32ad 33bd +413b 413c 34cc 34cd +415d 413b 33bd 34cd +415e 413c 34cd 35dd +413d 413e 12cd 12ce +415f 413d 11be 12ce +413e 413f 13dd 13de +4160 413e 12ce 13de +413f 4140 14ed 14ee +4161 413f 13de 14ee +4140 4141 15fd 15fe +4162 4140 14ee 15fe +4141 4142 170d 170e +4163 4141 15fe 170e +4142 4143 181d 181e +4164 4142 170e 181e +4143 4144 192d 192e +4165 4143 181e 192e +4144 4145 1a3d 1a3e +4166 4144 192e 1a3e +4145 4146 1b4d 1b4e +4167 4145 1a3e 1b4e +4146 4147 1c5d 1c5e +4168 4146 1b4e 1c5e +4147 4148 1d6d 1d6e +4169 4147 1c5e 1d6e +4148 4149 1e7d 1e7e +416a 4148 1d6e 1e7e +4149 414a 1f8d 1f8e +416b 4149 1e7e 1f8e +414a 414b 209d 209e +416c 414a 1f8e 209e +414b 414c 21ad 21ae +416d 414b 209e 21ae +414c 414d 22bd 22be +416e 414c 21ae 22be +414d 414e 23cd 23ce +416f 414d 22be 23ce +414e 414f 24dd 24de +4170 414e 23ce 24de +414f 4150 25ed 25ee +4171 414f 24de 25ee +4150 4151 26fd 26fe +4172 4150 25ee 26fe +4151 4152 280d 280e +4173 4151 26fe 280e +4152 4153 291d 291e +4174 4152 280e 291e +4153 4154 2a2d 2a2e +4175 4153 291e 2a2e +4154 4155 2b3d 2b3e +4176 4154 2a2e 2b3e +4155 4156 2c4d 2c4e +4177 4155 2b3e 2c4e +4156 4157 2d5d 2d5e +4178 4156 2c4e 2d5e +4157 4158 2e6d 2e6e +4179 4157 2d5e 2e6e +4158 4159 2f7d 2f7e +417a 4158 2e6e 2f7e +4159 415a 308d 308e +417b 4159 2f7e 308e +415a 415b 319d 319e +417c 415a 308e 319e +415b 415c 32ad 32ae +417d 415b 319e 32ae +415c 415d 33bd 33be +417e 415c 32ae 33be +415d 415e 34cd 34ce +417f 415d 33be 34ce +4180 415e 34ce 35de +415f 4160 12ce 12cf +4181 415f 11bf 12cf +4160 4161 13de 13df +4182 4160 12cf 13df +4161 4162 14ee 14ef +4183 4161 13df 14ef +4162 4163 15fe 15ff +4184 4162 14ef 15ff +4163 4164 170e 170f +4185 4163 15ff 170f +4164 4165 181e 181f +4186 4164 170f 181f +4165 4166 192e 192f +4187 4165 181f 192f +4166 4167 1a3e 1a3f +4188 4166 192f 1a3f +4167 4168 1b4e 1b4f +4189 4167 1a3f 1b4f +4168 4169 1c5e 1c5f +418a 4168 1b4f 1c5f +4169 416a 1d6e 1d6f +418b 4169 1c5f 1d6f +416a 416b 1e7e 1e7f +418c 416a 1d6f 1e7f +416b 416c 1f8e 1f8f +418d 416b 1e7f 1f8f +416c 416d 209e 209f +418e 416c 1f8f 209f +416d 416e 21ae 21af +418f 416d 209f 21af +416e 416f 22be 22bf +4190 416e 21af 22bf +416f 4170 23ce 23cf +4191 416f 22bf 23cf +4170 4171 24de 24df +4192 4170 23cf 24df +4171 4172 25ee 25ef +4193 4171 24df 25ef +4172 4173 26fe 26ff +4194 4172 25ef 26ff +4173 4174 280e 280f +4195 4173 26ff 280f +4174 4175 291e 291f +4196 4174 280f 291f +4175 4176 2a2e 2a2f +4197 4175 291f 2a2f +4176 4177 2b3e 2b3f +4198 4176 2a2f 2b3f +4177 4178 2c4e 2c4f +4199 4177 2b3f 2c4f +4178 4179 2d5e 2d5f +419a 4178 2c4f 2d5f +4179 417a 2e6e 2e6f +419b 4179 2d5f 2e6f +417a 417b 2f7e 2f7f +419c 417a 2e6f 2f7f +417b 417c 308e 308f +419d 417b 2f7f 308f +417c 417d 319e 319f +419e 417c 308f 319f +417d 417e 32ae 32af +419f 417d 319f 32af +417e 417f 33be 33bf +41a0 417e 32af 33bf +417f 4180 34ce 34cf +41a1 417f 33bf 34cf +41a2 4180 34cf 35df +4181 4182 12cf 12d0 +41a3 4181 11c0 12d0 +4182 4183 13df 13e0 +41a4 4182 12d0 13e0 +4183 4184 14ef 14f0 +41a5 4183 13e0 14f0 +4184 4185 15ff 1600 +41a6 4184 14f0 1600 +4185 4186 170f 1710 +41a7 4185 1600 1710 +4186 4187 181f 1820 +41a8 4186 1710 1820 +4187 4188 192f 1930 +41a9 4187 1820 1930 +4188 4189 1a3f 1a40 +41aa 4188 1930 1a40 +4189 418a 1b4f 1b50 +41ab 4189 1a40 1b50 +418a 418b 1c5f 1c60 +41ac 418a 1b50 1c60 +418b 418c 1d6f 1d70 +41ad 418b 1c60 1d70 +418c 418d 1e7f 1e80 +41ae 418c 1d70 1e80 +418d 418e 1f8f 1f90 +41af 418d 1e80 1f90 +418e 418f 209f 20a0 +41b0 418e 1f90 20a0 +418f 4190 21af 21b0 +41b1 418f 20a0 21b0 +4190 4191 22bf 22c0 +41b2 4190 21b0 22c0 +4191 4192 23cf 23d0 +41b3 4191 22c0 23d0 +4192 4193 24df 24e0 +41b4 4192 23d0 24e0 +4193 4194 25ef 25f0 +41b5 4193 24e0 25f0 +4194 4195 26ff 2700 +41b6 4194 25f0 2700 +4195 4196 280f 2810 +41b7 4195 2700 2810 +4196 4197 291f 2920 +41b8 4196 2810 2920 +4197 4198 2a2f 2a30 +41b9 4197 2920 2a30 +4198 4199 2b3f 2b40 +41ba 4198 2a30 2b40 +4199 419a 2c4f 2c50 +41bb 4199 2b40 2c50 +419a 419b 2d5f 2d60 +41bc 419a 2c50 2d60 +419b 419c 2e6f 2e70 +41bd 419b 2d60 2e70 +419c 419d 2f7f 2f80 +41be 419c 2e70 2f80 +419d 419e 308f 3090 +41bf 419d 2f80 3090 +419e 419f 319f 31a0 +41c0 419e 3090 31a0 +419f 41a0 32af 32b0 +41c1 419f 31a0 32b0 +41a0 41a1 33bf 33c0 +41c2 41a0 32b0 33c0 +41a1 41a2 34cf 34d0 +41c3 41a1 33c0 34d0 +41c4 41a2 34d0 35e0 +41a3 41a4 12d0 12d1 +41c5 41a3 11c1 12d1 +41a4 41a5 13e0 13e1 +41c6 41a4 12d1 13e1 +41a5 41a6 14f0 14f1 +41c7 41a5 13e1 14f1 +41a6 41a7 1600 1601 +41c8 41a6 14f1 1601 +41a7 41a8 1710 1711 +41c9 41a7 1601 1711 +41a8 41a9 1820 1821 +41ca 41a8 1711 1821 +41a9 41aa 1930 1931 +41cb 41a9 1821 1931 +41aa 41ab 1a40 1a41 +41cc 41aa 1931 1a41 +41ab 41ac 1b50 1b51 +41cd 41ab 1a41 1b51 +41ac 41ad 1c60 1c61 +41ce 41ac 1b51 1c61 +41ad 41ae 1d70 1d71 +41cf 41ad 1c61 1d71 +41ae 41af 1e80 1e81 +41d0 41ae 1d71 1e81 +41af 41b0 1f90 1f91 +41d1 41af 1e81 1f91 +41b0 41b1 20a0 20a1 +41d2 41b0 1f91 20a1 +41b1 41b2 21b0 21b1 +41d3 41b1 20a1 21b1 +41b2 41b3 22c0 22c1 +41d4 41b2 21b1 22c1 +41b3 41b4 23d0 23d1 +41d5 41b3 22c1 23d1 +41b4 41b5 24e0 24e1 +41d6 41b4 23d1 24e1 +41b5 41b6 25f0 25f1 +41d7 41b5 24e1 25f1 +41b6 41b7 2700 2701 +41d8 41b6 25f1 2701 +41b7 41b8 2810 2811 +41d9 41b7 2701 2811 +41b8 41b9 2920 2921 +41da 41b8 2811 2921 +41b9 41ba 2a30 2a31 +41db 41b9 2921 2a31 +41ba 41bb 2b40 2b41 +41dc 41ba 2a31 2b41 +41bb 41bc 2c50 2c51 +41dd 41bb 2b41 2c51 +41bc 41bd 2d60 2d61 +41de 41bc 2c51 2d61 +41bd 41be 2e70 2e71 +41df 41bd 2d61 2e71 +41be 41bf 2f80 2f81 +41e0 41be 2e71 2f81 +41bf 41c0 3090 3091 +41e1 41bf 2f81 3091 +41c0 41c1 31a0 31a1 +41e2 41c0 3091 31a1 +41c1 41c2 32b0 32b1 +41e3 41c1 31a1 32b1 +41c2 41c3 33c0 33c1 +41e4 41c2 32b1 33c1 +41c3 41c4 34d0 34d1 +41e5 41c3 33c1 34d1 +41e6 41c4 34d1 35e1 +41c5 41c6 12d1 12d2 +41e7 41c5 11c2 12d2 +41c6 41c7 13e1 13e2 +41e8 41c6 12d2 13e2 +41c7 41c8 14f1 14f2 +41e9 41c7 13e2 14f2 +41c8 41c9 1601 1602 +41ea 41c8 14f2 1602 +41c9 41ca 1711 1712 +41eb 41c9 1602 1712 +41ca 41cb 1821 1822 +41ec 41ca 1712 1822 +41cb 41cc 1931 1932 +41ed 41cb 1822 1932 +41cc 41cd 1a41 1a42 +41ee 41cc 1932 1a42 +41cd 41ce 1b51 1b52 +41ef 41cd 1a42 1b52 +41ce 41cf 1c61 1c62 +41f0 41ce 1b52 1c62 +41cf 41d0 1d71 1d72 +41f1 41cf 1c62 1d72 +41d0 41d1 1e81 1e82 +41f2 41d0 1d72 1e82 +41d1 41d2 1f91 1f92 +41f3 41d1 1e82 1f92 +41d2 41d3 20a1 20a2 +41f4 41d2 1f92 20a2 +41d3 41d4 21b1 21b2 +41f5 41d3 20a2 21b2 +41d4 41d5 22c1 22c2 +41f6 41d4 21b2 22c2 +41d5 41d6 23d1 23d2 +41f7 41d5 22c2 23d2 +41d6 41d7 24e1 24e2 +41f8 41d6 23d2 24e2 +41d7 41d8 25f1 25f2 +41f9 41d7 24e2 25f2 +41d8 41d9 2701 2702 +41fa 41d8 25f2 2702 +41d9 41da 2811 2812 +41fb 41d9 2702 2812 +41da 41db 2921 2922 +41fc 41da 2812 2922 +41db 41dc 2a31 2a32 +41fd 41db 2922 2a32 +41dc 41dd 2b41 2b42 +41fe 41dc 2a32 2b42 +41dd 41de 2c51 2c52 +41ff 41dd 2b42 2c52 +41de 41df 2d61 2d62 +4200 41de 2c52 2d62 +41df 41e0 2e71 2e72 +4201 41df 2d62 2e72 +41e0 41e1 2f81 2f82 +4202 41e0 2e72 2f82 +41e1 41e2 3091 3092 +4203 41e1 2f82 3092 +41e2 41e3 31a1 31a2 +4204 41e2 3092 31a2 +41e3 41e4 32b1 32b2 +4205 41e3 31a2 32b2 +41e4 41e5 33c1 33c2 +4206 41e4 32b2 33c2 +41e5 41e6 34d1 34d2 +4207 41e5 33c2 34d2 +4208 41e6 34d2 35e2 +41e7 41e8 12d2 12d3 +4209 41e7 11c3 12d3 +41e8 41e9 13e2 13e3 +420a 41e8 12d3 13e3 +41e9 41ea 14f2 14f3 +420b 41e9 13e3 14f3 +41ea 41eb 1602 1603 +420c 41ea 14f3 1603 +41eb 41ec 1712 1713 +420d 41eb 1603 1713 +41ec 41ed 1822 1823 +420e 41ec 1713 1823 +41ed 41ee 1932 1933 +420f 41ed 1823 1933 +41ee 41ef 1a42 1a43 +4210 41ee 1933 1a43 +41ef 41f0 1b52 1b53 +4211 41ef 1a43 1b53 +41f0 41f1 1c62 1c63 +4212 41f0 1b53 1c63 +41f1 41f2 1d72 1d73 +4213 41f1 1c63 1d73 +41f2 41f3 1e82 1e83 +4214 41f2 1d73 1e83 +41f3 41f4 1f92 1f93 +4215 41f3 1e83 1f93 +41f4 41f5 20a2 20a3 +4216 41f4 1f93 20a3 +41f5 41f6 21b2 21b3 +4217 41f5 20a3 21b3 +41f6 41f7 22c2 22c3 +4218 41f6 21b3 22c3 +41f7 41f8 23d2 23d3 +4219 41f7 22c3 23d3 +41f8 41f9 24e2 24e3 +421a 41f8 23d3 24e3 +41f9 41fa 25f2 25f3 +421b 41f9 24e3 25f3 +41fa 41fb 2702 2703 +421c 41fa 25f3 2703 +41fb 41fc 2812 2813 +421d 41fb 2703 2813 +41fc 41fd 2922 2923 +421e 41fc 2813 2923 +41fd 41fe 2a32 2a33 +421f 41fd 2923 2a33 +41fe 41ff 2b42 2b43 +4220 41fe 2a33 2b43 +41ff 4200 2c52 2c53 +4221 41ff 2b43 2c53 +4200 4201 2d62 2d63 +4222 4200 2c53 2d63 +4201 4202 2e72 2e73 +4223 4201 2d63 2e73 +4202 4203 2f82 2f83 +4224 4202 2e73 2f83 +4203 4204 3092 3093 +4225 4203 2f83 3093 +4204 4205 31a2 31a3 +4226 4204 3093 31a3 +4205 4206 32b2 32b3 +4227 4205 31a3 32b3 +4206 4207 33c2 33c3 +4228 4206 32b3 33c3 +4207 4208 34d2 34d3 +4229 4207 33c3 34d3 +422a 4208 34d3 35e3 +4209 420a 12d3 12d4 +420a 420b 13e3 13e4 +420b 420c 14f3 14f4 +420c 420d 1603 1604 +420d 420e 1713 1714 +420e 420f 1823 1824 +420f 4210 1933 1934 +4210 4211 1a43 1a44 +4211 4212 1b53 1b54 +4212 4213 1c63 1c64 +4213 4214 1d73 1d74 +4214 4215 1e83 1e84 +4215 4216 1f93 1f94 +4216 4217 20a3 20a4 +4217 4218 21b3 21b4 +4218 4219 22c3 22c4 +4219 421a 23d3 23d4 +421a 421b 24e3 24e4 +421b 421c 25f3 25f4 +421c 421d 2703 2704 +421d 421e 2813 2814 +421e 421f 2923 2924 +421f 4220 2a33 2a34 +4220 4221 2b43 2b44 +4221 4222 2c53 2c54 +4222 4223 2d63 2d64 +4223 4224 2e73 2e74 +4224 4225 2f83 2f84 +4225 4226 3093 3094 +4226 4227 31a3 31a4 +4227 4228 32b3 32b4 +4228 4229 33c3 33c4 +4229 422a 34d3 34d4 +422c 422b 11c6 12d6 +422b 4256 12d5 12d6 +422d 422c 11c7 12d7 +422c 4257 12d6 12d7 +422e 422d 11c8 12d8 +422d 4258 12d7 12d8 +422f 422e 11c9 12d9 +422e 4259 12d8 12d9 +4230 422f 11ca 12da +422f 425a 12d9 12da +4231 4230 11cb 12db +4230 425b 12da 12db +4232 4231 11cc 12dc +4231 425c 12db 12dc +4233 4232 11cd 12dd +4232 425d 12dc 12dd +4234 4233 11ce 12de +4233 425e 12dd 12de +4235 4234 11cf 12df +4234 425f 12de 12df +4236 4235 11d0 12e0 +4235 4260 12df 12e0 +4237 4236 11d1 12e1 +4236 4261 12e0 12e1 +4238 4237 11d2 12e2 +4237 4262 12e1 12e2 +4239 4238 11d3 12e3 +4238 4263 12e2 12e3 +423a 4239 11d4 12e4 +4239 4264 12e3 12e4 +423b 423a 11d5 12e5 +423a 4265 12e4 12e5 +423c 423b 11d6 12e6 +423b 4266 12e5 12e6 +423d 423c 11d7 12e7 +423c 4267 12e6 12e7 +423e 423d 11d8 12e8 +423d 4268 12e7 12e8 +423f 423e 11d9 12e9 +423e 4269 12e8 12e9 +4240 423f 11da 12ea +423f 426a 12e9 12ea +4241 4240 11db 12eb +4240 426b 12ea 12eb +4242 4241 11dc 12ec +4241 426c 12eb 12ec +4243 4242 11dd 12ed +4242 426d 12ec 12ed +4244 4243 11de 12ee +4243 426e 12ed 12ee +4245 4244 11df 12ef +4244 426f 12ee 12ef +4246 4245 11e0 12f0 +4245 4270 12ef 12f0 +4247 4246 11e1 12f1 +4246 4271 12f0 12f1 +4248 4247 11e2 12f2 +4247 4272 12f1 12f2 +4249 4248 11e3 12f3 +4248 4273 12f2 12f3 +424a 4249 11e4 12f4 +4249 4274 12f3 12f4 +424b 424a 11e5 12f5 +424a 4275 12f4 12f5 +424c 424b 11e6 12f6 +424b 4276 12f5 12f6 +424d 424c 11e7 12f7 +424c 4277 12f6 12f7 +424e 424d 11e8 12f8 +424d 4278 12f7 12f8 +424f 424e 11e9 12f9 +424e 4279 12f8 12f9 +4250 424f 11ea 12fa +424f 427a 12f9 12fa +4251 4250 11eb 12fb +4250 427b 12fa 12fb +4252 4251 11ec 12fc +4251 427c 12fb 12fc +4253 4252 11ed 12fd +4252 427d 12fc 12fd +4254 4253 11ee 12fe +4253 427e 12fd 12fe +4255 4254 11ef 12ff +4254 427f 12fe 12ff +4255 4280 12ff 1300 +4257 4256 12d6 13e6 +4256 4281 13e5 13e6 +4258 4257 12d7 13e7 +4257 4282 13e6 13e7 +4259 4258 12d8 13e8 +4258 4283 13e7 13e8 +425a 4259 12d9 13e9 +4259 4284 13e8 13e9 +425b 425a 12da 13ea +425a 4285 13e9 13ea +425c 425b 12db 13eb +425b 4286 13ea 13eb +425d 425c 12dc 13ec +425c 4287 13eb 13ec +425e 425d 12dd 13ed +425d 4288 13ec 13ed +425f 425e 12de 13ee +425e 4289 13ed 13ee +4260 425f 12df 13ef +425f 428a 13ee 13ef +4261 4260 12e0 13f0 +4260 428b 13ef 13f0 +4262 4261 12e1 13f1 +4261 428c 13f0 13f1 +4263 4262 12e2 13f2 +4262 428d 13f1 13f2 +4264 4263 12e3 13f3 +4263 428e 13f2 13f3 +4265 4264 12e4 13f4 +4264 428f 13f3 13f4 +4266 4265 12e5 13f5 +4265 4290 13f4 13f5 +4267 4266 12e6 13f6 +4266 4291 13f5 13f6 +4268 4267 12e7 13f7 +4267 4292 13f6 13f7 +4269 4268 12e8 13f8 +4268 4293 13f7 13f8 +426a 4269 12e9 13f9 +4269 4294 13f8 13f9 +426b 426a 12ea 13fa +426a 4295 13f9 13fa +426c 426b 12eb 13fb +426b 4296 13fa 13fb +426d 426c 12ec 13fc +426c 4297 13fb 13fc +426e 426d 12ed 13fd +426d 4298 13fc 13fd +426f 426e 12ee 13fe +426e 4299 13fd 13fe +4270 426f 12ef 13ff +426f 429a 13fe 13ff +4271 4270 12f0 1400 +4270 429b 13ff 1400 +4272 4271 12f1 1401 +4271 429c 1400 1401 +4273 4272 12f2 1402 +4272 429d 1401 1402 +4274 4273 12f3 1403 +4273 429e 1402 1403 +4275 4274 12f4 1404 +4274 429f 1403 1404 +4276 4275 12f5 1405 +4275 42a0 1404 1405 +4277 4276 12f6 1406 +4276 42a1 1405 1406 +4278 4277 12f7 1407 +4277 42a2 1406 1407 +4279 4278 12f8 1408 +4278 42a3 1407 1408 +427a 4279 12f9 1409 +4279 42a4 1408 1409 +427b 427a 12fa 140a +427a 42a5 1409 140a +427c 427b 12fb 140b +427b 42a6 140a 140b +427d 427c 12fc 140c +427c 42a7 140b 140c +427e 427d 12fd 140d +427d 42a8 140c 140d +427f 427e 12fe 140e +427e 42a9 140d 140e +4280 427f 12ff 140f +427f 42aa 140e 140f +4280 42ab 140f 1410 +4282 4281 13e6 14f6 +4281 42ac 14f5 14f6 +4283 4282 13e7 14f7 +4282 42ad 14f6 14f7 +4284 4283 13e8 14f8 +4283 42ae 14f7 14f8 +4285 4284 13e9 14f9 +4284 42af 14f8 14f9 +4286 4285 13ea 14fa +4285 42b0 14f9 14fa +4287 4286 13eb 14fb +4286 42b1 14fa 14fb +4288 4287 13ec 14fc +4287 42b2 14fb 14fc +4289 4288 13ed 14fd +4288 42b3 14fc 14fd +428a 4289 13ee 14fe +4289 42b4 14fd 14fe +428b 428a 13ef 14ff +428a 42b5 14fe 14ff +428c 428b 13f0 1500 +428b 42b6 14ff 1500 +428d 428c 13f1 1501 +428c 42b7 1500 1501 +428e 428d 13f2 1502 +428d 42b8 1501 1502 +428f 428e 13f3 1503 +428e 42b9 1502 1503 +4290 428f 13f4 1504 +428f 42ba 1503 1504 +4291 4290 13f5 1505 +4290 42bb 1504 1505 +4292 4291 13f6 1506 +4291 42bc 1505 1506 +4293 4292 13f7 1507 +4292 42bd 1506 1507 +4294 4293 13f8 1508 +4293 42be 1507 1508 +4295 4294 13f9 1509 +4294 42bf 1508 1509 +4296 4295 13fa 150a +4295 42c0 1509 150a +4297 4296 13fb 150b +4296 42c1 150a 150b +4298 4297 13fc 150c +4297 42c2 150b 150c +4299 4298 13fd 150d +4298 42c3 150c 150d +429a 4299 13fe 150e +4299 42c4 150d 150e +429b 429a 13ff 150f +429a 42c5 150e 150f +429c 429b 1400 1510 +429b 42c6 150f 1510 +429d 429c 1401 1511 +429c 42c7 1510 1511 +429e 429d 1402 1512 +429d 42c8 1511 1512 +429f 429e 1403 1513 +429e 42c9 1512 1513 +42a0 429f 1404 1514 +429f 42ca 1513 1514 +42a1 42a0 1405 1515 +42a0 42cb 1514 1515 +42a2 42a1 1406 1516 +42a1 42cc 1515 1516 +42a3 42a2 1407 1517 +42a2 42cd 1516 1517 +42a4 42a3 1408 1518 +42a3 42ce 1517 1518 +42a5 42a4 1409 1519 +42a4 42cf 1518 1519 +42a6 42a5 140a 151a +42a5 42d0 1519 151a +42a7 42a6 140b 151b +42a6 42d1 151a 151b +42a8 42a7 140c 151c +42a7 42d2 151b 151c +42a9 42a8 140d 151d +42a8 42d3 151c 151d +42aa 42a9 140e 151e +42a9 42d4 151d 151e +42ab 42aa 140f 151f +42aa 42d5 151e 151f +42ab 42d6 151f 1520 +42ad 42ac 14f6 1606 +42ac 42d7 1605 1606 +42ae 42ad 14f7 1607 +42ad 42d8 1606 1607 +42af 42ae 14f8 1608 +42ae 42d9 1607 1608 +42b0 42af 14f9 1609 +42af 42da 1608 1609 +42b1 42b0 14fa 160a +42b0 42db 1609 160a +42b2 42b1 14fb 160b +42b1 42dc 160a 160b +42b3 42b2 14fc 160c +42b2 42dd 160b 160c +42b4 42b3 14fd 160d +42b3 42de 160c 160d +42b5 42b4 14fe 160e +42b4 42df 160d 160e +42b6 42b5 14ff 160f +42b5 42e0 160e 160f +42b7 42b6 1500 1610 +42b6 42e1 160f 1610 +42b8 42b7 1501 1611 +42b7 42e2 1610 1611 +42b9 42b8 1502 1612 +42b8 42e3 1611 1612 +42ba 42b9 1503 1613 +42b9 42e4 1612 1613 +42bb 42ba 1504 1614 +42ba 42e5 1613 1614 +42bc 42bb 1505 1615 +42bb 42e6 1614 1615 +42bd 42bc 1506 1616 +42bc 42e7 1615 1616 +42be 42bd 1507 1617 +42bd 42e8 1616 1617 +42bf 42be 1508 1618 +42be 42e9 1617 1618 +42c0 42bf 1509 1619 +42bf 42ea 1618 1619 +42c1 42c0 150a 161a +42c0 42eb 1619 161a +42c2 42c1 150b 161b +42c1 42ec 161a 161b +42c3 42c2 150c 161c +42c2 42ed 161b 161c +42c4 42c3 150d 161d +42c3 42ee 161c 161d +42c5 42c4 150e 161e +42c4 42ef 161d 161e +42c6 42c5 150f 161f +42c5 42f0 161e 161f +42c7 42c6 1510 1620 +42c6 42f1 161f 1620 +42c8 42c7 1511 1621 +42c7 42f2 1620 1621 +42c9 42c8 1512 1622 +42c8 42f3 1621 1622 +42ca 42c9 1513 1623 +42c9 42f4 1622 1623 +42cb 42ca 1514 1624 +42ca 42f5 1623 1624 +42cc 42cb 1515 1625 +42cb 42f6 1624 1625 +42cd 42cc 1516 1626 +42cc 42f7 1625 1626 +42ce 42cd 1517 1627 +42cd 42f8 1626 1627 +42cf 42ce 1518 1628 +42ce 42f9 1627 1628 +42d0 42cf 1519 1629 +42cf 42fa 1628 1629 +42d1 42d0 151a 162a +42d0 42fb 1629 162a +42d2 42d1 151b 162b +42d1 42fc 162a 162b +42d3 42d2 151c 162c +42d2 42fd 162b 162c +42d4 42d3 151d 162d +42d3 42fe 162c 162d +42d5 42d4 151e 162e +42d4 42ff 162d 162e +42d6 42d5 151f 162f +42d5 4300 162e 162f +42d6 4301 162f 1630 +42d8 42d7 1606 1716 +42d7 4302 1715 1716 +42d9 42d8 1607 1717 +42d8 4303 1716 1717 +42da 42d9 1608 1718 +42d9 4304 1717 1718 +42db 42da 1609 1719 +42da 4305 1718 1719 +42dc 42db 160a 171a +42db 4306 1719 171a +42dd 42dc 160b 171b +42dc 4307 171a 171b +42de 42dd 160c 171c +42dd 4308 171b 171c +42df 42de 160d 171d +42de 4309 171c 171d +42e0 42df 160e 171e +42df 430a 171d 171e +42e1 42e0 160f 171f +42e0 430b 171e 171f +42e2 42e1 1610 1720 +42e1 430c 171f 1720 +42e3 42e2 1611 1721 +42e2 430d 1720 1721 +42e4 42e3 1612 1722 +42e3 430e 1721 1722 +42e5 42e4 1613 1723 +42e4 430f 1722 1723 +42e6 42e5 1614 1724 +42e5 4310 1723 1724 +42e7 42e6 1615 1725 +42e6 4311 1724 1725 +42e8 42e7 1616 1726 +42e7 4312 1725 1726 +42e9 42e8 1617 1727 +42e8 4313 1726 1727 +42ea 42e9 1618 1728 +42e9 4314 1727 1728 +42eb 42ea 1619 1729 +42ea 4315 1728 1729 +42ec 42eb 161a 172a +42eb 4316 1729 172a +42ed 42ec 161b 172b +42ec 4317 172a 172b +42ee 42ed 161c 172c +42ed 4318 172b 172c +42ef 42ee 161d 172d +42ee 4319 172c 172d +42f0 42ef 161e 172e +42ef 431a 172d 172e +42f1 42f0 161f 172f +42f0 431b 172e 172f +42f2 42f1 1620 1730 +42f1 431c 172f 1730 +42f3 42f2 1621 1731 +42f2 431d 1730 1731 +42f4 42f3 1622 1732 +42f3 431e 1731 1732 +42f5 42f4 1623 1733 +42f4 431f 1732 1733 +42f6 42f5 1624 1734 +42f5 4320 1733 1734 +42f7 42f6 1625 1735 +42f6 4321 1734 1735 +42f8 42f7 1626 1736 +42f7 4322 1735 1736 +42f9 42f8 1627 1737 +42f8 4323 1736 1737 +42fa 42f9 1628 1738 +42f9 4324 1737 1738 +42fb 42fa 1629 1739 +42fa 4325 1738 1739 +42fc 42fb 162a 173a +42fb 4326 1739 173a +42fd 42fc 162b 173b +42fc 4327 173a 173b +42fe 42fd 162c 173c +42fd 4328 173b 173c +42ff 42fe 162d 173d +42fe 4329 173c 173d +4300 42ff 162e 173e +42ff 432a 173d 173e +4301 4300 162f 173f +4300 432b 173e 173f +4301 432c 173f 1740 +4303 4302 1716 1826 +4302 432d 1825 1826 +4304 4303 1717 1827 +4303 432e 1826 1827 +4305 4304 1718 1828 +4304 432f 1827 1828 +4306 4305 1719 1829 +4305 4330 1828 1829 +4307 4306 171a 182a +4306 4331 1829 182a +4308 4307 171b 182b +4307 4332 182a 182b +4309 4308 171c 182c +4308 4333 182b 182c +430a 4309 171d 182d +4309 4334 182c 182d +430b 430a 171e 182e +430a 4335 182d 182e +430c 430b 171f 182f +430b 4336 182e 182f +430d 430c 1720 1830 +430c 4337 182f 1830 +430e 430d 1721 1831 +430d 4338 1830 1831 +430f 430e 1722 1832 +430e 4339 1831 1832 +4310 430f 1723 1833 +430f 433a 1832 1833 +4311 4310 1724 1834 +4310 433b 1833 1834 +4312 4311 1725 1835 +4311 433c 1834 1835 +4313 4312 1726 1836 +4312 433d 1835 1836 +4314 4313 1727 1837 +4313 433e 1836 1837 +4315 4314 1728 1838 +4314 433f 1837 1838 +4316 4315 1729 1839 +4315 4340 1838 1839 +4317 4316 172a 183a +4316 4341 1839 183a +4318 4317 172b 183b +4317 4342 183a 183b +4319 4318 172c 183c +4318 4343 183b 183c +431a 4319 172d 183d +4319 4344 183c 183d +431b 431a 172e 183e +431a 4345 183d 183e +431c 431b 172f 183f +431b 4346 183e 183f +431d 431c 1730 1840 +431c 4347 183f 1840 +431e 431d 1731 1841 +431d 4348 1840 1841 +431f 431e 1732 1842 +431e 4349 1841 1842 +4320 431f 1733 1843 +431f 434a 1842 1843 +4321 4320 1734 1844 +4320 434b 1843 1844 +4322 4321 1735 1845 +4321 434c 1844 1845 +4323 4322 1736 1846 +4322 434d 1845 1846 +4324 4323 1737 1847 +4323 434e 1846 1847 +4325 4324 1738 1848 +4324 434f 1847 1848 +4326 4325 1739 1849 +4325 4350 1848 1849 +4327 4326 173a 184a +4326 4351 1849 184a +4328 4327 173b 184b +4327 4352 184a 184b +4329 4328 173c 184c +4328 4353 184b 184c +432a 4329 173d 184d +4329 4354 184c 184d +432b 432a 173e 184e +432a 4355 184d 184e +432c 432b 173f 184f +432b 4356 184e 184f +432c 4357 184f 1850 +432e 432d 1826 1936 +432d 4358 1935 1936 +432f 432e 1827 1937 +432e 4359 1936 1937 +4330 432f 1828 1938 +432f 435a 1937 1938 +4331 4330 1829 1939 +4330 435b 1938 1939 +4332 4331 182a 193a +4331 435c 1939 193a +4333 4332 182b 193b +4332 435d 193a 193b +4334 4333 182c 193c +4333 435e 193b 193c +4335 4334 182d 193d +4334 435f 193c 193d +4336 4335 182e 193e +4335 4360 193d 193e +4337 4336 182f 193f +4336 4361 193e 193f +4338 4337 1830 1940 +4337 4362 193f 1940 +4339 4338 1831 1941 +4338 4363 1940 1941 +433a 4339 1832 1942 +4339 4364 1941 1942 +433b 433a 1833 1943 +433a 4365 1942 1943 +433c 433b 1834 1944 +433b 4366 1943 1944 +433d 433c 1835 1945 +433c 4367 1944 1945 +433e 433d 1836 1946 +433d 4368 1945 1946 +433f 433e 1837 1947 +433e 4369 1946 1947 +4340 433f 1838 1948 +433f 436a 1947 1948 +4341 4340 1839 1949 +4340 436b 1948 1949 +4342 4341 183a 194a +4341 436c 1949 194a +4343 4342 183b 194b +4342 436d 194a 194b +4344 4343 183c 194c +4343 436e 194b 194c +4345 4344 183d 194d +4344 436f 194c 194d +4346 4345 183e 194e +4345 4370 194d 194e +4347 4346 183f 194f +4346 4371 194e 194f +4348 4347 1840 1950 +4347 4372 194f 1950 +4349 4348 1841 1951 +4348 4373 1950 1951 +434a 4349 1842 1952 +4349 4374 1951 1952 +434b 434a 1843 1953 +434a 4375 1952 1953 +434c 434b 1844 1954 +434b 4376 1953 1954 +434d 434c 1845 1955 +434c 4377 1954 1955 +434e 434d 1846 1956 +434d 4378 1955 1956 +434f 434e 1847 1957 +434e 4379 1956 1957 +4350 434f 1848 1958 +434f 437a 1957 1958 +4351 4350 1849 1959 +4350 437b 1958 1959 +4352 4351 184a 195a +4351 437c 1959 195a +4353 4352 184b 195b +4352 437d 195a 195b +4354 4353 184c 195c +4353 437e 195b 195c +4355 4354 184d 195d +4354 437f 195c 195d +4356 4355 184e 195e +4355 4380 195d 195e +4357 4356 184f 195f +4356 4381 195e 195f +4357 4382 195f 1960 +4359 4358 1936 1a46 +4358 4383 1a45 1a46 +435a 4359 1937 1a47 +4359 4384 1a46 1a47 +435b 435a 1938 1a48 +435a 4385 1a47 1a48 +435c 435b 1939 1a49 +435b 4386 1a48 1a49 +435d 435c 193a 1a4a +435c 4387 1a49 1a4a +435e 435d 193b 1a4b +435d 4388 1a4a 1a4b +435f 435e 193c 1a4c +435e 4389 1a4b 1a4c +4360 435f 193d 1a4d +435f 438a 1a4c 1a4d +4361 4360 193e 1a4e +4360 438b 1a4d 1a4e +4362 4361 193f 1a4f +4361 438c 1a4e 1a4f +4363 4362 1940 1a50 +4362 438d 1a4f 1a50 +4364 4363 1941 1a51 +4363 438e 1a50 1a51 +4365 4364 1942 1a52 +4364 438f 1a51 1a52 +4366 4365 1943 1a53 +4365 4390 1a52 1a53 +4367 4366 1944 1a54 +4366 4391 1a53 1a54 +4368 4367 1945 1a55 +4367 4392 1a54 1a55 +4369 4368 1946 1a56 +4368 4393 1a55 1a56 +436a 4369 1947 1a57 +4369 4394 1a56 1a57 +436b 436a 1948 1a58 +436a 4395 1a57 1a58 +436c 436b 1949 1a59 +436b 4396 1a58 1a59 +436d 436c 194a 1a5a +436c 4397 1a59 1a5a +436e 436d 194b 1a5b +436d 4398 1a5a 1a5b +436f 436e 194c 1a5c +436e 4399 1a5b 1a5c +4370 436f 194d 1a5d +436f 439a 1a5c 1a5d +4371 4370 194e 1a5e +4370 439b 1a5d 1a5e +4372 4371 194f 1a5f +4371 439c 1a5e 1a5f +4373 4372 1950 1a60 +4372 439d 1a5f 1a60 +4374 4373 1951 1a61 +4373 439e 1a60 1a61 +4375 4374 1952 1a62 +4374 439f 1a61 1a62 +4376 4375 1953 1a63 +4375 43a0 1a62 1a63 +4377 4376 1954 1a64 +4376 43a1 1a63 1a64 +4378 4377 1955 1a65 +4377 43a2 1a64 1a65 +4379 4378 1956 1a66 +4378 43a3 1a65 1a66 +437a 4379 1957 1a67 +4379 43a4 1a66 1a67 +437b 437a 1958 1a68 +437a 43a5 1a67 1a68 +437c 437b 1959 1a69 +437b 43a6 1a68 1a69 +437d 437c 195a 1a6a +437c 43a7 1a69 1a6a +437e 437d 195b 1a6b +437d 43a8 1a6a 1a6b +437f 437e 195c 1a6c +437e 43a9 1a6b 1a6c +4380 437f 195d 1a6d +437f 43aa 1a6c 1a6d +4381 4380 195e 1a6e +4380 43ab 1a6d 1a6e +4382 4381 195f 1a6f +4381 43ac 1a6e 1a6f +4382 43ad 1a6f 1a70 +4384 4383 1a46 1b56 +4383 43ae 1b55 1b56 +4385 4384 1a47 1b57 +4384 43af 1b56 1b57 +4386 4385 1a48 1b58 +4385 43b0 1b57 1b58 +4387 4386 1a49 1b59 +4386 43b1 1b58 1b59 +4388 4387 1a4a 1b5a +4387 43b2 1b59 1b5a +4389 4388 1a4b 1b5b +4388 43b3 1b5a 1b5b +438a 4389 1a4c 1b5c +4389 43b4 1b5b 1b5c +438b 438a 1a4d 1b5d +438a 43b5 1b5c 1b5d +438c 438b 1a4e 1b5e +438b 43b6 1b5d 1b5e +438d 438c 1a4f 1b5f +438c 43b7 1b5e 1b5f +438e 438d 1a50 1b60 +438d 43b8 1b5f 1b60 +438f 438e 1a51 1b61 +438e 43b9 1b60 1b61 +4390 438f 1a52 1b62 +438f 43ba 1b61 1b62 +4391 4390 1a53 1b63 +4390 43bb 1b62 1b63 +4392 4391 1a54 1b64 +4391 43bc 1b63 1b64 +4393 4392 1a55 1b65 +4392 43bd 1b64 1b65 +4394 4393 1a56 1b66 +4393 43be 1b65 1b66 +4395 4394 1a57 1b67 +4394 43bf 1b66 1b67 +4396 4395 1a58 1b68 +4395 43c0 1b67 1b68 +4397 4396 1a59 1b69 +4396 43c1 1b68 1b69 +4398 4397 1a5a 1b6a +4397 43c2 1b69 1b6a +4399 4398 1a5b 1b6b +4398 43c3 1b6a 1b6b +439a 4399 1a5c 1b6c +4399 43c4 1b6b 1b6c +439b 439a 1a5d 1b6d +439a 43c5 1b6c 1b6d +439c 439b 1a5e 1b6e +439b 43c6 1b6d 1b6e +439d 439c 1a5f 1b6f +439c 43c7 1b6e 1b6f +439e 439d 1a60 1b70 +439d 43c8 1b6f 1b70 +439f 439e 1a61 1b71 +439e 43c9 1b70 1b71 +43a0 439f 1a62 1b72 +439f 43ca 1b71 1b72 +43a1 43a0 1a63 1b73 +43a0 43cb 1b72 1b73 +43a2 43a1 1a64 1b74 +43a1 43cc 1b73 1b74 +43a3 43a2 1a65 1b75 +43a2 43cd 1b74 1b75 +43a4 43a3 1a66 1b76 +43a3 43ce 1b75 1b76 +43a5 43a4 1a67 1b77 +43a4 43cf 1b76 1b77 +43a6 43a5 1a68 1b78 +43a5 43d0 1b77 1b78 +43a7 43a6 1a69 1b79 +43a6 43d1 1b78 1b79 +43a8 43a7 1a6a 1b7a +43a7 43d2 1b79 1b7a +43a9 43a8 1a6b 1b7b +43a8 43d3 1b7a 1b7b +43aa 43a9 1a6c 1b7c +43a9 43d4 1b7b 1b7c +43ab 43aa 1a6d 1b7d +43aa 43d5 1b7c 1b7d +43ac 43ab 1a6e 1b7e +43ab 43d6 1b7d 1b7e +43ad 43ac 1a6f 1b7f +43ac 43d7 1b7e 1b7f +43ad 43d8 1b7f 1b80 +43af 43ae 1b56 1c66 +43ae 43d9 1c65 1c66 +43b0 43af 1b57 1c67 +43af 43da 1c66 1c67 +43b1 43b0 1b58 1c68 +43b0 43db 1c67 1c68 +43b2 43b1 1b59 1c69 +43b1 43dc 1c68 1c69 +43b3 43b2 1b5a 1c6a +43b2 43dd 1c69 1c6a +43b4 43b3 1b5b 1c6b +43b3 43de 1c6a 1c6b +43b5 43b4 1b5c 1c6c +43b4 43df 1c6b 1c6c +43b6 43b5 1b5d 1c6d +43b5 43e0 1c6c 1c6d +43b7 43b6 1b5e 1c6e +43b6 43e1 1c6d 1c6e +43b8 43b7 1b5f 1c6f +43b7 43e2 1c6e 1c6f +43b9 43b8 1b60 1c70 +43b8 43e3 1c6f 1c70 +43ba 43b9 1b61 1c71 +43b9 43e4 1c70 1c71 +43bb 43ba 1b62 1c72 +43ba 43e5 1c71 1c72 +43bc 43bb 1b63 1c73 +43bb 43e6 1c72 1c73 +43bd 43bc 1b64 1c74 +43bc 43e7 1c73 1c74 +43be 43bd 1b65 1c75 +43bd 43e8 1c74 1c75 +43bf 43be 1b66 1c76 +43be 43e9 1c75 1c76 +43c0 43bf 1b67 1c77 +43bf 43ea 1c76 1c77 +43c1 43c0 1b68 1c78 +43c0 43eb 1c77 1c78 +43c2 43c1 1b69 1c79 +43c1 43ec 1c78 1c79 +43c3 43c2 1b6a 1c7a +43c2 43ed 1c79 1c7a +43c4 43c3 1b6b 1c7b +43c3 43ee 1c7a 1c7b +43c5 43c4 1b6c 1c7c +43c4 43ef 1c7b 1c7c +43c6 43c5 1b6d 1c7d +43c5 43f0 1c7c 1c7d +43c7 43c6 1b6e 1c7e +43c6 43f1 1c7d 1c7e +43c8 43c7 1b6f 1c7f +43c7 43f2 1c7e 1c7f +43c9 43c8 1b70 1c80 +43c8 43f3 1c7f 1c80 +43ca 43c9 1b71 1c81 +43c9 43f4 1c80 1c81 +43cb 43ca 1b72 1c82 +43ca 43f5 1c81 1c82 +43cc 43cb 1b73 1c83 +43cb 43f6 1c82 1c83 +43cd 43cc 1b74 1c84 +43cc 43f7 1c83 1c84 +43ce 43cd 1b75 1c85 +43cd 43f8 1c84 1c85 +43cf 43ce 1b76 1c86 +43ce 43f9 1c85 1c86 +43d0 43cf 1b77 1c87 +43cf 43fa 1c86 1c87 +43d1 43d0 1b78 1c88 +43d0 43fb 1c87 1c88 +43d2 43d1 1b79 1c89 +43d1 43fc 1c88 1c89 +43d3 43d2 1b7a 1c8a +43d2 43fd 1c89 1c8a +43d4 43d3 1b7b 1c8b +43d3 43fe 1c8a 1c8b +43d5 43d4 1b7c 1c8c +43d4 43ff 1c8b 1c8c +43d6 43d5 1b7d 1c8d +43d5 4400 1c8c 1c8d +43d7 43d6 1b7e 1c8e +43d6 4401 1c8d 1c8e +43d8 43d7 1b7f 1c8f +43d7 4402 1c8e 1c8f +43d8 4403 1c8f 1c90 +43da 43d9 1c66 1d76 +43d9 4404 1d75 1d76 +43db 43da 1c67 1d77 +43da 4405 1d76 1d77 +43dc 43db 1c68 1d78 +43db 4406 1d77 1d78 +43dd 43dc 1c69 1d79 +43dc 4407 1d78 1d79 +43de 43dd 1c6a 1d7a +43dd 4408 1d79 1d7a +43df 43de 1c6b 1d7b +43de 4409 1d7a 1d7b +43e0 43df 1c6c 1d7c +43df 440a 1d7b 1d7c +43e1 43e0 1c6d 1d7d +43e0 440b 1d7c 1d7d +43e2 43e1 1c6e 1d7e +43e1 440c 1d7d 1d7e +43e3 43e2 1c6f 1d7f +43e2 440d 1d7e 1d7f +43e4 43e3 1c70 1d80 +43e3 440e 1d7f 1d80 +43e5 43e4 1c71 1d81 +43e4 440f 1d80 1d81 +43e6 43e5 1c72 1d82 +43e5 4410 1d81 1d82 +43e7 43e6 1c73 1d83 +43e6 4411 1d82 1d83 +43e8 43e7 1c74 1d84 +43e7 4412 1d83 1d84 +43e9 43e8 1c75 1d85 +43e8 4413 1d84 1d85 +43ea 43e9 1c76 1d86 +43e9 4414 1d85 1d86 +43eb 43ea 1c77 1d87 +43ea 4415 1d86 1d87 +43ec 43eb 1c78 1d88 +43eb 4416 1d87 1d88 +43ed 43ec 1c79 1d89 +43ec 4417 1d88 1d89 +43ee 43ed 1c7a 1d8a +43ed 4418 1d89 1d8a +43ef 43ee 1c7b 1d8b +43ee 4419 1d8a 1d8b +43f0 43ef 1c7c 1d8c +43ef 441a 1d8b 1d8c +43f1 43f0 1c7d 1d8d +43f0 441b 1d8c 1d8d +43f2 43f1 1c7e 1d8e +43f1 441c 1d8d 1d8e +43f3 43f2 1c7f 1d8f +43f2 441d 1d8e 1d8f +43f4 43f3 1c80 1d90 +43f3 441e 1d8f 1d90 +43f5 43f4 1c81 1d91 +43f4 441f 1d90 1d91 +43f6 43f5 1c82 1d92 +43f5 4420 1d91 1d92 +43f7 43f6 1c83 1d93 +43f6 4421 1d92 1d93 +43f8 43f7 1c84 1d94 +43f7 4422 1d93 1d94 +43f9 43f8 1c85 1d95 +43f8 4423 1d94 1d95 +43fa 43f9 1c86 1d96 +43f9 4424 1d95 1d96 +43fb 43fa 1c87 1d97 +43fa 4425 1d96 1d97 +43fc 43fb 1c88 1d98 +43fb 4426 1d97 1d98 +43fd 43fc 1c89 1d99 +43fc 4427 1d98 1d99 +43fe 43fd 1c8a 1d9a +43fd 4428 1d99 1d9a +43ff 43fe 1c8b 1d9b +43fe 4429 1d9a 1d9b +4400 43ff 1c8c 1d9c +43ff 442a 1d9b 1d9c +4401 4400 1c8d 1d9d +4400 442b 1d9c 1d9d +4402 4401 1c8e 1d9e +4401 442c 1d9d 1d9e +4403 4402 1c8f 1d9f +4402 442d 1d9e 1d9f +4403 442e 1d9f 1da0 +4405 4404 1d76 1e86 +4404 442f 1e85 1e86 +4406 4405 1d77 1e87 +4405 4430 1e86 1e87 +4407 4406 1d78 1e88 +4406 4431 1e87 1e88 +4408 4407 1d79 1e89 +4407 4432 1e88 1e89 +4409 4408 1d7a 1e8a +4408 4433 1e89 1e8a +440a 4409 1d7b 1e8b +4409 4434 1e8a 1e8b +440b 440a 1d7c 1e8c +440a 4435 1e8b 1e8c +440c 440b 1d7d 1e8d +440b 4436 1e8c 1e8d +440d 440c 1d7e 1e8e +440c 4437 1e8d 1e8e +440e 440d 1d7f 1e8f +440d 4438 1e8e 1e8f +440f 440e 1d80 1e90 +440e 4439 1e8f 1e90 +4410 440f 1d81 1e91 +440f 443a 1e90 1e91 +4411 4410 1d82 1e92 +4410 443b 1e91 1e92 +4412 4411 1d83 1e93 +4411 443c 1e92 1e93 +4413 4412 1d84 1e94 +4412 443d 1e93 1e94 +4414 4413 1d85 1e95 +4413 443e 1e94 1e95 +4415 4414 1d86 1e96 +4414 443f 1e95 1e96 +4416 4415 1d87 1e97 +4415 4440 1e96 1e97 +4417 4416 1d88 1e98 +4416 4441 1e97 1e98 +4418 4417 1d89 1e99 +4417 4442 1e98 1e99 +4419 4418 1d8a 1e9a +4418 4443 1e99 1e9a +441a 4419 1d8b 1e9b +4419 4444 1e9a 1e9b +441b 441a 1d8c 1e9c +441a 4445 1e9b 1e9c +441c 441b 1d8d 1e9d +441b 4446 1e9c 1e9d +441d 441c 1d8e 1e9e +441c 4447 1e9d 1e9e +441e 441d 1d8f 1e9f +441d 4448 1e9e 1e9f +441f 441e 1d90 1ea0 +441e 4449 1e9f 1ea0 +4420 441f 1d91 1ea1 +441f 444a 1ea0 1ea1 +4421 4420 1d92 1ea2 +4420 444b 1ea1 1ea2 +4422 4421 1d93 1ea3 +4421 444c 1ea2 1ea3 +4423 4422 1d94 1ea4 +4422 444d 1ea3 1ea4 +4424 4423 1d95 1ea5 +4423 444e 1ea4 1ea5 +4425 4424 1d96 1ea6 +4424 444f 1ea5 1ea6 +4426 4425 1d97 1ea7 +4425 4450 1ea6 1ea7 +4427 4426 1d98 1ea8 +4426 4451 1ea7 1ea8 +4428 4427 1d99 1ea9 +4427 4452 1ea8 1ea9 +4429 4428 1d9a 1eaa +4428 4453 1ea9 1eaa +442a 4429 1d9b 1eab +4429 4454 1eaa 1eab +442b 442a 1d9c 1eac +442a 4455 1eab 1eac +442c 442b 1d9d 1ead +442b 4456 1eac 1ead +442d 442c 1d9e 1eae +442c 4457 1ead 1eae +442e 442d 1d9f 1eaf +442d 4458 1eae 1eaf +442e 4459 1eaf 1eb0 +4430 442f 1e86 1f96 +442f 445a 1f95 1f96 +4431 4430 1e87 1f97 +4430 445b 1f96 1f97 +4432 4431 1e88 1f98 +4431 445c 1f97 1f98 +4433 4432 1e89 1f99 +4432 445d 1f98 1f99 +4434 4433 1e8a 1f9a +4433 445e 1f99 1f9a +4435 4434 1e8b 1f9b +4434 445f 1f9a 1f9b +4436 4435 1e8c 1f9c +4435 4460 1f9b 1f9c +4437 4436 1e8d 1f9d +4436 4461 1f9c 1f9d +4438 4437 1e8e 1f9e +4437 4462 1f9d 1f9e +4439 4438 1e8f 1f9f +4438 4463 1f9e 1f9f +443a 4439 1e90 1fa0 +4439 4464 1f9f 1fa0 +443b 443a 1e91 1fa1 +443a 4465 1fa0 1fa1 +443c 443b 1e92 1fa2 +443b 4466 1fa1 1fa2 +443d 443c 1e93 1fa3 +443c 4467 1fa2 1fa3 +443e 443d 1e94 1fa4 +443d 4468 1fa3 1fa4 +443f 443e 1e95 1fa5 +443e 4469 1fa4 1fa5 +4440 443f 1e96 1fa6 +443f 446a 1fa5 1fa6 +4441 4440 1e97 1fa7 +4440 446b 1fa6 1fa7 +4442 4441 1e98 1fa8 +4441 446c 1fa7 1fa8 +4443 4442 1e99 1fa9 +4442 446d 1fa8 1fa9 +4444 4443 1e9a 1faa +4443 446e 1fa9 1faa +4445 4444 1e9b 1fab +4444 446f 1faa 1fab +4446 4445 1e9c 1fac +4445 4470 1fab 1fac +4447 4446 1e9d 1fad +4446 4471 1fac 1fad +4448 4447 1e9e 1fae +4447 4472 1fad 1fae +4449 4448 1e9f 1faf +4448 4473 1fae 1faf +444a 4449 1ea0 1fb0 +4449 4474 1faf 1fb0 +444b 444a 1ea1 1fb1 +444a 4475 1fb0 1fb1 +444c 444b 1ea2 1fb2 +444b 4476 1fb1 1fb2 +444d 444c 1ea3 1fb3 +444c 4477 1fb2 1fb3 +444e 444d 1ea4 1fb4 +444d 4478 1fb3 1fb4 +444f 444e 1ea5 1fb5 +444e 4479 1fb4 1fb5 +4450 444f 1ea6 1fb6 +444f 447a 1fb5 1fb6 +4451 4450 1ea7 1fb7 +4450 447b 1fb6 1fb7 +4452 4451 1ea8 1fb8 +4451 447c 1fb7 1fb8 +4453 4452 1ea9 1fb9 +4452 447d 1fb8 1fb9 +4454 4453 1eaa 1fba +4453 447e 1fb9 1fba +4455 4454 1eab 1fbb +4454 447f 1fba 1fbb +4456 4455 1eac 1fbc +4455 4480 1fbb 1fbc +4457 4456 1ead 1fbd +4456 4481 1fbc 1fbd +4458 4457 1eae 1fbe +4457 4482 1fbd 1fbe +4459 4458 1eaf 1fbf +4458 4483 1fbe 1fbf +4459 4484 1fbf 1fc0 +445b 445a 1f96 20a6 +445a 4485 20a5 20a6 +445c 445b 1f97 20a7 +445b 4486 20a6 20a7 +445d 445c 1f98 20a8 +445c 4487 20a7 20a8 +445e 445d 1f99 20a9 +445d 4488 20a8 20a9 +445f 445e 1f9a 20aa +445e 4489 20a9 20aa +4460 445f 1f9b 20ab +445f 448a 20aa 20ab +4461 4460 1f9c 20ac +4460 448b 20ab 20ac +4462 4461 1f9d 20ad +4461 448c 20ac 20ad +4463 4462 1f9e 20ae +4462 448d 20ad 20ae +4464 4463 1f9f 20af +4463 448e 20ae 20af +4465 4464 1fa0 20b0 +4464 448f 20af 20b0 +4466 4465 1fa1 20b1 +4465 4490 20b0 20b1 +4467 4466 1fa2 20b2 +4466 4491 20b1 20b2 +4468 4467 1fa3 20b3 +4467 4492 20b2 20b3 +4469 4468 1fa4 20b4 +4468 4493 20b3 20b4 +446a 4469 1fa5 20b5 +4469 4494 20b4 20b5 +446b 446a 1fa6 20b6 +446a 4495 20b5 20b6 +446c 446b 1fa7 20b7 +446b 4496 20b6 20b7 +446d 446c 1fa8 20b8 +446c 4497 20b7 20b8 +446e 446d 1fa9 20b9 +446d 4498 20b8 20b9 +446f 446e 1faa 20ba +446e 4499 20b9 20ba +4470 446f 1fab 20bb +446f 449a 20ba 20bb +4471 4470 1fac 20bc +4470 449b 20bb 20bc +4472 4471 1fad 20bd +4471 449c 20bc 20bd +4473 4472 1fae 20be +4472 449d 20bd 20be +4474 4473 1faf 20bf +4473 449e 20be 20bf +4475 4474 1fb0 20c0 +4474 449f 20bf 20c0 +4476 4475 1fb1 20c1 +4475 44a0 20c0 20c1 +4477 4476 1fb2 20c2 +4476 44a1 20c1 20c2 +4478 4477 1fb3 20c3 +4477 44a2 20c2 20c3 +4479 4478 1fb4 20c4 +4478 44a3 20c3 20c4 +447a 4479 1fb5 20c5 +4479 44a4 20c4 20c5 +447b 447a 1fb6 20c6 +447a 44a5 20c5 20c6 +447c 447b 1fb7 20c7 +447b 44a6 20c6 20c7 +447d 447c 1fb8 20c8 +447c 44a7 20c7 20c8 +447e 447d 1fb9 20c9 +447d 44a8 20c8 20c9 +447f 447e 1fba 20ca +447e 44a9 20c9 20ca +4480 447f 1fbb 20cb +447f 44aa 20ca 20cb +4481 4480 1fbc 20cc +4480 44ab 20cb 20cc +4482 4481 1fbd 20cd +4481 44ac 20cc 20cd +4483 4482 1fbe 20ce +4482 44ad 20cd 20ce +4484 4483 1fbf 20cf +4483 44ae 20ce 20cf +4484 44af 20cf 20d0 +4486 4485 20a6 21b6 +4485 44b0 21b5 21b6 +4487 4486 20a7 21b7 +4486 44b1 21b6 21b7 +4488 4487 20a8 21b8 +4487 44b2 21b7 21b8 +4489 4488 20a9 21b9 +4488 44b3 21b8 21b9 +448a 4489 20aa 21ba +4489 44b4 21b9 21ba +448b 448a 20ab 21bb +448a 44b5 21ba 21bb +448c 448b 20ac 21bc +448b 44b6 21bb 21bc +448d 448c 20ad 21bd +448c 44b7 21bc 21bd +448e 448d 20ae 21be +448d 44b8 21bd 21be +448f 448e 20af 21bf +448e 44b9 21be 21bf +4490 448f 20b0 21c0 +448f 44ba 21bf 21c0 +4491 4490 20b1 21c1 +4490 44bb 21c0 21c1 +4492 4491 20b2 21c2 +4491 44bc 21c1 21c2 +4493 4492 20b3 21c3 +4492 44bd 21c2 21c3 +4494 4493 20b4 21c4 +4493 44be 21c3 21c4 +4495 4494 20b5 21c5 +4494 44bf 21c4 21c5 +4496 4495 20b6 21c6 +4495 44c0 21c5 21c6 +4497 4496 20b7 21c7 +4496 44c1 21c6 21c7 +4498 4497 20b8 21c8 +4497 44c2 21c7 21c8 +4499 4498 20b9 21c9 +4498 44c3 21c8 21c9 +449a 4499 20ba 21ca +4499 44c4 21c9 21ca +449b 449a 20bb 21cb +449a 44c5 21ca 21cb +449c 449b 20bc 21cc +449b 44c6 21cb 21cc +449d 449c 20bd 21cd +449c 44c7 21cc 21cd +449e 449d 20be 21ce +449d 44c8 21cd 21ce +449f 449e 20bf 21cf +449e 44c9 21ce 21cf +44a0 449f 20c0 21d0 +449f 44ca 21cf 21d0 +44a1 44a0 20c1 21d1 +44a0 44cb 21d0 21d1 +44a2 44a1 20c2 21d2 +44a1 44cc 21d1 21d2 +44a3 44a2 20c3 21d3 +44a2 44cd 21d2 21d3 +44a4 44a3 20c4 21d4 +44a3 44ce 21d3 21d4 +44a5 44a4 20c5 21d5 +44a4 44cf 21d4 21d5 +44a6 44a5 20c6 21d6 +44a5 44d0 21d5 21d6 +44a7 44a6 20c7 21d7 +44a6 44d1 21d6 21d7 +44a8 44a7 20c8 21d8 +44a7 44d2 21d7 21d8 +44a9 44a8 20c9 21d9 +44a8 44d3 21d8 21d9 +44aa 44a9 20ca 21da +44a9 44d4 21d9 21da +44ab 44aa 20cb 21db +44aa 44d5 21da 21db +44ac 44ab 20cc 21dc +44ab 44d6 21db 21dc +44ad 44ac 20cd 21dd +44ac 44d7 21dc 21dd +44ae 44ad 20ce 21de +44ad 44d8 21dd 21de +44af 44ae 20cf 21df +44ae 44d9 21de 21df +44af 44da 21df 21e0 +44b1 44b0 21b6 22c6 +44b0 44db 22c5 22c6 +44b2 44b1 21b7 22c7 +44b1 44dc 22c6 22c7 +44b3 44b2 21b8 22c8 +44b2 44dd 22c7 22c8 +44b4 44b3 21b9 22c9 +44b3 44de 22c8 22c9 +44b5 44b4 21ba 22ca +44b4 44df 22c9 22ca +44b6 44b5 21bb 22cb +44b5 44e0 22ca 22cb +44b7 44b6 21bc 22cc +44b6 44e1 22cb 22cc +44b8 44b7 21bd 22cd +44b7 44e2 22cc 22cd +44b9 44b8 21be 22ce +44b8 44e3 22cd 22ce +44ba 44b9 21bf 22cf +44b9 44e4 22ce 22cf +44bb 44ba 21c0 22d0 +44ba 44e5 22cf 22d0 +44bc 44bb 21c1 22d1 +44bb 44e6 22d0 22d1 +44bd 44bc 21c2 22d2 +44bc 44e7 22d1 22d2 +44be 44bd 21c3 22d3 +44bd 44e8 22d2 22d3 +44bf 44be 21c4 22d4 +44be 44e9 22d3 22d4 +44c0 44bf 21c5 22d5 +44bf 44ea 22d4 22d5 +44c1 44c0 21c6 22d6 +44c0 44eb 22d5 22d6 +44c2 44c1 21c7 22d7 +44c1 44ec 22d6 22d7 +44c3 44c2 21c8 22d8 +44c2 44ed 22d7 22d8 +44c4 44c3 21c9 22d9 +44c3 44ee 22d8 22d9 +44c5 44c4 21ca 22da +44c4 44ef 22d9 22da +44c6 44c5 21cb 22db +44c5 44f0 22da 22db +44c7 44c6 21cc 22dc +44c6 44f1 22db 22dc +44c8 44c7 21cd 22dd +44c7 44f2 22dc 22dd +44c9 44c8 21ce 22de +44c8 44f3 22dd 22de +44ca 44c9 21cf 22df +44c9 44f4 22de 22df +44cb 44ca 21d0 22e0 +44ca 44f5 22df 22e0 +44cc 44cb 21d1 22e1 +44cb 44f6 22e0 22e1 +44cd 44cc 21d2 22e2 +44cc 44f7 22e1 22e2 +44ce 44cd 21d3 22e3 +44cd 44f8 22e2 22e3 +44cf 44ce 21d4 22e4 +44ce 44f9 22e3 22e4 +44d0 44cf 21d5 22e5 +44cf 44fa 22e4 22e5 +44d1 44d0 21d6 22e6 +44d0 44fb 22e5 22e6 +44d2 44d1 21d7 22e7 +44d1 44fc 22e6 22e7 +44d3 44d2 21d8 22e8 +44d2 44fd 22e7 22e8 +44d4 44d3 21d9 22e9 +44d3 44fe 22e8 22e9 +44d5 44d4 21da 22ea +44d4 44ff 22e9 22ea +44d6 44d5 21db 22eb +44d5 4500 22ea 22eb +44d7 44d6 21dc 22ec +44d6 4501 22eb 22ec +44d8 44d7 21dd 22ed +44d7 4502 22ec 22ed +44d9 44d8 21de 22ee +44d8 4503 22ed 22ee +44da 44d9 21df 22ef +44d9 4504 22ee 22ef +44da 4505 22ef 22f0 +44dc 44db 22c6 23d6 +44db 4506 23d5 23d6 +44dd 44dc 22c7 23d7 +44dc 4507 23d6 23d7 +44de 44dd 22c8 23d8 +44dd 4508 23d7 23d8 +44df 44de 22c9 23d9 +44de 4509 23d8 23d9 +44e0 44df 22ca 23da +44df 450a 23d9 23da +44e1 44e0 22cb 23db +44e0 450b 23da 23db +44e2 44e1 22cc 23dc +44e1 450c 23db 23dc +44e3 44e2 22cd 23dd +44e2 450d 23dc 23dd +44e4 44e3 22ce 23de +44e3 450e 23dd 23de +44e5 44e4 22cf 23df +44e4 450f 23de 23df +44e6 44e5 22d0 23e0 +44e5 4510 23df 23e0 +44e7 44e6 22d1 23e1 +44e6 4511 23e0 23e1 +44e8 44e7 22d2 23e2 +44e7 4512 23e1 23e2 +44e9 44e8 22d3 23e3 +44e8 4513 23e2 23e3 +44ea 44e9 22d4 23e4 +44e9 4514 23e3 23e4 +44eb 44ea 22d5 23e5 +44ea 4515 23e4 23e5 +44ec 44eb 22d6 23e6 +44eb 4516 23e5 23e6 +44ed 44ec 22d7 23e7 +44ec 4517 23e6 23e7 +44ee 44ed 22d8 23e8 +44ed 4518 23e7 23e8 +44ef 44ee 22d9 23e9 +44ee 4519 23e8 23e9 +44f0 44ef 22da 23ea +44ef 451a 23e9 23ea +44f1 44f0 22db 23eb +44f0 451b 23ea 23eb +44f2 44f1 22dc 23ec +44f1 451c 23eb 23ec +44f3 44f2 22dd 23ed +44f2 451d 23ec 23ed +44f4 44f3 22de 23ee +44f3 451e 23ed 23ee +44f5 44f4 22df 23ef +44f4 451f 23ee 23ef +44f6 44f5 22e0 23f0 +44f5 4520 23ef 23f0 +44f7 44f6 22e1 23f1 +44f6 4521 23f0 23f1 +44f8 44f7 22e2 23f2 +44f7 4522 23f1 23f2 +44f9 44f8 22e3 23f3 +44f8 4523 23f2 23f3 +44fa 44f9 22e4 23f4 +44f9 4524 23f3 23f4 +44fb 44fa 22e5 23f5 +44fa 4525 23f4 23f5 +44fc 44fb 22e6 23f6 +44fb 4526 23f5 23f6 +44fd 44fc 22e7 23f7 +44fc 4527 23f6 23f7 +44fe 44fd 22e8 23f8 +44fd 4528 23f7 23f8 +44ff 44fe 22e9 23f9 +44fe 4529 23f8 23f9 +4500 44ff 22ea 23fa +44ff 452a 23f9 23fa +4501 4500 22eb 23fb +4500 452b 23fa 23fb +4502 4501 22ec 23fc +4501 452c 23fb 23fc +4503 4502 22ed 23fd +4502 452d 23fc 23fd +4504 4503 22ee 23fe +4503 452e 23fd 23fe +4505 4504 22ef 23ff +4504 452f 23fe 23ff +4505 4530 23ff 2400 +4507 4506 23d6 24e6 +4506 4531 24e5 24e6 +4508 4507 23d7 24e7 +4507 4532 24e6 24e7 +4509 4508 23d8 24e8 +4508 4533 24e7 24e8 +450a 4509 23d9 24e9 +4509 4534 24e8 24e9 +450b 450a 23da 24ea +450a 4535 24e9 24ea +450c 450b 23db 24eb +450b 4536 24ea 24eb +450d 450c 23dc 24ec +450c 4537 24eb 24ec +450e 450d 23dd 24ed +450d 4538 24ec 24ed +450f 450e 23de 24ee +450e 4539 24ed 24ee +4510 450f 23df 24ef +450f 453a 24ee 24ef +4511 4510 23e0 24f0 +4510 453b 24ef 24f0 +4512 4511 23e1 24f1 +4511 453c 24f0 24f1 +4513 4512 23e2 24f2 +4512 453d 24f1 24f2 +4514 4513 23e3 24f3 +4513 453e 24f2 24f3 +4515 4514 23e4 24f4 +4514 453f 24f3 24f4 +4516 4515 23e5 24f5 +4515 4540 24f4 24f5 +4517 4516 23e6 24f6 +4516 4541 24f5 24f6 +4518 4517 23e7 24f7 +4517 4542 24f6 24f7 +4519 4518 23e8 24f8 +4518 4543 24f7 24f8 +451a 4519 23e9 24f9 +4519 4544 24f8 24f9 +451b 451a 23ea 24fa +451a 4545 24f9 24fa +451c 451b 23eb 24fb +451b 4546 24fa 24fb +451d 451c 23ec 24fc +451c 4547 24fb 24fc +451e 451d 23ed 24fd +451d 4548 24fc 24fd +451f 451e 23ee 24fe +451e 4549 24fd 24fe +4520 451f 23ef 24ff +451f 454a 24fe 24ff +4521 4520 23f0 2500 +4520 454b 24ff 2500 +4522 4521 23f1 2501 +4521 454c 2500 2501 +4523 4522 23f2 2502 +4522 454d 2501 2502 +4524 4523 23f3 2503 +4523 454e 2502 2503 +4525 4524 23f4 2504 +4524 454f 2503 2504 +4526 4525 23f5 2505 +4525 4550 2504 2505 +4527 4526 23f6 2506 +4526 4551 2505 2506 +4528 4527 23f7 2507 +4527 4552 2506 2507 +4529 4528 23f8 2508 +4528 4553 2507 2508 +452a 4529 23f9 2509 +4529 4554 2508 2509 +452b 452a 23fa 250a +452a 4555 2509 250a +452c 452b 23fb 250b +452b 4556 250a 250b +452d 452c 23fc 250c +452c 4557 250b 250c +452e 452d 23fd 250d +452d 4558 250c 250d +452f 452e 23fe 250e +452e 4559 250d 250e +4530 452f 23ff 250f +452f 455a 250e 250f +4530 455b 250f 2510 +4532 4531 24e6 25f6 +4531 455c 25f5 25f6 +4533 4532 24e7 25f7 +4532 455d 25f6 25f7 +4534 4533 24e8 25f8 +4533 455e 25f7 25f8 +4535 4534 24e9 25f9 +4534 455f 25f8 25f9 +4536 4535 24ea 25fa +4535 4560 25f9 25fa +4537 4536 24eb 25fb +4536 4561 25fa 25fb +4538 4537 24ec 25fc +4537 4562 25fb 25fc +4539 4538 24ed 25fd +4538 4563 25fc 25fd +453a 4539 24ee 25fe +4539 4564 25fd 25fe +453b 453a 24ef 25ff +453a 4565 25fe 25ff +453c 453b 24f0 2600 +453b 4566 25ff 2600 +453d 453c 24f1 2601 +453c 4567 2600 2601 +453e 453d 24f2 2602 +453d 4568 2601 2602 +453f 453e 24f3 2603 +453e 4569 2602 2603 +4540 453f 24f4 2604 +453f 456a 2603 2604 +4541 4540 24f5 2605 +4540 456b 2604 2605 +4542 4541 24f6 2606 +4541 456c 2605 2606 +4543 4542 24f7 2607 +4542 456d 2606 2607 +4544 4543 24f8 2608 +4543 456e 2607 2608 +4545 4544 24f9 2609 +4544 456f 2608 2609 +4546 4545 24fa 260a +4545 4570 2609 260a +4547 4546 24fb 260b +4546 4571 260a 260b +4548 4547 24fc 260c +4547 4572 260b 260c +4549 4548 24fd 260d +4548 4573 260c 260d +454a 4549 24fe 260e +4549 4574 260d 260e +454b 454a 24ff 260f +454a 4575 260e 260f +454c 454b 2500 2610 +454b 4576 260f 2610 +454d 454c 2501 2611 +454c 4577 2610 2611 +454e 454d 2502 2612 +454d 4578 2611 2612 +454f 454e 2503 2613 +454e 4579 2612 2613 +4550 454f 2504 2614 +454f 457a 2613 2614 +4551 4550 2505 2615 +4550 457b 2614 2615 +4552 4551 2506 2616 +4551 457c 2615 2616 +4553 4552 2507 2617 +4552 457d 2616 2617 +4554 4553 2508 2618 +4553 457e 2617 2618 +4555 4554 2509 2619 +4554 457f 2618 2619 +4556 4555 250a 261a +4555 4580 2619 261a +4557 4556 250b 261b +4556 4581 261a 261b +4558 4557 250c 261c +4557 4582 261b 261c +4559 4558 250d 261d +4558 4583 261c 261d +455a 4559 250e 261e +4559 4584 261d 261e +455b 455a 250f 261f +455a 4585 261e 261f +455b 4586 261f 2620 +455d 455c 25f6 2706 +455c 4587 2705 2706 +455e 455d 25f7 2707 +455d 4588 2706 2707 +455f 455e 25f8 2708 +455e 4589 2707 2708 +4560 455f 25f9 2709 +455f 458a 2708 2709 +4561 4560 25fa 270a +4560 458b 2709 270a +4562 4561 25fb 270b +4561 458c 270a 270b +4563 4562 25fc 270c +4562 458d 270b 270c +4564 4563 25fd 270d +4563 458e 270c 270d +4565 4564 25fe 270e +4564 458f 270d 270e +4566 4565 25ff 270f +4565 4590 270e 270f +4567 4566 2600 2710 +4566 4591 270f 2710 +4568 4567 2601 2711 +4567 4592 2710 2711 +4569 4568 2602 2712 +4568 4593 2711 2712 +456a 4569 2603 2713 +4569 4594 2712 2713 +456b 456a 2604 2714 +456a 4595 2713 2714 +456c 456b 2605 2715 +456b 4596 2714 2715 +456d 456c 2606 2716 +456c 4597 2715 2716 +456e 456d 2607 2717 +456d 4598 2716 2717 +456f 456e 2608 2718 +456e 4599 2717 2718 +4570 456f 2609 2719 +456f 459a 2718 2719 +4571 4570 260a 271a +4570 459b 2719 271a +4572 4571 260b 271b +4571 459c 271a 271b +4573 4572 260c 271c +4572 459d 271b 271c +4574 4573 260d 271d +4573 459e 271c 271d +4575 4574 260e 271e +4574 459f 271d 271e +4576 4575 260f 271f +4575 45a0 271e 271f +4577 4576 2610 2720 +4576 45a1 271f 2720 +4578 4577 2611 2721 +4577 45a2 2720 2721 +4579 4578 2612 2722 +4578 45a3 2721 2722 +457a 4579 2613 2723 +4579 45a4 2722 2723 +457b 457a 2614 2724 +457a 45a5 2723 2724 +457c 457b 2615 2725 +457b 45a6 2724 2725 +457d 457c 2616 2726 +457c 45a7 2725 2726 +457e 457d 2617 2727 +457d 45a8 2726 2727 +457f 457e 2618 2728 +457e 45a9 2727 2728 +4580 457f 2619 2729 +457f 45aa 2728 2729 +4581 4580 261a 272a +4580 45ab 2729 272a +4582 4581 261b 272b +4581 45ac 272a 272b +4583 4582 261c 272c +4582 45ad 272b 272c +4584 4583 261d 272d +4583 45ae 272c 272d +4585 4584 261e 272e +4584 45af 272d 272e +4586 4585 261f 272f +4585 45b0 272e 272f +4586 45b1 272f 2730 +4588 4587 2706 2816 +4587 45b2 2815 2816 +4589 4588 2707 2817 +4588 45b3 2816 2817 +458a 4589 2708 2818 +4589 45b4 2817 2818 +458b 458a 2709 2819 +458a 45b5 2818 2819 +458c 458b 270a 281a +458b 45b6 2819 281a +458d 458c 270b 281b +458c 45b7 281a 281b +458e 458d 270c 281c +458d 45b8 281b 281c +458f 458e 270d 281d +458e 45b9 281c 281d +4590 458f 270e 281e +458f 45ba 281d 281e +4591 4590 270f 281f +4590 45bb 281e 281f +4592 4591 2710 2820 +4591 45bc 281f 2820 +4593 4592 2711 2821 +4592 45bd 2820 2821 +4594 4593 2712 2822 +4593 45be 2821 2822 +4595 4594 2713 2823 +4594 45bf 2822 2823 +4596 4595 2714 2824 +4595 45c0 2823 2824 +4597 4596 2715 2825 +4596 45c1 2824 2825 +4598 4597 2716 2826 +4597 45c2 2825 2826 +4599 4598 2717 2827 +4598 45c3 2826 2827 +459a 4599 2718 2828 +4599 45c4 2827 2828 +459b 459a 2719 2829 +459a 45c5 2828 2829 +459c 459b 271a 282a +459b 45c6 2829 282a +459d 459c 271b 282b +459c 45c7 282a 282b +459e 459d 271c 282c +459d 45c8 282b 282c +459f 459e 271d 282d +459e 45c9 282c 282d +45a0 459f 271e 282e +459f 45ca 282d 282e +45a1 45a0 271f 282f +45a0 45cb 282e 282f +45a2 45a1 2720 2830 +45a1 45cc 282f 2830 +45a3 45a2 2721 2831 +45a2 45cd 2830 2831 +45a4 45a3 2722 2832 +45a3 45ce 2831 2832 +45a5 45a4 2723 2833 +45a4 45cf 2832 2833 +45a6 45a5 2724 2834 +45a5 45d0 2833 2834 +45a7 45a6 2725 2835 +45a6 45d1 2834 2835 +45a8 45a7 2726 2836 +45a7 45d2 2835 2836 +45a9 45a8 2727 2837 +45a8 45d3 2836 2837 +45aa 45a9 2728 2838 +45a9 45d4 2837 2838 +45ab 45aa 2729 2839 +45aa 45d5 2838 2839 +45ac 45ab 272a 283a +45ab 45d6 2839 283a +45ad 45ac 272b 283b +45ac 45d7 283a 283b +45ae 45ad 272c 283c +45ad 45d8 283b 283c +45af 45ae 272d 283d +45ae 45d9 283c 283d +45b0 45af 272e 283e +45af 45da 283d 283e +45b1 45b0 272f 283f +45b0 45db 283e 283f +45b1 45dc 283f 2840 +45b3 45b2 2816 2926 +45b2 45dd 2925 2926 +45b4 45b3 2817 2927 +45b3 45de 2926 2927 +45b5 45b4 2818 2928 +45b4 45df 2927 2928 +45b6 45b5 2819 2929 +45b5 45e0 2928 2929 +45b7 45b6 281a 292a +45b6 45e1 2929 292a +45b8 45b7 281b 292b +45b7 45e2 292a 292b +45b9 45b8 281c 292c +45b8 45e3 292b 292c +45ba 45b9 281d 292d +45b9 45e4 292c 292d +45bb 45ba 281e 292e +45ba 45e5 292d 292e +45bc 45bb 281f 292f +45bb 45e6 292e 292f +45bd 45bc 2820 2930 +45bc 45e7 292f 2930 +45be 45bd 2821 2931 +45bd 45e8 2930 2931 +45bf 45be 2822 2932 +45be 45e9 2931 2932 +45c0 45bf 2823 2933 +45bf 45ea 2932 2933 +45c1 45c0 2824 2934 +45c0 45eb 2933 2934 +45c2 45c1 2825 2935 +45c1 45ec 2934 2935 +45c3 45c2 2826 2936 +45c2 45ed 2935 2936 +45c4 45c3 2827 2937 +45c3 45ee 2936 2937 +45c5 45c4 2828 2938 +45c4 45ef 2937 2938 +45c6 45c5 2829 2939 +45c5 45f0 2938 2939 +45c7 45c6 282a 293a +45c6 45f1 2939 293a +45c8 45c7 282b 293b +45c7 45f2 293a 293b +45c9 45c8 282c 293c +45c8 45f3 293b 293c +45ca 45c9 282d 293d +45c9 45f4 293c 293d +45cb 45ca 282e 293e +45ca 45f5 293d 293e +45cc 45cb 282f 293f +45cb 45f6 293e 293f +45cd 45cc 2830 2940 +45cc 45f7 293f 2940 +45ce 45cd 2831 2941 +45cd 45f8 2940 2941 +45cf 45ce 2832 2942 +45ce 45f9 2941 2942 +45d0 45cf 2833 2943 +45cf 45fa 2942 2943 +45d1 45d0 2834 2944 +45d0 45fb 2943 2944 +45d2 45d1 2835 2945 +45d1 45fc 2944 2945 +45d3 45d2 2836 2946 +45d2 45fd 2945 2946 +45d4 45d3 2837 2947 +45d3 45fe 2946 2947 +45d5 45d4 2838 2948 +45d4 45ff 2947 2948 +45d6 45d5 2839 2949 +45d5 4600 2948 2949 +45d7 45d6 283a 294a +45d6 4601 2949 294a +45d8 45d7 283b 294b +45d7 4602 294a 294b +45d9 45d8 283c 294c +45d8 4603 294b 294c +45da 45d9 283d 294d +45d9 4604 294c 294d +45db 45da 283e 294e +45da 4605 294d 294e +45dc 45db 283f 294f +45db 4606 294e 294f +45dc 4607 294f 2950 +45de 45dd 2926 2a36 +45dd 4608 2a35 2a36 +45df 45de 2927 2a37 +45de 4609 2a36 2a37 +45e0 45df 2928 2a38 +45df 460a 2a37 2a38 +45e1 45e0 2929 2a39 +45e0 460b 2a38 2a39 +45e2 45e1 292a 2a3a +45e1 460c 2a39 2a3a +45e3 45e2 292b 2a3b +45e2 460d 2a3a 2a3b +45e4 45e3 292c 2a3c +45e3 460e 2a3b 2a3c +45e5 45e4 292d 2a3d +45e4 460f 2a3c 2a3d +45e6 45e5 292e 2a3e +45e5 4610 2a3d 2a3e +45e7 45e6 292f 2a3f +45e6 4611 2a3e 2a3f +45e8 45e7 2930 2a40 +45e7 4612 2a3f 2a40 +45e9 45e8 2931 2a41 +45e8 4613 2a40 2a41 +45ea 45e9 2932 2a42 +45e9 4614 2a41 2a42 +45eb 45ea 2933 2a43 +45ea 4615 2a42 2a43 +45ec 45eb 2934 2a44 +45eb 4616 2a43 2a44 +45ed 45ec 2935 2a45 +45ec 4617 2a44 2a45 +45ee 45ed 2936 2a46 +45ed 4618 2a45 2a46 +45ef 45ee 2937 2a47 +45ee 4619 2a46 2a47 +45f0 45ef 2938 2a48 +45ef 461a 2a47 2a48 +45f1 45f0 2939 2a49 +45f0 461b 2a48 2a49 +45f2 45f1 293a 2a4a +45f1 461c 2a49 2a4a +45f3 45f2 293b 2a4b +45f2 461d 2a4a 2a4b +45f4 45f3 293c 2a4c +45f3 461e 2a4b 2a4c +45f5 45f4 293d 2a4d +45f4 461f 2a4c 2a4d +45f6 45f5 293e 2a4e +45f5 4620 2a4d 2a4e +45f7 45f6 293f 2a4f +45f6 4621 2a4e 2a4f +45f8 45f7 2940 2a50 +45f7 4622 2a4f 2a50 +45f9 45f8 2941 2a51 +45f8 4623 2a50 2a51 +45fa 45f9 2942 2a52 +45f9 4624 2a51 2a52 +45fb 45fa 2943 2a53 +45fa 4625 2a52 2a53 +45fc 45fb 2944 2a54 +45fb 4626 2a53 2a54 +45fd 45fc 2945 2a55 +45fc 4627 2a54 2a55 +45fe 45fd 2946 2a56 +45fd 4628 2a55 2a56 +45ff 45fe 2947 2a57 +45fe 4629 2a56 2a57 +4600 45ff 2948 2a58 +45ff 462a 2a57 2a58 +4601 4600 2949 2a59 +4600 462b 2a58 2a59 +4602 4601 294a 2a5a +4601 462c 2a59 2a5a +4603 4602 294b 2a5b +4602 462d 2a5a 2a5b +4604 4603 294c 2a5c +4603 462e 2a5b 2a5c +4605 4604 294d 2a5d +4604 462f 2a5c 2a5d +4606 4605 294e 2a5e +4605 4630 2a5d 2a5e +4607 4606 294f 2a5f +4606 4631 2a5e 2a5f +4607 4632 2a5f 2a60 +4609 4608 2a36 2b46 +4608 4633 2b45 2b46 +460a 4609 2a37 2b47 +4609 4634 2b46 2b47 +460b 460a 2a38 2b48 +460a 4635 2b47 2b48 +460c 460b 2a39 2b49 +460b 4636 2b48 2b49 +460d 460c 2a3a 2b4a +460c 4637 2b49 2b4a +460e 460d 2a3b 2b4b +460d 4638 2b4a 2b4b +460f 460e 2a3c 2b4c +460e 4639 2b4b 2b4c +4610 460f 2a3d 2b4d +460f 463a 2b4c 2b4d +4611 4610 2a3e 2b4e +4610 463b 2b4d 2b4e +4612 4611 2a3f 2b4f +4611 463c 2b4e 2b4f +4613 4612 2a40 2b50 +4612 463d 2b4f 2b50 +4614 4613 2a41 2b51 +4613 463e 2b50 2b51 +4615 4614 2a42 2b52 +4614 463f 2b51 2b52 +4616 4615 2a43 2b53 +4615 4640 2b52 2b53 +4617 4616 2a44 2b54 +4616 4641 2b53 2b54 +4618 4617 2a45 2b55 +4617 4642 2b54 2b55 +4619 4618 2a46 2b56 +4618 4643 2b55 2b56 +461a 4619 2a47 2b57 +4619 4644 2b56 2b57 +461b 461a 2a48 2b58 +461a 4645 2b57 2b58 +461c 461b 2a49 2b59 +461b 4646 2b58 2b59 +461d 461c 2a4a 2b5a +461c 4647 2b59 2b5a +461e 461d 2a4b 2b5b +461d 4648 2b5a 2b5b +461f 461e 2a4c 2b5c +461e 4649 2b5b 2b5c +4620 461f 2a4d 2b5d +461f 464a 2b5c 2b5d +4621 4620 2a4e 2b5e +4620 464b 2b5d 2b5e +4622 4621 2a4f 2b5f +4621 464c 2b5e 2b5f +4623 4622 2a50 2b60 +4622 464d 2b5f 2b60 +4624 4623 2a51 2b61 +4623 464e 2b60 2b61 +4625 4624 2a52 2b62 +4624 464f 2b61 2b62 +4626 4625 2a53 2b63 +4625 4650 2b62 2b63 +4627 4626 2a54 2b64 +4626 4651 2b63 2b64 +4628 4627 2a55 2b65 +4627 4652 2b64 2b65 +4629 4628 2a56 2b66 +4628 4653 2b65 2b66 +462a 4629 2a57 2b67 +4629 4654 2b66 2b67 +462b 462a 2a58 2b68 +462a 4655 2b67 2b68 +462c 462b 2a59 2b69 +462b 4656 2b68 2b69 +462d 462c 2a5a 2b6a +462c 4657 2b69 2b6a +462e 462d 2a5b 2b6b +462d 4658 2b6a 2b6b +462f 462e 2a5c 2b6c +462e 4659 2b6b 2b6c +4630 462f 2a5d 2b6d +462f 465a 2b6c 2b6d +4631 4630 2a5e 2b6e +4630 465b 2b6d 2b6e +4632 4631 2a5f 2b6f +4631 465c 2b6e 2b6f +4632 465d 2b6f 2b70 +4634 4633 2b46 2c56 +4633 465e 2c55 2c56 +4635 4634 2b47 2c57 +4634 465f 2c56 2c57 +4636 4635 2b48 2c58 +4635 4660 2c57 2c58 +4637 4636 2b49 2c59 +4636 4661 2c58 2c59 +4638 4637 2b4a 2c5a +4637 4662 2c59 2c5a +4639 4638 2b4b 2c5b +4638 4663 2c5a 2c5b +463a 4639 2b4c 2c5c +4639 4664 2c5b 2c5c +463b 463a 2b4d 2c5d +463a 4665 2c5c 2c5d +463c 463b 2b4e 2c5e +463b 4666 2c5d 2c5e +463d 463c 2b4f 2c5f +463c 4667 2c5e 2c5f +463e 463d 2b50 2c60 +463d 4668 2c5f 2c60 +463f 463e 2b51 2c61 +463e 4669 2c60 2c61 +4640 463f 2b52 2c62 +463f 466a 2c61 2c62 +4641 4640 2b53 2c63 +4640 466b 2c62 2c63 +4642 4641 2b54 2c64 +4641 466c 2c63 2c64 +4643 4642 2b55 2c65 +4642 466d 2c64 2c65 +4644 4643 2b56 2c66 +4643 466e 2c65 2c66 +4645 4644 2b57 2c67 +4644 466f 2c66 2c67 +4646 4645 2b58 2c68 +4645 4670 2c67 2c68 +4647 4646 2b59 2c69 +4646 4671 2c68 2c69 +4648 4647 2b5a 2c6a +4647 4672 2c69 2c6a +4649 4648 2b5b 2c6b +4648 4673 2c6a 2c6b +464a 4649 2b5c 2c6c +4649 4674 2c6b 2c6c +464b 464a 2b5d 2c6d +464a 4675 2c6c 2c6d +464c 464b 2b5e 2c6e +464b 4676 2c6d 2c6e +464d 464c 2b5f 2c6f +464c 4677 2c6e 2c6f +464e 464d 2b60 2c70 +464d 4678 2c6f 2c70 +464f 464e 2b61 2c71 +464e 4679 2c70 2c71 +4650 464f 2b62 2c72 +464f 467a 2c71 2c72 +4651 4650 2b63 2c73 +4650 467b 2c72 2c73 +4652 4651 2b64 2c74 +4651 467c 2c73 2c74 +4653 4652 2b65 2c75 +4652 467d 2c74 2c75 +4654 4653 2b66 2c76 +4653 467e 2c75 2c76 +4655 4654 2b67 2c77 +4654 467f 2c76 2c77 +4656 4655 2b68 2c78 +4655 4680 2c77 2c78 +4657 4656 2b69 2c79 +4656 4681 2c78 2c79 +4658 4657 2b6a 2c7a +4657 4682 2c79 2c7a +4659 4658 2b6b 2c7b +4658 4683 2c7a 2c7b +465a 4659 2b6c 2c7c +4659 4684 2c7b 2c7c +465b 465a 2b6d 2c7d +465a 4685 2c7c 2c7d +465c 465b 2b6e 2c7e +465b 4686 2c7d 2c7e +465d 465c 2b6f 2c7f +465c 4687 2c7e 2c7f +465d 4688 2c7f 2c80 +465f 465e 2c56 2d66 +465e 4689 2d65 2d66 +4660 465f 2c57 2d67 +465f 468a 2d66 2d67 +4661 4660 2c58 2d68 +4660 468b 2d67 2d68 +4662 4661 2c59 2d69 +4661 468c 2d68 2d69 +4663 4662 2c5a 2d6a +4662 468d 2d69 2d6a +4664 4663 2c5b 2d6b +4663 468e 2d6a 2d6b +4665 4664 2c5c 2d6c +4664 468f 2d6b 2d6c +4666 4665 2c5d 2d6d +4665 4690 2d6c 2d6d +4667 4666 2c5e 2d6e +4666 4691 2d6d 2d6e +4668 4667 2c5f 2d6f +4667 4692 2d6e 2d6f +4669 4668 2c60 2d70 +4668 4693 2d6f 2d70 +466a 4669 2c61 2d71 +4669 4694 2d70 2d71 +466b 466a 2c62 2d72 +466a 4695 2d71 2d72 +466c 466b 2c63 2d73 +466b 4696 2d72 2d73 +466d 466c 2c64 2d74 +466c 4697 2d73 2d74 +466e 466d 2c65 2d75 +466d 4698 2d74 2d75 +466f 466e 2c66 2d76 +466e 4699 2d75 2d76 +4670 466f 2c67 2d77 +466f 469a 2d76 2d77 +4671 4670 2c68 2d78 +4670 469b 2d77 2d78 +4672 4671 2c69 2d79 +4671 469c 2d78 2d79 +4673 4672 2c6a 2d7a +4672 469d 2d79 2d7a +4674 4673 2c6b 2d7b +4673 469e 2d7a 2d7b +4675 4674 2c6c 2d7c +4674 469f 2d7b 2d7c +4676 4675 2c6d 2d7d +4675 46a0 2d7c 2d7d +4677 4676 2c6e 2d7e +4676 46a1 2d7d 2d7e +4678 4677 2c6f 2d7f +4677 46a2 2d7e 2d7f +4679 4678 2c70 2d80 +4678 46a3 2d7f 2d80 +467a 4679 2c71 2d81 +4679 46a4 2d80 2d81 +467b 467a 2c72 2d82 +467a 46a5 2d81 2d82 +467c 467b 2c73 2d83 +467b 46a6 2d82 2d83 +467d 467c 2c74 2d84 +467c 46a7 2d83 2d84 +467e 467d 2c75 2d85 +467d 46a8 2d84 2d85 +467f 467e 2c76 2d86 +467e 46a9 2d85 2d86 +4680 467f 2c77 2d87 +467f 46aa 2d86 2d87 +4681 4680 2c78 2d88 +4680 46ab 2d87 2d88 +4682 4681 2c79 2d89 +4681 46ac 2d88 2d89 +4683 4682 2c7a 2d8a +4682 46ad 2d89 2d8a +4684 4683 2c7b 2d8b +4683 46ae 2d8a 2d8b +4685 4684 2c7c 2d8c +4684 46af 2d8b 2d8c +4686 4685 2c7d 2d8d +4685 46b0 2d8c 2d8d +4687 4686 2c7e 2d8e +4686 46b1 2d8d 2d8e +4688 4687 2c7f 2d8f +4687 46b2 2d8e 2d8f +4688 46b3 2d8f 2d90 +468a 4689 2d66 2e76 +4689 46b4 2e75 2e76 +468b 468a 2d67 2e77 +468a 46b5 2e76 2e77 +468c 468b 2d68 2e78 +468b 46b6 2e77 2e78 +468d 468c 2d69 2e79 +468c 46b7 2e78 2e79 +468e 468d 2d6a 2e7a +468d 46b8 2e79 2e7a +468f 468e 2d6b 2e7b +468e 46b9 2e7a 2e7b +4690 468f 2d6c 2e7c +468f 46ba 2e7b 2e7c +4691 4690 2d6d 2e7d +4690 46bb 2e7c 2e7d +4692 4691 2d6e 2e7e +4691 46bc 2e7d 2e7e +4693 4692 2d6f 2e7f +4692 46bd 2e7e 2e7f +4694 4693 2d70 2e80 +4693 46be 2e7f 2e80 +4695 4694 2d71 2e81 +4694 46bf 2e80 2e81 +4696 4695 2d72 2e82 +4695 46c0 2e81 2e82 +4697 4696 2d73 2e83 +4696 46c1 2e82 2e83 +4698 4697 2d74 2e84 +4697 46c2 2e83 2e84 +4699 4698 2d75 2e85 +4698 46c3 2e84 2e85 +469a 4699 2d76 2e86 +4699 46c4 2e85 2e86 +469b 469a 2d77 2e87 +469a 46c5 2e86 2e87 +469c 469b 2d78 2e88 +469b 46c6 2e87 2e88 +469d 469c 2d79 2e89 +469c 46c7 2e88 2e89 +469e 469d 2d7a 2e8a +469d 46c8 2e89 2e8a +469f 469e 2d7b 2e8b +469e 46c9 2e8a 2e8b +46a0 469f 2d7c 2e8c +469f 46ca 2e8b 2e8c +46a1 46a0 2d7d 2e8d +46a0 46cb 2e8c 2e8d +46a2 46a1 2d7e 2e8e +46a1 46cc 2e8d 2e8e +46a3 46a2 2d7f 2e8f +46a2 46cd 2e8e 2e8f +46a4 46a3 2d80 2e90 +46a3 46ce 2e8f 2e90 +46a5 46a4 2d81 2e91 +46a4 46cf 2e90 2e91 +46a6 46a5 2d82 2e92 +46a5 46d0 2e91 2e92 +46a7 46a6 2d83 2e93 +46a6 46d1 2e92 2e93 +46a8 46a7 2d84 2e94 +46a7 46d2 2e93 2e94 +46a9 46a8 2d85 2e95 +46a8 46d3 2e94 2e95 +46aa 46a9 2d86 2e96 +46a9 46d4 2e95 2e96 +46ab 46aa 2d87 2e97 +46aa 46d5 2e96 2e97 +46ac 46ab 2d88 2e98 +46ab 46d6 2e97 2e98 +46ad 46ac 2d89 2e99 +46ac 46d7 2e98 2e99 +46ae 46ad 2d8a 2e9a +46ad 46d8 2e99 2e9a +46af 46ae 2d8b 2e9b +46ae 46d9 2e9a 2e9b +46b0 46af 2d8c 2e9c +46af 46da 2e9b 2e9c +46b1 46b0 2d8d 2e9d +46b0 46db 2e9c 2e9d +46b2 46b1 2d8e 2e9e +46b1 46dc 2e9d 2e9e +46b3 46b2 2d8f 2e9f +46b2 46dd 2e9e 2e9f +46b3 46de 2e9f 2ea0 +46b5 46b4 2e76 2f86 +46b4 46df 2f85 2f86 +46b6 46b5 2e77 2f87 +46b5 46e0 2f86 2f87 +46b7 46b6 2e78 2f88 +46b6 46e1 2f87 2f88 +46b8 46b7 2e79 2f89 +46b7 46e2 2f88 2f89 +46b9 46b8 2e7a 2f8a +46b8 46e3 2f89 2f8a +46ba 46b9 2e7b 2f8b +46b9 46e4 2f8a 2f8b +46bb 46ba 2e7c 2f8c +46ba 46e5 2f8b 2f8c +46bc 46bb 2e7d 2f8d +46bb 46e6 2f8c 2f8d +46bd 46bc 2e7e 2f8e +46bc 46e7 2f8d 2f8e +46be 46bd 2e7f 2f8f +46bd 46e8 2f8e 2f8f +46bf 46be 2e80 2f90 +46be 46e9 2f8f 2f90 +46c0 46bf 2e81 2f91 +46bf 46ea 2f90 2f91 +46c1 46c0 2e82 2f92 +46c0 46eb 2f91 2f92 +46c2 46c1 2e83 2f93 +46c1 46ec 2f92 2f93 +46c3 46c2 2e84 2f94 +46c2 46ed 2f93 2f94 +46c4 46c3 2e85 2f95 +46c3 46ee 2f94 2f95 +46c5 46c4 2e86 2f96 +46c4 46ef 2f95 2f96 +46c6 46c5 2e87 2f97 +46c5 46f0 2f96 2f97 +46c7 46c6 2e88 2f98 +46c6 46f1 2f97 2f98 +46c8 46c7 2e89 2f99 +46c7 46f2 2f98 2f99 +46c9 46c8 2e8a 2f9a +46c8 46f3 2f99 2f9a +46ca 46c9 2e8b 2f9b +46c9 46f4 2f9a 2f9b +46cb 46ca 2e8c 2f9c +46ca 46f5 2f9b 2f9c +46cc 46cb 2e8d 2f9d +46cb 46f6 2f9c 2f9d +46cd 46cc 2e8e 2f9e +46cc 46f7 2f9d 2f9e +46ce 46cd 2e8f 2f9f +46cd 46f8 2f9e 2f9f +46cf 46ce 2e90 2fa0 +46ce 46f9 2f9f 2fa0 +46d0 46cf 2e91 2fa1 +46cf 46fa 2fa0 2fa1 +46d1 46d0 2e92 2fa2 +46d0 46fb 2fa1 2fa2 +46d2 46d1 2e93 2fa3 +46d1 46fc 2fa2 2fa3 +46d3 46d2 2e94 2fa4 +46d2 46fd 2fa3 2fa4 +46d4 46d3 2e95 2fa5 +46d3 46fe 2fa4 2fa5 +46d5 46d4 2e96 2fa6 +46d4 46ff 2fa5 2fa6 +46d6 46d5 2e97 2fa7 +46d5 4700 2fa6 2fa7 +46d7 46d6 2e98 2fa8 +46d6 4701 2fa7 2fa8 +46d8 46d7 2e99 2fa9 +46d7 4702 2fa8 2fa9 +46d9 46d8 2e9a 2faa +46d8 4703 2fa9 2faa +46da 46d9 2e9b 2fab +46d9 4704 2faa 2fab +46db 46da 2e9c 2fac +46da 4705 2fab 2fac +46dc 46db 2e9d 2fad +46db 4706 2fac 2fad +46dd 46dc 2e9e 2fae +46dc 4707 2fad 2fae +46de 46dd 2e9f 2faf +46dd 4708 2fae 2faf +46de 4709 2faf 2fb0 +46e0 46df 2f86 3096 +46df 470a 3095 3096 +46e1 46e0 2f87 3097 +46e0 470b 3096 3097 +46e2 46e1 2f88 3098 +46e1 470c 3097 3098 +46e3 46e2 2f89 3099 +46e2 470d 3098 3099 +46e4 46e3 2f8a 309a +46e3 470e 3099 309a +46e5 46e4 2f8b 309b +46e4 470f 309a 309b +46e6 46e5 2f8c 309c +46e5 4710 309b 309c +46e7 46e6 2f8d 309d +46e6 4711 309c 309d +46e8 46e7 2f8e 309e +46e7 4712 309d 309e +46e9 46e8 2f8f 309f +46e8 4713 309e 309f +46ea 46e9 2f90 30a0 +46e9 4714 309f 30a0 +46eb 46ea 2f91 30a1 +46ea 4715 30a0 30a1 +46ec 46eb 2f92 30a2 +46eb 4716 30a1 30a2 +46ed 46ec 2f93 30a3 +46ec 4717 30a2 30a3 +46ee 46ed 2f94 30a4 +46ed 4718 30a3 30a4 +46ef 46ee 2f95 30a5 +46ee 4719 30a4 30a5 +46f0 46ef 2f96 30a6 +46ef 471a 30a5 30a6 +46f1 46f0 2f97 30a7 +46f0 471b 30a6 30a7 +46f2 46f1 2f98 30a8 +46f1 471c 30a7 30a8 +46f3 46f2 2f99 30a9 +46f2 471d 30a8 30a9 +46f4 46f3 2f9a 30aa +46f3 471e 30a9 30aa +46f5 46f4 2f9b 30ab +46f4 471f 30aa 30ab +46f6 46f5 2f9c 30ac +46f5 4720 30ab 30ac +46f7 46f6 2f9d 30ad +46f6 4721 30ac 30ad +46f8 46f7 2f9e 30ae +46f7 4722 30ad 30ae +46f9 46f8 2f9f 30af +46f8 4723 30ae 30af +46fa 46f9 2fa0 30b0 +46f9 4724 30af 30b0 +46fb 46fa 2fa1 30b1 +46fa 4725 30b0 30b1 +46fc 46fb 2fa2 30b2 +46fb 4726 30b1 30b2 +46fd 46fc 2fa3 30b3 +46fc 4727 30b2 30b3 +46fe 46fd 2fa4 30b4 +46fd 4728 30b3 30b4 +46ff 46fe 2fa5 30b5 +46fe 4729 30b4 30b5 +4700 46ff 2fa6 30b6 +46ff 472a 30b5 30b6 +4701 4700 2fa7 30b7 +4700 472b 30b6 30b7 +4702 4701 2fa8 30b8 +4701 472c 30b7 30b8 +4703 4702 2fa9 30b9 +4702 472d 30b8 30b9 +4704 4703 2faa 30ba +4703 472e 30b9 30ba +4705 4704 2fab 30bb +4704 472f 30ba 30bb +4706 4705 2fac 30bc +4705 4730 30bb 30bc +4707 4706 2fad 30bd +4706 4731 30bc 30bd +4708 4707 2fae 30be +4707 4732 30bd 30be +4709 4708 2faf 30bf +4708 4733 30be 30bf +4709 4734 30bf 30c0 +470b 470a 3096 31a6 +470a 4735 31a5 31a6 +470c 470b 3097 31a7 +470b 4736 31a6 31a7 +470d 470c 3098 31a8 +470c 4737 31a7 31a8 +470e 470d 3099 31a9 +470d 4738 31a8 31a9 +470f 470e 309a 31aa +470e 4739 31a9 31aa +4710 470f 309b 31ab +470f 473a 31aa 31ab +4711 4710 309c 31ac +4710 473b 31ab 31ac +4712 4711 309d 31ad +4711 473c 31ac 31ad +4713 4712 309e 31ae +4712 473d 31ad 31ae +4714 4713 309f 31af +4713 473e 31ae 31af +4715 4714 30a0 31b0 +4714 473f 31af 31b0 +4716 4715 30a1 31b1 +4715 4740 31b0 31b1 +4717 4716 30a2 31b2 +4716 4741 31b1 31b2 +4718 4717 30a3 31b3 +4717 4742 31b2 31b3 +4719 4718 30a4 31b4 +4718 4743 31b3 31b4 +471a 4719 30a5 31b5 +4719 4744 31b4 31b5 +471b 471a 30a6 31b6 +471a 4745 31b5 31b6 +471c 471b 30a7 31b7 +471b 4746 31b6 31b7 +471d 471c 30a8 31b8 +471c 4747 31b7 31b8 +471e 471d 30a9 31b9 +471d 4748 31b8 31b9 +471f 471e 30aa 31ba +471e 4749 31b9 31ba +4720 471f 30ab 31bb +471f 474a 31ba 31bb +4721 4720 30ac 31bc +4720 474b 31bb 31bc +4722 4721 30ad 31bd +4721 474c 31bc 31bd +4723 4722 30ae 31be +4722 474d 31bd 31be +4724 4723 30af 31bf +4723 474e 31be 31bf +4725 4724 30b0 31c0 +4724 474f 31bf 31c0 +4726 4725 30b1 31c1 +4725 4750 31c0 31c1 +4727 4726 30b2 31c2 +4726 4751 31c1 31c2 +4728 4727 30b3 31c3 +4727 4752 31c2 31c3 +4729 4728 30b4 31c4 +4728 4753 31c3 31c4 +472a 4729 30b5 31c5 +4729 4754 31c4 31c5 +472b 472a 30b6 31c6 +472a 4755 31c5 31c6 +472c 472b 30b7 31c7 +472b 4756 31c6 31c7 +472d 472c 30b8 31c8 +472c 4757 31c7 31c8 +472e 472d 30b9 31c9 +472d 4758 31c8 31c9 +472f 472e 30ba 31ca +472e 4759 31c9 31ca +4730 472f 30bb 31cb +472f 475a 31ca 31cb +4731 4730 30bc 31cc +4730 475b 31cb 31cc +4732 4731 30bd 31cd +4731 475c 31cc 31cd +4733 4732 30be 31ce +4732 475d 31cd 31ce +4734 4733 30bf 31cf +4733 475e 31ce 31cf +4734 475f 31cf 31d0 +4736 4735 31a6 32b6 +4735 4760 32b5 32b6 +4737 4736 31a7 32b7 +4736 4761 32b6 32b7 +4738 4737 31a8 32b8 +4737 4762 32b7 32b8 +4739 4738 31a9 32b9 +4738 4763 32b8 32b9 +473a 4739 31aa 32ba +4739 4764 32b9 32ba +473b 473a 31ab 32bb +473a 4765 32ba 32bb +473c 473b 31ac 32bc +473b 4766 32bb 32bc +473d 473c 31ad 32bd +473c 4767 32bc 32bd +473e 473d 31ae 32be +473d 4768 32bd 32be +473f 473e 31af 32bf +473e 4769 32be 32bf +4740 473f 31b0 32c0 +473f 476a 32bf 32c0 +4741 4740 31b1 32c1 +4740 476b 32c0 32c1 +4742 4741 31b2 32c2 +4741 476c 32c1 32c2 +4743 4742 31b3 32c3 +4742 476d 32c2 32c3 +4744 4743 31b4 32c4 +4743 476e 32c3 32c4 +4745 4744 31b5 32c5 +4744 476f 32c4 32c5 +4746 4745 31b6 32c6 +4745 4770 32c5 32c6 +4747 4746 31b7 32c7 +4746 4771 32c6 32c7 +4748 4747 31b8 32c8 +4747 4772 32c7 32c8 +4749 4748 31b9 32c9 +4748 4773 32c8 32c9 +474a 4749 31ba 32ca +4749 4774 32c9 32ca +474b 474a 31bb 32cb +474a 4775 32ca 32cb +474c 474b 31bc 32cc +474b 4776 32cb 32cc +474d 474c 31bd 32cd +474c 4777 32cc 32cd +474e 474d 31be 32ce +474d 4778 32cd 32ce +474f 474e 31bf 32cf +474e 4779 32ce 32cf +4750 474f 31c0 32d0 +474f 477a 32cf 32d0 +4751 4750 31c1 32d1 +4750 477b 32d0 32d1 +4752 4751 31c2 32d2 +4751 477c 32d1 32d2 +4753 4752 31c3 32d3 +4752 477d 32d2 32d3 +4754 4753 31c4 32d4 +4753 477e 32d3 32d4 +4755 4754 31c5 32d5 +4754 477f 32d4 32d5 +4756 4755 31c6 32d6 +4755 4780 32d5 32d6 +4757 4756 31c7 32d7 +4756 4781 32d6 32d7 +4758 4757 31c8 32d8 +4757 4782 32d7 32d8 +4759 4758 31c9 32d9 +4758 4783 32d8 32d9 +475a 4759 31ca 32da +4759 4784 32d9 32da +475b 475a 31cb 32db +475a 4785 32da 32db +475c 475b 31cc 32dc +475b 4786 32db 32dc +475d 475c 31cd 32dd +475c 4787 32dc 32dd +475e 475d 31ce 32de +475d 4788 32dd 32de +475f 475e 31cf 32df +475e 4789 32de 32df +475f 478a 32df 32e0 +4761 4760 32b6 33c6 +4760 478b 33c5 33c6 +4762 4761 32b7 33c7 +4761 478c 33c6 33c7 +4763 4762 32b8 33c8 +4762 478d 33c7 33c8 +4764 4763 32b9 33c9 +4763 478e 33c8 33c9 +4765 4764 32ba 33ca +4764 478f 33c9 33ca +4766 4765 32bb 33cb +4765 4790 33ca 33cb +4767 4766 32bc 33cc +4766 4791 33cb 33cc +4768 4767 32bd 33cd +4767 4792 33cc 33cd +4769 4768 32be 33ce +4768 4793 33cd 33ce +476a 4769 32bf 33cf +4769 4794 33ce 33cf +476b 476a 32c0 33d0 +476a 4795 33cf 33d0 +476c 476b 32c1 33d1 +476b 4796 33d0 33d1 +476d 476c 32c2 33d2 +476c 4797 33d1 33d2 +476e 476d 32c3 33d3 +476d 4798 33d2 33d3 +476f 476e 32c4 33d4 +476e 4799 33d3 33d4 +4770 476f 32c5 33d5 +476f 479a 33d4 33d5 +4771 4770 32c6 33d6 +4770 479b 33d5 33d6 +4772 4771 32c7 33d7 +4771 479c 33d6 33d7 +4773 4772 32c8 33d8 +4772 479d 33d7 33d8 +4774 4773 32c9 33d9 +4773 479e 33d8 33d9 +4775 4774 32ca 33da +4774 479f 33d9 33da +4776 4775 32cb 33db +4775 47a0 33da 33db +4777 4776 32cc 33dc +4776 47a1 33db 33dc +4778 4777 32cd 33dd +4777 47a2 33dc 33dd +4779 4778 32ce 33de +4778 47a3 33dd 33de +477a 4779 32cf 33df +4779 47a4 33de 33df +477b 477a 32d0 33e0 +477a 47a5 33df 33e0 +477c 477b 32d1 33e1 +477b 47a6 33e0 33e1 +477d 477c 32d2 33e2 +477c 47a7 33e1 33e2 +477e 477d 32d3 33e3 +477d 47a8 33e2 33e3 +477f 477e 32d4 33e4 +477e 47a9 33e3 33e4 +4780 477f 32d5 33e5 +477f 47aa 33e4 33e5 +4781 4780 32d6 33e6 +4780 47ab 33e5 33e6 +4782 4781 32d7 33e7 +4781 47ac 33e6 33e7 +4783 4782 32d8 33e8 +4782 47ad 33e7 33e8 +4784 4783 32d9 33e9 +4783 47ae 33e8 33e9 +4785 4784 32da 33ea +4784 47af 33e9 33ea +4786 4785 32db 33eb +4785 47b0 33ea 33eb +4787 4786 32dc 33ec +4786 47b1 33eb 33ec +4788 4787 32dd 33ed +4787 47b2 33ec 33ed +4789 4788 32de 33ee +4788 47b3 33ed 33ee +478a 4789 32df 33ef +4789 47b4 33ee 33ef +478a 47b5 33ef 33f0 +478c 478b 33c6 34d6 +478b 47b6 34d5 34d6 +478d 478c 33c7 34d7 +478c 47b7 34d6 34d7 +478e 478d 33c8 34d8 +478d 47b8 34d7 34d8 +478f 478e 33c9 34d9 +478e 47b9 34d8 34d9 +4790 478f 33ca 34da +478f 47ba 34d9 34da +4791 4790 33cb 34db +4790 47bb 34da 34db +4792 4791 33cc 34dc +4791 47bc 34db 34dc +4793 4792 33cd 34dd +4792 47bd 34dc 34dd +4794 4793 33ce 34de +4793 47be 34dd 34de +4795 4794 33cf 34df +4794 47bf 34de 34df +4796 4795 33d0 34e0 +4795 47c0 34df 34e0 +4797 4796 33d1 34e1 +4796 47c1 34e0 34e1 +4798 4797 33d2 34e2 +4797 47c2 34e1 34e2 +4799 4798 33d3 34e3 +4798 47c3 34e2 34e3 +479a 4799 33d4 34e4 +4799 47c4 34e3 34e4 +479b 479a 33d5 34e5 +479a 47c5 34e4 34e5 +479c 479b 33d6 34e6 +479b 47c6 34e5 34e6 +479d 479c 33d7 34e7 +479c 47c7 34e6 34e7 +479e 479d 33d8 34e8 +479d 47c8 34e7 34e8 +479f 479e 33d9 34e9 +479e 47c9 34e8 34e9 +47a0 479f 33da 34ea +479f 47ca 34e9 34ea +47a1 47a0 33db 34eb +47a0 47cb 34ea 34eb +47a2 47a1 33dc 34ec +47a1 47cc 34eb 34ec +47a3 47a2 33dd 34ed +47a2 47cd 34ec 34ed +47a4 47a3 33de 34ee +47a3 47ce 34ed 34ee +47a5 47a4 33df 34ef +47a4 47cf 34ee 34ef +47a6 47a5 33e0 34f0 +47a5 47d0 34ef 34f0 +47a7 47a6 33e1 34f1 +47a6 47d1 34f0 34f1 +47a8 47a7 33e2 34f2 +47a7 47d2 34f1 34f2 +47a9 47a8 33e3 34f3 +47a8 47d3 34f2 34f3 +47aa 47a9 33e4 34f4 +47a9 47d4 34f3 34f4 +47ab 47aa 33e5 34f5 +47aa 47d5 34f4 34f5 +47ac 47ab 33e6 34f6 +47ab 47d6 34f5 34f6 +47ad 47ac 33e7 34f7 +47ac 47d7 34f6 34f7 +47ae 47ad 33e8 34f8 +47ad 47d8 34f7 34f8 +47af 47ae 33e9 34f9 +47ae 47d9 34f8 34f9 +47b0 47af 33ea 34fa +47af 47da 34f9 34fa +47b1 47b0 33eb 34fb +47b0 47db 34fa 34fb +47b2 47b1 33ec 34fc +47b1 47dc 34fb 34fc +47b3 47b2 33ed 34fd +47b2 47dd 34fc 34fd +47b4 47b3 33ee 34fe +47b3 47de 34fd 34fe +47b5 47b4 33ef 34ff +47b4 47df 34fe 34ff +47b5 47e0 34ff 3500 +47b7 47b6 34d6 35e6 +47b8 47b7 34d7 35e7 +47b9 47b8 34d8 35e8 +47ba 47b9 34d9 35e9 +47bb 47ba 34da 35ea +47bc 47bb 34db 35eb +47bd 47bc 34dc 35ec +47be 47bd 34dd 35ed +47bf 47be 34de 35ee +47c0 47bf 34df 35ef +47c1 47c0 34e0 35f0 +47c2 47c1 34e1 35f1 +47c3 47c2 34e2 35f2 +47c4 47c3 34e3 35f3 +47c5 47c4 34e4 35f4 +47c6 47c5 34e5 35f5 +47c7 47c6 34e6 35f6 +47c8 47c7 34e7 35f7 +47c9 47c8 34e8 35f8 +47ca 47c9 34e9 35f9 +47cb 47ca 34ea 35fa +47cc 47cb 34eb 35fb +47cd 47cc 34ec 35fc +47ce 47cd 34ed 35fd +47cf 47ce 34ee 35fe +47d0 47cf 34ef 35ff +47d1 47d0 34f0 3600 +47d2 47d1 34f1 3601 +47d3 47d2 34f2 3602 +47d4 47d3 34f3 3603 +47d5 47d4 34f4 3604 +47d6 47d5 34f5 3605 +47d7 47d6 34f6 3606 +47d8 47d7 34f7 3607 +47d9 47d8 34f8 3608 +47da 47d9 34f9 3609 +47db 47da 34fa 360a +47dc 47db 34fb 360b +47dd 47dc 34fc 360c +47de 47dd 34fd 360d +47df 47de 34fe 360e +47e0 47df 34ff 360f +47e2 47e1 116a 127a +47e1 480c 1279 127a +47e3 47e2 116b 127b +47e2 480d 127a 127b +47e4 47e3 116c 127c +47e3 480e 127b 127c +47e5 47e4 116d 127d +47e4 480f 127c 127d +47e6 47e5 116e 127e +47e5 4810 127d 127e +47e7 47e6 116f 127f +47e6 4811 127e 127f +47e8 47e7 1170 1280 +47e7 4812 127f 1280 +47e9 47e8 1171 1281 +47e8 4813 1280 1281 +47ea 47e9 1172 1282 +47e9 4814 1281 1282 +47eb 47ea 1173 1283 +47ea 4815 1282 1283 +47ec 47eb 1174 1284 +47eb 4816 1283 1284 +47ed 47ec 1175 1285 +47ec 4817 1284 1285 +47ee 47ed 1176 1286 +47ed 4818 1285 1286 +47ef 47ee 1177 1287 +47ee 4819 1286 1287 +47f0 47ef 1178 1288 +47ef 481a 1287 1288 +47f1 47f0 1179 1289 +47f0 481b 1288 1289 +47f2 47f1 117a 128a +47f1 481c 1289 128a +47f3 47f2 117b 128b +47f2 481d 128a 128b +47f4 47f3 117c 128c +47f3 481e 128b 128c +47f5 47f4 117d 128d +47f4 481f 128c 128d +47f6 47f5 117e 128e +47f5 4820 128d 128e +47f7 47f6 117f 128f +47f6 4821 128e 128f +47f8 47f7 1180 1290 +47f7 4822 128f 1290 +47f9 47f8 1181 1291 +47f8 4823 1290 1291 +47fa 47f9 1182 1292 +47f9 4824 1291 1292 +47fb 47fa 1183 1293 +47fa 4825 1292 1293 +47fc 47fb 1184 1294 +47fb 4826 1293 1294 +47fd 47fc 1185 1295 +47fc 4827 1294 1295 +47fe 47fd 1186 1296 +47fd 4828 1295 1296 +47ff 47fe 1187 1297 +47fe 4829 1296 1297 +4800 47ff 1188 1298 +47ff 482a 1297 1298 +4801 4800 1189 1299 +4800 482b 1298 1299 +4802 4801 118a 129a +4801 482c 1299 129a +4803 4802 118b 129b +4802 482d 129a 129b +4804 4803 118c 129c +4803 482e 129b 129c +4805 4804 118d 129d +4804 482f 129c 129d +4806 4805 118e 129e +4805 4830 129d 129e +4807 4806 118f 129f +4806 4831 129e 129f +4808 4807 1190 12a0 +4807 4832 129f 12a0 +4809 4808 1191 12a1 +4808 4833 12a0 12a1 +480a 4809 1192 12a2 +4809 4834 12a1 12a2 +480b 480a 1193 12a3 +480a 4835 12a2 12a3 +480b 4836 12a3 12a4 +480d 480c 127a 138a +480c 4837 1389 138a +480e 480d 127b 138b +480d 4838 138a 138b +480f 480e 127c 138c +480e 4839 138b 138c +4810 480f 127d 138d +480f 483a 138c 138d +4811 4810 127e 138e +4810 483b 138d 138e +4812 4811 127f 138f +4811 483c 138e 138f +4813 4812 1280 1390 +4812 483d 138f 1390 +4814 4813 1281 1391 +4813 483e 1390 1391 +4815 4814 1282 1392 +4814 483f 1391 1392 +4816 4815 1283 1393 +4815 4840 1392 1393 +4817 4816 1284 1394 +4816 4841 1393 1394 +4818 4817 1285 1395 +4817 4842 1394 1395 +4819 4818 1286 1396 +4818 4843 1395 1396 +481a 4819 1287 1397 +4819 4844 1396 1397 +481b 481a 1288 1398 +481a 4845 1397 1398 +481c 481b 1289 1399 +481b 4846 1398 1399 +481d 481c 128a 139a +481c 4847 1399 139a +481e 481d 128b 139b +481d 4848 139a 139b +481f 481e 128c 139c +481e 4849 139b 139c +4820 481f 128d 139d +481f 484a 139c 139d +4821 4820 128e 139e +4820 484b 139d 139e +4822 4821 128f 139f +4821 484c 139e 139f +4823 4822 1290 13a0 +4822 484d 139f 13a0 +4824 4823 1291 13a1 +4823 484e 13a0 13a1 +4825 4824 1292 13a2 +4824 484f 13a1 13a2 +4826 4825 1293 13a3 +4825 4850 13a2 13a3 +4827 4826 1294 13a4 +4826 4851 13a3 13a4 +4828 4827 1295 13a5 +4827 4852 13a4 13a5 +4829 4828 1296 13a6 +4828 4853 13a5 13a6 +482a 4829 1297 13a7 +4829 4854 13a6 13a7 +482b 482a 1298 13a8 +482a 4855 13a7 13a8 +482c 482b 1299 13a9 +482b 4856 13a8 13a9 +482d 482c 129a 13aa +482c 4857 13a9 13aa +482e 482d 129b 13ab +482d 4858 13aa 13ab +482f 482e 129c 13ac +482e 4859 13ab 13ac +4830 482f 129d 13ad +482f 485a 13ac 13ad +4831 4830 129e 13ae +4830 485b 13ad 13ae +4832 4831 129f 13af +4831 485c 13ae 13af +4833 4832 12a0 13b0 +4832 485d 13af 13b0 +4834 4833 12a1 13b1 +4833 485e 13b0 13b1 +4835 4834 12a2 13b2 +4834 485f 13b1 13b2 +4836 4835 12a3 13b3 +4835 4860 13b2 13b3 +4836 4861 13b3 13b4 +4838 4837 138a 149a +4837 4862 1499 149a +4839 4838 138b 149b +4838 4863 149a 149b +483a 4839 138c 149c +4839 4864 149b 149c +483b 483a 138d 149d +483a 4865 149c 149d +483c 483b 138e 149e +483b 4866 149d 149e +483d 483c 138f 149f +483c 4867 149e 149f +483e 483d 1390 14a0 +483d 4868 149f 14a0 +483f 483e 1391 14a1 +483e 4869 14a0 14a1 +4840 483f 1392 14a2 +483f 486a 14a1 14a2 +4841 4840 1393 14a3 +4840 486b 14a2 14a3 +4842 4841 1394 14a4 +4841 486c 14a3 14a4 +4843 4842 1395 14a5 +4842 486d 14a4 14a5 +4844 4843 1396 14a6 +4843 486e 14a5 14a6 +4845 4844 1397 14a7 +4844 486f 14a6 14a7 +4846 4845 1398 14a8 +4845 4870 14a7 14a8 +4847 4846 1399 14a9 +4846 4871 14a8 14a9 +4848 4847 139a 14aa +4847 4872 14a9 14aa +4849 4848 139b 14ab +4848 4873 14aa 14ab +484a 4849 139c 14ac +4849 4874 14ab 14ac +484b 484a 139d 14ad +484a 4875 14ac 14ad +484c 484b 139e 14ae +484b 4876 14ad 14ae +484d 484c 139f 14af +484c 4877 14ae 14af +484e 484d 13a0 14b0 +484d 4878 14af 14b0 +484f 484e 13a1 14b1 +484e 4879 14b0 14b1 +4850 484f 13a2 14b2 +484f 487a 14b1 14b2 +4851 4850 13a3 14b3 +4850 487b 14b2 14b3 +4852 4851 13a4 14b4 +4851 487c 14b3 14b4 +4853 4852 13a5 14b5 +4852 487d 14b4 14b5 +4854 4853 13a6 14b6 +4853 487e 14b5 14b6 +4855 4854 13a7 14b7 +4854 487f 14b6 14b7 +4856 4855 13a8 14b8 +4855 4880 14b7 14b8 +4857 4856 13a9 14b9 +4856 4881 14b8 14b9 +4858 4857 13aa 14ba +4857 4882 14b9 14ba +4859 4858 13ab 14bb +4858 4883 14ba 14bb +485a 4859 13ac 14bc +4859 4884 14bb 14bc +485b 485a 13ad 14bd +485a 4885 14bc 14bd +485c 485b 13ae 14be +485b 4886 14bd 14be +485d 485c 13af 14bf +485c 4887 14be 14bf +485e 485d 13b0 14c0 +485d 4888 14bf 14c0 +485f 485e 13b1 14c1 +485e 4889 14c0 14c1 +4860 485f 13b2 14c2 +485f 488a 14c1 14c2 +4861 4860 13b3 14c3 +4860 488b 14c2 14c3 +4861 488c 14c3 14c4 +4863 4862 149a 15aa +4862 488d 15a9 15aa +4864 4863 149b 15ab +4863 488e 15aa 15ab +4865 4864 149c 15ac +4864 488f 15ab 15ac +4866 4865 149d 15ad +4865 4890 15ac 15ad +4867 4866 149e 15ae +4866 4891 15ad 15ae +4868 4867 149f 15af +4867 4892 15ae 15af +4869 4868 14a0 15b0 +4868 4893 15af 15b0 +486a 4869 14a1 15b1 +4869 4894 15b0 15b1 +486b 486a 14a2 15b2 +486a 4895 15b1 15b2 +486c 486b 14a3 15b3 +486b 4896 15b2 15b3 +486d 486c 14a4 15b4 +486c 4897 15b3 15b4 +486e 486d 14a5 15b5 +486d 4898 15b4 15b5 +486f 486e 14a6 15b6 +486e 4899 15b5 15b6 +4870 486f 14a7 15b7 +486f 489a 15b6 15b7 +4871 4870 14a8 15b8 +4870 489b 15b7 15b8 +4872 4871 14a9 15b9 +4871 489c 15b8 15b9 +4873 4872 14aa 15ba +4872 489d 15b9 15ba +4874 4873 14ab 15bb +4873 489e 15ba 15bb +4875 4874 14ac 15bc +4874 489f 15bb 15bc +4876 4875 14ad 15bd +4875 48a0 15bc 15bd +4877 4876 14ae 15be +4876 48a1 15bd 15be +4878 4877 14af 15bf +4877 48a2 15be 15bf +4879 4878 14b0 15c0 +4878 48a3 15bf 15c0 +487a 4879 14b1 15c1 +4879 48a4 15c0 15c1 +487b 487a 14b2 15c2 +487a 48a5 15c1 15c2 +487c 487b 14b3 15c3 +487b 48a6 15c2 15c3 +487d 487c 14b4 15c4 +487c 48a7 15c3 15c4 +487e 487d 14b5 15c5 +487d 48a8 15c4 15c5 +487f 487e 14b6 15c6 +487e 48a9 15c5 15c6 +4880 487f 14b7 15c7 +487f 48aa 15c6 15c7 +4881 4880 14b8 15c8 +4880 48ab 15c7 15c8 +4882 4881 14b9 15c9 +4881 48ac 15c8 15c9 +4883 4882 14ba 15ca +4882 48ad 15c9 15ca +4884 4883 14bb 15cb +4883 48ae 15ca 15cb +4885 4884 14bc 15cc +4884 48af 15cb 15cc +4886 4885 14bd 15cd +4885 48b0 15cc 15cd +4887 4886 14be 15ce +4886 48b1 15cd 15ce +4888 4887 14bf 15cf +4887 48b2 15ce 15cf +4889 4888 14c0 15d0 +4888 48b3 15cf 15d0 +488a 4889 14c1 15d1 +4889 48b4 15d0 15d1 +488b 488a 14c2 15d2 +488a 48b5 15d1 15d2 +488c 488b 14c3 15d3 +488b 48b6 15d2 15d3 +488c 48b7 15d3 15d4 +488e 488d 15aa 16ba +488d 48b8 16b9 16ba +488f 488e 15ab 16bb +488e 48b9 16ba 16bb +4890 488f 15ac 16bc +488f 48ba 16bb 16bc +4891 4890 15ad 16bd +4890 48bb 16bc 16bd +4892 4891 15ae 16be +4891 48bc 16bd 16be +4893 4892 15af 16bf +4892 48bd 16be 16bf +4894 4893 15b0 16c0 +4893 48be 16bf 16c0 +4895 4894 15b1 16c1 +4894 48bf 16c0 16c1 +4896 4895 15b2 16c2 +4895 48c0 16c1 16c2 +4897 4896 15b3 16c3 +4896 48c1 16c2 16c3 +4898 4897 15b4 16c4 +4897 48c2 16c3 16c4 +4899 4898 15b5 16c5 +4898 48c3 16c4 16c5 +489a 4899 15b6 16c6 +4899 48c4 16c5 16c6 +489b 489a 15b7 16c7 +489a 48c5 16c6 16c7 +489c 489b 15b8 16c8 +489b 48c6 16c7 16c8 +489d 489c 15b9 16c9 +489c 48c7 16c8 16c9 +489e 489d 15ba 16ca +489d 48c8 16c9 16ca +489f 489e 15bb 16cb +489e 48c9 16ca 16cb +48a0 489f 15bc 16cc +489f 48ca 16cb 16cc +48a1 48a0 15bd 16cd +48a0 48cb 16cc 16cd +48a2 48a1 15be 16ce +48a1 48cc 16cd 16ce +48a3 48a2 15bf 16cf +48a2 48cd 16ce 16cf +48a4 48a3 15c0 16d0 +48a3 48ce 16cf 16d0 +48a5 48a4 15c1 16d1 +48a4 48cf 16d0 16d1 +48a6 48a5 15c2 16d2 +48a5 48d0 16d1 16d2 +48a7 48a6 15c3 16d3 +48a6 48d1 16d2 16d3 +48a8 48a7 15c4 16d4 +48a7 48d2 16d3 16d4 +48a9 48a8 15c5 16d5 +48a8 48d3 16d4 16d5 +48aa 48a9 15c6 16d6 +48a9 48d4 16d5 16d6 +48ab 48aa 15c7 16d7 +48aa 48d5 16d6 16d7 +48ac 48ab 15c8 16d8 +48ab 48d6 16d7 16d8 +48ad 48ac 15c9 16d9 +48ac 48d7 16d8 16d9 +48ae 48ad 15ca 16da +48ad 48d8 16d9 16da +48af 48ae 15cb 16db +48ae 48d9 16da 16db +48b0 48af 15cc 16dc +48af 48da 16db 16dc +48b1 48b0 15cd 16dd +48b0 48db 16dc 16dd +48b2 48b1 15ce 16de +48b1 48dc 16dd 16de +48b3 48b2 15cf 16df +48b2 48dd 16de 16df +48b4 48b3 15d0 16e0 +48b3 48de 16df 16e0 +48b5 48b4 15d1 16e1 +48b4 48df 16e0 16e1 +48b6 48b5 15d2 16e2 +48b5 48e0 16e1 16e2 +48b7 48b6 15d3 16e3 +48b6 48e1 16e2 16e3 +48b7 48e2 16e3 16e4 +48b9 48b8 16ba 17ca +48b8 48e3 17c9 17ca +48ba 48b9 16bb 17cb +48b9 48e4 17ca 17cb +48bb 48ba 16bc 17cc +48ba 48e5 17cb 17cc +48bc 48bb 16bd 17cd +48bb 48e6 17cc 17cd +48bd 48bc 16be 17ce +48bc 48e7 17cd 17ce +48be 48bd 16bf 17cf +48bd 48e8 17ce 17cf +48bf 48be 16c0 17d0 +48be 48e9 17cf 17d0 +48c0 48bf 16c1 17d1 +48bf 48ea 17d0 17d1 +48c1 48c0 16c2 17d2 +48c0 48eb 17d1 17d2 +48c2 48c1 16c3 17d3 +48c1 48ec 17d2 17d3 +48c3 48c2 16c4 17d4 +48c2 48ed 17d3 17d4 +48c4 48c3 16c5 17d5 +48c3 48ee 17d4 17d5 +48c5 48c4 16c6 17d6 +48c4 48ef 17d5 17d6 +48c6 48c5 16c7 17d7 +48c5 48f0 17d6 17d7 +48c7 48c6 16c8 17d8 +48c6 48f1 17d7 17d8 +48c8 48c7 16c9 17d9 +48c7 48f2 17d8 17d9 +48c9 48c8 16ca 17da +48c8 48f3 17d9 17da +48ca 48c9 16cb 17db +48c9 48f4 17da 17db +48cb 48ca 16cc 17dc +48ca 48f5 17db 17dc +48cc 48cb 16cd 17dd +48cb 48f6 17dc 17dd +48cd 48cc 16ce 17de +48cc 48f7 17dd 17de +48ce 48cd 16cf 17df +48cd 48f8 17de 17df +48cf 48ce 16d0 17e0 +48ce 48f9 17df 17e0 +48d0 48cf 16d1 17e1 +48cf 48fa 17e0 17e1 +48d1 48d0 16d2 17e2 +48d0 48fb 17e1 17e2 +48d2 48d1 16d3 17e3 +48d1 48fc 17e2 17e3 +48d3 48d2 16d4 17e4 +48d2 48fd 17e3 17e4 +48d4 48d3 16d5 17e5 +48d3 48fe 17e4 17e5 +48d5 48d4 16d6 17e6 +48d4 48ff 17e5 17e6 +48d6 48d5 16d7 17e7 +48d5 4900 17e6 17e7 +48d7 48d6 16d8 17e8 +48d6 4901 17e7 17e8 +48d8 48d7 16d9 17e9 +48d7 4902 17e8 17e9 +48d9 48d8 16da 17ea +48d8 4903 17e9 17ea +48da 48d9 16db 17eb +48d9 4904 17ea 17eb +48db 48da 16dc 17ec +48da 4905 17eb 17ec +48dc 48db 16dd 17ed +48db 4906 17ec 17ed +48dd 48dc 16de 17ee +48dc 4907 17ed 17ee +48de 48dd 16df 17ef +48dd 4908 17ee 17ef +48df 48de 16e0 17f0 +48de 4909 17ef 17f0 +48e0 48df 16e1 17f1 +48df 490a 17f0 17f1 +48e1 48e0 16e2 17f2 +48e0 490b 17f1 17f2 +48e2 48e1 16e3 17f3 +48e1 490c 17f2 17f3 +48e2 490d 17f3 17f4 +48e4 48e3 17ca 18da +48e3 490e 18d9 18da +48e5 48e4 17cb 18db +48e4 490f 18da 18db +48e6 48e5 17cc 18dc +48e5 4910 18db 18dc +48e7 48e6 17cd 18dd +48e6 4911 18dc 18dd +48e8 48e7 17ce 18de +48e7 4912 18dd 18de +48e9 48e8 17cf 18df +48e8 4913 18de 18df +48ea 48e9 17d0 18e0 +48e9 4914 18df 18e0 +48eb 48ea 17d1 18e1 +48ea 4915 18e0 18e1 +48ec 48eb 17d2 18e2 +48eb 4916 18e1 18e2 +48ed 48ec 17d3 18e3 +48ec 4917 18e2 18e3 +48ee 48ed 17d4 18e4 +48ed 4918 18e3 18e4 +48ef 48ee 17d5 18e5 +48ee 4919 18e4 18e5 +48f0 48ef 17d6 18e6 +48ef 491a 18e5 18e6 +48f1 48f0 17d7 18e7 +48f0 491b 18e6 18e7 +48f2 48f1 17d8 18e8 +48f1 491c 18e7 18e8 +48f3 48f2 17d9 18e9 +48f2 491d 18e8 18e9 +48f4 48f3 17da 18ea +48f3 491e 18e9 18ea +48f5 48f4 17db 18eb +48f4 491f 18ea 18eb +48f6 48f5 17dc 18ec +48f5 4920 18eb 18ec +48f7 48f6 17dd 18ed +48f6 4921 18ec 18ed +48f8 48f7 17de 18ee +48f7 4922 18ed 18ee +48f9 48f8 17df 18ef +48f8 4923 18ee 18ef +48fa 48f9 17e0 18f0 +48f9 4924 18ef 18f0 +48fb 48fa 17e1 18f1 +48fa 4925 18f0 18f1 +48fc 48fb 17e2 18f2 +48fb 4926 18f1 18f2 +48fd 48fc 17e3 18f3 +48fc 4927 18f2 18f3 +48fe 48fd 17e4 18f4 +48fd 4928 18f3 18f4 +48ff 48fe 17e5 18f5 +48fe 4929 18f4 18f5 +4900 48ff 17e6 18f6 +48ff 492a 18f5 18f6 +4901 4900 17e7 18f7 +4900 492b 18f6 18f7 +4902 4901 17e8 18f8 +4901 492c 18f7 18f8 +4903 4902 17e9 18f9 +4902 492d 18f8 18f9 +4904 4903 17ea 18fa +4903 492e 18f9 18fa +4905 4904 17eb 18fb +4904 492f 18fa 18fb +4906 4905 17ec 18fc +4905 4930 18fb 18fc +4907 4906 17ed 18fd +4906 4931 18fc 18fd +4908 4907 17ee 18fe +4907 4932 18fd 18fe +4909 4908 17ef 18ff +4908 4933 18fe 18ff +490a 4909 17f0 1900 +4909 4934 18ff 1900 +490b 490a 17f1 1901 +490a 4935 1900 1901 +490c 490b 17f2 1902 +490b 4936 1901 1902 +490d 490c 17f3 1903 +490c 4937 1902 1903 +490d 4938 1903 1904 +490f 490e 18da 19ea +490e 4939 19e9 19ea +4910 490f 18db 19eb +490f 493a 19ea 19eb +4911 4910 18dc 19ec +4910 493b 19eb 19ec +4912 4911 18dd 19ed +4911 493c 19ec 19ed +4913 4912 18de 19ee +4912 493d 19ed 19ee +4914 4913 18df 19ef +4913 493e 19ee 19ef +4915 4914 18e0 19f0 +4914 493f 19ef 19f0 +4916 4915 18e1 19f1 +4915 4940 19f0 19f1 +4917 4916 18e2 19f2 +4916 4941 19f1 19f2 +4918 4917 18e3 19f3 +4917 4942 19f2 19f3 +4919 4918 18e4 19f4 +4918 4943 19f3 19f4 +491a 4919 18e5 19f5 +4919 4944 19f4 19f5 +491b 491a 18e6 19f6 +491a 4945 19f5 19f6 +491c 491b 18e7 19f7 +491b 4946 19f6 19f7 +491d 491c 18e8 19f8 +491c 4947 19f7 19f8 +491e 491d 18e9 19f9 +491d 4948 19f8 19f9 +491f 491e 18ea 19fa +491e 4949 19f9 19fa +4920 491f 18eb 19fb +491f 494a 19fa 19fb +4921 4920 18ec 19fc +4920 494b 19fb 19fc +4922 4921 18ed 19fd +4921 494c 19fc 19fd +4923 4922 18ee 19fe +4922 494d 19fd 19fe +4924 4923 18ef 19ff +4923 494e 19fe 19ff +4925 4924 18f0 1a00 +4924 494f 19ff 1a00 +4926 4925 18f1 1a01 +4925 4950 1a00 1a01 +4927 4926 18f2 1a02 +4926 4951 1a01 1a02 +4928 4927 18f3 1a03 +4927 4952 1a02 1a03 +4929 4928 18f4 1a04 +4928 4953 1a03 1a04 +492a 4929 18f5 1a05 +4929 4954 1a04 1a05 +492b 492a 18f6 1a06 +492a 4955 1a05 1a06 +492c 492b 18f7 1a07 +492b 4956 1a06 1a07 +492d 492c 18f8 1a08 +492c 4957 1a07 1a08 +492e 492d 18f9 1a09 +492d 4958 1a08 1a09 +492f 492e 18fa 1a0a +492e 4959 1a09 1a0a +4930 492f 18fb 1a0b +492f 495a 1a0a 1a0b +4931 4930 18fc 1a0c +4930 495b 1a0b 1a0c +4932 4931 18fd 1a0d +4931 495c 1a0c 1a0d +4933 4932 18fe 1a0e +4932 495d 1a0d 1a0e +4934 4933 18ff 1a0f +4933 495e 1a0e 1a0f +4935 4934 1900 1a10 +4934 495f 1a0f 1a10 +4936 4935 1901 1a11 +4935 4960 1a10 1a11 +4937 4936 1902 1a12 +4936 4961 1a11 1a12 +4938 4937 1903 1a13 +4937 4962 1a12 1a13 +4938 4963 1a13 1a14 +493a 4939 19ea 1afa +4939 4964 1af9 1afa +493b 493a 19eb 1afb +493a 4965 1afa 1afb +493c 493b 19ec 1afc +493b 4966 1afb 1afc +493d 493c 19ed 1afd +493c 4967 1afc 1afd +493e 493d 19ee 1afe +493d 4968 1afd 1afe +493f 493e 19ef 1aff +493e 4969 1afe 1aff +4940 493f 19f0 1b00 +493f 496a 1aff 1b00 +4941 4940 19f1 1b01 +4940 496b 1b00 1b01 +4942 4941 19f2 1b02 +4941 496c 1b01 1b02 +4943 4942 19f3 1b03 +4942 496d 1b02 1b03 +4944 4943 19f4 1b04 +4943 496e 1b03 1b04 +4945 4944 19f5 1b05 +4944 496f 1b04 1b05 +4946 4945 19f6 1b06 +4945 4970 1b05 1b06 +4947 4946 19f7 1b07 +4946 4971 1b06 1b07 +4948 4947 19f8 1b08 +4947 4972 1b07 1b08 +4949 4948 19f9 1b09 +4948 4973 1b08 1b09 +494a 4949 19fa 1b0a +4949 4974 1b09 1b0a +494b 494a 19fb 1b0b +494a 4975 1b0a 1b0b +494c 494b 19fc 1b0c +494b 4976 1b0b 1b0c +494d 494c 19fd 1b0d +494c 4977 1b0c 1b0d +494e 494d 19fe 1b0e +494d 4978 1b0d 1b0e +494f 494e 19ff 1b0f +494e 4979 1b0e 1b0f +4950 494f 1a00 1b10 +494f 497a 1b0f 1b10 +4951 4950 1a01 1b11 +4950 497b 1b10 1b11 +4952 4951 1a02 1b12 +4951 497c 1b11 1b12 +4953 4952 1a03 1b13 +4952 497d 1b12 1b13 +4954 4953 1a04 1b14 +4953 497e 1b13 1b14 +4955 4954 1a05 1b15 +4954 497f 1b14 1b15 +4956 4955 1a06 1b16 +4955 4980 1b15 1b16 +4957 4956 1a07 1b17 +4956 4981 1b16 1b17 +4958 4957 1a08 1b18 +4957 4982 1b17 1b18 +4959 4958 1a09 1b19 +4958 4983 1b18 1b19 +495a 4959 1a0a 1b1a +4959 4984 1b19 1b1a +495b 495a 1a0b 1b1b +495a 4985 1b1a 1b1b +495c 495b 1a0c 1b1c +495b 4986 1b1b 1b1c +495d 495c 1a0d 1b1d +495c 4987 1b1c 1b1d +495e 495d 1a0e 1b1e +495d 4988 1b1d 1b1e +495f 495e 1a0f 1b1f +495e 4989 1b1e 1b1f +4960 495f 1a10 1b20 +495f 498a 1b1f 1b20 +4961 4960 1a11 1b21 +4960 498b 1b20 1b21 +4962 4961 1a12 1b22 +4961 498c 1b21 1b22 +4963 4962 1a13 1b23 +4962 498d 1b22 1b23 +4963 498e 1b23 1b24 +4965 4964 1afa 1c0a +4964 498f 1c09 1c0a +4966 4965 1afb 1c0b +4965 4990 1c0a 1c0b +4967 4966 1afc 1c0c +4966 4991 1c0b 1c0c +4968 4967 1afd 1c0d +4967 4992 1c0c 1c0d +4969 4968 1afe 1c0e +4968 4993 1c0d 1c0e +496a 4969 1aff 1c0f +4969 4994 1c0e 1c0f +496b 496a 1b00 1c10 +496a 4995 1c0f 1c10 +496c 496b 1b01 1c11 +496b 4996 1c10 1c11 +496d 496c 1b02 1c12 +496c 4997 1c11 1c12 +496e 496d 1b03 1c13 +496d 4998 1c12 1c13 +496f 496e 1b04 1c14 +496e 4999 1c13 1c14 +4970 496f 1b05 1c15 +496f 499a 1c14 1c15 +4971 4970 1b06 1c16 +4970 499b 1c15 1c16 +4972 4971 1b07 1c17 +4971 499c 1c16 1c17 +4973 4972 1b08 1c18 +4972 499d 1c17 1c18 +4974 4973 1b09 1c19 +4973 499e 1c18 1c19 +4975 4974 1b0a 1c1a +4974 499f 1c19 1c1a +4976 4975 1b0b 1c1b +4975 49a0 1c1a 1c1b +4977 4976 1b0c 1c1c +4976 49a1 1c1b 1c1c +4978 4977 1b0d 1c1d +4977 49a2 1c1c 1c1d +4979 4978 1b0e 1c1e +4978 49a3 1c1d 1c1e +497a 4979 1b0f 1c1f +4979 49a4 1c1e 1c1f +497b 497a 1b10 1c20 +497a 49a5 1c1f 1c20 +497c 497b 1b11 1c21 +497b 49a6 1c20 1c21 +497d 497c 1b12 1c22 +497c 49a7 1c21 1c22 +497e 497d 1b13 1c23 +497d 49a8 1c22 1c23 +497f 497e 1b14 1c24 +497e 49a9 1c23 1c24 +4980 497f 1b15 1c25 +497f 49aa 1c24 1c25 +4981 4980 1b16 1c26 +4980 49ab 1c25 1c26 +4982 4981 1b17 1c27 +4981 49ac 1c26 1c27 +4983 4982 1b18 1c28 +4982 49ad 1c27 1c28 +4984 4983 1b19 1c29 +4983 49ae 1c28 1c29 +4985 4984 1b1a 1c2a +4984 49af 1c29 1c2a +4986 4985 1b1b 1c2b +4985 49b0 1c2a 1c2b +4987 4986 1b1c 1c2c +4986 49b1 1c2b 1c2c +4988 4987 1b1d 1c2d +4987 49b2 1c2c 1c2d +4989 4988 1b1e 1c2e +4988 49b3 1c2d 1c2e +498a 4989 1b1f 1c2f +4989 49b4 1c2e 1c2f +498b 498a 1b20 1c30 +498a 49b5 1c2f 1c30 +498c 498b 1b21 1c31 +498b 49b6 1c30 1c31 +498d 498c 1b22 1c32 +498c 49b7 1c31 1c32 +498e 498d 1b23 1c33 +498d 49b8 1c32 1c33 +498e 49b9 1c33 1c34 +4990 498f 1c0a 1d1a +498f 49ba 1d19 1d1a +4991 4990 1c0b 1d1b +4990 49bb 1d1a 1d1b +4992 4991 1c0c 1d1c +4991 49bc 1d1b 1d1c +4993 4992 1c0d 1d1d +4992 49bd 1d1c 1d1d +4994 4993 1c0e 1d1e +4993 49be 1d1d 1d1e +4995 4994 1c0f 1d1f +4994 49bf 1d1e 1d1f +4996 4995 1c10 1d20 +4995 49c0 1d1f 1d20 +4997 4996 1c11 1d21 +4996 49c1 1d20 1d21 +4998 4997 1c12 1d22 +4997 49c2 1d21 1d22 +4999 4998 1c13 1d23 +4998 49c3 1d22 1d23 +499a 4999 1c14 1d24 +4999 49c4 1d23 1d24 +499b 499a 1c15 1d25 +499a 49c5 1d24 1d25 +499c 499b 1c16 1d26 +499b 49c6 1d25 1d26 +499d 499c 1c17 1d27 +499c 49c7 1d26 1d27 +499e 499d 1c18 1d28 +499d 49c8 1d27 1d28 +499f 499e 1c19 1d29 +499e 49c9 1d28 1d29 +49a0 499f 1c1a 1d2a +499f 49ca 1d29 1d2a +49a1 49a0 1c1b 1d2b +49a0 49cb 1d2a 1d2b +49a2 49a1 1c1c 1d2c +49a1 49cc 1d2b 1d2c +49a3 49a2 1c1d 1d2d +49a2 49cd 1d2c 1d2d +49a4 49a3 1c1e 1d2e +49a3 49ce 1d2d 1d2e +49a5 49a4 1c1f 1d2f +49a4 49cf 1d2e 1d2f +49a6 49a5 1c20 1d30 +49a5 49d0 1d2f 1d30 +49a7 49a6 1c21 1d31 +49a6 49d1 1d30 1d31 +49a8 49a7 1c22 1d32 +49a7 49d2 1d31 1d32 +49a9 49a8 1c23 1d33 +49a8 49d3 1d32 1d33 +49aa 49a9 1c24 1d34 +49a9 49d4 1d33 1d34 +49ab 49aa 1c25 1d35 +49aa 49d5 1d34 1d35 +49ac 49ab 1c26 1d36 +49ab 49d6 1d35 1d36 +49ad 49ac 1c27 1d37 +49ac 49d7 1d36 1d37 +49ae 49ad 1c28 1d38 +49ad 49d8 1d37 1d38 +49af 49ae 1c29 1d39 +49ae 49d9 1d38 1d39 +49b0 49af 1c2a 1d3a +49af 49da 1d39 1d3a +49b1 49b0 1c2b 1d3b +49b0 49db 1d3a 1d3b +49b2 49b1 1c2c 1d3c +49b1 49dc 1d3b 1d3c +49b3 49b2 1c2d 1d3d +49b2 49dd 1d3c 1d3d +49b4 49b3 1c2e 1d3e +49b3 49de 1d3d 1d3e +49b5 49b4 1c2f 1d3f +49b4 49df 1d3e 1d3f +49b6 49b5 1c30 1d40 +49b5 49e0 1d3f 1d40 +49b7 49b6 1c31 1d41 +49b6 49e1 1d40 1d41 +49b8 49b7 1c32 1d42 +49b7 49e2 1d41 1d42 +49b9 49b8 1c33 1d43 +49b8 49e3 1d42 1d43 +49b9 49e4 1d43 1d44 +49bb 49ba 1d1a 1e2a +49ba 49e5 1e29 1e2a +49bc 49bb 1d1b 1e2b +49bb 49e6 1e2a 1e2b +49bd 49bc 1d1c 1e2c +49bc 49e7 1e2b 1e2c +49be 49bd 1d1d 1e2d +49bd 49e8 1e2c 1e2d +49bf 49be 1d1e 1e2e +49be 49e9 1e2d 1e2e +49c0 49bf 1d1f 1e2f +49bf 49ea 1e2e 1e2f +49c1 49c0 1d20 1e30 +49c0 49eb 1e2f 1e30 +49c2 49c1 1d21 1e31 +49c1 49ec 1e30 1e31 +49c3 49c2 1d22 1e32 +49c2 49ed 1e31 1e32 +49c4 49c3 1d23 1e33 +49c3 49ee 1e32 1e33 +49c5 49c4 1d24 1e34 +49c4 49ef 1e33 1e34 +49c6 49c5 1d25 1e35 +49c5 49f0 1e34 1e35 +49c7 49c6 1d26 1e36 +49c6 49f1 1e35 1e36 +49c8 49c7 1d27 1e37 +49c7 49f2 1e36 1e37 +49c9 49c8 1d28 1e38 +49c8 49f3 1e37 1e38 +49ca 49c9 1d29 1e39 +49c9 49f4 1e38 1e39 +49cb 49ca 1d2a 1e3a +49ca 49f5 1e39 1e3a +49cc 49cb 1d2b 1e3b +49cb 49f6 1e3a 1e3b +49cd 49cc 1d2c 1e3c +49cc 49f7 1e3b 1e3c +49ce 49cd 1d2d 1e3d +49cd 49f8 1e3c 1e3d +49cf 49ce 1d2e 1e3e +49ce 49f9 1e3d 1e3e +49d0 49cf 1d2f 1e3f +49cf 49fa 1e3e 1e3f +49d1 49d0 1d30 1e40 +49d0 49fb 1e3f 1e40 +49d2 49d1 1d31 1e41 +49d1 49fc 1e40 1e41 +49d3 49d2 1d32 1e42 +49d2 49fd 1e41 1e42 +49d4 49d3 1d33 1e43 +49d3 49fe 1e42 1e43 +49d5 49d4 1d34 1e44 +49d4 49ff 1e43 1e44 +49d6 49d5 1d35 1e45 +49d5 4a00 1e44 1e45 +49d7 49d6 1d36 1e46 +49d6 4a01 1e45 1e46 +49d8 49d7 1d37 1e47 +49d7 4a02 1e46 1e47 +49d9 49d8 1d38 1e48 +49d8 4a03 1e47 1e48 +49da 49d9 1d39 1e49 +49d9 4a04 1e48 1e49 +49db 49da 1d3a 1e4a +49da 4a05 1e49 1e4a +49dc 49db 1d3b 1e4b +49db 4a06 1e4a 1e4b +49dd 49dc 1d3c 1e4c +49dc 4a07 1e4b 1e4c +49de 49dd 1d3d 1e4d +49dd 4a08 1e4c 1e4d +49df 49de 1d3e 1e4e +49de 4a09 1e4d 1e4e +49e0 49df 1d3f 1e4f +49df 4a0a 1e4e 1e4f +49e1 49e0 1d40 1e50 +49e0 4a0b 1e4f 1e50 +49e2 49e1 1d41 1e51 +49e1 4a0c 1e50 1e51 +49e3 49e2 1d42 1e52 +49e2 4a0d 1e51 1e52 +49e4 49e3 1d43 1e53 +49e3 4a0e 1e52 1e53 +49e4 4a0f 1e53 1e54 +49e6 49e5 1e2a 1f3a +49e5 4a10 1f39 1f3a +49e7 49e6 1e2b 1f3b +49e6 4a11 1f3a 1f3b +49e8 49e7 1e2c 1f3c +49e7 4a12 1f3b 1f3c +49e9 49e8 1e2d 1f3d +49e8 4a13 1f3c 1f3d +49ea 49e9 1e2e 1f3e +49e9 4a14 1f3d 1f3e +49eb 49ea 1e2f 1f3f +49ea 4a15 1f3e 1f3f +49ec 49eb 1e30 1f40 +49eb 4a16 1f3f 1f40 +49ed 49ec 1e31 1f41 +49ec 4a17 1f40 1f41 +49ee 49ed 1e32 1f42 +49ed 4a18 1f41 1f42 +49ef 49ee 1e33 1f43 +49ee 4a19 1f42 1f43 +49f0 49ef 1e34 1f44 +49ef 4a1a 1f43 1f44 +49f1 49f0 1e35 1f45 +49f0 4a1b 1f44 1f45 +49f2 49f1 1e36 1f46 +49f1 4a1c 1f45 1f46 +49f3 49f2 1e37 1f47 +49f2 4a1d 1f46 1f47 +49f4 49f3 1e38 1f48 +49f3 4a1e 1f47 1f48 +49f5 49f4 1e39 1f49 +49f4 4a1f 1f48 1f49 +49f6 49f5 1e3a 1f4a +49f5 4a20 1f49 1f4a +49f7 49f6 1e3b 1f4b +49f6 4a21 1f4a 1f4b +49f8 49f7 1e3c 1f4c +49f7 4a22 1f4b 1f4c +49f9 49f8 1e3d 1f4d +49f8 4a23 1f4c 1f4d +49fa 49f9 1e3e 1f4e +49f9 4a24 1f4d 1f4e +49fb 49fa 1e3f 1f4f +49fa 4a25 1f4e 1f4f +49fc 49fb 1e40 1f50 +49fb 4a26 1f4f 1f50 +49fd 49fc 1e41 1f51 +49fc 4a27 1f50 1f51 +49fe 49fd 1e42 1f52 +49fd 4a28 1f51 1f52 +49ff 49fe 1e43 1f53 +49fe 4a29 1f52 1f53 +4a00 49ff 1e44 1f54 +49ff 4a2a 1f53 1f54 +4a01 4a00 1e45 1f55 +4a00 4a2b 1f54 1f55 +4a02 4a01 1e46 1f56 +4a01 4a2c 1f55 1f56 +4a03 4a02 1e47 1f57 +4a02 4a2d 1f56 1f57 +4a04 4a03 1e48 1f58 +4a03 4a2e 1f57 1f58 +4a05 4a04 1e49 1f59 +4a04 4a2f 1f58 1f59 +4a06 4a05 1e4a 1f5a +4a05 4a30 1f59 1f5a +4a07 4a06 1e4b 1f5b +4a06 4a31 1f5a 1f5b +4a08 4a07 1e4c 1f5c +4a07 4a32 1f5b 1f5c +4a09 4a08 1e4d 1f5d +4a08 4a33 1f5c 1f5d +4a0a 4a09 1e4e 1f5e +4a09 4a34 1f5d 1f5e +4a0b 4a0a 1e4f 1f5f +4a0a 4a35 1f5e 1f5f +4a0c 4a0b 1e50 1f60 +4a0b 4a36 1f5f 1f60 +4a0d 4a0c 1e51 1f61 +4a0c 4a37 1f60 1f61 +4a0e 4a0d 1e52 1f62 +4a0d 4a38 1f61 1f62 +4a0f 4a0e 1e53 1f63 +4a0e 4a39 1f62 1f63 +4a0f 4a3a 1f63 1f64 +4a11 4a10 1f3a 204a +4a10 4a3b 2049 204a +4a12 4a11 1f3b 204b +4a11 4a3c 204a 204b +4a13 4a12 1f3c 204c +4a12 4a3d 204b 204c +4a14 4a13 1f3d 204d +4a13 4a3e 204c 204d +4a15 4a14 1f3e 204e +4a14 4a3f 204d 204e +4a16 4a15 1f3f 204f +4a15 4a40 204e 204f +4a17 4a16 1f40 2050 +4a16 4a41 204f 2050 +4a18 4a17 1f41 2051 +4a17 4a42 2050 2051 +4a19 4a18 1f42 2052 +4a18 4a43 2051 2052 +4a1a 4a19 1f43 2053 +4a19 4a44 2052 2053 +4a1b 4a1a 1f44 2054 +4a1a 4a45 2053 2054 +4a1c 4a1b 1f45 2055 +4a1b 4a46 2054 2055 +4a1d 4a1c 1f46 2056 +4a1c 4a47 2055 2056 +4a1e 4a1d 1f47 2057 +4a1d 4a48 2056 2057 +4a1f 4a1e 1f48 2058 +4a1e 4a49 2057 2058 +4a20 4a1f 1f49 2059 +4a1f 4a4a 2058 2059 +4a21 4a20 1f4a 205a +4a20 4a4b 2059 205a +4a22 4a21 1f4b 205b +4a21 4a4c 205a 205b +4a23 4a22 1f4c 205c +4a22 4a4d 205b 205c +4a24 4a23 1f4d 205d +4a23 4a4e 205c 205d +4a25 4a24 1f4e 205e +4a24 4a4f 205d 205e +4a26 4a25 1f4f 205f +4a25 4a50 205e 205f +4a27 4a26 1f50 2060 +4a26 4a51 205f 2060 +4a28 4a27 1f51 2061 +4a27 4a52 2060 2061 +4a29 4a28 1f52 2062 +4a28 4a53 2061 2062 +4a2a 4a29 1f53 2063 +4a29 4a54 2062 2063 +4a2b 4a2a 1f54 2064 +4a2a 4a55 2063 2064 +4a2c 4a2b 1f55 2065 +4a2b 4a56 2064 2065 +4a2d 4a2c 1f56 2066 +4a2c 4a57 2065 2066 +4a2e 4a2d 1f57 2067 +4a2d 4a58 2066 2067 +4a2f 4a2e 1f58 2068 +4a2e 4a59 2067 2068 +4a30 4a2f 1f59 2069 +4a2f 4a5a 2068 2069 +4a31 4a30 1f5a 206a +4a30 4a5b 2069 206a +4a32 4a31 1f5b 206b +4a31 4a5c 206a 206b +4a33 4a32 1f5c 206c +4a32 4a5d 206b 206c +4a34 4a33 1f5d 206d +4a33 4a5e 206c 206d +4a35 4a34 1f5e 206e +4a34 4a5f 206d 206e +4a36 4a35 1f5f 206f +4a35 4a60 206e 206f +4a37 4a36 1f60 2070 +4a36 4a61 206f 2070 +4a38 4a37 1f61 2071 +4a37 4a62 2070 2071 +4a39 4a38 1f62 2072 +4a38 4a63 2071 2072 +4a3a 4a39 1f63 2073 +4a39 4a64 2072 2073 +4a3a 4a65 2073 2074 +4a3c 4a3b 204a 215a +4a3b 4a66 2159 215a +4a3d 4a3c 204b 215b +4a3c 4a67 215a 215b +4a3e 4a3d 204c 215c +4a3d 4a68 215b 215c +4a3f 4a3e 204d 215d +4a3e 4a69 215c 215d +4a40 4a3f 204e 215e +4a3f 4a6a 215d 215e +4a41 4a40 204f 215f +4a40 4a6b 215e 215f +4a42 4a41 2050 2160 +4a41 4a6c 215f 2160 +4a43 4a42 2051 2161 +4a42 4a6d 2160 2161 +4a44 4a43 2052 2162 +4a43 4a6e 2161 2162 +4a45 4a44 2053 2163 +4a44 4a6f 2162 2163 +4a46 4a45 2054 2164 +4a45 4a70 2163 2164 +4a47 4a46 2055 2165 +4a46 4a71 2164 2165 +4a48 4a47 2056 2166 +4a47 4a72 2165 2166 +4a49 4a48 2057 2167 +4a48 4a73 2166 2167 +4a4a 4a49 2058 2168 +4a49 4a74 2167 2168 +4a4b 4a4a 2059 2169 +4a4a 4a75 2168 2169 +4a4c 4a4b 205a 216a +4a4b 4a76 2169 216a +4a4d 4a4c 205b 216b +4a4c 4a77 216a 216b +4a4e 4a4d 205c 216c +4a4d 4a78 216b 216c +4a4f 4a4e 205d 216d +4a4e 4a79 216c 216d +4a50 4a4f 205e 216e +4a4f 4a7a 216d 216e +4a51 4a50 205f 216f +4a50 4a7b 216e 216f +4a52 4a51 2060 2170 +4a51 4a7c 216f 2170 +4a53 4a52 2061 2171 +4a52 4a7d 2170 2171 +4a54 4a53 2062 2172 +4a53 4a7e 2171 2172 +4a55 4a54 2063 2173 +4a54 4a7f 2172 2173 +4a56 4a55 2064 2174 +4a55 4a80 2173 2174 +4a57 4a56 2065 2175 +4a56 4a81 2174 2175 +4a58 4a57 2066 2176 +4a57 4a82 2175 2176 +4a59 4a58 2067 2177 +4a58 4a83 2176 2177 +4a5a 4a59 2068 2178 +4a59 4a84 2177 2178 +4a5b 4a5a 2069 2179 +4a5a 4a85 2178 2179 +4a5c 4a5b 206a 217a +4a5b 4a86 2179 217a +4a5d 4a5c 206b 217b +4a5c 4a87 217a 217b +4a5e 4a5d 206c 217c +4a5d 4a88 217b 217c +4a5f 4a5e 206d 217d +4a5e 4a89 217c 217d +4a60 4a5f 206e 217e +4a5f 4a8a 217d 217e +4a61 4a60 206f 217f +4a60 4a8b 217e 217f +4a62 4a61 2070 2180 +4a61 4a8c 217f 2180 +4a63 4a62 2071 2181 +4a62 4a8d 2180 2181 +4a64 4a63 2072 2182 +4a63 4a8e 2181 2182 +4a65 4a64 2073 2183 +4a64 4a8f 2182 2183 +4a65 4a90 2183 2184 +4a67 4a66 215a 226a +4a66 4a91 2269 226a +4a68 4a67 215b 226b +4a67 4a92 226a 226b +4a69 4a68 215c 226c +4a68 4a93 226b 226c +4a6a 4a69 215d 226d +4a69 4a94 226c 226d +4a6b 4a6a 215e 226e +4a6a 4a95 226d 226e +4a6c 4a6b 215f 226f +4a6b 4a96 226e 226f +4a6d 4a6c 2160 2270 +4a6c 4a97 226f 2270 +4a6e 4a6d 2161 2271 +4a6d 4a98 2270 2271 +4a6f 4a6e 2162 2272 +4a6e 4a99 2271 2272 +4a70 4a6f 2163 2273 +4a6f 4a9a 2272 2273 +4a71 4a70 2164 2274 +4a70 4a9b 2273 2274 +4a72 4a71 2165 2275 +4a71 4a9c 2274 2275 +4a73 4a72 2166 2276 +4a72 4a9d 2275 2276 +4a74 4a73 2167 2277 +4a73 4a9e 2276 2277 +4a75 4a74 2168 2278 +4a74 4a9f 2277 2278 +4a76 4a75 2169 2279 +4a75 4aa0 2278 2279 +4a77 4a76 216a 227a +4a76 4aa1 2279 227a +4a78 4a77 216b 227b +4a77 4aa2 227a 227b +4a79 4a78 216c 227c +4a78 4aa3 227b 227c +4a7a 4a79 216d 227d +4a79 4aa4 227c 227d +4a7b 4a7a 216e 227e +4a7a 4aa5 227d 227e +4a7c 4a7b 216f 227f +4a7b 4aa6 227e 227f +4a7d 4a7c 2170 2280 +4a7c 4aa7 227f 2280 +4a7e 4a7d 2171 2281 +4a7d 4aa8 2280 2281 +4a7f 4a7e 2172 2282 +4a7e 4aa9 2281 2282 +4a80 4a7f 2173 2283 +4a7f 4aaa 2282 2283 +4a81 4a80 2174 2284 +4a80 4aab 2283 2284 +4a82 4a81 2175 2285 +4a81 4aac 2284 2285 +4a83 4a82 2176 2286 +4a82 4aad 2285 2286 +4a84 4a83 2177 2287 +4a83 4aae 2286 2287 +4a85 4a84 2178 2288 +4a84 4aaf 2287 2288 +4a86 4a85 2179 2289 +4a85 4ab0 2288 2289 +4a87 4a86 217a 228a +4a86 4ab1 2289 228a +4a88 4a87 217b 228b +4a87 4ab2 228a 228b +4a89 4a88 217c 228c +4a88 4ab3 228b 228c +4a8a 4a89 217d 228d +4a89 4ab4 228c 228d +4a8b 4a8a 217e 228e +4a8a 4ab5 228d 228e +4a8c 4a8b 217f 228f +4a8b 4ab6 228e 228f +4a8d 4a8c 2180 2290 +4a8c 4ab7 228f 2290 +4a8e 4a8d 2181 2291 +4a8d 4ab8 2290 2291 +4a8f 4a8e 2182 2292 +4a8e 4ab9 2291 2292 +4a90 4a8f 2183 2293 +4a8f 4aba 2292 2293 +4a90 4abb 2293 2294 +4a92 4a91 226a 237a +4a91 4abc 2379 237a +4a93 4a92 226b 237b +4a92 4abd 237a 237b +4a94 4a93 226c 237c +4a93 4abe 237b 237c +4a95 4a94 226d 237d +4a94 4abf 237c 237d +4a96 4a95 226e 237e +4a95 4ac0 237d 237e +4a97 4a96 226f 237f +4a96 4ac1 237e 237f +4a98 4a97 2270 2380 +4a97 4ac2 237f 2380 +4a99 4a98 2271 2381 +4a98 4ac3 2380 2381 +4a9a 4a99 2272 2382 +4a99 4ac4 2381 2382 +4a9b 4a9a 2273 2383 +4a9a 4ac5 2382 2383 +4a9c 4a9b 2274 2384 +4a9b 4ac6 2383 2384 +4a9d 4a9c 2275 2385 +4a9c 4ac7 2384 2385 +4a9e 4a9d 2276 2386 +4a9d 4ac8 2385 2386 +4a9f 4a9e 2277 2387 +4a9e 4ac9 2386 2387 +4aa0 4a9f 2278 2388 +4a9f 4aca 2387 2388 +4aa1 4aa0 2279 2389 +4aa0 4acb 2388 2389 +4aa2 4aa1 227a 238a +4aa1 4acc 2389 238a +4aa3 4aa2 227b 238b +4aa2 4acd 238a 238b +4aa4 4aa3 227c 238c +4aa3 4ace 238b 238c +4aa5 4aa4 227d 238d +4aa4 4acf 238c 238d +4aa6 4aa5 227e 238e +4aa5 4ad0 238d 238e +4aa7 4aa6 227f 238f +4aa6 4ad1 238e 238f +4aa8 4aa7 2280 2390 +4aa7 4ad2 238f 2390 +4aa9 4aa8 2281 2391 +4aa8 4ad3 2390 2391 +4aaa 4aa9 2282 2392 +4aa9 4ad4 2391 2392 +4aab 4aaa 2283 2393 +4aaa 4ad5 2392 2393 +4aac 4aab 2284 2394 +4aab 4ad6 2393 2394 +4aad 4aac 2285 2395 +4aac 4ad7 2394 2395 +4aae 4aad 2286 2396 +4aad 4ad8 2395 2396 +4aaf 4aae 2287 2397 +4aae 4ad9 2396 2397 +4ab0 4aaf 2288 2398 +4aaf 4ada 2397 2398 +4ab1 4ab0 2289 2399 +4ab0 4adb 2398 2399 +4ab2 4ab1 228a 239a +4ab1 4adc 2399 239a +4ab3 4ab2 228b 239b +4ab2 4add 239a 239b +4ab4 4ab3 228c 239c +4ab3 4ade 239b 239c +4ab5 4ab4 228d 239d +4ab4 4adf 239c 239d +4ab6 4ab5 228e 239e +4ab5 4ae0 239d 239e +4ab7 4ab6 228f 239f +4ab6 4ae1 239e 239f +4ab8 4ab7 2290 23a0 +4ab7 4ae2 239f 23a0 +4ab9 4ab8 2291 23a1 +4ab8 4ae3 23a0 23a1 +4aba 4ab9 2292 23a2 +4ab9 4ae4 23a1 23a2 +4abb 4aba 2293 23a3 +4aba 4ae5 23a2 23a3 +4abb 4ae6 23a3 23a4 +4abd 4abc 237a 248a +4abc 4ae7 2489 248a +4abe 4abd 237b 248b +4abd 4ae8 248a 248b +4abf 4abe 237c 248c +4abe 4ae9 248b 248c +4ac0 4abf 237d 248d +4abf 4aea 248c 248d +4ac1 4ac0 237e 248e +4ac0 4aeb 248d 248e +4ac2 4ac1 237f 248f +4ac1 4aec 248e 248f +4ac3 4ac2 2380 2490 +4ac2 4aed 248f 2490 +4ac4 4ac3 2381 2491 +4ac3 4aee 2490 2491 +4ac5 4ac4 2382 2492 +4ac4 4aef 2491 2492 +4ac6 4ac5 2383 2493 +4ac5 4af0 2492 2493 +4ac7 4ac6 2384 2494 +4ac6 4af1 2493 2494 +4ac8 4ac7 2385 2495 +4ac7 4af2 2494 2495 +4ac9 4ac8 2386 2496 +4ac8 4af3 2495 2496 +4aca 4ac9 2387 2497 +4ac9 4af4 2496 2497 +4acb 4aca 2388 2498 +4aca 4af5 2497 2498 +4acc 4acb 2389 2499 +4acb 4af6 2498 2499 +4acd 4acc 238a 249a +4acc 4af7 2499 249a +4ace 4acd 238b 249b +4acd 4af8 249a 249b +4acf 4ace 238c 249c +4ace 4af9 249b 249c +4ad0 4acf 238d 249d +4acf 4afa 249c 249d +4ad1 4ad0 238e 249e +4ad0 4afb 249d 249e +4ad2 4ad1 238f 249f +4ad1 4afc 249e 249f +4ad3 4ad2 2390 24a0 +4ad2 4afd 249f 24a0 +4ad4 4ad3 2391 24a1 +4ad3 4afe 24a0 24a1 +4ad5 4ad4 2392 24a2 +4ad4 4aff 24a1 24a2 +4ad6 4ad5 2393 24a3 +4ad5 4b00 24a2 24a3 +4ad7 4ad6 2394 24a4 +4ad6 4b01 24a3 24a4 +4ad8 4ad7 2395 24a5 +4ad7 4b02 24a4 24a5 +4ad9 4ad8 2396 24a6 +4ad8 4b03 24a5 24a6 +4ada 4ad9 2397 24a7 +4ad9 4b04 24a6 24a7 +4adb 4ada 2398 24a8 +4ada 4b05 24a7 24a8 +4adc 4adb 2399 24a9 +4adb 4b06 24a8 24a9 +4add 4adc 239a 24aa +4adc 4b07 24a9 24aa +4ade 4add 239b 24ab +4add 4b08 24aa 24ab +4adf 4ade 239c 24ac +4ade 4b09 24ab 24ac +4ae0 4adf 239d 24ad +4adf 4b0a 24ac 24ad +4ae1 4ae0 239e 24ae +4ae0 4b0b 24ad 24ae +4ae2 4ae1 239f 24af +4ae1 4b0c 24ae 24af +4ae3 4ae2 23a0 24b0 +4ae2 4b0d 24af 24b0 +4ae4 4ae3 23a1 24b1 +4ae3 4b0e 24b0 24b1 +4ae5 4ae4 23a2 24b2 +4ae4 4b0f 24b1 24b2 +4ae6 4ae5 23a3 24b3 +4ae5 4b10 24b2 24b3 +4ae6 4b11 24b3 24b4 +4ae8 4ae7 248a 259a +4ae7 4b12 2599 259a +4ae9 4ae8 248b 259b +4ae8 4b13 259a 259b +4aea 4ae9 248c 259c +4ae9 4b14 259b 259c +4aeb 4aea 248d 259d +4aea 4b15 259c 259d +4aec 4aeb 248e 259e +4aeb 4b16 259d 259e +4aed 4aec 248f 259f +4aec 4b17 259e 259f +4aee 4aed 2490 25a0 +4aed 4b18 259f 25a0 +4aef 4aee 2491 25a1 +4aee 4b19 25a0 25a1 +4af0 4aef 2492 25a2 +4aef 4b1a 25a1 25a2 +4af1 4af0 2493 25a3 +4af0 4b1b 25a2 25a3 +4af2 4af1 2494 25a4 +4af1 4b1c 25a3 25a4 +4af3 4af2 2495 25a5 +4af2 4b1d 25a4 25a5 +4af4 4af3 2496 25a6 +4af3 4b1e 25a5 25a6 +4af5 4af4 2497 25a7 +4af4 4b1f 25a6 25a7 +4af6 4af5 2498 25a8 +4af5 4b20 25a7 25a8 +4af7 4af6 2499 25a9 +4af6 4b21 25a8 25a9 +4af8 4af7 249a 25aa +4af7 4b22 25a9 25aa +4af9 4af8 249b 25ab +4af8 4b23 25aa 25ab +4afa 4af9 249c 25ac +4af9 4b24 25ab 25ac +4afb 4afa 249d 25ad +4afa 4b25 25ac 25ad +4afc 4afb 249e 25ae +4afb 4b26 25ad 25ae +4afd 4afc 249f 25af +4afc 4b27 25ae 25af +4afe 4afd 24a0 25b0 +4afd 4b28 25af 25b0 +4aff 4afe 24a1 25b1 +4afe 4b29 25b0 25b1 +4b00 4aff 24a2 25b2 +4aff 4b2a 25b1 25b2 +4b01 4b00 24a3 25b3 +4b00 4b2b 25b2 25b3 +4b02 4b01 24a4 25b4 +4b01 4b2c 25b3 25b4 +4b03 4b02 24a5 25b5 +4b02 4b2d 25b4 25b5 +4b04 4b03 24a6 25b6 +4b03 4b2e 25b5 25b6 +4b05 4b04 24a7 25b7 +4b04 4b2f 25b6 25b7 +4b06 4b05 24a8 25b8 +4b05 4b30 25b7 25b8 +4b07 4b06 24a9 25b9 +4b06 4b31 25b8 25b9 +4b08 4b07 24aa 25ba +4b07 4b32 25b9 25ba +4b09 4b08 24ab 25bb +4b08 4b33 25ba 25bb +4b0a 4b09 24ac 25bc +4b09 4b34 25bb 25bc +4b0b 4b0a 24ad 25bd +4b0a 4b35 25bc 25bd +4b0c 4b0b 24ae 25be +4b0b 4b36 25bd 25be +4b0d 4b0c 24af 25bf +4b0c 4b37 25be 25bf +4b0e 4b0d 24b0 25c0 +4b0d 4b38 25bf 25c0 +4b0f 4b0e 24b1 25c1 +4b0e 4b39 25c0 25c1 +4b10 4b0f 24b2 25c2 +4b0f 4b3a 25c1 25c2 +4b11 4b10 24b3 25c3 +4b10 4b3b 25c2 25c3 +4b11 4b3c 25c3 25c4 +4b13 4b12 259a 26aa +4b12 4b3d 26a9 26aa +4b14 4b13 259b 26ab +4b13 4b3e 26aa 26ab +4b15 4b14 259c 26ac +4b14 4b3f 26ab 26ac +4b16 4b15 259d 26ad +4b15 4b40 26ac 26ad +4b17 4b16 259e 26ae +4b16 4b41 26ad 26ae +4b18 4b17 259f 26af +4b17 4b42 26ae 26af +4b19 4b18 25a0 26b0 +4b18 4b43 26af 26b0 +4b1a 4b19 25a1 26b1 +4b19 4b44 26b0 26b1 +4b1b 4b1a 25a2 26b2 +4b1a 4b45 26b1 26b2 +4b1c 4b1b 25a3 26b3 +4b1b 4b46 26b2 26b3 +4b1d 4b1c 25a4 26b4 +4b1c 4b47 26b3 26b4 +4b1e 4b1d 25a5 26b5 +4b1d 4b48 26b4 26b5 +4b1f 4b1e 25a6 26b6 +4b1e 4b49 26b5 26b6 +4b20 4b1f 25a7 26b7 +4b1f 4b4a 26b6 26b7 +4b21 4b20 25a8 26b8 +4b20 4b4b 26b7 26b8 +4b22 4b21 25a9 26b9 +4b21 4b4c 26b8 26b9 +4b23 4b22 25aa 26ba +4b22 4b4d 26b9 26ba +4b24 4b23 25ab 26bb +4b23 4b4e 26ba 26bb +4b25 4b24 25ac 26bc +4b24 4b4f 26bb 26bc +4b26 4b25 25ad 26bd +4b25 4b50 26bc 26bd +4b27 4b26 25ae 26be +4b26 4b51 26bd 26be +4b28 4b27 25af 26bf +4b27 4b52 26be 26bf +4b29 4b28 25b0 26c0 +4b28 4b53 26bf 26c0 +4b2a 4b29 25b1 26c1 +4b29 4b54 26c0 26c1 +4b2b 4b2a 25b2 26c2 +4b2a 4b55 26c1 26c2 +4b2c 4b2b 25b3 26c3 +4b2b 4b56 26c2 26c3 +4b2d 4b2c 25b4 26c4 +4b2c 4b57 26c3 26c4 +4b2e 4b2d 25b5 26c5 +4b2d 4b58 26c4 26c5 +4b2f 4b2e 25b6 26c6 +4b2e 4b59 26c5 26c6 +4b30 4b2f 25b7 26c7 +4b2f 4b5a 26c6 26c7 +4b31 4b30 25b8 26c8 +4b30 4b5b 26c7 26c8 +4b32 4b31 25b9 26c9 +4b31 4b5c 26c8 26c9 +4b33 4b32 25ba 26ca +4b32 4b5d 26c9 26ca +4b34 4b33 25bb 26cb +4b33 4b5e 26ca 26cb +4b35 4b34 25bc 26cc +4b34 4b5f 26cb 26cc +4b36 4b35 25bd 26cd +4b35 4b60 26cc 26cd +4b37 4b36 25be 26ce +4b36 4b61 26cd 26ce +4b38 4b37 25bf 26cf +4b37 4b62 26ce 26cf +4b39 4b38 25c0 26d0 +4b38 4b63 26cf 26d0 +4b3a 4b39 25c1 26d1 +4b39 4b64 26d0 26d1 +4b3b 4b3a 25c2 26d2 +4b3a 4b65 26d1 26d2 +4b3c 4b3b 25c3 26d3 +4b3b 4b66 26d2 26d3 +4b3c 4b67 26d3 26d4 +4b3e 4b3d 26aa 27ba +4b3d 4b68 27b9 27ba +4b3f 4b3e 26ab 27bb +4b3e 4b69 27ba 27bb +4b40 4b3f 26ac 27bc +4b3f 4b6a 27bb 27bc +4b41 4b40 26ad 27bd +4b40 4b6b 27bc 27bd +4b42 4b41 26ae 27be +4b41 4b6c 27bd 27be +4b43 4b42 26af 27bf +4b42 4b6d 27be 27bf +4b44 4b43 26b0 27c0 +4b43 4b6e 27bf 27c0 +4b45 4b44 26b1 27c1 +4b44 4b6f 27c0 27c1 +4b46 4b45 26b2 27c2 +4b45 4b70 27c1 27c2 +4b47 4b46 26b3 27c3 +4b46 4b71 27c2 27c3 +4b48 4b47 26b4 27c4 +4b47 4b72 27c3 27c4 +4b49 4b48 26b5 27c5 +4b48 4b73 27c4 27c5 +4b4a 4b49 26b6 27c6 +4b49 4b74 27c5 27c6 +4b4b 4b4a 26b7 27c7 +4b4a 4b75 27c6 27c7 +4b4c 4b4b 26b8 27c8 +4b4b 4b76 27c7 27c8 +4b4d 4b4c 26b9 27c9 +4b4c 4b77 27c8 27c9 +4b4e 4b4d 26ba 27ca +4b4d 4b78 27c9 27ca +4b4f 4b4e 26bb 27cb +4b4e 4b79 27ca 27cb +4b50 4b4f 26bc 27cc +4b4f 4b7a 27cb 27cc +4b51 4b50 26bd 27cd +4b50 4b7b 27cc 27cd +4b52 4b51 26be 27ce +4b51 4b7c 27cd 27ce +4b53 4b52 26bf 27cf +4b52 4b7d 27ce 27cf +4b54 4b53 26c0 27d0 +4b53 4b7e 27cf 27d0 +4b55 4b54 26c1 27d1 +4b54 4b7f 27d0 27d1 +4b56 4b55 26c2 27d2 +4b55 4b80 27d1 27d2 +4b57 4b56 26c3 27d3 +4b56 4b81 27d2 27d3 +4b58 4b57 26c4 27d4 +4b57 4b82 27d3 27d4 +4b59 4b58 26c5 27d5 +4b58 4b83 27d4 27d5 +4b5a 4b59 26c6 27d6 +4b59 4b84 27d5 27d6 +4b5b 4b5a 26c7 27d7 +4b5a 4b85 27d6 27d7 +4b5c 4b5b 26c8 27d8 +4b5b 4b86 27d7 27d8 +4b5d 4b5c 26c9 27d9 +4b5c 4b87 27d8 27d9 +4b5e 4b5d 26ca 27da +4b5d 4b88 27d9 27da +4b5f 4b5e 26cb 27db +4b5e 4b89 27da 27db +4b60 4b5f 26cc 27dc +4b5f 4b8a 27db 27dc +4b61 4b60 26cd 27dd +4b60 4b8b 27dc 27dd +4b62 4b61 26ce 27de +4b61 4b8c 27dd 27de +4b63 4b62 26cf 27df +4b62 4b8d 27de 27df +4b64 4b63 26d0 27e0 +4b63 4b8e 27df 27e0 +4b65 4b64 26d1 27e1 +4b64 4b8f 27e0 27e1 +4b66 4b65 26d2 27e2 +4b65 4b90 27e1 27e2 +4b67 4b66 26d3 27e3 +4b66 4b91 27e2 27e3 +4b67 4b92 27e3 27e4 +4b69 4b68 27ba 28ca +4b68 4b93 28c9 28ca +4b6a 4b69 27bb 28cb +4b69 4b94 28ca 28cb +4b6b 4b6a 27bc 28cc +4b6a 4b95 28cb 28cc +4b6c 4b6b 27bd 28cd +4b6b 4b96 28cc 28cd +4b6d 4b6c 27be 28ce +4b6c 4b97 28cd 28ce +4b6e 4b6d 27bf 28cf +4b6d 4b98 28ce 28cf +4b6f 4b6e 27c0 28d0 +4b6e 4b99 28cf 28d0 +4b70 4b6f 27c1 28d1 +4b6f 4b9a 28d0 28d1 +4b71 4b70 27c2 28d2 +4b70 4b9b 28d1 28d2 +4b72 4b71 27c3 28d3 +4b71 4b9c 28d2 28d3 +4b73 4b72 27c4 28d4 +4b72 4b9d 28d3 28d4 +4b74 4b73 27c5 28d5 +4b73 4b9e 28d4 28d5 +4b75 4b74 27c6 28d6 +4b74 4b9f 28d5 28d6 +4b76 4b75 27c7 28d7 +4b75 4ba0 28d6 28d7 +4b77 4b76 27c8 28d8 +4b76 4ba1 28d7 28d8 +4b78 4b77 27c9 28d9 +4b77 4ba2 28d8 28d9 +4b79 4b78 27ca 28da +4b78 4ba3 28d9 28da +4b7a 4b79 27cb 28db +4b79 4ba4 28da 28db +4b7b 4b7a 27cc 28dc +4b7a 4ba5 28db 28dc +4b7c 4b7b 27cd 28dd +4b7b 4ba6 28dc 28dd +4b7d 4b7c 27ce 28de +4b7c 4ba7 28dd 28de +4b7e 4b7d 27cf 28df +4b7d 4ba8 28de 28df +4b7f 4b7e 27d0 28e0 +4b7e 4ba9 28df 28e0 +4b80 4b7f 27d1 28e1 +4b7f 4baa 28e0 28e1 +4b81 4b80 27d2 28e2 +4b80 4bab 28e1 28e2 +4b82 4b81 27d3 28e3 +4b81 4bac 28e2 28e3 +4b83 4b82 27d4 28e4 +4b82 4bad 28e3 28e4 +4b84 4b83 27d5 28e5 +4b83 4bae 28e4 28e5 +4b85 4b84 27d6 28e6 +4b84 4baf 28e5 28e6 +4b86 4b85 27d7 28e7 +4b85 4bb0 28e6 28e7 +4b87 4b86 27d8 28e8 +4b86 4bb1 28e7 28e8 +4b88 4b87 27d9 28e9 +4b87 4bb2 28e8 28e9 +4b89 4b88 27da 28ea +4b88 4bb3 28e9 28ea +4b8a 4b89 27db 28eb +4b89 4bb4 28ea 28eb +4b8b 4b8a 27dc 28ec +4b8a 4bb5 28eb 28ec +4b8c 4b8b 27dd 28ed +4b8b 4bb6 28ec 28ed +4b8d 4b8c 27de 28ee +4b8c 4bb7 28ed 28ee +4b8e 4b8d 27df 28ef +4b8d 4bb8 28ee 28ef +4b8f 4b8e 27e0 28f0 +4b8e 4bb9 28ef 28f0 +4b90 4b8f 27e1 28f1 +4b8f 4bba 28f0 28f1 +4b91 4b90 27e2 28f2 +4b90 4bbb 28f1 28f2 +4b92 4b91 27e3 28f3 +4b91 4bbc 28f2 28f3 +4b92 4bbd 28f3 28f4 +4b94 4b93 28ca 29da +4b93 4bbe 29d9 29da +4b95 4b94 28cb 29db +4b94 4bbf 29da 29db +4b96 4b95 28cc 29dc +4b95 4bc0 29db 29dc +4b97 4b96 28cd 29dd +4b96 4bc1 29dc 29dd +4b98 4b97 28ce 29de +4b97 4bc2 29dd 29de +4b99 4b98 28cf 29df +4b98 4bc3 29de 29df +4b9a 4b99 28d0 29e0 +4b99 4bc4 29df 29e0 +4b9b 4b9a 28d1 29e1 +4b9a 4bc5 29e0 29e1 +4b9c 4b9b 28d2 29e2 +4b9b 4bc6 29e1 29e2 +4b9d 4b9c 28d3 29e3 +4b9c 4bc7 29e2 29e3 +4b9e 4b9d 28d4 29e4 +4b9d 4bc8 29e3 29e4 +4b9f 4b9e 28d5 29e5 +4b9e 4bc9 29e4 29e5 +4ba0 4b9f 28d6 29e6 +4b9f 4bca 29e5 29e6 +4ba1 4ba0 28d7 29e7 +4ba0 4bcb 29e6 29e7 +4ba2 4ba1 28d8 29e8 +4ba1 4bcc 29e7 29e8 +4ba3 4ba2 28d9 29e9 +4ba2 4bcd 29e8 29e9 +4ba4 4ba3 28da 29ea +4ba3 4bce 29e9 29ea +4ba5 4ba4 28db 29eb +4ba4 4bcf 29ea 29eb +4ba6 4ba5 28dc 29ec +4ba5 4bd0 29eb 29ec +4ba7 4ba6 28dd 29ed +4ba6 4bd1 29ec 29ed +4ba8 4ba7 28de 29ee +4ba7 4bd2 29ed 29ee +4ba9 4ba8 28df 29ef +4ba8 4bd3 29ee 29ef +4baa 4ba9 28e0 29f0 +4ba9 4bd4 29ef 29f0 +4bab 4baa 28e1 29f1 +4baa 4bd5 29f0 29f1 +4bac 4bab 28e2 29f2 +4bab 4bd6 29f1 29f2 +4bad 4bac 28e3 29f3 +4bac 4bd7 29f2 29f3 +4bae 4bad 28e4 29f4 +4bad 4bd8 29f3 29f4 +4baf 4bae 28e5 29f5 +4bae 4bd9 29f4 29f5 +4bb0 4baf 28e6 29f6 +4baf 4bda 29f5 29f6 +4bb1 4bb0 28e7 29f7 +4bb0 4bdb 29f6 29f7 +4bb2 4bb1 28e8 29f8 +4bb1 4bdc 29f7 29f8 +4bb3 4bb2 28e9 29f9 +4bb2 4bdd 29f8 29f9 +4bb4 4bb3 28ea 29fa +4bb3 4bde 29f9 29fa +4bb5 4bb4 28eb 29fb +4bb4 4bdf 29fa 29fb +4bb6 4bb5 28ec 29fc +4bb5 4be0 29fb 29fc +4bb7 4bb6 28ed 29fd +4bb6 4be1 29fc 29fd +4bb8 4bb7 28ee 29fe +4bb7 4be2 29fd 29fe +4bb9 4bb8 28ef 29ff +4bb8 4be3 29fe 29ff +4bba 4bb9 28f0 2a00 +4bb9 4be4 29ff 2a00 +4bbb 4bba 28f1 2a01 +4bba 4be5 2a00 2a01 +4bbc 4bbb 28f2 2a02 +4bbb 4be6 2a01 2a02 +4bbd 4bbc 28f3 2a03 +4bbc 4be7 2a02 2a03 +4bbd 4be8 2a03 2a04 +4bbf 4bbe 29da 2aea +4bbe 4be9 2ae9 2aea +4bc0 4bbf 29db 2aeb +4bbf 4bea 2aea 2aeb +4bc1 4bc0 29dc 2aec +4bc0 4beb 2aeb 2aec +4bc2 4bc1 29dd 2aed +4bc1 4bec 2aec 2aed +4bc3 4bc2 29de 2aee +4bc2 4bed 2aed 2aee +4bc4 4bc3 29df 2aef +4bc3 4bee 2aee 2aef +4bc5 4bc4 29e0 2af0 +4bc4 4bef 2aef 2af0 +4bc6 4bc5 29e1 2af1 +4bc5 4bf0 2af0 2af1 +4bc7 4bc6 29e2 2af2 +4bc6 4bf1 2af1 2af2 +4bc8 4bc7 29e3 2af3 +4bc7 4bf2 2af2 2af3 +4bc9 4bc8 29e4 2af4 +4bc8 4bf3 2af3 2af4 +4bca 4bc9 29e5 2af5 +4bc9 4bf4 2af4 2af5 +4bcb 4bca 29e6 2af6 +4bca 4bf5 2af5 2af6 +4bcc 4bcb 29e7 2af7 +4bcb 4bf6 2af6 2af7 +4bcd 4bcc 29e8 2af8 +4bcc 4bf7 2af7 2af8 +4bce 4bcd 29e9 2af9 +4bcd 4bf8 2af8 2af9 +4bcf 4bce 29ea 2afa +4bce 4bf9 2af9 2afa +4bd0 4bcf 29eb 2afb +4bcf 4bfa 2afa 2afb +4bd1 4bd0 29ec 2afc +4bd0 4bfb 2afb 2afc +4bd2 4bd1 29ed 2afd +4bd1 4bfc 2afc 2afd +4bd3 4bd2 29ee 2afe +4bd2 4bfd 2afd 2afe +4bd4 4bd3 29ef 2aff +4bd3 4bfe 2afe 2aff +4bd5 4bd4 29f0 2b00 +4bd4 4bff 2aff 2b00 +4bd6 4bd5 29f1 2b01 +4bd5 4c00 2b00 2b01 +4bd7 4bd6 29f2 2b02 +4bd6 4c01 2b01 2b02 +4bd8 4bd7 29f3 2b03 +4bd7 4c02 2b02 2b03 +4bd9 4bd8 29f4 2b04 +4bd8 4c03 2b03 2b04 +4bda 4bd9 29f5 2b05 +4bd9 4c04 2b04 2b05 +4bdb 4bda 29f6 2b06 +4bda 4c05 2b05 2b06 +4bdc 4bdb 29f7 2b07 +4bdb 4c06 2b06 2b07 +4bdd 4bdc 29f8 2b08 +4bdc 4c07 2b07 2b08 +4bde 4bdd 29f9 2b09 +4bdd 4c08 2b08 2b09 +4bdf 4bde 29fa 2b0a +4bde 4c09 2b09 2b0a +4be0 4bdf 29fb 2b0b +4bdf 4c0a 2b0a 2b0b +4be1 4be0 29fc 2b0c +4be0 4c0b 2b0b 2b0c +4be2 4be1 29fd 2b0d +4be1 4c0c 2b0c 2b0d +4be3 4be2 29fe 2b0e +4be2 4c0d 2b0d 2b0e +4be4 4be3 29ff 2b0f +4be3 4c0e 2b0e 2b0f +4be5 4be4 2a00 2b10 +4be4 4c0f 2b0f 2b10 +4be6 4be5 2a01 2b11 +4be5 4c10 2b10 2b11 +4be7 4be6 2a02 2b12 +4be6 4c11 2b11 2b12 +4be8 4be7 2a03 2b13 +4be7 4c12 2b12 2b13 +4be8 4c13 2b13 2b14 +4bea 4be9 2aea 2bfa +4be9 4c14 2bf9 2bfa +4beb 4bea 2aeb 2bfb +4bea 4c15 2bfa 2bfb +4bec 4beb 2aec 2bfc +4beb 4c16 2bfb 2bfc +4bed 4bec 2aed 2bfd +4bec 4c17 2bfc 2bfd +4bee 4bed 2aee 2bfe +4bed 4c18 2bfd 2bfe +4bef 4bee 2aef 2bff +4bee 4c19 2bfe 2bff +4bf0 4bef 2af0 2c00 +4bef 4c1a 2bff 2c00 +4bf1 4bf0 2af1 2c01 +4bf0 4c1b 2c00 2c01 +4bf2 4bf1 2af2 2c02 +4bf1 4c1c 2c01 2c02 +4bf3 4bf2 2af3 2c03 +4bf2 4c1d 2c02 2c03 +4bf4 4bf3 2af4 2c04 +4bf3 4c1e 2c03 2c04 +4bf5 4bf4 2af5 2c05 +4bf4 4c1f 2c04 2c05 +4bf6 4bf5 2af6 2c06 +4bf5 4c20 2c05 2c06 +4bf7 4bf6 2af7 2c07 +4bf6 4c21 2c06 2c07 +4bf8 4bf7 2af8 2c08 +4bf7 4c22 2c07 2c08 +4bf9 4bf8 2af9 2c09 +4bf8 4c23 2c08 2c09 +4bfa 4bf9 2afa 2c0a +4bf9 4c24 2c09 2c0a +4bfb 4bfa 2afb 2c0b +4bfa 4c25 2c0a 2c0b +4bfc 4bfb 2afc 2c0c +4bfb 4c26 2c0b 2c0c +4bfd 4bfc 2afd 2c0d +4bfc 4c27 2c0c 2c0d +4bfe 4bfd 2afe 2c0e +4bfd 4c28 2c0d 2c0e +4bff 4bfe 2aff 2c0f +4bfe 4c29 2c0e 2c0f +4c00 4bff 2b00 2c10 +4bff 4c2a 2c0f 2c10 +4c01 4c00 2b01 2c11 +4c00 4c2b 2c10 2c11 +4c02 4c01 2b02 2c12 +4c01 4c2c 2c11 2c12 +4c03 4c02 2b03 2c13 +4c02 4c2d 2c12 2c13 +4c04 4c03 2b04 2c14 +4c03 4c2e 2c13 2c14 +4c05 4c04 2b05 2c15 +4c04 4c2f 2c14 2c15 +4c06 4c05 2b06 2c16 +4c05 4c30 2c15 2c16 +4c07 4c06 2b07 2c17 +4c06 4c31 2c16 2c17 +4c08 4c07 2b08 2c18 +4c07 4c32 2c17 2c18 +4c09 4c08 2b09 2c19 +4c08 4c33 2c18 2c19 +4c0a 4c09 2b0a 2c1a +4c09 4c34 2c19 2c1a +4c0b 4c0a 2b0b 2c1b +4c0a 4c35 2c1a 2c1b +4c0c 4c0b 2b0c 2c1c +4c0b 4c36 2c1b 2c1c +4c0d 4c0c 2b0d 2c1d +4c0c 4c37 2c1c 2c1d +4c0e 4c0d 2b0e 2c1e +4c0d 4c38 2c1d 2c1e +4c0f 4c0e 2b0f 2c1f +4c0e 4c39 2c1e 2c1f +4c10 4c0f 2b10 2c20 +4c0f 4c3a 2c1f 2c20 +4c11 4c10 2b11 2c21 +4c10 4c3b 2c20 2c21 +4c12 4c11 2b12 2c22 +4c11 4c3c 2c21 2c22 +4c13 4c12 2b13 2c23 +4c12 4c3d 2c22 2c23 +4c13 4c3e 2c23 2c24 +4c15 4c14 2bfa 2d0a +4c14 4c3f 2d09 2d0a +4c16 4c15 2bfb 2d0b +4c15 4c40 2d0a 2d0b +4c17 4c16 2bfc 2d0c +4c16 4c41 2d0b 2d0c +4c18 4c17 2bfd 2d0d +4c17 4c42 2d0c 2d0d +4c19 4c18 2bfe 2d0e +4c18 4c43 2d0d 2d0e +4c1a 4c19 2bff 2d0f +4c19 4c44 2d0e 2d0f +4c1b 4c1a 2c00 2d10 +4c1a 4c45 2d0f 2d10 +4c1c 4c1b 2c01 2d11 +4c1b 4c46 2d10 2d11 +4c1d 4c1c 2c02 2d12 +4c1c 4c47 2d11 2d12 +4c1e 4c1d 2c03 2d13 +4c1d 4c48 2d12 2d13 +4c1f 4c1e 2c04 2d14 +4c1e 4c49 2d13 2d14 +4c20 4c1f 2c05 2d15 +4c1f 4c4a 2d14 2d15 +4c21 4c20 2c06 2d16 +4c20 4c4b 2d15 2d16 +4c22 4c21 2c07 2d17 +4c21 4c4c 2d16 2d17 +4c23 4c22 2c08 2d18 +4c22 4c4d 2d17 2d18 +4c24 4c23 2c09 2d19 +4c23 4c4e 2d18 2d19 +4c25 4c24 2c0a 2d1a +4c24 4c4f 2d19 2d1a +4c26 4c25 2c0b 2d1b +4c25 4c50 2d1a 2d1b +4c27 4c26 2c0c 2d1c +4c26 4c51 2d1b 2d1c +4c28 4c27 2c0d 2d1d +4c27 4c52 2d1c 2d1d +4c29 4c28 2c0e 2d1e +4c28 4c53 2d1d 2d1e +4c2a 4c29 2c0f 2d1f +4c29 4c54 2d1e 2d1f +4c2b 4c2a 2c10 2d20 +4c2a 4c55 2d1f 2d20 +4c2c 4c2b 2c11 2d21 +4c2b 4c56 2d20 2d21 +4c2d 4c2c 2c12 2d22 +4c2c 4c57 2d21 2d22 +4c2e 4c2d 2c13 2d23 +4c2d 4c58 2d22 2d23 +4c2f 4c2e 2c14 2d24 +4c2e 4c59 2d23 2d24 +4c30 4c2f 2c15 2d25 +4c2f 4c5a 2d24 2d25 +4c31 4c30 2c16 2d26 +4c30 4c5b 2d25 2d26 +4c32 4c31 2c17 2d27 +4c31 4c5c 2d26 2d27 +4c33 4c32 2c18 2d28 +4c32 4c5d 2d27 2d28 +4c34 4c33 2c19 2d29 +4c33 4c5e 2d28 2d29 +4c35 4c34 2c1a 2d2a +4c34 4c5f 2d29 2d2a +4c36 4c35 2c1b 2d2b +4c35 4c60 2d2a 2d2b +4c37 4c36 2c1c 2d2c +4c36 4c61 2d2b 2d2c +4c38 4c37 2c1d 2d2d +4c37 4c62 2d2c 2d2d +4c39 4c38 2c1e 2d2e +4c38 4c63 2d2d 2d2e +4c3a 4c39 2c1f 2d2f +4c39 4c64 2d2e 2d2f +4c3b 4c3a 2c20 2d30 +4c3a 4c65 2d2f 2d30 +4c3c 4c3b 2c21 2d31 +4c3b 4c66 2d30 2d31 +4c3d 4c3c 2c22 2d32 +4c3c 4c67 2d31 2d32 +4c3e 4c3d 2c23 2d33 +4c3d 4c68 2d32 2d33 +4c3e 4c69 2d33 2d34 +4c40 4c3f 2d0a 2e1a +4c3f 4c6a 2e19 2e1a +4c41 4c40 2d0b 2e1b +4c40 4c6b 2e1a 2e1b +4c42 4c41 2d0c 2e1c +4c41 4c6c 2e1b 2e1c +4c43 4c42 2d0d 2e1d +4c42 4c6d 2e1c 2e1d +4c44 4c43 2d0e 2e1e +4c43 4c6e 2e1d 2e1e +4c45 4c44 2d0f 2e1f +4c44 4c6f 2e1e 2e1f +4c46 4c45 2d10 2e20 +4c45 4c70 2e1f 2e20 +4c47 4c46 2d11 2e21 +4c46 4c71 2e20 2e21 +4c48 4c47 2d12 2e22 +4c47 4c72 2e21 2e22 +4c49 4c48 2d13 2e23 +4c48 4c73 2e22 2e23 +4c4a 4c49 2d14 2e24 +4c49 4c74 2e23 2e24 +4c4b 4c4a 2d15 2e25 +4c4a 4c75 2e24 2e25 +4c4c 4c4b 2d16 2e26 +4c4b 4c76 2e25 2e26 +4c4d 4c4c 2d17 2e27 +4c4c 4c77 2e26 2e27 +4c4e 4c4d 2d18 2e28 +4c4d 4c78 2e27 2e28 +4c4f 4c4e 2d19 2e29 +4c4e 4c79 2e28 2e29 +4c50 4c4f 2d1a 2e2a +4c4f 4c7a 2e29 2e2a +4c51 4c50 2d1b 2e2b +4c50 4c7b 2e2a 2e2b +4c52 4c51 2d1c 2e2c +4c51 4c7c 2e2b 2e2c +4c53 4c52 2d1d 2e2d +4c52 4c7d 2e2c 2e2d +4c54 4c53 2d1e 2e2e +4c53 4c7e 2e2d 2e2e +4c55 4c54 2d1f 2e2f +4c54 4c7f 2e2e 2e2f +4c56 4c55 2d20 2e30 +4c55 4c80 2e2f 2e30 +4c57 4c56 2d21 2e31 +4c56 4c81 2e30 2e31 +4c58 4c57 2d22 2e32 +4c57 4c82 2e31 2e32 +4c59 4c58 2d23 2e33 +4c58 4c83 2e32 2e33 +4c5a 4c59 2d24 2e34 +4c59 4c84 2e33 2e34 +4c5b 4c5a 2d25 2e35 +4c5a 4c85 2e34 2e35 +4c5c 4c5b 2d26 2e36 +4c5b 4c86 2e35 2e36 +4c5d 4c5c 2d27 2e37 +4c5c 4c87 2e36 2e37 +4c5e 4c5d 2d28 2e38 +4c5d 4c88 2e37 2e38 +4c5f 4c5e 2d29 2e39 +4c5e 4c89 2e38 2e39 +4c60 4c5f 2d2a 2e3a +4c5f 4c8a 2e39 2e3a +4c61 4c60 2d2b 2e3b +4c60 4c8b 2e3a 2e3b +4c62 4c61 2d2c 2e3c +4c61 4c8c 2e3b 2e3c +4c63 4c62 2d2d 2e3d +4c62 4c8d 2e3c 2e3d +4c64 4c63 2d2e 2e3e +4c63 4c8e 2e3d 2e3e +4c65 4c64 2d2f 2e3f +4c64 4c8f 2e3e 2e3f +4c66 4c65 2d30 2e40 +4c65 4c90 2e3f 2e40 +4c67 4c66 2d31 2e41 +4c66 4c91 2e40 2e41 +4c68 4c67 2d32 2e42 +4c67 4c92 2e41 2e42 +4c69 4c68 2d33 2e43 +4c68 4c93 2e42 2e43 +4c69 4c94 2e43 2e44 +4c6b 4c6a 2e1a 2f2a +4c6a 4c95 2f29 2f2a +4c6c 4c6b 2e1b 2f2b +4c6b 4c96 2f2a 2f2b +4c6d 4c6c 2e1c 2f2c +4c6c 4c97 2f2b 2f2c +4c6e 4c6d 2e1d 2f2d +4c6d 4c98 2f2c 2f2d +4c6f 4c6e 2e1e 2f2e +4c6e 4c99 2f2d 2f2e +4c70 4c6f 2e1f 2f2f +4c6f 4c9a 2f2e 2f2f +4c71 4c70 2e20 2f30 +4c70 4c9b 2f2f 2f30 +4c72 4c71 2e21 2f31 +4c71 4c9c 2f30 2f31 +4c73 4c72 2e22 2f32 +4c72 4c9d 2f31 2f32 +4c74 4c73 2e23 2f33 +4c73 4c9e 2f32 2f33 +4c75 4c74 2e24 2f34 +4c74 4c9f 2f33 2f34 +4c76 4c75 2e25 2f35 +4c75 4ca0 2f34 2f35 +4c77 4c76 2e26 2f36 +4c76 4ca1 2f35 2f36 +4c78 4c77 2e27 2f37 +4c77 4ca2 2f36 2f37 +4c79 4c78 2e28 2f38 +4c78 4ca3 2f37 2f38 +4c7a 4c79 2e29 2f39 +4c79 4ca4 2f38 2f39 +4c7b 4c7a 2e2a 2f3a +4c7a 4ca5 2f39 2f3a +4c7c 4c7b 2e2b 2f3b +4c7b 4ca6 2f3a 2f3b +4c7d 4c7c 2e2c 2f3c +4c7c 4ca7 2f3b 2f3c +4c7e 4c7d 2e2d 2f3d +4c7d 4ca8 2f3c 2f3d +4c7f 4c7e 2e2e 2f3e +4c7e 4ca9 2f3d 2f3e +4c80 4c7f 2e2f 2f3f +4c7f 4caa 2f3e 2f3f +4c81 4c80 2e30 2f40 +4c80 4cab 2f3f 2f40 +4c82 4c81 2e31 2f41 +4c81 4cac 2f40 2f41 +4c83 4c82 2e32 2f42 +4c82 4cad 2f41 2f42 +4c84 4c83 2e33 2f43 +4c83 4cae 2f42 2f43 +4c85 4c84 2e34 2f44 +4c84 4caf 2f43 2f44 +4c86 4c85 2e35 2f45 +4c85 4cb0 2f44 2f45 +4c87 4c86 2e36 2f46 +4c86 4cb1 2f45 2f46 +4c88 4c87 2e37 2f47 +4c87 4cb2 2f46 2f47 +4c89 4c88 2e38 2f48 +4c88 4cb3 2f47 2f48 +4c8a 4c89 2e39 2f49 +4c89 4cb4 2f48 2f49 +4c8b 4c8a 2e3a 2f4a +4c8a 4cb5 2f49 2f4a +4c8c 4c8b 2e3b 2f4b +4c8b 4cb6 2f4a 2f4b +4c8d 4c8c 2e3c 2f4c +4c8c 4cb7 2f4b 2f4c +4c8e 4c8d 2e3d 2f4d +4c8d 4cb8 2f4c 2f4d +4c8f 4c8e 2e3e 2f4e +4c8e 4cb9 2f4d 2f4e +4c90 4c8f 2e3f 2f4f +4c8f 4cba 2f4e 2f4f +4c91 4c90 2e40 2f50 +4c90 4cbb 2f4f 2f50 +4c92 4c91 2e41 2f51 +4c91 4cbc 2f50 2f51 +4c93 4c92 2e42 2f52 +4c92 4cbd 2f51 2f52 +4c94 4c93 2e43 2f53 +4c93 4cbe 2f52 2f53 +4c94 4cbf 2f53 2f54 +4c96 4c95 2f2a 303a +4c95 4cc0 3039 303a +4c97 4c96 2f2b 303b +4c96 4cc1 303a 303b +4c98 4c97 2f2c 303c +4c97 4cc2 303b 303c +4c99 4c98 2f2d 303d +4c98 4cc3 303c 303d +4c9a 4c99 2f2e 303e +4c99 4cc4 303d 303e +4c9b 4c9a 2f2f 303f +4c9a 4cc5 303e 303f +4c9c 4c9b 2f30 3040 +4c9b 4cc6 303f 3040 +4c9d 4c9c 2f31 3041 +4c9c 4cc7 3040 3041 +4c9e 4c9d 2f32 3042 +4c9d 4cc8 3041 3042 +4c9f 4c9e 2f33 3043 +4c9e 4cc9 3042 3043 +4ca0 4c9f 2f34 3044 +4c9f 4cca 3043 3044 +4ca1 4ca0 2f35 3045 +4ca0 4ccb 3044 3045 +4ca2 4ca1 2f36 3046 +4ca1 4ccc 3045 3046 +4ca3 4ca2 2f37 3047 +4ca2 4ccd 3046 3047 +4ca4 4ca3 2f38 3048 +4ca3 4cce 3047 3048 +4ca5 4ca4 2f39 3049 +4ca4 4ccf 3048 3049 +4ca6 4ca5 2f3a 304a +4ca5 4cd0 3049 304a +4ca7 4ca6 2f3b 304b +4ca6 4cd1 304a 304b +4ca8 4ca7 2f3c 304c +4ca7 4cd2 304b 304c +4ca9 4ca8 2f3d 304d +4ca8 4cd3 304c 304d +4caa 4ca9 2f3e 304e +4ca9 4cd4 304d 304e +4cab 4caa 2f3f 304f +4caa 4cd5 304e 304f +4cac 4cab 2f40 3050 +4cab 4cd6 304f 3050 +4cad 4cac 2f41 3051 +4cac 4cd7 3050 3051 +4cae 4cad 2f42 3052 +4cad 4cd8 3051 3052 +4caf 4cae 2f43 3053 +4cae 4cd9 3052 3053 +4cb0 4caf 2f44 3054 +4caf 4cda 3053 3054 +4cb1 4cb0 2f45 3055 +4cb0 4cdb 3054 3055 +4cb2 4cb1 2f46 3056 +4cb1 4cdc 3055 3056 +4cb3 4cb2 2f47 3057 +4cb2 4cdd 3056 3057 +4cb4 4cb3 2f48 3058 +4cb3 4cde 3057 3058 +4cb5 4cb4 2f49 3059 +4cb4 4cdf 3058 3059 +4cb6 4cb5 2f4a 305a +4cb5 4ce0 3059 305a +4cb7 4cb6 2f4b 305b +4cb6 4ce1 305a 305b +4cb8 4cb7 2f4c 305c +4cb7 4ce2 305b 305c +4cb9 4cb8 2f4d 305d +4cb8 4ce3 305c 305d +4cba 4cb9 2f4e 305e +4cb9 4ce4 305d 305e +4cbb 4cba 2f4f 305f +4cba 4ce5 305e 305f +4cbc 4cbb 2f50 3060 +4cbb 4ce6 305f 3060 +4cbd 4cbc 2f51 3061 +4cbc 4ce7 3060 3061 +4cbe 4cbd 2f52 3062 +4cbd 4ce8 3061 3062 +4cbf 4cbe 2f53 3063 +4cbe 4ce9 3062 3063 +4cbf 4cea 3063 3064 +4cc1 4cc0 303a 314a +4cc0 4ceb 3149 314a +4cc2 4cc1 303b 314b +4cc1 4cec 314a 314b +4cc3 4cc2 303c 314c +4cc2 4ced 314b 314c +4cc4 4cc3 303d 314d +4cc3 4cee 314c 314d +4cc5 4cc4 303e 314e +4cc4 4cef 314d 314e +4cc6 4cc5 303f 314f +4cc5 4cf0 314e 314f +4cc7 4cc6 3040 3150 +4cc6 4cf1 314f 3150 +4cc8 4cc7 3041 3151 +4cc7 4cf2 3150 3151 +4cc9 4cc8 3042 3152 +4cc8 4cf3 3151 3152 +4cca 4cc9 3043 3153 +4cc9 4cf4 3152 3153 +4ccb 4cca 3044 3154 +4cca 4cf5 3153 3154 +4ccc 4ccb 3045 3155 +4ccb 4cf6 3154 3155 +4ccd 4ccc 3046 3156 +4ccc 4cf7 3155 3156 +4cce 4ccd 3047 3157 +4ccd 4cf8 3156 3157 +4ccf 4cce 3048 3158 +4cce 4cf9 3157 3158 +4cd0 4ccf 3049 3159 +4ccf 4cfa 3158 3159 +4cd1 4cd0 304a 315a +4cd0 4cfb 3159 315a +4cd2 4cd1 304b 315b +4cd1 4cfc 315a 315b +4cd3 4cd2 304c 315c +4cd2 4cfd 315b 315c +4cd4 4cd3 304d 315d +4cd3 4cfe 315c 315d +4cd5 4cd4 304e 315e +4cd4 4cff 315d 315e +4cd6 4cd5 304f 315f +4cd5 4d00 315e 315f +4cd7 4cd6 3050 3160 +4cd6 4d01 315f 3160 +4cd8 4cd7 3051 3161 +4cd7 4d02 3160 3161 +4cd9 4cd8 3052 3162 +4cd8 4d03 3161 3162 +4cda 4cd9 3053 3163 +4cd9 4d04 3162 3163 +4cdb 4cda 3054 3164 +4cda 4d05 3163 3164 +4cdc 4cdb 3055 3165 +4cdb 4d06 3164 3165 +4cdd 4cdc 3056 3166 +4cdc 4d07 3165 3166 +4cde 4cdd 3057 3167 +4cdd 4d08 3166 3167 +4cdf 4cde 3058 3168 +4cde 4d09 3167 3168 +4ce0 4cdf 3059 3169 +4cdf 4d0a 3168 3169 +4ce1 4ce0 305a 316a +4ce0 4d0b 3169 316a +4ce2 4ce1 305b 316b +4ce1 4d0c 316a 316b +4ce3 4ce2 305c 316c +4ce2 4d0d 316b 316c +4ce4 4ce3 305d 316d +4ce3 4d0e 316c 316d +4ce5 4ce4 305e 316e +4ce4 4d0f 316d 316e +4ce6 4ce5 305f 316f +4ce5 4d10 316e 316f +4ce7 4ce6 3060 3170 +4ce6 4d11 316f 3170 +4ce8 4ce7 3061 3171 +4ce7 4d12 3170 3171 +4ce9 4ce8 3062 3172 +4ce8 4d13 3171 3172 +4cea 4ce9 3063 3173 +4ce9 4d14 3172 3173 +4cea 4d15 3173 3174 +4cec 4ceb 314a 325a +4ceb 4d16 3259 325a +4ced 4cec 314b 325b +4cec 4d17 325a 325b +4cee 4ced 314c 325c +4ced 4d18 325b 325c +4cef 4cee 314d 325d +4cee 4d19 325c 325d +4cf0 4cef 314e 325e +4cef 4d1a 325d 325e +4cf1 4cf0 314f 325f +4cf0 4d1b 325e 325f +4cf2 4cf1 3150 3260 +4cf1 4d1c 325f 3260 +4cf3 4cf2 3151 3261 +4cf2 4d1d 3260 3261 +4cf4 4cf3 3152 3262 +4cf3 4d1e 3261 3262 +4cf5 4cf4 3153 3263 +4cf4 4d1f 3262 3263 +4cf6 4cf5 3154 3264 +4cf5 4d20 3263 3264 +4cf7 4cf6 3155 3265 +4cf6 4d21 3264 3265 +4cf8 4cf7 3156 3266 +4cf7 4d22 3265 3266 +4cf9 4cf8 3157 3267 +4cf8 4d23 3266 3267 +4cfa 4cf9 3158 3268 +4cf9 4d24 3267 3268 +4cfb 4cfa 3159 3269 +4cfa 4d25 3268 3269 +4cfc 4cfb 315a 326a +4cfb 4d26 3269 326a +4cfd 4cfc 315b 326b +4cfc 4d27 326a 326b +4cfe 4cfd 315c 326c +4cfd 4d28 326b 326c +4cff 4cfe 315d 326d +4cfe 4d29 326c 326d +4d00 4cff 315e 326e +4cff 4d2a 326d 326e +4d01 4d00 315f 326f +4d00 4d2b 326e 326f +4d02 4d01 3160 3270 +4d01 4d2c 326f 3270 +4d03 4d02 3161 3271 +4d02 4d2d 3270 3271 +4d04 4d03 3162 3272 +4d03 4d2e 3271 3272 +4d05 4d04 3163 3273 +4d04 4d2f 3272 3273 +4d06 4d05 3164 3274 +4d05 4d30 3273 3274 +4d07 4d06 3165 3275 +4d06 4d31 3274 3275 +4d08 4d07 3166 3276 +4d07 4d32 3275 3276 +4d09 4d08 3167 3277 +4d08 4d33 3276 3277 +4d0a 4d09 3168 3278 +4d09 4d34 3277 3278 +4d0b 4d0a 3169 3279 +4d0a 4d35 3278 3279 +4d0c 4d0b 316a 327a +4d0b 4d36 3279 327a +4d0d 4d0c 316b 327b +4d0c 4d37 327a 327b +4d0e 4d0d 316c 327c +4d0d 4d38 327b 327c +4d0f 4d0e 316d 327d +4d0e 4d39 327c 327d +4d10 4d0f 316e 327e +4d0f 4d3a 327d 327e +4d11 4d10 316f 327f +4d10 4d3b 327e 327f +4d12 4d11 3170 3280 +4d11 4d3c 327f 3280 +4d13 4d12 3171 3281 +4d12 4d3d 3280 3281 +4d14 4d13 3172 3282 +4d13 4d3e 3281 3282 +4d15 4d14 3173 3283 +4d14 4d3f 3282 3283 +4d15 4d40 3283 3284 +4d17 4d16 325a 336a +4d16 4d41 3369 336a +4d18 4d17 325b 336b +4d17 4d42 336a 336b +4d19 4d18 325c 336c +4d18 4d43 336b 336c +4d1a 4d19 325d 336d +4d19 4d44 336c 336d +4d1b 4d1a 325e 336e +4d1a 4d45 336d 336e +4d1c 4d1b 325f 336f +4d1b 4d46 336e 336f +4d1d 4d1c 3260 3370 +4d1c 4d47 336f 3370 +4d1e 4d1d 3261 3371 +4d1d 4d48 3370 3371 +4d1f 4d1e 3262 3372 +4d1e 4d49 3371 3372 +4d20 4d1f 3263 3373 +4d1f 4d4a 3372 3373 +4d21 4d20 3264 3374 +4d20 4d4b 3373 3374 +4d22 4d21 3265 3375 +4d21 4d4c 3374 3375 +4d23 4d22 3266 3376 +4d22 4d4d 3375 3376 +4d24 4d23 3267 3377 +4d23 4d4e 3376 3377 +4d25 4d24 3268 3378 +4d24 4d4f 3377 3378 +4d26 4d25 3269 3379 +4d25 4d50 3378 3379 +4d27 4d26 326a 337a +4d26 4d51 3379 337a +4d28 4d27 326b 337b +4d27 4d52 337a 337b +4d29 4d28 326c 337c +4d28 4d53 337b 337c +4d2a 4d29 326d 337d +4d29 4d54 337c 337d +4d2b 4d2a 326e 337e +4d2a 4d55 337d 337e +4d2c 4d2b 326f 337f +4d2b 4d56 337e 337f +4d2d 4d2c 3270 3380 +4d2c 4d57 337f 3380 +4d2e 4d2d 3271 3381 +4d2d 4d58 3380 3381 +4d2f 4d2e 3272 3382 +4d2e 4d59 3381 3382 +4d30 4d2f 3273 3383 +4d2f 4d5a 3382 3383 +4d31 4d30 3274 3384 +4d30 4d5b 3383 3384 +4d32 4d31 3275 3385 +4d31 4d5c 3384 3385 +4d33 4d32 3276 3386 +4d32 4d5d 3385 3386 +4d34 4d33 3277 3387 +4d33 4d5e 3386 3387 +4d35 4d34 3278 3388 +4d34 4d5f 3387 3388 +4d36 4d35 3279 3389 +4d35 4d60 3388 3389 +4d37 4d36 327a 338a +4d36 4d61 3389 338a +4d38 4d37 327b 338b +4d37 4d62 338a 338b +4d39 4d38 327c 338c +4d38 4d63 338b 338c +4d3a 4d39 327d 338d +4d39 4d64 338c 338d +4d3b 4d3a 327e 338e +4d3a 4d65 338d 338e +4d3c 4d3b 327f 338f +4d3b 4d66 338e 338f +4d3d 4d3c 3280 3390 +4d3c 4d67 338f 3390 +4d3e 4d3d 3281 3391 +4d3d 4d68 3390 3391 +4d3f 4d3e 3282 3392 +4d3e 4d69 3391 3392 +4d40 4d3f 3283 3393 +4d3f 4d6a 3392 3393 +4d40 4d6b 3393 3394 +4d42 4d41 336a 347a +4d41 4d6c 3479 347a +4d43 4d42 336b 347b +4d42 4d6d 347a 347b +4d44 4d43 336c 347c +4d43 4d6e 347b 347c +4d45 4d44 336d 347d +4d44 4d6f 347c 347d +4d46 4d45 336e 347e +4d45 4d70 347d 347e +4d47 4d46 336f 347f +4d46 4d71 347e 347f +4d48 4d47 3370 3480 +4d47 4d72 347f 3480 +4d49 4d48 3371 3481 +4d48 4d73 3480 3481 +4d4a 4d49 3372 3482 +4d49 4d74 3481 3482 +4d4b 4d4a 3373 3483 +4d4a 4d75 3482 3483 +4d4c 4d4b 3374 3484 +4d4b 4d76 3483 3484 +4d4d 4d4c 3375 3485 +4d4c 4d77 3484 3485 +4d4e 4d4d 3376 3486 +4d4d 4d78 3485 3486 +4d4f 4d4e 3377 3487 +4d4e 4d79 3486 3487 +4d50 4d4f 3378 3488 +4d4f 4d7a 3487 3488 +4d51 4d50 3379 3489 +4d50 4d7b 3488 3489 +4d52 4d51 337a 348a +4d51 4d7c 3489 348a +4d53 4d52 337b 348b +4d52 4d7d 348a 348b +4d54 4d53 337c 348c +4d53 4d7e 348b 348c +4d55 4d54 337d 348d +4d54 4d7f 348c 348d +4d56 4d55 337e 348e +4d55 4d80 348d 348e +4d57 4d56 337f 348f +4d56 4d81 348e 348f +4d58 4d57 3380 3490 +4d57 4d82 348f 3490 +4d59 4d58 3381 3491 +4d58 4d83 3490 3491 +4d5a 4d59 3382 3492 +4d59 4d84 3491 3492 +4d5b 4d5a 3383 3493 +4d5a 4d85 3492 3493 +4d5c 4d5b 3384 3494 +4d5b 4d86 3493 3494 +4d5d 4d5c 3385 3495 +4d5c 4d87 3494 3495 +4d5e 4d5d 3386 3496 +4d5d 4d88 3495 3496 +4d5f 4d5e 3387 3497 +4d5e 4d89 3496 3497 +4d60 4d5f 3388 3498 +4d5f 4d8a 3497 3498 +4d61 4d60 3389 3499 +4d60 4d8b 3498 3499 +4d62 4d61 338a 349a +4d61 4d8c 3499 349a +4d63 4d62 338b 349b +4d62 4d8d 349a 349b +4d64 4d63 338c 349c +4d63 4d8e 349b 349c +4d65 4d64 338d 349d +4d64 4d8f 349c 349d +4d66 4d65 338e 349e +4d65 4d90 349d 349e +4d67 4d66 338f 349f +4d66 4d91 349e 349f +4d68 4d67 3390 34a0 +4d67 4d92 349f 34a0 +4d69 4d68 3391 34a1 +4d68 4d93 34a0 34a1 +4d6a 4d69 3392 34a2 +4d69 4d94 34a1 34a2 +4d6b 4d6a 3393 34a3 +4d6a 4d95 34a2 34a3 +4d6b 4d96 34a3 34a4 +4d6d 4d6c 347a 358a +4d6e 4d6d 347b 358b +4d6f 4d6e 347c 358c +4d70 4d6f 347d 358d +4d71 4d70 347e 358e +4d72 4d71 347f 358f +4d73 4d72 3480 3590 +4d74 4d73 3481 3591 +4d75 4d74 3482 3592 +4d76 4d75 3483 3593 +4d77 4d76 3484 3594 +4d78 4d77 3485 3595 +4d79 4d78 3486 3596 +4d7a 4d79 3487 3597 +4d7b 4d7a 3488 3598 +4d7c 4d7b 3489 3599 +4d7d 4d7c 348a 359a +4d7e 4d7d 348b 359b +4d7f 4d7e 348c 359c +4d80 4d7f 348d 359d +4d81 4d80 348e 359e +4d82 4d81 348f 359f +4d83 4d82 3490 35a0 +4d84 4d83 3491 35a1 +4d85 4d84 3492 35a2 +4d86 4d85 3493 35a3 +4d87 4d86 3494 35a4 +4d88 4d87 3495 35a5 +4d89 4d88 3496 35a6 +4d8a 4d89 3497 35a7 +4d8b 4d8a 3498 35a8 +4d8c 4d8b 3499 35a9 +4d8d 4d8c 349a 35aa +4d8e 4d8d 349b 35ab +4d8f 4d8e 349c 35ac +4d90 4d8f 349d 35ad +4d91 4d90 349e 35ae +4d92 4d91 349f 35af +4d93 4d92 34a0 35b0 +4d94 4d93 34a1 35b1 +4d95 4d94 34a2 35b2 +4d96 4d95 34a3 35b3 +4d97 4d98 1277 1278 +4d97 4db9 1167 1277 +4d98 4d99 1387 1388 +4d98 4dba 1277 1387 +4d99 4d9a 1497 1498 +4d99 4dbb 1387 1497 +4d9a 4d9b 15a7 15a8 +4d9a 4dbc 1497 15a7 +4d9b 4d9c 16b7 16b8 +4d9b 4dbd 15a7 16b7 +4d9c 4d9d 17c7 17c8 +4d9c 4dbe 16b7 17c7 +4d9d 4d9e 18d7 18d8 +4d9d 4dbf 17c7 18d7 +4d9e 4d9f 19e7 19e8 +4d9e 4dc0 18d7 19e7 +4d9f 4da0 1af7 1af8 +4d9f 4dc1 19e7 1af7 +4da0 4da1 1c07 1c08 +4da0 4dc2 1af7 1c07 +4da1 4da2 1d17 1d18 +4da1 4dc3 1c07 1d17 +4da2 4da3 1e27 1e28 +4da2 4dc4 1d17 1e27 +4da3 4da4 1f37 1f38 +4da3 4dc5 1e27 1f37 +4da4 4da5 2047 2048 +4da4 4dc6 1f37 2047 +4da5 4da6 2157 2158 +4da5 4dc7 2047 2157 +4da6 4da7 2267 2268 +4da6 4dc8 2157 2267 +4da7 4da8 2377 2378 +4da7 4dc9 2267 2377 +4da8 4da9 2487 2488 +4da8 4dca 2377 2487 +4da9 4daa 2597 2598 +4da9 4dcb 2487 2597 +4daa 4dab 26a7 26a8 +4daa 4dcc 2597 26a7 +4dab 4dac 27b7 27b8 +4dab 4dcd 26a7 27b7 +4dac 4dad 28c7 28c8 +4dac 4dce 27b7 28c7 +4dad 4dae 29d7 29d8 +4dad 4dcf 28c7 29d7 +4dae 4daf 2ae7 2ae8 +4dae 4dd0 29d7 2ae7 +4daf 4db0 2bf7 2bf8 +4daf 4dd1 2ae7 2bf7 +4db0 4db1 2d07 2d08 +4db0 4dd2 2bf7 2d07 +4db1 4db2 2e17 2e18 +4db1 4dd3 2d07 2e17 +4db2 4db3 2f27 2f28 +4db2 4dd4 2e17 2f27 +4db3 4db4 3037 3038 +4db3 4dd5 2f27 3037 +4db4 4db5 3147 3148 +4db4 4dd6 3037 3147 +4db5 4db6 3257 3258 +4db5 4dd7 3147 3257 +4db6 4db7 3367 3368 +4db6 4dd8 3257 3367 +4db7 4db8 3477 3478 +4db7 4dd9 3367 3477 +4db8 4dda 3477 3587 +4db9 4dba 1276 1277 +4db9 4ddb 1166 1276 +4dba 4dbb 1386 1387 +4dba 4ddc 1276 1386 +4dbb 4dbc 1496 1497 +4dbb 4ddd 1386 1496 +4dbc 4dbd 15a6 15a7 +4dbc 4dde 1496 15a6 +4dbd 4dbe 16b6 16b7 +4dbd 4ddf 15a6 16b6 +4dbe 4dbf 17c6 17c7 +4dbe 4de0 16b6 17c6 +4dbf 4dc0 18d6 18d7 +4dbf 4de1 17c6 18d6 +4dc0 4dc1 19e6 19e7 +4dc0 4de2 18d6 19e6 +4dc1 4dc2 1af6 1af7 +4dc1 4de3 19e6 1af6 +4dc2 4dc3 1c06 1c07 +4dc2 4de4 1af6 1c06 +4dc3 4dc4 1d16 1d17 +4dc3 4de5 1c06 1d16 +4dc4 4dc5 1e26 1e27 +4dc4 4de6 1d16 1e26 +4dc5 4dc6 1f36 1f37 +4dc5 4de7 1e26 1f36 +4dc6 4dc7 2046 2047 +4dc6 4de8 1f36 2046 +4dc7 4dc8 2156 2157 +4dc7 4de9 2046 2156 +4dc8 4dc9 2266 2267 +4dc8 4dea 2156 2266 +4dc9 4dca 2376 2377 +4dc9 4deb 2266 2376 +4dca 4dcb 2486 2487 +4dca 4dec 2376 2486 +4dcb 4dcc 2596 2597 +4dcb 4ded 2486 2596 +4dcc 4dcd 26a6 26a7 +4dcc 4dee 2596 26a6 +4dcd 4dce 27b6 27b7 +4dcd 4def 26a6 27b6 +4dce 4dcf 28c6 28c7 +4dce 4df0 27b6 28c6 +4dcf 4dd0 29d6 29d7 +4dcf 4df1 28c6 29d6 +4dd0 4dd1 2ae6 2ae7 +4dd0 4df2 29d6 2ae6 +4dd1 4dd2 2bf6 2bf7 +4dd1 4df3 2ae6 2bf6 +4dd2 4dd3 2d06 2d07 +4dd2 4df4 2bf6 2d06 +4dd3 4dd4 2e16 2e17 +4dd3 4df5 2d06 2e16 +4dd4 4dd5 2f26 2f27 +4dd4 4df6 2e16 2f26 +4dd5 4dd6 3036 3037 +4dd5 4df7 2f26 3036 +4dd6 4dd7 3146 3147 +4dd6 4df8 3036 3146 +4dd7 4dd8 3256 3257 +4dd7 4df9 3146 3256 +4dd8 4dd9 3366 3367 +4dd8 4dfa 3256 3366 +4dd9 4dda 3476 3477 +4dd9 4dfb 3366 3476 +4dda 4dfc 3476 3586 +4ddb 4ddc 1275 1276 +4ddb 4dfd 1165 1275 +4ddc 4ddd 1385 1386 +4ddc 4dfe 1275 1385 +4ddd 4dde 1495 1496 +4ddd 4dff 1385 1495 +4dde 4ddf 15a5 15a6 +4dde 4e00 1495 15a5 +4ddf 4de0 16b5 16b6 +4ddf 4e01 15a5 16b5 +4de0 4de1 17c5 17c6 +4de0 4e02 16b5 17c5 +4de1 4de2 18d5 18d6 +4de1 4e03 17c5 18d5 +4de2 4de3 19e5 19e6 +4de2 4e04 18d5 19e5 +4de3 4de4 1af5 1af6 +4de3 4e05 19e5 1af5 +4de4 4de5 1c05 1c06 +4de4 4e06 1af5 1c05 +4de5 4de6 1d15 1d16 +4de5 4e07 1c05 1d15 +4de6 4de7 1e25 1e26 +4de6 4e08 1d15 1e25 +4de7 4de8 1f35 1f36 +4de7 4e09 1e25 1f35 +4de8 4de9 2045 2046 +4de8 4e0a 1f35 2045 +4de9 4dea 2155 2156 +4de9 4e0b 2045 2155 +4dea 4deb 2265 2266 +4dea 4e0c 2155 2265 +4deb 4dec 2375 2376 +4deb 4e0d 2265 2375 +4dec 4ded 2485 2486 +4dec 4e0e 2375 2485 +4ded 4dee 2595 2596 +4ded 4e0f 2485 2595 +4dee 4def 26a5 26a6 +4dee 4e10 2595 26a5 +4def 4df0 27b5 27b6 +4def 4e11 26a5 27b5 +4df0 4df1 28c5 28c6 +4df0 4e12 27b5 28c5 +4df1 4df2 29d5 29d6 +4df1 4e13 28c5 29d5 +4df2 4df3 2ae5 2ae6 +4df2 4e14 29d5 2ae5 +4df3 4df4 2bf5 2bf6 +4df3 4e15 2ae5 2bf5 +4df4 4df5 2d05 2d06 +4df4 4e16 2bf5 2d05 +4df5 4df6 2e15 2e16 +4df5 4e17 2d05 2e15 +4df6 4df7 2f25 2f26 +4df6 4e18 2e15 2f25 +4df7 4df8 3035 3036 +4df7 4e19 2f25 3035 +4df8 4df9 3145 3146 +4df8 4e1a 3035 3145 +4df9 4dfa 3255 3256 +4df9 4e1b 3145 3255 +4dfa 4dfb 3365 3366 +4dfa 4e1c 3255 3365 +4dfb 4dfc 3475 3476 +4dfb 4e1d 3365 3475 +4dfc 4e1e 3475 3585 +4dfd 4dfe 1274 1275 +4dfd 4e1f 1164 1274 +4dfe 4dff 1384 1385 +4dfe 4e20 1274 1384 +4dff 4e00 1494 1495 +4dff 4e21 1384 1494 +4e00 4e01 15a4 15a5 +4e00 4e22 1494 15a4 +4e01 4e02 16b4 16b5 +4e01 4e23 15a4 16b4 +4e02 4e03 17c4 17c5 +4e02 4e24 16b4 17c4 +4e03 4e04 18d4 18d5 +4e03 4e25 17c4 18d4 +4e04 4e05 19e4 19e5 +4e04 4e26 18d4 19e4 +4e05 4e06 1af4 1af5 +4e05 4e27 19e4 1af4 +4e06 4e07 1c04 1c05 +4e06 4e28 1af4 1c04 +4e07 4e08 1d14 1d15 +4e07 4e29 1c04 1d14 +4e08 4e09 1e24 1e25 +4e08 4e2a 1d14 1e24 +4e09 4e0a 1f34 1f35 +4e09 4e2b 1e24 1f34 +4e0a 4e0b 2044 2045 +4e0a 4e2c 1f34 2044 +4e0b 4e0c 2154 2155 +4e0b 4e2d 2044 2154 +4e0c 4e0d 2264 2265 +4e0c 4e2e 2154 2264 +4e0d 4e0e 2374 2375 +4e0d 4e2f 2264 2374 +4e0e 4e0f 2484 2485 +4e0e 4e30 2374 2484 +4e0f 4e10 2594 2595 +4e0f 4e31 2484 2594 +4e10 4e11 26a4 26a5 +4e10 4e32 2594 26a4 +4e11 4e12 27b4 27b5 +4e11 4e33 26a4 27b4 +4e12 4e13 28c4 28c5 +4e12 4e34 27b4 28c4 +4e13 4e14 29d4 29d5 +4e13 4e35 28c4 29d4 +4e14 4e15 2ae4 2ae5 +4e14 4e36 29d4 2ae4 +4e15 4e16 2bf4 2bf5 +4e15 4e37 2ae4 2bf4 +4e16 4e17 2d04 2d05 +4e16 4e38 2bf4 2d04 +4e17 4e18 2e14 2e15 +4e17 4e39 2d04 2e14 +4e18 4e19 2f24 2f25 +4e18 4e3a 2e14 2f24 +4e19 4e1a 3034 3035 +4e19 4e3b 2f24 3034 +4e1a 4e1b 3144 3145 +4e1a 4e3c 3034 3144 +4e1b 4e1c 3254 3255 +4e1b 4e3d 3144 3254 +4e1c 4e1d 3364 3365 +4e1c 4e3e 3254 3364 +4e1d 4e1e 3474 3475 +4e1d 4e3f 3364 3474 +4e1e 4e40 3474 3584 +4e1f 4e20 1273 1274 +4e1f 4e41 1163 1273 +4e20 4e21 1383 1384 +4e20 4e42 1273 1383 +4e21 4e22 1493 1494 +4e21 4e43 1383 1493 +4e22 4e23 15a3 15a4 +4e22 4e44 1493 15a3 +4e23 4e24 16b3 16b4 +4e23 4e45 15a3 16b3 +4e24 4e25 17c3 17c4 +4e24 4e46 16b3 17c3 +4e25 4e26 18d3 18d4 +4e25 4e47 17c3 18d3 +4e26 4e27 19e3 19e4 +4e26 4e48 18d3 19e3 +4e27 4e28 1af3 1af4 +4e27 4e49 19e3 1af3 +4e28 4e29 1c03 1c04 +4e28 4e4a 1af3 1c03 +4e29 4e2a 1d13 1d14 +4e29 4e4b 1c03 1d13 +4e2a 4e2b 1e23 1e24 +4e2a 4e4c 1d13 1e23 +4e2b 4e2c 1f33 1f34 +4e2b 4e4d 1e23 1f33 +4e2c 4e2d 2043 2044 +4e2c 4e4e 1f33 2043 +4e2d 4e2e 2153 2154 +4e2d 4e4f 2043 2153 +4e2e 4e2f 2263 2264 +4e2e 4e50 2153 2263 +4e2f 4e30 2373 2374 +4e2f 4e51 2263 2373 +4e30 4e31 2483 2484 +4e30 4e52 2373 2483 +4e31 4e32 2593 2594 +4e31 4e53 2483 2593 +4e32 4e33 26a3 26a4 +4e32 4e54 2593 26a3 +4e33 4e34 27b3 27b4 +4e33 4e55 26a3 27b3 +4e34 4e35 28c3 28c4 +4e34 4e56 27b3 28c3 +4e35 4e36 29d3 29d4 +4e35 4e57 28c3 29d3 +4e36 4e37 2ae3 2ae4 +4e36 4e58 29d3 2ae3 +4e37 4e38 2bf3 2bf4 +4e37 4e59 2ae3 2bf3 +4e38 4e39 2d03 2d04 +4e38 4e5a 2bf3 2d03 +4e39 4e3a 2e13 2e14 +4e39 4e5b 2d03 2e13 +4e3a 4e3b 2f23 2f24 +4e3a 4e5c 2e13 2f23 +4e3b 4e3c 3033 3034 +4e3b 4e5d 2f23 3033 +4e3c 4e3d 3143 3144 +4e3c 4e5e 3033 3143 +4e3d 4e3e 3253 3254 +4e3d 4e5f 3143 3253 +4e3e 4e3f 3363 3364 +4e3e 4e60 3253 3363 +4e3f 4e40 3473 3474 +4e3f 4e61 3363 3473 +4e40 4e62 3473 3583 +4e41 4e42 1272 1273 +4e41 4e63 1162 1272 +4e42 4e43 1382 1383 +4e42 4e64 1272 1382 +4e43 4e44 1492 1493 +4e43 4e65 1382 1492 +4e44 4e45 15a2 15a3 +4e44 4e66 1492 15a2 +4e45 4e46 16b2 16b3 +4e45 4e67 15a2 16b2 +4e46 4e47 17c2 17c3 +4e46 4e68 16b2 17c2 +4e47 4e48 18d2 18d3 +4e47 4e69 17c2 18d2 +4e48 4e49 19e2 19e3 +4e48 4e6a 18d2 19e2 +4e49 4e4a 1af2 1af3 +4e49 4e6b 19e2 1af2 +4e4a 4e4b 1c02 1c03 +4e4a 4e6c 1af2 1c02 +4e4b 4e4c 1d12 1d13 +4e4b 4e6d 1c02 1d12 +4e4c 4e4d 1e22 1e23 +4e4c 4e6e 1d12 1e22 +4e4d 4e4e 1f32 1f33 +4e4d 4e6f 1e22 1f32 +4e4e 4e4f 2042 2043 +4e4e 4e70 1f32 2042 +4e4f 4e50 2152 2153 +4e4f 4e71 2042 2152 +4e50 4e51 2262 2263 +4e50 4e72 2152 2262 +4e51 4e52 2372 2373 +4e51 4e73 2262 2372 +4e52 4e53 2482 2483 +4e52 4e74 2372 2482 +4e53 4e54 2592 2593 +4e53 4e75 2482 2592 +4e54 4e55 26a2 26a3 +4e54 4e76 2592 26a2 +4e55 4e56 27b2 27b3 +4e55 4e77 26a2 27b2 +4e56 4e57 28c2 28c3 +4e56 4e78 27b2 28c2 +4e57 4e58 29d2 29d3 +4e57 4e79 28c2 29d2 +4e58 4e59 2ae2 2ae3 +4e58 4e7a 29d2 2ae2 +4e59 4e5a 2bf2 2bf3 +4e59 4e7b 2ae2 2bf2 +4e5a 4e5b 2d02 2d03 +4e5a 4e7c 2bf2 2d02 +4e5b 4e5c 2e12 2e13 +4e5b 4e7d 2d02 2e12 +4e5c 4e5d 2f22 2f23 +4e5c 4e7e 2e12 2f22 +4e5d 4e5e 3032 3033 +4e5d 4e7f 2f22 3032 +4e5e 4e5f 3142 3143 +4e5e 4e80 3032 3142 +4e5f 4e60 3252 3253 +4e5f 4e81 3142 3252 +4e60 4e61 3362 3363 +4e60 4e82 3252 3362 +4e61 4e62 3472 3473 +4e61 4e83 3362 3472 +4e62 4e84 3472 3582 +4e63 4e64 1271 1272 +4e63 4e85 1161 1271 +4e64 4e65 1381 1382 +4e64 4e86 1271 1381 +4e65 4e66 1491 1492 +4e65 4e87 1381 1491 +4e66 4e67 15a1 15a2 +4e66 4e88 1491 15a1 +4e67 4e68 16b1 16b2 +4e67 4e89 15a1 16b1 +4e68 4e69 17c1 17c2 +4e68 4e8a 16b1 17c1 +4e69 4e6a 18d1 18d2 +4e69 4e8b 17c1 18d1 +4e6a 4e6b 19e1 19e2 +4e6a 4e8c 18d1 19e1 +4e6b 4e6c 1af1 1af2 +4e6b 4e8d 19e1 1af1 +4e6c 4e6d 1c01 1c02 +4e6c 4e8e 1af1 1c01 +4e6d 4e6e 1d11 1d12 +4e6d 4e8f 1c01 1d11 +4e6e 4e6f 1e21 1e22 +4e6e 4e90 1d11 1e21 +4e6f 4e70 1f31 1f32 +4e6f 4e91 1e21 1f31 +4e70 4e71 2041 2042 +4e70 4e92 1f31 2041 +4e71 4e72 2151 2152 +4e71 4e93 2041 2151 +4e72 4e73 2261 2262 +4e72 4e94 2151 2261 +4e73 4e74 2371 2372 +4e73 4e95 2261 2371 +4e74 4e75 2481 2482 +4e74 4e96 2371 2481 +4e75 4e76 2591 2592 +4e75 4e97 2481 2591 +4e76 4e77 26a1 26a2 +4e76 4e98 2591 26a1 +4e77 4e78 27b1 27b2 +4e77 4e99 26a1 27b1 +4e78 4e79 28c1 28c2 +4e78 4e9a 27b1 28c1 +4e79 4e7a 29d1 29d2 +4e79 4e9b 28c1 29d1 +4e7a 4e7b 2ae1 2ae2 +4e7a 4e9c 29d1 2ae1 +4e7b 4e7c 2bf1 2bf2 +4e7b 4e9d 2ae1 2bf1 +4e7c 4e7d 2d01 2d02 +4e7c 4e9e 2bf1 2d01 +4e7d 4e7e 2e11 2e12 +4e7d 4e9f 2d01 2e11 +4e7e 4e7f 2f21 2f22 +4e7e 4ea0 2e11 2f21 +4e7f 4e80 3031 3032 +4e7f 4ea1 2f21 3031 +4e80 4e81 3141 3142 +4e80 4ea2 3031 3141 +4e81 4e82 3251 3252 +4e81 4ea3 3141 3251 +4e82 4e83 3361 3362 +4e82 4ea4 3251 3361 +4e83 4e84 3471 3472 +4e83 4ea5 3361 3471 +4e84 4ea6 3471 3581 +4e85 4e86 1270 1271 +4e85 4ea7 1160 1270 +4e86 4e87 1380 1381 +4e86 4ea8 1270 1380 +4e87 4e88 1490 1491 +4e87 4ea9 1380 1490 +4e88 4e89 15a0 15a1 +4e88 4eaa 1490 15a0 +4e89 4e8a 16b0 16b1 +4e89 4eab 15a0 16b0 +4e8a 4e8b 17c0 17c1 +4e8a 4eac 16b0 17c0 +4e8b 4e8c 18d0 18d1 +4e8b 4ead 17c0 18d0 +4e8c 4e8d 19e0 19e1 +4e8c 4eae 18d0 19e0 +4e8d 4e8e 1af0 1af1 +4e8d 4eaf 19e0 1af0 +4e8e 4e8f 1c00 1c01 +4e8e 4eb0 1af0 1c00 +4e8f 4e90 1d10 1d11 +4e8f 4eb1 1c00 1d10 +4e90 4e91 1e20 1e21 +4e90 4eb2 1d10 1e20 +4e91 4e92 1f30 1f31 +4e91 4eb3 1e20 1f30 +4e92 4e93 2040 2041 +4e92 4eb4 1f30 2040 +4e93 4e94 2150 2151 +4e93 4eb5 2040 2150 +4e94 4e95 2260 2261 +4e94 4eb6 2150 2260 +4e95 4e96 2370 2371 +4e95 4eb7 2260 2370 +4e96 4e97 2480 2481 +4e96 4eb8 2370 2480 +4e97 4e98 2590 2591 +4e97 4eb9 2480 2590 +4e98 4e99 26a0 26a1 +4e98 4eba 2590 26a0 +4e99 4e9a 27b0 27b1 +4e99 4ebb 26a0 27b0 +4e9a 4e9b 28c0 28c1 +4e9a 4ebc 27b0 28c0 +4e9b 4e9c 29d0 29d1 +4e9b 4ebd 28c0 29d0 +4e9c 4e9d 2ae0 2ae1 +4e9c 4ebe 29d0 2ae0 +4e9d 4e9e 2bf0 2bf1 +4e9d 4ebf 2ae0 2bf0 +4e9e 4e9f 2d00 2d01 +4e9e 4ec0 2bf0 2d00 +4e9f 4ea0 2e10 2e11 +4e9f 4ec1 2d00 2e10 +4ea0 4ea1 2f20 2f21 +4ea0 4ec2 2e10 2f20 +4ea1 4ea2 3030 3031 +4ea1 4ec3 2f20 3030 +4ea2 4ea3 3140 3141 +4ea2 4ec4 3030 3140 +4ea3 4ea4 3250 3251 +4ea3 4ec5 3140 3250 +4ea4 4ea5 3360 3361 +4ea4 4ec6 3250 3360 +4ea5 4ea6 3470 3471 +4ea5 4ec7 3360 3470 +4ea6 4ec8 3470 3580 +4ea7 4ea8 126f 1270 +4ea7 4ec9 115f 126f +4ea8 4ea9 137f 1380 +4ea8 4eca 126f 137f +4ea9 4eaa 148f 1490 +4ea9 4ecb 137f 148f +4eaa 4eab 159f 15a0 +4eaa 4ecc 148f 159f +4eab 4eac 16af 16b0 +4eab 4ecd 159f 16af +4eac 4ead 17bf 17c0 +4eac 4ece 16af 17bf +4ead 4eae 18cf 18d0 +4ead 4ecf 17bf 18cf +4eae 4eaf 19df 19e0 +4eae 4ed0 18cf 19df +4eaf 4eb0 1aef 1af0 +4eaf 4ed1 19df 1aef +4eb0 4eb1 1bff 1c00 +4eb0 4ed2 1aef 1bff +4eb1 4eb2 1d0f 1d10 +4eb1 4ed3 1bff 1d0f +4eb2 4eb3 1e1f 1e20 +4eb2 4ed4 1d0f 1e1f +4eb3 4eb4 1f2f 1f30 +4eb3 4ed5 1e1f 1f2f +4eb4 4eb5 203f 2040 +4eb4 4ed6 1f2f 203f +4eb5 4eb6 214f 2150 +4eb5 4ed7 203f 214f +4eb6 4eb7 225f 2260 +4eb6 4ed8 214f 225f +4eb7 4eb8 236f 2370 +4eb7 4ed9 225f 236f +4eb8 4eb9 247f 2480 +4eb8 4eda 236f 247f +4eb9 4eba 258f 2590 +4eb9 4edb 247f 258f +4eba 4ebb 269f 26a0 +4eba 4edc 258f 269f +4ebb 4ebc 27af 27b0 +4ebb 4edd 269f 27af +4ebc 4ebd 28bf 28c0 +4ebc 4ede 27af 28bf +4ebd 4ebe 29cf 29d0 +4ebd 4edf 28bf 29cf +4ebe 4ebf 2adf 2ae0 +4ebe 4ee0 29cf 2adf +4ebf 4ec0 2bef 2bf0 +4ebf 4ee1 2adf 2bef +4ec0 4ec1 2cff 2d00 +4ec0 4ee2 2bef 2cff +4ec1 4ec2 2e0f 2e10 +4ec1 4ee3 2cff 2e0f +4ec2 4ec3 2f1f 2f20 +4ec2 4ee4 2e0f 2f1f +4ec3 4ec4 302f 3030 +4ec3 4ee5 2f1f 302f +4ec4 4ec5 313f 3140 +4ec4 4ee6 302f 313f +4ec5 4ec6 324f 3250 +4ec5 4ee7 313f 324f +4ec6 4ec7 335f 3360 +4ec6 4ee8 324f 335f +4ec7 4ec8 346f 3470 +4ec7 4ee9 335f 346f +4ec8 4eea 346f 357f +4ec9 4eca 126e 126f +4ec9 4eeb 115e 126e +4eca 4ecb 137e 137f +4eca 4eec 126e 137e +4ecb 4ecc 148e 148f +4ecb 4eed 137e 148e +4ecc 4ecd 159e 159f +4ecc 4eee 148e 159e +4ecd 4ece 16ae 16af +4ecd 4eef 159e 16ae +4ece 4ecf 17be 17bf +4ece 4ef0 16ae 17be +4ecf 4ed0 18ce 18cf +4ecf 4ef1 17be 18ce +4ed0 4ed1 19de 19df +4ed0 4ef2 18ce 19de +4ed1 4ed2 1aee 1aef +4ed1 4ef3 19de 1aee +4ed2 4ed3 1bfe 1bff +4ed2 4ef4 1aee 1bfe +4ed3 4ed4 1d0e 1d0f +4ed3 4ef5 1bfe 1d0e +4ed4 4ed5 1e1e 1e1f +4ed4 4ef6 1d0e 1e1e +4ed5 4ed6 1f2e 1f2f +4ed5 4ef7 1e1e 1f2e +4ed6 4ed7 203e 203f +4ed6 4ef8 1f2e 203e +4ed7 4ed8 214e 214f +4ed7 4ef9 203e 214e +4ed8 4ed9 225e 225f +4ed8 4efa 214e 225e +4ed9 4eda 236e 236f +4ed9 4efb 225e 236e +4eda 4edb 247e 247f +4eda 4efc 236e 247e +4edb 4edc 258e 258f +4edb 4efd 247e 258e +4edc 4edd 269e 269f +4edc 4efe 258e 269e +4edd 4ede 27ae 27af +4edd 4eff 269e 27ae +4ede 4edf 28be 28bf +4ede 4f00 27ae 28be +4edf 4ee0 29ce 29cf +4edf 4f01 28be 29ce +4ee0 4ee1 2ade 2adf +4ee0 4f02 29ce 2ade +4ee1 4ee2 2bee 2bef +4ee1 4f03 2ade 2bee +4ee2 4ee3 2cfe 2cff +4ee2 4f04 2bee 2cfe +4ee3 4ee4 2e0e 2e0f +4ee3 4f05 2cfe 2e0e +4ee4 4ee5 2f1e 2f1f +4ee4 4f06 2e0e 2f1e +4ee5 4ee6 302e 302f +4ee5 4f07 2f1e 302e +4ee6 4ee7 313e 313f +4ee6 4f08 302e 313e +4ee7 4ee8 324e 324f +4ee7 4f09 313e 324e +4ee8 4ee9 335e 335f +4ee8 4f0a 324e 335e +4ee9 4eea 346e 346f +4ee9 4f0b 335e 346e +4eea 4f0c 346e 357e +4eeb 4eec 126d 126e +4eeb 4f0d 115d 126d +4eec 4eed 137d 137e +4eec 4f0e 126d 137d +4eed 4eee 148d 148e +4eed 4f0f 137d 148d +4eee 4eef 159d 159e +4eee 4f10 148d 159d +4eef 4ef0 16ad 16ae +4eef 4f11 159d 16ad +4ef0 4ef1 17bd 17be +4ef0 4f12 16ad 17bd +4ef1 4ef2 18cd 18ce +4ef1 4f13 17bd 18cd +4ef2 4ef3 19dd 19de +4ef2 4f14 18cd 19dd +4ef3 4ef4 1aed 1aee +4ef3 4f15 19dd 1aed +4ef4 4ef5 1bfd 1bfe +4ef4 4f16 1aed 1bfd +4ef5 4ef6 1d0d 1d0e +4ef5 4f17 1bfd 1d0d +4ef6 4ef7 1e1d 1e1e +4ef6 4f18 1d0d 1e1d +4ef7 4ef8 1f2d 1f2e +4ef7 4f19 1e1d 1f2d +4ef8 4ef9 203d 203e +4ef8 4f1a 1f2d 203d +4ef9 4efa 214d 214e +4ef9 4f1b 203d 214d +4efa 4efb 225d 225e +4efa 4f1c 214d 225d +4efb 4efc 236d 236e +4efb 4f1d 225d 236d +4efc 4efd 247d 247e +4efc 4f1e 236d 247d +4efd 4efe 258d 258e +4efd 4f1f 247d 258d +4efe 4eff 269d 269e +4efe 4f20 258d 269d +4eff 4f00 27ad 27ae +4eff 4f21 269d 27ad +4f00 4f01 28bd 28be +4f00 4f22 27ad 28bd +4f01 4f02 29cd 29ce +4f01 4f23 28bd 29cd +4f02 4f03 2add 2ade +4f02 4f24 29cd 2add +4f03 4f04 2bed 2bee +4f03 4f25 2add 2bed +4f04 4f05 2cfd 2cfe +4f04 4f26 2bed 2cfd +4f05 4f06 2e0d 2e0e +4f05 4f27 2cfd 2e0d +4f06 4f07 2f1d 2f1e +4f06 4f28 2e0d 2f1d +4f07 4f08 302d 302e +4f07 4f29 2f1d 302d +4f08 4f09 313d 313e +4f08 4f2a 302d 313d +4f09 4f0a 324d 324e +4f09 4f2b 313d 324d +4f0a 4f0b 335d 335e +4f0a 4f2c 324d 335d +4f0b 4f0c 346d 346e +4f0b 4f2d 335d 346d +4f0c 4f2e 346d 357d +4f0d 4f0e 126c 126d +4f0d 4f2f 115c 126c +4f0e 4f0f 137c 137d +4f0e 4f30 126c 137c +4f0f 4f10 148c 148d +4f0f 4f31 137c 148c +4f10 4f11 159c 159d +4f10 4f32 148c 159c +4f11 4f12 16ac 16ad +4f11 4f33 159c 16ac +4f12 4f13 17bc 17bd +4f12 4f34 16ac 17bc +4f13 4f14 18cc 18cd +4f13 4f35 17bc 18cc +4f14 4f15 19dc 19dd +4f14 4f36 18cc 19dc +4f15 4f16 1aec 1aed +4f15 4f37 19dc 1aec +4f16 4f17 1bfc 1bfd +4f16 4f38 1aec 1bfc +4f17 4f18 1d0c 1d0d +4f17 4f39 1bfc 1d0c +4f18 4f19 1e1c 1e1d +4f18 4f3a 1d0c 1e1c +4f19 4f1a 1f2c 1f2d +4f19 4f3b 1e1c 1f2c +4f1a 4f1b 203c 203d +4f1a 4f3c 1f2c 203c +4f1b 4f1c 214c 214d +4f1b 4f3d 203c 214c +4f1c 4f1d 225c 225d +4f1c 4f3e 214c 225c +4f1d 4f1e 236c 236d +4f1d 4f3f 225c 236c +4f1e 4f1f 247c 247d +4f1e 4f40 236c 247c +4f1f 4f20 258c 258d +4f1f 4f41 247c 258c +4f20 4f21 269c 269d +4f20 4f42 258c 269c +4f21 4f22 27ac 27ad +4f21 4f43 269c 27ac +4f22 4f23 28bc 28bd +4f22 4f44 27ac 28bc +4f23 4f24 29cc 29cd +4f23 4f45 28bc 29cc +4f24 4f25 2adc 2add +4f24 4f46 29cc 2adc +4f25 4f26 2bec 2bed +4f25 4f47 2adc 2bec +4f26 4f27 2cfc 2cfd +4f26 4f48 2bec 2cfc +4f27 4f28 2e0c 2e0d +4f27 4f49 2cfc 2e0c +4f28 4f29 2f1c 2f1d +4f28 4f4a 2e0c 2f1c +4f29 4f2a 302c 302d +4f29 4f4b 2f1c 302c +4f2a 4f2b 313c 313d +4f2a 4f4c 302c 313c +4f2b 4f2c 324c 324d +4f2b 4f4d 313c 324c +4f2c 4f2d 335c 335d +4f2c 4f4e 324c 335c +4f2d 4f2e 346c 346d +4f2d 4f4f 335c 346c +4f2e 4f50 346c 357c +4f2f 4f30 126b 126c +4f2f 4f51 115b 126b +4f30 4f31 137b 137c +4f30 4f52 126b 137b +4f31 4f32 148b 148c +4f31 4f53 137b 148b +4f32 4f33 159b 159c +4f32 4f54 148b 159b +4f33 4f34 16ab 16ac +4f33 4f55 159b 16ab +4f34 4f35 17bb 17bc +4f34 4f56 16ab 17bb +4f35 4f36 18cb 18cc +4f35 4f57 17bb 18cb +4f36 4f37 19db 19dc +4f36 4f58 18cb 19db +4f37 4f38 1aeb 1aec +4f37 4f59 19db 1aeb +4f38 4f39 1bfb 1bfc +4f38 4f5a 1aeb 1bfb +4f39 4f3a 1d0b 1d0c +4f39 4f5b 1bfb 1d0b +4f3a 4f3b 1e1b 1e1c +4f3a 4f5c 1d0b 1e1b +4f3b 4f3c 1f2b 1f2c +4f3b 4f5d 1e1b 1f2b +4f3c 4f3d 203b 203c +4f3c 4f5e 1f2b 203b +4f3d 4f3e 214b 214c +4f3d 4f5f 203b 214b +4f3e 4f3f 225b 225c +4f3e 4f60 214b 225b +4f3f 4f40 236b 236c +4f3f 4f61 225b 236b +4f40 4f41 247b 247c +4f40 4f62 236b 247b +4f41 4f42 258b 258c +4f41 4f63 247b 258b +4f42 4f43 269b 269c +4f42 4f64 258b 269b +4f43 4f44 27ab 27ac +4f43 4f65 269b 27ab +4f44 4f45 28bb 28bc +4f44 4f66 27ab 28bb +4f45 4f46 29cb 29cc +4f45 4f67 28bb 29cb +4f46 4f47 2adb 2adc +4f46 4f68 29cb 2adb +4f47 4f48 2beb 2bec +4f47 4f69 2adb 2beb +4f48 4f49 2cfb 2cfc +4f48 4f6a 2beb 2cfb +4f49 4f4a 2e0b 2e0c +4f49 4f6b 2cfb 2e0b +4f4a 4f4b 2f1b 2f1c +4f4a 4f6c 2e0b 2f1b +4f4b 4f4c 302b 302c +4f4b 4f6d 2f1b 302b +4f4c 4f4d 313b 313c +4f4c 4f6e 302b 313b +4f4d 4f4e 324b 324c +4f4d 4f6f 313b 324b +4f4e 4f4f 335b 335c +4f4e 4f70 324b 335b +4f4f 4f50 346b 346c +4f4f 4f71 335b 346b +4f50 4f72 346b 357b +4f51 4f52 126a 126b +4f51 4f73 115a 126a +4f52 4f53 137a 137b +4f52 4f74 126a 137a +4f53 4f54 148a 148b +4f53 4f75 137a 148a +4f54 4f55 159a 159b +4f54 4f76 148a 159a +4f55 4f56 16aa 16ab +4f55 4f77 159a 16aa +4f56 4f57 17ba 17bb +4f56 4f78 16aa 17ba +4f57 4f58 18ca 18cb +4f57 4f79 17ba 18ca +4f58 4f59 19da 19db +4f58 4f7a 18ca 19da +4f59 4f5a 1aea 1aeb +4f59 4f7b 19da 1aea +4f5a 4f5b 1bfa 1bfb +4f5a 4f7c 1aea 1bfa +4f5b 4f5c 1d0a 1d0b +4f5b 4f7d 1bfa 1d0a +4f5c 4f5d 1e1a 1e1b +4f5c 4f7e 1d0a 1e1a +4f5d 4f5e 1f2a 1f2b +4f5d 4f7f 1e1a 1f2a +4f5e 4f5f 203a 203b +4f5e 4f80 1f2a 203a +4f5f 4f60 214a 214b +4f5f 4f81 203a 214a +4f60 4f61 225a 225b +4f60 4f82 214a 225a +4f61 4f62 236a 236b +4f61 4f83 225a 236a +4f62 4f63 247a 247b +4f62 4f84 236a 247a +4f63 4f64 258a 258b +4f63 4f85 247a 258a +4f64 4f65 269a 269b +4f64 4f86 258a 269a +4f65 4f66 27aa 27ab +4f65 4f87 269a 27aa +4f66 4f67 28ba 28bb +4f66 4f88 27aa 28ba +4f67 4f68 29ca 29cb +4f67 4f89 28ba 29ca +4f68 4f69 2ada 2adb +4f68 4f8a 29ca 2ada +4f69 4f6a 2bea 2beb +4f69 4f8b 2ada 2bea +4f6a 4f6b 2cfa 2cfb +4f6a 4f8c 2bea 2cfa +4f6b 4f6c 2e0a 2e0b +4f6b 4f8d 2cfa 2e0a +4f6c 4f6d 2f1a 2f1b +4f6c 4f8e 2e0a 2f1a +4f6d 4f6e 302a 302b +4f6d 4f8f 2f1a 302a +4f6e 4f6f 313a 313b +4f6e 4f90 302a 313a +4f6f 4f70 324a 324b +4f6f 4f91 313a 324a +4f70 4f71 335a 335b +4f70 4f92 324a 335a +4f71 4f72 346a 346b +4f71 4f93 335a 346a +4f72 4f94 346a 357a +4f73 4f74 1269 126a +4f73 4f95 1159 1269 +4f74 4f75 1379 137a +4f74 4f96 1269 1379 +4f75 4f76 1489 148a +4f75 4f97 1379 1489 +4f76 4f77 1599 159a +4f76 4f98 1489 1599 +4f77 4f78 16a9 16aa +4f77 4f99 1599 16a9 +4f78 4f79 17b9 17ba +4f78 4f9a 16a9 17b9 +4f79 4f7a 18c9 18ca +4f79 4f9b 17b9 18c9 +4f7a 4f7b 19d9 19da +4f7a 4f9c 18c9 19d9 +4f7b 4f7c 1ae9 1aea +4f7b 4f9d 19d9 1ae9 +4f7c 4f7d 1bf9 1bfa +4f7c 4f9e 1ae9 1bf9 +4f7d 4f7e 1d09 1d0a +4f7d 4f9f 1bf9 1d09 +4f7e 4f7f 1e19 1e1a +4f7e 4fa0 1d09 1e19 +4f7f 4f80 1f29 1f2a +4f7f 4fa1 1e19 1f29 +4f80 4f81 2039 203a +4f80 4fa2 1f29 2039 +4f81 4f82 2149 214a +4f81 4fa3 2039 2149 +4f82 4f83 2259 225a +4f82 4fa4 2149 2259 +4f83 4f84 2369 236a +4f83 4fa5 2259 2369 +4f84 4f85 2479 247a +4f84 4fa6 2369 2479 +4f85 4f86 2589 258a +4f85 4fa7 2479 2589 +4f86 4f87 2699 269a +4f86 4fa8 2589 2699 +4f87 4f88 27a9 27aa +4f87 4fa9 2699 27a9 +4f88 4f89 28b9 28ba +4f88 4faa 27a9 28b9 +4f89 4f8a 29c9 29ca +4f89 4fab 28b9 29c9 +4f8a 4f8b 2ad9 2ada +4f8a 4fac 29c9 2ad9 +4f8b 4f8c 2be9 2bea +4f8b 4fad 2ad9 2be9 +4f8c 4f8d 2cf9 2cfa +4f8c 4fae 2be9 2cf9 +4f8d 4f8e 2e09 2e0a +4f8d 4faf 2cf9 2e09 +4f8e 4f8f 2f19 2f1a +4f8e 4fb0 2e09 2f19 +4f8f 4f90 3029 302a +4f8f 4fb1 2f19 3029 +4f90 4f91 3139 313a +4f90 4fb2 3029 3139 +4f91 4f92 3249 324a +4f91 4fb3 3139 3249 +4f92 4f93 3359 335a +4f92 4fb4 3249 3359 +4f93 4f94 3469 346a +4f93 4fb5 3359 3469 +4f94 4fb6 3469 3579 +4f95 4f96 1268 1269 +4f95 4fb7 1158 1268 +4f96 4f97 1378 1379 +4f96 4fb8 1268 1378 +4f97 4f98 1488 1489 +4f97 4fb9 1378 1488 +4f98 4f99 1598 1599 +4f98 4fba 1488 1598 +4f99 4f9a 16a8 16a9 +4f99 4fbb 1598 16a8 +4f9a 4f9b 17b8 17b9 +4f9a 4fbc 16a8 17b8 +4f9b 4f9c 18c8 18c9 +4f9b 4fbd 17b8 18c8 +4f9c 4f9d 19d8 19d9 +4f9c 4fbe 18c8 19d8 +4f9d 4f9e 1ae8 1ae9 +4f9d 4fbf 19d8 1ae8 +4f9e 4f9f 1bf8 1bf9 +4f9e 4fc0 1ae8 1bf8 +4f9f 4fa0 1d08 1d09 +4f9f 4fc1 1bf8 1d08 +4fa0 4fa1 1e18 1e19 +4fa0 4fc2 1d08 1e18 +4fa1 4fa2 1f28 1f29 +4fa1 4fc3 1e18 1f28 +4fa2 4fa3 2038 2039 +4fa2 4fc4 1f28 2038 +4fa3 4fa4 2148 2149 +4fa3 4fc5 2038 2148 +4fa4 4fa5 2258 2259 +4fa4 4fc6 2148 2258 +4fa5 4fa6 2368 2369 +4fa5 4fc7 2258 2368 +4fa6 4fa7 2478 2479 +4fa6 4fc8 2368 2478 +4fa7 4fa8 2588 2589 +4fa7 4fc9 2478 2588 +4fa8 4fa9 2698 2699 +4fa8 4fca 2588 2698 +4fa9 4faa 27a8 27a9 +4fa9 4fcb 2698 27a8 +4faa 4fab 28b8 28b9 +4faa 4fcc 27a8 28b8 +4fab 4fac 29c8 29c9 +4fab 4fcd 28b8 29c8 +4fac 4fad 2ad8 2ad9 +4fac 4fce 29c8 2ad8 +4fad 4fae 2be8 2be9 +4fad 4fcf 2ad8 2be8 +4fae 4faf 2cf8 2cf9 +4fae 4fd0 2be8 2cf8 +4faf 4fb0 2e08 2e09 +4faf 4fd1 2cf8 2e08 +4fb0 4fb1 2f18 2f19 +4fb0 4fd2 2e08 2f18 +4fb1 4fb2 3028 3029 +4fb1 4fd3 2f18 3028 +4fb2 4fb3 3138 3139 +4fb2 4fd4 3028 3138 +4fb3 4fb4 3248 3249 +4fb3 4fd5 3138 3248 +4fb4 4fb5 3358 3359 +4fb4 4fd6 3248 3358 +4fb5 4fb6 3468 3469 +4fb5 4fd7 3358 3468 +4fb6 4fd8 3468 3578 +4fb7 4fb8 1267 1268 +4fb7 4fd9 1157 1267 +4fb8 4fb9 1377 1378 +4fb8 4fda 1267 1377 +4fb9 4fba 1487 1488 +4fb9 4fdb 1377 1487 +4fba 4fbb 1597 1598 +4fba 4fdc 1487 1597 +4fbb 4fbc 16a7 16a8 +4fbb 4fdd 1597 16a7 +4fbc 4fbd 17b7 17b8 +4fbc 4fde 16a7 17b7 +4fbd 4fbe 18c7 18c8 +4fbd 4fdf 17b7 18c7 +4fbe 4fbf 19d7 19d8 +4fbe 4fe0 18c7 19d7 +4fbf 4fc0 1ae7 1ae8 +4fbf 4fe1 19d7 1ae7 +4fc0 4fc1 1bf7 1bf8 +4fc0 4fe2 1ae7 1bf7 +4fc1 4fc2 1d07 1d08 +4fc1 4fe3 1bf7 1d07 +4fc2 4fc3 1e17 1e18 +4fc2 4fe4 1d07 1e17 +4fc3 4fc4 1f27 1f28 +4fc3 4fe5 1e17 1f27 +4fc4 4fc5 2037 2038 +4fc4 4fe6 1f27 2037 +4fc5 4fc6 2147 2148 +4fc5 4fe7 2037 2147 +4fc6 4fc7 2257 2258 +4fc6 4fe8 2147 2257 +4fc7 4fc8 2367 2368 +4fc7 4fe9 2257 2367 +4fc8 4fc9 2477 2478 +4fc8 4fea 2367 2477 +4fc9 4fca 2587 2588 +4fc9 4feb 2477 2587 +4fca 4fcb 2697 2698 +4fca 4fec 2587 2697 +4fcb 4fcc 27a7 27a8 +4fcb 4fed 2697 27a7 +4fcc 4fcd 28b7 28b8 +4fcc 4fee 27a7 28b7 +4fcd 4fce 29c7 29c8 +4fcd 4fef 28b7 29c7 +4fce 4fcf 2ad7 2ad8 +4fce 4ff0 29c7 2ad7 +4fcf 4fd0 2be7 2be8 +4fcf 4ff1 2ad7 2be7 +4fd0 4fd1 2cf7 2cf8 +4fd0 4ff2 2be7 2cf7 +4fd1 4fd2 2e07 2e08 +4fd1 4ff3 2cf7 2e07 +4fd2 4fd3 2f17 2f18 +4fd2 4ff4 2e07 2f17 +4fd3 4fd4 3027 3028 +4fd3 4ff5 2f17 3027 +4fd4 4fd5 3137 3138 +4fd4 4ff6 3027 3137 +4fd5 4fd6 3247 3248 +4fd5 4ff7 3137 3247 +4fd6 4fd7 3357 3358 +4fd6 4ff8 3247 3357 +4fd7 4fd8 3467 3468 +4fd7 4ff9 3357 3467 +4fd8 4ffa 3467 3577 +4fd9 4fda 1266 1267 +4fd9 4ffb 1156 1266 +4fda 4fdb 1376 1377 +4fda 4ffc 1266 1376 +4fdb 4fdc 1486 1487 +4fdb 4ffd 1376 1486 +4fdc 4fdd 1596 1597 +4fdc 4ffe 1486 1596 +4fdd 4fde 16a6 16a7 +4fdd 4fff 1596 16a6 +4fde 4fdf 17b6 17b7 +4fde 5000 16a6 17b6 +4fdf 4fe0 18c6 18c7 +4fdf 5001 17b6 18c6 +4fe0 4fe1 19d6 19d7 +4fe0 5002 18c6 19d6 +4fe1 4fe2 1ae6 1ae7 +4fe1 5003 19d6 1ae6 +4fe2 4fe3 1bf6 1bf7 +4fe2 5004 1ae6 1bf6 +4fe3 4fe4 1d06 1d07 +4fe3 5005 1bf6 1d06 +4fe4 4fe5 1e16 1e17 +4fe4 5006 1d06 1e16 +4fe5 4fe6 1f26 1f27 +4fe5 5007 1e16 1f26 +4fe6 4fe7 2036 2037 +4fe6 5008 1f26 2036 +4fe7 4fe8 2146 2147 +4fe7 5009 2036 2146 +4fe8 4fe9 2256 2257 +4fe8 500a 2146 2256 +4fe9 4fea 2366 2367 +4fe9 500b 2256 2366 +4fea 4feb 2476 2477 +4fea 500c 2366 2476 +4feb 4fec 2586 2587 +4feb 500d 2476 2586 +4fec 4fed 2696 2697 +4fec 500e 2586 2696 +4fed 4fee 27a6 27a7 +4fed 500f 2696 27a6 +4fee 4fef 28b6 28b7 +4fee 5010 27a6 28b6 +4fef 4ff0 29c6 29c7 +4fef 5011 28b6 29c6 +4ff0 4ff1 2ad6 2ad7 +4ff0 5012 29c6 2ad6 +4ff1 4ff2 2be6 2be7 +4ff1 5013 2ad6 2be6 +4ff2 4ff3 2cf6 2cf7 +4ff2 5014 2be6 2cf6 +4ff3 4ff4 2e06 2e07 +4ff3 5015 2cf6 2e06 +4ff4 4ff5 2f16 2f17 +4ff4 5016 2e06 2f16 +4ff5 4ff6 3026 3027 +4ff5 5017 2f16 3026 +4ff6 4ff7 3136 3137 +4ff6 5018 3026 3136 +4ff7 4ff8 3246 3247 +4ff7 5019 3136 3246 +4ff8 4ff9 3356 3357 +4ff8 501a 3246 3356 +4ff9 4ffa 3466 3467 +4ff9 501b 3356 3466 +4ffa 501c 3466 3576 +4ffb 4ffc 1265 1266 +4ffb 501d 1155 1265 +4ffc 4ffd 1375 1376 +4ffc 501e 1265 1375 +4ffd 4ffe 1485 1486 +4ffd 501f 1375 1485 +4ffe 4fff 1595 1596 +4ffe 5020 1485 1595 +4fff 5000 16a5 16a6 +4fff 5021 1595 16a5 +5000 5001 17b5 17b6 +5000 5022 16a5 17b5 +5001 5002 18c5 18c6 +5001 5023 17b5 18c5 +5002 5003 19d5 19d6 +5002 5024 18c5 19d5 +5003 5004 1ae5 1ae6 +5003 5025 19d5 1ae5 +5004 5005 1bf5 1bf6 +5004 5026 1ae5 1bf5 +5005 5006 1d05 1d06 +5005 5027 1bf5 1d05 +5006 5007 1e15 1e16 +5006 5028 1d05 1e15 +5007 5008 1f25 1f26 +5007 5029 1e15 1f25 +5008 5009 2035 2036 +5008 502a 1f25 2035 +5009 500a 2145 2146 +5009 502b 2035 2145 +500a 500b 2255 2256 +500a 502c 2145 2255 +500b 500c 2365 2366 +500b 502d 2255 2365 +500c 500d 2475 2476 +500c 502e 2365 2475 +500d 500e 2585 2586 +500d 502f 2475 2585 +500e 500f 2695 2696 +500e 5030 2585 2695 +500f 5010 27a5 27a6 +500f 5031 2695 27a5 +5010 5011 28b5 28b6 +5010 5032 27a5 28b5 +5011 5012 29c5 29c6 +5011 5033 28b5 29c5 +5012 5013 2ad5 2ad6 +5012 5034 29c5 2ad5 +5013 5014 2be5 2be6 +5013 5035 2ad5 2be5 +5014 5015 2cf5 2cf6 +5014 5036 2be5 2cf5 +5015 5016 2e05 2e06 +5015 5037 2cf5 2e05 +5016 5017 2f15 2f16 +5016 5038 2e05 2f15 +5017 5018 3025 3026 +5017 5039 2f15 3025 +5018 5019 3135 3136 +5018 503a 3025 3135 +5019 501a 3245 3246 +5019 503b 3135 3245 +501a 501b 3355 3356 +501a 503c 3245 3355 +501b 501c 3465 3466 +501b 503d 3355 3465 +501c 503e 3465 3575 +501d 501e 1264 1265 +501d 503f 1154 1264 +501e 501f 1374 1375 +501e 5040 1264 1374 +501f 5020 1484 1485 +501f 5041 1374 1484 +5020 5021 1594 1595 +5020 5042 1484 1594 +5021 5022 16a4 16a5 +5021 5043 1594 16a4 +5022 5023 17b4 17b5 +5022 5044 16a4 17b4 +5023 5024 18c4 18c5 +5023 5045 17b4 18c4 +5024 5025 19d4 19d5 +5024 5046 18c4 19d4 +5025 5026 1ae4 1ae5 +5025 5047 19d4 1ae4 +5026 5027 1bf4 1bf5 +5026 5048 1ae4 1bf4 +5027 5028 1d04 1d05 +5027 5049 1bf4 1d04 +5028 5029 1e14 1e15 +5028 504a 1d04 1e14 +5029 502a 1f24 1f25 +5029 504b 1e14 1f24 +502a 502b 2034 2035 +502a 504c 1f24 2034 +502b 502c 2144 2145 +502b 504d 2034 2144 +502c 502d 2254 2255 +502c 504e 2144 2254 +502d 502e 2364 2365 +502d 504f 2254 2364 +502e 502f 2474 2475 +502e 5050 2364 2474 +502f 5030 2584 2585 +502f 5051 2474 2584 +5030 5031 2694 2695 +5030 5052 2584 2694 +5031 5032 27a4 27a5 +5031 5053 2694 27a4 +5032 5033 28b4 28b5 +5032 5054 27a4 28b4 +5033 5034 29c4 29c5 +5033 5055 28b4 29c4 +5034 5035 2ad4 2ad5 +5034 5056 29c4 2ad4 +5035 5036 2be4 2be5 +5035 5057 2ad4 2be4 +5036 5037 2cf4 2cf5 +5036 5058 2be4 2cf4 +5037 5038 2e04 2e05 +5037 5059 2cf4 2e04 +5038 5039 2f14 2f15 +5038 505a 2e04 2f14 +5039 503a 3024 3025 +5039 505b 2f14 3024 +503a 503b 3134 3135 +503a 505c 3024 3134 +503b 503c 3244 3245 +503b 505d 3134 3244 +503c 503d 3354 3355 +503c 505e 3244 3354 +503d 503e 3464 3465 +503d 505f 3354 3464 +503e 5060 3464 3574 +503f 5040 1263 1264 +503f 5061 1153 1263 +5040 5041 1373 1374 +5040 5062 1263 1373 +5041 5042 1483 1484 +5041 5063 1373 1483 +5042 5043 1593 1594 +5042 5064 1483 1593 +5043 5044 16a3 16a4 +5043 5065 1593 16a3 +5044 5045 17b3 17b4 +5044 5066 16a3 17b3 +5045 5046 18c3 18c4 +5045 5067 17b3 18c3 +5046 5047 19d3 19d4 +5046 5068 18c3 19d3 +5047 5048 1ae3 1ae4 +5047 5069 19d3 1ae3 +5048 5049 1bf3 1bf4 +5048 506a 1ae3 1bf3 +5049 504a 1d03 1d04 +5049 506b 1bf3 1d03 +504a 504b 1e13 1e14 +504a 506c 1d03 1e13 +504b 504c 1f23 1f24 +504b 506d 1e13 1f23 +504c 504d 2033 2034 +504c 506e 1f23 2033 +504d 504e 2143 2144 +504d 506f 2033 2143 +504e 504f 2253 2254 +504e 5070 2143 2253 +504f 5050 2363 2364 +504f 5071 2253 2363 +5050 5051 2473 2474 +5050 5072 2363 2473 +5051 5052 2583 2584 +5051 5073 2473 2583 +5052 5053 2693 2694 +5052 5074 2583 2693 +5053 5054 27a3 27a4 +5053 5075 2693 27a3 +5054 5055 28b3 28b4 +5054 5076 27a3 28b3 +5055 5056 29c3 29c4 +5055 5077 28b3 29c3 +5056 5057 2ad3 2ad4 +5056 5078 29c3 2ad3 +5057 5058 2be3 2be4 +5057 5079 2ad3 2be3 +5058 5059 2cf3 2cf4 +5058 507a 2be3 2cf3 +5059 505a 2e03 2e04 +5059 507b 2cf3 2e03 +505a 505b 2f13 2f14 +505a 507c 2e03 2f13 +505b 505c 3023 3024 +505b 507d 2f13 3023 +505c 505d 3133 3134 +505c 507e 3023 3133 +505d 505e 3243 3244 +505d 507f 3133 3243 +505e 505f 3353 3354 +505e 5080 3243 3353 +505f 5060 3463 3464 +505f 5081 3353 3463 +5060 5082 3463 3573 +5061 5062 1262 1263 +5061 5083 1152 1262 +5062 5063 1372 1373 +5062 5084 1262 1372 +5063 5064 1482 1483 +5063 5085 1372 1482 +5064 5065 1592 1593 +5064 5086 1482 1592 +5065 5066 16a2 16a3 +5065 5087 1592 16a2 +5066 5067 17b2 17b3 +5066 5088 16a2 17b2 +5067 5068 18c2 18c3 +5067 5089 17b2 18c2 +5068 5069 19d2 19d3 +5068 508a 18c2 19d2 +5069 506a 1ae2 1ae3 +5069 508b 19d2 1ae2 +506a 506b 1bf2 1bf3 +506a 508c 1ae2 1bf2 +506b 506c 1d02 1d03 +506b 508d 1bf2 1d02 +506c 506d 1e12 1e13 +506c 508e 1d02 1e12 +506d 506e 1f22 1f23 +506d 508f 1e12 1f22 +506e 506f 2032 2033 +506e 5090 1f22 2032 +506f 5070 2142 2143 +506f 5091 2032 2142 +5070 5071 2252 2253 +5070 5092 2142 2252 +5071 5072 2362 2363 +5071 5093 2252 2362 +5072 5073 2472 2473 +5072 5094 2362 2472 +5073 5074 2582 2583 +5073 5095 2472 2582 +5074 5075 2692 2693 +5074 5096 2582 2692 +5075 5076 27a2 27a3 +5075 5097 2692 27a2 +5076 5077 28b2 28b3 +5076 5098 27a2 28b2 +5077 5078 29c2 29c3 +5077 5099 28b2 29c2 +5078 5079 2ad2 2ad3 +5078 509a 29c2 2ad2 +5079 507a 2be2 2be3 +5079 509b 2ad2 2be2 +507a 507b 2cf2 2cf3 +507a 509c 2be2 2cf2 +507b 507c 2e02 2e03 +507b 509d 2cf2 2e02 +507c 507d 2f12 2f13 +507c 509e 2e02 2f12 +507d 507e 3022 3023 +507d 509f 2f12 3022 +507e 507f 3132 3133 +507e 50a0 3022 3132 +507f 5080 3242 3243 +507f 50a1 3132 3242 +5080 5081 3352 3353 +5080 50a2 3242 3352 +5081 5082 3462 3463 +5081 50a3 3352 3462 +5082 50a4 3462 3572 +5083 5084 1261 1262 +5083 50a5 1151 1261 +5084 5085 1371 1372 +5084 50a6 1261 1371 +5085 5086 1481 1482 +5085 50a7 1371 1481 +5086 5087 1591 1592 +5086 50a8 1481 1591 +5087 5088 16a1 16a2 +5087 50a9 1591 16a1 +5088 5089 17b1 17b2 +5088 50aa 16a1 17b1 +5089 508a 18c1 18c2 +5089 50ab 17b1 18c1 +508a 508b 19d1 19d2 +508a 50ac 18c1 19d1 +508b 508c 1ae1 1ae2 +508b 50ad 19d1 1ae1 +508c 508d 1bf1 1bf2 +508c 50ae 1ae1 1bf1 +508d 508e 1d01 1d02 +508d 50af 1bf1 1d01 +508e 508f 1e11 1e12 +508e 50b0 1d01 1e11 +508f 5090 1f21 1f22 +508f 50b1 1e11 1f21 +5090 5091 2031 2032 +5090 50b2 1f21 2031 +5091 5092 2141 2142 +5091 50b3 2031 2141 +5092 5093 2251 2252 +5092 50b4 2141 2251 +5093 5094 2361 2362 +5093 50b5 2251 2361 +5094 5095 2471 2472 +5094 50b6 2361 2471 +5095 5096 2581 2582 +5095 50b7 2471 2581 +5096 5097 2691 2692 +5096 50b8 2581 2691 +5097 5098 27a1 27a2 +5097 50b9 2691 27a1 +5098 5099 28b1 28b2 +5098 50ba 27a1 28b1 +5099 509a 29c1 29c2 +5099 50bb 28b1 29c1 +509a 509b 2ad1 2ad2 +509a 50bc 29c1 2ad1 +509b 509c 2be1 2be2 +509b 50bd 2ad1 2be1 +509c 509d 2cf1 2cf2 +509c 50be 2be1 2cf1 +509d 509e 2e01 2e02 +509d 50bf 2cf1 2e01 +509e 509f 2f11 2f12 +509e 50c0 2e01 2f11 +509f 50a0 3021 3022 +509f 50c1 2f11 3021 +50a0 50a1 3131 3132 +50a0 50c2 3021 3131 +50a1 50a2 3241 3242 +50a1 50c3 3131 3241 +50a2 50a3 3351 3352 +50a2 50c4 3241 3351 +50a3 50a4 3461 3462 +50a3 50c5 3351 3461 +50a4 50c6 3461 3571 +50a5 50a6 1260 1261 +50a5 50c7 1150 1260 +50a6 50a7 1370 1371 +50a6 50c8 1260 1370 +50a7 50a8 1480 1481 +50a7 50c9 1370 1480 +50a8 50a9 1590 1591 +50a8 50ca 1480 1590 +50a9 50aa 16a0 16a1 +50a9 50cb 1590 16a0 +50aa 50ab 17b0 17b1 +50aa 50cc 16a0 17b0 +50ab 50ac 18c0 18c1 +50ab 50cd 17b0 18c0 +50ac 50ad 19d0 19d1 +50ac 50ce 18c0 19d0 +50ad 50ae 1ae0 1ae1 +50ad 50cf 19d0 1ae0 +50ae 50af 1bf0 1bf1 +50ae 50d0 1ae0 1bf0 +50af 50b0 1d00 1d01 +50af 50d1 1bf0 1d00 +50b0 50b1 1e10 1e11 +50b0 50d2 1d00 1e10 +50b1 50b2 1f20 1f21 +50b1 50d3 1e10 1f20 +50b2 50b3 2030 2031 +50b2 50d4 1f20 2030 +50b3 50b4 2140 2141 +50b3 50d5 2030 2140 +50b4 50b5 2250 2251 +50b4 50d6 2140 2250 +50b5 50b6 2360 2361 +50b5 50d7 2250 2360 +50b6 50b7 2470 2471 +50b6 50d8 2360 2470 +50b7 50b8 2580 2581 +50b7 50d9 2470 2580 +50b8 50b9 2690 2691 +50b8 50da 2580 2690 +50b9 50ba 27a0 27a1 +50b9 50db 2690 27a0 +50ba 50bb 28b0 28b1 +50ba 50dc 27a0 28b0 +50bb 50bc 29c0 29c1 +50bb 50dd 28b0 29c0 +50bc 50bd 2ad0 2ad1 +50bc 50de 29c0 2ad0 +50bd 50be 2be0 2be1 +50bd 50df 2ad0 2be0 +50be 50bf 2cf0 2cf1 +50be 50e0 2be0 2cf0 +50bf 50c0 2e00 2e01 +50bf 50e1 2cf0 2e00 +50c0 50c1 2f10 2f11 +50c0 50e2 2e00 2f10 +50c1 50c2 3020 3021 +50c1 50e3 2f10 3020 +50c2 50c3 3130 3131 +50c2 50e4 3020 3130 +50c3 50c4 3240 3241 +50c3 50e5 3130 3240 +50c4 50c5 3350 3351 +50c4 50e6 3240 3350 +50c5 50c6 3460 3461 +50c5 50e7 3350 3460 +50c6 50e8 3460 3570 +50c7 50c8 125f 1260 +50c7 50e9 114f 125f +50c8 50c9 136f 1370 +50c8 50ea 125f 136f +50c9 50ca 147f 1480 +50c9 50eb 136f 147f +50ca 50cb 158f 1590 +50ca 50ec 147f 158f +50cb 50cc 169f 16a0 +50cb 50ed 158f 169f +50cc 50cd 17af 17b0 +50cc 50ee 169f 17af +50cd 50ce 18bf 18c0 +50cd 50ef 17af 18bf +50ce 50cf 19cf 19d0 +50ce 50f0 18bf 19cf +50cf 50d0 1adf 1ae0 +50cf 50f1 19cf 1adf +50d0 50d1 1bef 1bf0 +50d0 50f2 1adf 1bef +50d1 50d2 1cff 1d00 +50d1 50f3 1bef 1cff +50d2 50d3 1e0f 1e10 +50d2 50f4 1cff 1e0f +50d3 50d4 1f1f 1f20 +50d3 50f5 1e0f 1f1f +50d4 50d5 202f 2030 +50d4 50f6 1f1f 202f +50d5 50d6 213f 2140 +50d5 50f7 202f 213f +50d6 50d7 224f 2250 +50d6 50f8 213f 224f +50d7 50d8 235f 2360 +50d7 50f9 224f 235f +50d8 50d9 246f 2470 +50d8 50fa 235f 246f +50d9 50da 257f 2580 +50d9 50fb 246f 257f +50da 50db 268f 2690 +50da 50fc 257f 268f +50db 50dc 279f 27a0 +50db 50fd 268f 279f +50dc 50dd 28af 28b0 +50dc 50fe 279f 28af +50dd 50de 29bf 29c0 +50dd 50ff 28af 29bf +50de 50df 2acf 2ad0 +50de 5100 29bf 2acf +50df 50e0 2bdf 2be0 +50df 5101 2acf 2bdf +50e0 50e1 2cef 2cf0 +50e0 5102 2bdf 2cef +50e1 50e2 2dff 2e00 +50e1 5103 2cef 2dff +50e2 50e3 2f0f 2f10 +50e2 5104 2dff 2f0f +50e3 50e4 301f 3020 +50e3 5105 2f0f 301f +50e4 50e5 312f 3130 +50e4 5106 301f 312f +50e5 50e6 323f 3240 +50e5 5107 312f 323f +50e6 50e7 334f 3350 +50e6 5108 323f 334f +50e7 50e8 345f 3460 +50e7 5109 334f 345f +50e8 510a 345f 356f +50e9 50ea 125e 125f +50e9 510b 114e 125e +50ea 50eb 136e 136f +50ea 510c 125e 136e +50eb 50ec 147e 147f +50eb 510d 136e 147e +50ec 50ed 158e 158f +50ec 510e 147e 158e +50ed 50ee 169e 169f +50ed 510f 158e 169e +50ee 50ef 17ae 17af +50ee 5110 169e 17ae +50ef 50f0 18be 18bf +50ef 5111 17ae 18be +50f0 50f1 19ce 19cf +50f0 5112 18be 19ce +50f1 50f2 1ade 1adf +50f1 5113 19ce 1ade +50f2 50f3 1bee 1bef +50f2 5114 1ade 1bee +50f3 50f4 1cfe 1cff +50f3 5115 1bee 1cfe +50f4 50f5 1e0e 1e0f +50f4 5116 1cfe 1e0e +50f5 50f6 1f1e 1f1f +50f5 5117 1e0e 1f1e +50f6 50f7 202e 202f +50f6 5118 1f1e 202e +50f7 50f8 213e 213f +50f7 5119 202e 213e +50f8 50f9 224e 224f +50f8 511a 213e 224e +50f9 50fa 235e 235f +50f9 511b 224e 235e +50fa 50fb 246e 246f +50fa 511c 235e 246e +50fb 50fc 257e 257f +50fb 511d 246e 257e +50fc 50fd 268e 268f +50fc 511e 257e 268e +50fd 50fe 279e 279f +50fd 511f 268e 279e +50fe 50ff 28ae 28af +50fe 5120 279e 28ae +50ff 5100 29be 29bf +50ff 5121 28ae 29be +5100 5101 2ace 2acf +5100 5122 29be 2ace +5101 5102 2bde 2bdf +5101 5123 2ace 2bde +5102 5103 2cee 2cef +5102 5124 2bde 2cee +5103 5104 2dfe 2dff +5103 5125 2cee 2dfe +5104 5105 2f0e 2f0f +5104 5126 2dfe 2f0e +5105 5106 301e 301f +5105 5127 2f0e 301e +5106 5107 312e 312f +5106 5128 301e 312e +5107 5108 323e 323f +5107 5129 312e 323e +5108 5109 334e 334f +5108 512a 323e 334e +5109 510a 345e 345f +5109 512b 334e 345e +510a 512c 345e 356e +510b 510c 125d 125e +510b 512d 114d 125d +510c 510d 136d 136e +510c 512e 125d 136d +510d 510e 147d 147e +510d 512f 136d 147d +510e 510f 158d 158e +510e 5130 147d 158d +510f 5110 169d 169e +510f 5131 158d 169d +5110 5111 17ad 17ae +5110 5132 169d 17ad +5111 5112 18bd 18be +5111 5133 17ad 18bd +5112 5113 19cd 19ce +5112 5134 18bd 19cd +5113 5114 1add 1ade +5113 5135 19cd 1add +5114 5115 1bed 1bee +5114 5136 1add 1bed +5115 5116 1cfd 1cfe +5115 5137 1bed 1cfd +5116 5117 1e0d 1e0e +5116 5138 1cfd 1e0d +5117 5118 1f1d 1f1e +5117 5139 1e0d 1f1d +5118 5119 202d 202e +5118 513a 1f1d 202d +5119 511a 213d 213e +5119 513b 202d 213d +511a 511b 224d 224e +511a 513c 213d 224d +511b 511c 235d 235e +511b 513d 224d 235d +511c 511d 246d 246e +511c 513e 235d 246d +511d 511e 257d 257e +511d 513f 246d 257d +511e 511f 268d 268e +511e 5140 257d 268d +511f 5120 279d 279e +511f 5141 268d 279d +5120 5121 28ad 28ae +5120 5142 279d 28ad +5121 5122 29bd 29be +5121 5143 28ad 29bd +5122 5123 2acd 2ace +5122 5144 29bd 2acd +5123 5124 2bdd 2bde +5123 5145 2acd 2bdd +5124 5125 2ced 2cee +5124 5146 2bdd 2ced +5125 5126 2dfd 2dfe +5125 5147 2ced 2dfd +5126 5127 2f0d 2f0e +5126 5148 2dfd 2f0d +5127 5128 301d 301e +5127 5149 2f0d 301d +5128 5129 312d 312e +5128 514a 301d 312d +5129 512a 323d 323e +5129 514b 312d 323d +512a 512b 334d 334e +512a 514c 323d 334d +512b 512c 345d 345e +512b 514d 334d 345d +512c 514e 345d 356d +512d 512e 125c 125d +512d 514f 114c 125c +512e 512f 136c 136d +512e 5150 125c 136c +512f 5130 147c 147d +512f 5151 136c 147c +5130 5131 158c 158d +5130 5152 147c 158c +5131 5132 169c 169d +5131 5153 158c 169c +5132 5133 17ac 17ad +5132 5154 169c 17ac +5133 5134 18bc 18bd +5133 5155 17ac 18bc +5134 5135 19cc 19cd +5134 5156 18bc 19cc +5135 5136 1adc 1add +5135 5157 19cc 1adc +5136 5137 1bec 1bed +5136 5158 1adc 1bec +5137 5138 1cfc 1cfd +5137 5159 1bec 1cfc +5138 5139 1e0c 1e0d +5138 515a 1cfc 1e0c +5139 513a 1f1c 1f1d +5139 515b 1e0c 1f1c +513a 513b 202c 202d +513a 515c 1f1c 202c +513b 513c 213c 213d +513b 515d 202c 213c +513c 513d 224c 224d +513c 515e 213c 224c +513d 513e 235c 235d +513d 515f 224c 235c +513e 513f 246c 246d +513e 5160 235c 246c +513f 5140 257c 257d +513f 5161 246c 257c +5140 5141 268c 268d +5140 5162 257c 268c +5141 5142 279c 279d +5141 5163 268c 279c +5142 5143 28ac 28ad +5142 5164 279c 28ac +5143 5144 29bc 29bd +5143 5165 28ac 29bc +5144 5145 2acc 2acd +5144 5166 29bc 2acc +5145 5146 2bdc 2bdd +5145 5167 2acc 2bdc +5146 5147 2cec 2ced +5146 5168 2bdc 2cec +5147 5148 2dfc 2dfd +5147 5169 2cec 2dfc +5148 5149 2f0c 2f0d +5148 516a 2dfc 2f0c +5149 514a 301c 301d +5149 516b 2f0c 301c +514a 514b 312c 312d +514a 516c 301c 312c +514b 514c 323c 323d +514b 516d 312c 323c +514c 514d 334c 334d +514c 516e 323c 334c +514d 514e 345c 345d +514d 516f 334c 345c +514e 5170 345c 356c +514f 5150 125b 125c +514f 5171 114b 125b +5150 5151 136b 136c +5150 5172 125b 136b +5151 5152 147b 147c +5151 5173 136b 147b +5152 5153 158b 158c +5152 5174 147b 158b +5153 5154 169b 169c +5153 5175 158b 169b +5154 5155 17ab 17ac +5154 5176 169b 17ab +5155 5156 18bb 18bc +5155 5177 17ab 18bb +5156 5157 19cb 19cc +5156 5178 18bb 19cb +5157 5158 1adb 1adc +5157 5179 19cb 1adb +5158 5159 1beb 1bec +5158 517a 1adb 1beb +5159 515a 1cfb 1cfc +5159 517b 1beb 1cfb +515a 515b 1e0b 1e0c +515a 517c 1cfb 1e0b +515b 515c 1f1b 1f1c +515b 517d 1e0b 1f1b +515c 515d 202b 202c +515c 517e 1f1b 202b +515d 515e 213b 213c +515d 517f 202b 213b +515e 515f 224b 224c +515e 5180 213b 224b +515f 5160 235b 235c +515f 5181 224b 235b +5160 5161 246b 246c +5160 5182 235b 246b +5161 5162 257b 257c +5161 5183 246b 257b +5162 5163 268b 268c +5162 5184 257b 268b +5163 5164 279b 279c +5163 5185 268b 279b +5164 5165 28ab 28ac +5164 5186 279b 28ab +5165 5166 29bb 29bc +5165 5187 28ab 29bb +5166 5167 2acb 2acc +5166 5188 29bb 2acb +5167 5168 2bdb 2bdc +5167 5189 2acb 2bdb +5168 5169 2ceb 2cec +5168 518a 2bdb 2ceb +5169 516a 2dfb 2dfc +5169 518b 2ceb 2dfb +516a 516b 2f0b 2f0c +516a 518c 2dfb 2f0b +516b 516c 301b 301c +516b 518d 2f0b 301b +516c 516d 312b 312c +516c 518e 301b 312b +516d 516e 323b 323c +516d 518f 312b 323b +516e 516f 334b 334c +516e 5190 323b 334b +516f 5170 345b 345c +516f 5191 334b 345b +5170 5192 345b 356b +5171 5172 125a 125b +5171 5193 114a 125a +5172 5173 136a 136b +5172 5194 125a 136a +5173 5174 147a 147b +5173 5195 136a 147a +5174 5175 158a 158b +5174 5196 147a 158a +5175 5176 169a 169b +5175 5197 158a 169a +5176 5177 17aa 17ab +5176 5198 169a 17aa +5177 5178 18ba 18bb +5177 5199 17aa 18ba +5178 5179 19ca 19cb +5178 519a 18ba 19ca +5179 517a 1ada 1adb +5179 519b 19ca 1ada +517a 517b 1bea 1beb +517a 519c 1ada 1bea +517b 517c 1cfa 1cfb +517b 519d 1bea 1cfa +517c 517d 1e0a 1e0b +517c 519e 1cfa 1e0a +517d 517e 1f1a 1f1b +517d 519f 1e0a 1f1a +517e 517f 202a 202b +517e 51a0 1f1a 202a +517f 5180 213a 213b +517f 51a1 202a 213a +5180 5181 224a 224b +5180 51a2 213a 224a +5181 5182 235a 235b +5181 51a3 224a 235a +5182 5183 246a 246b +5182 51a4 235a 246a +5183 5184 257a 257b +5183 51a5 246a 257a +5184 5185 268a 268b +5184 51a6 257a 268a +5185 5186 279a 279b +5185 51a7 268a 279a +5186 5187 28aa 28ab +5186 51a8 279a 28aa +5187 5188 29ba 29bb +5187 51a9 28aa 29ba +5188 5189 2aca 2acb +5188 51aa 29ba 2aca +5189 518a 2bda 2bdb +5189 51ab 2aca 2bda +518a 518b 2cea 2ceb +518a 51ac 2bda 2cea +518b 518c 2dfa 2dfb +518b 51ad 2cea 2dfa +518c 518d 2f0a 2f0b +518c 51ae 2dfa 2f0a +518d 518e 301a 301b +518d 51af 2f0a 301a +518e 518f 312a 312b +518e 51b0 301a 312a +518f 5190 323a 323b +518f 51b1 312a 323a +5190 5191 334a 334b +5190 51b2 323a 334a +5191 5192 345a 345b +5191 51b3 334a 345a +5192 51b4 345a 356a +5193 5194 1259 125a +5194 5195 1369 136a +5195 5196 1479 147a +5196 5197 1589 158a +5197 5198 1699 169a +5198 5199 17a9 17aa +5199 519a 18b9 18ba +519a 519b 19c9 19ca +519b 519c 1ad9 1ada +519c 519d 1be9 1bea +519d 519e 1cf9 1cfa +519e 519f 1e09 1e0a +519f 51a0 1f19 1f1a +51a0 51a1 2029 202a +51a1 51a2 2139 213a +51a2 51a3 2249 224a +51a3 51a4 2359 235a +51a4 51a5 2469 246a +51a5 51a6 2579 257a +51a6 51a7 2689 268a +51a7 51a8 2799 279a +51a8 51a9 28a9 28aa +51a9 51aa 29b9 29ba +51aa 51ab 2ac9 2aca +51ab 51ac 2bd9 2bda +51ac 51ad 2ce9 2cea +51ad 51ae 2df9 2dfa +51ae 51af 2f09 2f0a +51af 51b0 3019 301a +51b0 51b1 3129 312a +51b1 51b2 3239 323a +51b2 51b3 3349 334a +51b3 51b4 3459 345a +51b6 51b5 3429 342a +51d7 51b5 342a 353a +51b7 51b6 3319 331a +51d8 51b6 331a 342a +51b8 51b7 3209 320a +51d9 51b7 320a 331a +51b9 51b8 30f9 30fa +51da 51b8 30fa 320a +51ba 51b9 2fe9 2fea +51db 51b9 2fea 30fa +51bb 51ba 2ed9 2eda +51dc 51ba 2eda 2fea +51bc 51bb 2dc9 2dca +51dd 51bb 2dca 2eda +51bd 51bc 2cb9 2cba +51de 51bc 2cba 2dca +51be 51bd 2ba9 2baa +51df 51bd 2baa 2cba +51bf 51be 2a99 2a9a +51e0 51be 2a9a 2baa +51c0 51bf 2989 298a +51e1 51bf 298a 2a9a +51c1 51c0 2879 287a +51e2 51c0 287a 298a +51c2 51c1 2769 276a +51e3 51c1 276a 287a +51c3 51c2 2659 265a +51e4 51c2 265a 276a +51c4 51c3 2549 254a +51e5 51c3 254a 265a +51c5 51c4 2439 243a +51e6 51c4 243a 254a +51c6 51c5 2329 232a +51e7 51c5 232a 243a +51c7 51c6 2219 221a +51e8 51c6 221a 232a +51c8 51c7 2109 210a +51e9 51c7 210a 221a +51c9 51c8 1ff9 1ffa +51ea 51c8 1ffa 210a +51ca 51c9 1ee9 1eea +51eb 51c9 1eea 1ffa +51cb 51ca 1dd9 1dda +51ec 51ca 1dda 1eea +51cc 51cb 1cc9 1cca +51ed 51cb 1cca 1dda +51cd 51cc 1bb9 1bba +51ee 51cc 1bba 1cca +51ce 51cd 1aa9 1aaa +51ef 51cd 1aaa 1bba +51cf 51ce 1999 199a +51f0 51ce 199a 1aaa +51d0 51cf 1889 188a +51f1 51cf 188a 199a +51d1 51d0 1779 177a +51f2 51d0 177a 188a +51d2 51d1 1669 166a +51f3 51d1 166a 177a +51d3 51d2 1559 155a +51f4 51d2 155a 166a +51d4 51d3 1449 144a +51f5 51d3 144a 155a +51d5 51d4 1339 133a +51f6 51d4 133a 144a +51d6 51d5 1229 122a +51f7 51d5 122a 133a +51f8 51d6 111a 122a +51d8 51d7 342a 342b +51f9 51d7 342b 353b +51d9 51d8 331a 331b +51fa 51d8 331b 342b +51da 51d9 320a 320b +51fb 51d9 320b 331b +51db 51da 30fa 30fb +51fc 51da 30fb 320b +51dc 51db 2fea 2feb +51fd 51db 2feb 30fb +51dd 51dc 2eda 2edb +51fe 51dc 2edb 2feb +51de 51dd 2dca 2dcb +51ff 51dd 2dcb 2edb +51df 51de 2cba 2cbb +5200 51de 2cbb 2dcb +51e0 51df 2baa 2bab +5201 51df 2bab 2cbb +51e1 51e0 2a9a 2a9b +5202 51e0 2a9b 2bab +51e2 51e1 298a 298b +5203 51e1 298b 2a9b +51e3 51e2 287a 287b +5204 51e2 287b 298b +51e4 51e3 276a 276b +5205 51e3 276b 287b +51e5 51e4 265a 265b +5206 51e4 265b 276b +51e6 51e5 254a 254b +5207 51e5 254b 265b +51e7 51e6 243a 243b +5208 51e6 243b 254b +51e8 51e7 232a 232b +5209 51e7 232b 243b +51e9 51e8 221a 221b +520a 51e8 221b 232b +51ea 51e9 210a 210b +520b 51e9 210b 221b +51eb 51ea 1ffa 1ffb +520c 51ea 1ffb 210b +51ec 51eb 1eea 1eeb +520d 51eb 1eeb 1ffb +51ed 51ec 1dda 1ddb +520e 51ec 1ddb 1eeb +51ee 51ed 1cca 1ccb +520f 51ed 1ccb 1ddb +51ef 51ee 1bba 1bbb +5210 51ee 1bbb 1ccb +51f0 51ef 1aaa 1aab +5211 51ef 1aab 1bbb +51f1 51f0 199a 199b +5212 51f0 199b 1aab +51f2 51f1 188a 188b +5213 51f1 188b 199b +51f3 51f2 177a 177b +5214 51f2 177b 188b +51f4 51f3 166a 166b +5215 51f3 166b 177b +51f5 51f4 155a 155b +5216 51f4 155b 166b +51f6 51f5 144a 144b +5217 51f5 144b 155b +51f7 51f6 133a 133b +5218 51f6 133b 144b +51f8 51f7 122a 122b +5219 51f7 122b 133b +521a 51f8 111b 122b +51fa 51f9 342b 342c +521b 51f9 342c 353c +51fb 51fa 331b 331c +521c 51fa 331c 342c +51fc 51fb 320b 320c +521d 51fb 320c 331c +51fd 51fc 30fb 30fc +521e 51fc 30fc 320c +51fe 51fd 2feb 2fec +521f 51fd 2fec 30fc +51ff 51fe 2edb 2edc +5220 51fe 2edc 2fec +5200 51ff 2dcb 2dcc +5221 51ff 2dcc 2edc +5201 5200 2cbb 2cbc +5222 5200 2cbc 2dcc +5202 5201 2bab 2bac +5223 5201 2bac 2cbc +5203 5202 2a9b 2a9c +5224 5202 2a9c 2bac +5204 5203 298b 298c +5225 5203 298c 2a9c +5205 5204 287b 287c +5226 5204 287c 298c +5206 5205 276b 276c +5227 5205 276c 287c +5207 5206 265b 265c +5228 5206 265c 276c +5208 5207 254b 254c +5229 5207 254c 265c +5209 5208 243b 243c +522a 5208 243c 254c +520a 5209 232b 232c +522b 5209 232c 243c +520b 520a 221b 221c +522c 520a 221c 232c +520c 520b 210b 210c +522d 520b 210c 221c +520d 520c 1ffb 1ffc +522e 520c 1ffc 210c +520e 520d 1eeb 1eec +522f 520d 1eec 1ffc +520f 520e 1ddb 1ddc +5230 520e 1ddc 1eec +5210 520f 1ccb 1ccc +5231 520f 1ccc 1ddc +5211 5210 1bbb 1bbc +5232 5210 1bbc 1ccc +5212 5211 1aab 1aac +5233 5211 1aac 1bbc +5213 5212 199b 199c +5234 5212 199c 1aac +5214 5213 188b 188c +5235 5213 188c 199c +5215 5214 177b 177c +5236 5214 177c 188c +5216 5215 166b 166c +5237 5215 166c 177c +5217 5216 155b 155c +5238 5216 155c 166c +5218 5217 144b 144c +5239 5217 144c 155c +5219 5218 133b 133c +523a 5218 133c 144c +521a 5219 122b 122c +523b 5219 122c 133c +523c 521a 111c 122c +521c 521b 342c 342d +523d 521b 342d 353d +521d 521c 331c 331d +523e 521c 331d 342d +521e 521d 320c 320d +523f 521d 320d 331d +521f 521e 30fc 30fd +5240 521e 30fd 320d +5220 521f 2fec 2fed +5241 521f 2fed 30fd +5221 5220 2edc 2edd +5242 5220 2edd 2fed +5222 5221 2dcc 2dcd +5243 5221 2dcd 2edd +5223 5222 2cbc 2cbd +5244 5222 2cbd 2dcd +5224 5223 2bac 2bad +5245 5223 2bad 2cbd +5225 5224 2a9c 2a9d +5246 5224 2a9d 2bad +5226 5225 298c 298d +5247 5225 298d 2a9d +5227 5226 287c 287d +5248 5226 287d 298d +5228 5227 276c 276d +5249 5227 276d 287d +5229 5228 265c 265d +524a 5228 265d 276d +522a 5229 254c 254d +524b 5229 254d 265d +522b 522a 243c 243d +524c 522a 243d 254d +522c 522b 232c 232d +524d 522b 232d 243d +522d 522c 221c 221d +524e 522c 221d 232d +522e 522d 210c 210d +524f 522d 210d 221d +522f 522e 1ffc 1ffd +5250 522e 1ffd 210d +5230 522f 1eec 1eed +5251 522f 1eed 1ffd +5231 5230 1ddc 1ddd +5252 5230 1ddd 1eed +5232 5231 1ccc 1ccd +5253 5231 1ccd 1ddd +5233 5232 1bbc 1bbd +5254 5232 1bbd 1ccd +5234 5233 1aac 1aad +5255 5233 1aad 1bbd +5235 5234 199c 199d +5256 5234 199d 1aad +5236 5235 188c 188d +5257 5235 188d 199d +5237 5236 177c 177d +5258 5236 177d 188d +5238 5237 166c 166d +5259 5237 166d 177d +5239 5238 155c 155d +525a 5238 155d 166d +523a 5239 144c 144d +525b 5239 144d 155d +523b 523a 133c 133d +525c 523a 133d 144d +523c 523b 122c 122d +525d 523b 122d 133d +525e 523c 111d 122d +523e 523d 342d 342e +525f 523d 342e 353e +523f 523e 331d 331e +5260 523e 331e 342e +5240 523f 320d 320e +5261 523f 320e 331e +5241 5240 30fd 30fe +5262 5240 30fe 320e +5242 5241 2fed 2fee +5263 5241 2fee 30fe +5243 5242 2edd 2ede +5264 5242 2ede 2fee +5244 5243 2dcd 2dce +5265 5243 2dce 2ede +5245 5244 2cbd 2cbe +5266 5244 2cbe 2dce +5246 5245 2bad 2bae +5267 5245 2bae 2cbe +5247 5246 2a9d 2a9e +5268 5246 2a9e 2bae +5248 5247 298d 298e +5269 5247 298e 2a9e +5249 5248 287d 287e +526a 5248 287e 298e +524a 5249 276d 276e +526b 5249 276e 287e +524b 524a 265d 265e +526c 524a 265e 276e +524c 524b 254d 254e +526d 524b 254e 265e +524d 524c 243d 243e +526e 524c 243e 254e +524e 524d 232d 232e +526f 524d 232e 243e +524f 524e 221d 221e +5270 524e 221e 232e +5250 524f 210d 210e +5271 524f 210e 221e +5251 5250 1ffd 1ffe +5272 5250 1ffe 210e +5252 5251 1eed 1eee +5273 5251 1eee 1ffe +5253 5252 1ddd 1dde +5274 5252 1dde 1eee +5254 5253 1ccd 1cce +5275 5253 1cce 1dde +5255 5254 1bbd 1bbe +5276 5254 1bbe 1cce +5256 5255 1aad 1aae +5277 5255 1aae 1bbe +5257 5256 199d 199e +5278 5256 199e 1aae +5258 5257 188d 188e +5279 5257 188e 199e +5259 5258 177d 177e +527a 5258 177e 188e +525a 5259 166d 166e +527b 5259 166e 177e +525b 525a 155d 155e +527c 525a 155e 166e +525c 525b 144d 144e +527d 525b 144e 155e +525d 525c 133d 133e +527e 525c 133e 144e +525e 525d 122d 122e +527f 525d 122e 133e +5280 525e 111e 122e +5260 525f 342e 342f +5281 525f 342f 353f +5261 5260 331e 331f +5282 5260 331f 342f +5262 5261 320e 320f +5283 5261 320f 331f +5263 5262 30fe 30ff +5284 5262 30ff 320f +5264 5263 2fee 2fef +5285 5263 2fef 30ff +5265 5264 2ede 2edf +5286 5264 2edf 2fef +5266 5265 2dce 2dcf +5287 5265 2dcf 2edf +5267 5266 2cbe 2cbf +5288 5266 2cbf 2dcf +5268 5267 2bae 2baf +5289 5267 2baf 2cbf +5269 5268 2a9e 2a9f +528a 5268 2a9f 2baf +526a 5269 298e 298f +528b 5269 298f 2a9f +526b 526a 287e 287f +528c 526a 287f 298f +526c 526b 276e 276f +528d 526b 276f 287f +526d 526c 265e 265f +528e 526c 265f 276f +526e 526d 254e 254f +528f 526d 254f 265f +526f 526e 243e 243f +5290 526e 243f 254f +5270 526f 232e 232f +5291 526f 232f 243f +5271 5270 221e 221f +5292 5270 221f 232f +5272 5271 210e 210f +5293 5271 210f 221f +5273 5272 1ffe 1fff +5294 5272 1fff 210f +5274 5273 1eee 1eef +5295 5273 1eef 1fff +5275 5274 1dde 1ddf +5296 5274 1ddf 1eef +5276 5275 1cce 1ccf +5297 5275 1ccf 1ddf +5277 5276 1bbe 1bbf +5298 5276 1bbf 1ccf +5278 5277 1aae 1aaf +5299 5277 1aaf 1bbf +5279 5278 199e 199f +529a 5278 199f 1aaf +527a 5279 188e 188f +529b 5279 188f 199f +527b 527a 177e 177f +529c 527a 177f 188f +527c 527b 166e 166f +529d 527b 166f 177f +527d 527c 155e 155f +529e 527c 155f 166f +527e 527d 144e 144f +529f 527d 144f 155f +527f 527e 133e 133f +52a0 527e 133f 144f +5280 527f 122e 122f +52a1 527f 122f 133f +52a2 5280 111f 122f +5282 5281 342f 3430 +52a3 5281 3430 3540 +5283 5282 331f 3320 +52a4 5282 3320 3430 +5284 5283 320f 3210 +52a5 5283 3210 3320 +5285 5284 30ff 3100 +52a6 5284 3100 3210 +5286 5285 2fef 2ff0 +52a7 5285 2ff0 3100 +5287 5286 2edf 2ee0 +52a8 5286 2ee0 2ff0 +5288 5287 2dcf 2dd0 +52a9 5287 2dd0 2ee0 +5289 5288 2cbf 2cc0 +52aa 5288 2cc0 2dd0 +528a 5289 2baf 2bb0 +52ab 5289 2bb0 2cc0 +528b 528a 2a9f 2aa0 +52ac 528a 2aa0 2bb0 +528c 528b 298f 2990 +52ad 528b 2990 2aa0 +528d 528c 287f 2880 +52ae 528c 2880 2990 +528e 528d 276f 2770 +52af 528d 2770 2880 +528f 528e 265f 2660 +52b0 528e 2660 2770 +5290 528f 254f 2550 +52b1 528f 2550 2660 +5291 5290 243f 2440 +52b2 5290 2440 2550 +5292 5291 232f 2330 +52b3 5291 2330 2440 +5293 5292 221f 2220 +52b4 5292 2220 2330 +5294 5293 210f 2110 +52b5 5293 2110 2220 +5295 5294 1fff 2000 +52b6 5294 2000 2110 +5296 5295 1eef 1ef0 +52b7 5295 1ef0 2000 +5297 5296 1ddf 1de0 +52b8 5296 1de0 1ef0 +5298 5297 1ccf 1cd0 +52b9 5297 1cd0 1de0 +5299 5298 1bbf 1bc0 +52ba 5298 1bc0 1cd0 +529a 5299 1aaf 1ab0 +52bb 5299 1ab0 1bc0 +529b 529a 199f 19a0 +52bc 529a 19a0 1ab0 +529c 529b 188f 1890 +52bd 529b 1890 19a0 +529d 529c 177f 1780 +52be 529c 1780 1890 +529e 529d 166f 1670 +52bf 529d 1670 1780 +529f 529e 155f 1560 +52c0 529e 1560 1670 +52a0 529f 144f 1450 +52c1 529f 1450 1560 +52a1 52a0 133f 1340 +52c2 52a0 1340 1450 +52a2 52a1 122f 1230 +52c3 52a1 1230 1340 +52c4 52a2 1120 1230 +52a4 52a3 3430 3431 +52c5 52a3 3431 3541 +52a5 52a4 3320 3321 +52c6 52a4 3321 3431 +52a6 52a5 3210 3211 +52c7 52a5 3211 3321 +52a7 52a6 3100 3101 +52c8 52a6 3101 3211 +52a8 52a7 2ff0 2ff1 +52c9 52a7 2ff1 3101 +52a9 52a8 2ee0 2ee1 +52ca 52a8 2ee1 2ff1 +52aa 52a9 2dd0 2dd1 +52cb 52a9 2dd1 2ee1 +52ab 52aa 2cc0 2cc1 +52cc 52aa 2cc1 2dd1 +52ac 52ab 2bb0 2bb1 +52cd 52ab 2bb1 2cc1 +52ad 52ac 2aa0 2aa1 +52ce 52ac 2aa1 2bb1 +52ae 52ad 2990 2991 +52cf 52ad 2991 2aa1 +52af 52ae 2880 2881 +52d0 52ae 2881 2991 +52b0 52af 2770 2771 +52d1 52af 2771 2881 +52b1 52b0 2660 2661 +52d2 52b0 2661 2771 +52b2 52b1 2550 2551 +52d3 52b1 2551 2661 +52b3 52b2 2440 2441 +52d4 52b2 2441 2551 +52b4 52b3 2330 2331 +52d5 52b3 2331 2441 +52b5 52b4 2220 2221 +52d6 52b4 2221 2331 +52b6 52b5 2110 2111 +52d7 52b5 2111 2221 +52b7 52b6 2000 2001 +52d8 52b6 2001 2111 +52b8 52b7 1ef0 1ef1 +52d9 52b7 1ef1 2001 +52b9 52b8 1de0 1de1 +52da 52b8 1de1 1ef1 +52ba 52b9 1cd0 1cd1 +52db 52b9 1cd1 1de1 +52bb 52ba 1bc0 1bc1 +52dc 52ba 1bc1 1cd1 +52bc 52bb 1ab0 1ab1 +52dd 52bb 1ab1 1bc1 +52bd 52bc 19a0 19a1 +52de 52bc 19a1 1ab1 +52be 52bd 1890 1891 +52df 52bd 1891 19a1 +52bf 52be 1780 1781 +52e0 52be 1781 1891 +52c0 52bf 1670 1671 +52e1 52bf 1671 1781 +52c1 52c0 1560 1561 +52e2 52c0 1561 1671 +52c2 52c1 1450 1451 +52e3 52c1 1451 1561 +52c3 52c2 1340 1341 +52e4 52c2 1341 1451 +52c4 52c3 1230 1231 +52e5 52c3 1231 1341 +52e6 52c4 1121 1231 +52c6 52c5 3431 3432 +52e7 52c5 3432 3542 +52c7 52c6 3321 3322 +52e8 52c6 3322 3432 +52c8 52c7 3211 3212 +52e9 52c7 3212 3322 +52c9 52c8 3101 3102 +52ea 52c8 3102 3212 +52ca 52c9 2ff1 2ff2 +52eb 52c9 2ff2 3102 +52cb 52ca 2ee1 2ee2 +52ec 52ca 2ee2 2ff2 +52cc 52cb 2dd1 2dd2 +52ed 52cb 2dd2 2ee2 +52cd 52cc 2cc1 2cc2 +52ee 52cc 2cc2 2dd2 +52ce 52cd 2bb1 2bb2 +52ef 52cd 2bb2 2cc2 +52cf 52ce 2aa1 2aa2 +52f0 52ce 2aa2 2bb2 +52d0 52cf 2991 2992 +52f1 52cf 2992 2aa2 +52d1 52d0 2881 2882 +52f2 52d0 2882 2992 +52d2 52d1 2771 2772 +52f3 52d1 2772 2882 +52d3 52d2 2661 2662 +52f4 52d2 2662 2772 +52d4 52d3 2551 2552 +52f5 52d3 2552 2662 +52d5 52d4 2441 2442 +52f6 52d4 2442 2552 +52d6 52d5 2331 2332 +52f7 52d5 2332 2442 +52d7 52d6 2221 2222 +52f8 52d6 2222 2332 +52d8 52d7 2111 2112 +52f9 52d7 2112 2222 +52d9 52d8 2001 2002 +52fa 52d8 2002 2112 +52da 52d9 1ef1 1ef2 +52fb 52d9 1ef2 2002 +52db 52da 1de1 1de2 +52fc 52da 1de2 1ef2 +52dc 52db 1cd1 1cd2 +52fd 52db 1cd2 1de2 +52dd 52dc 1bc1 1bc2 +52fe 52dc 1bc2 1cd2 +52de 52dd 1ab1 1ab2 +52ff 52dd 1ab2 1bc2 +52df 52de 19a1 19a2 +5300 52de 19a2 1ab2 +52e0 52df 1891 1892 +5301 52df 1892 19a2 +52e1 52e0 1781 1782 +5302 52e0 1782 1892 +52e2 52e1 1671 1672 +5303 52e1 1672 1782 +52e3 52e2 1561 1562 +5304 52e2 1562 1672 +52e4 52e3 1451 1452 +5305 52e3 1452 1562 +52e5 52e4 1341 1342 +5306 52e4 1342 1452 +52e6 52e5 1231 1232 +5307 52e5 1232 1342 +5308 52e6 1122 1232 +52e8 52e7 3432 3433 +5309 52e7 3433 3543 +52e9 52e8 3322 3323 +530a 52e8 3323 3433 +52ea 52e9 3212 3213 +530b 52e9 3213 3323 +52eb 52ea 3102 3103 +530c 52ea 3103 3213 +52ec 52eb 2ff2 2ff3 +530d 52eb 2ff3 3103 +52ed 52ec 2ee2 2ee3 +530e 52ec 2ee3 2ff3 +52ee 52ed 2dd2 2dd3 +530f 52ed 2dd3 2ee3 +52ef 52ee 2cc2 2cc3 +5310 52ee 2cc3 2dd3 +52f0 52ef 2bb2 2bb3 +5311 52ef 2bb3 2cc3 +52f1 52f0 2aa2 2aa3 +5312 52f0 2aa3 2bb3 +52f2 52f1 2992 2993 +5313 52f1 2993 2aa3 +52f3 52f2 2882 2883 +5314 52f2 2883 2993 +52f4 52f3 2772 2773 +5315 52f3 2773 2883 +52f5 52f4 2662 2663 +5316 52f4 2663 2773 +52f6 52f5 2552 2553 +5317 52f5 2553 2663 +52f7 52f6 2442 2443 +5318 52f6 2443 2553 +52f8 52f7 2332 2333 +5319 52f7 2333 2443 +52f9 52f8 2222 2223 +531a 52f8 2223 2333 +52fa 52f9 2112 2113 +531b 52f9 2113 2223 +52fb 52fa 2002 2003 +531c 52fa 2003 2113 +52fc 52fb 1ef2 1ef3 +531d 52fb 1ef3 2003 +52fd 52fc 1de2 1de3 +531e 52fc 1de3 1ef3 +52fe 52fd 1cd2 1cd3 +531f 52fd 1cd3 1de3 +52ff 52fe 1bc2 1bc3 +5320 52fe 1bc3 1cd3 +5300 52ff 1ab2 1ab3 +5321 52ff 1ab3 1bc3 +5301 5300 19a2 19a3 +5322 5300 19a3 1ab3 +5302 5301 1892 1893 +5323 5301 1893 19a3 +5303 5302 1782 1783 +5324 5302 1783 1893 +5304 5303 1672 1673 +5325 5303 1673 1783 +5305 5304 1562 1563 +5326 5304 1563 1673 +5306 5305 1452 1453 +5327 5305 1453 1563 +5307 5306 1342 1343 +5328 5306 1343 1453 +5308 5307 1232 1233 +5329 5307 1233 1343 +532a 5308 1123 1233 +530a 5309 3433 3434 +532b 5309 3434 3544 +530b 530a 3323 3324 +532c 530a 3324 3434 +530c 530b 3213 3214 +532d 530b 3214 3324 +530d 530c 3103 3104 +532e 530c 3104 3214 +530e 530d 2ff3 2ff4 +532f 530d 2ff4 3104 +530f 530e 2ee3 2ee4 +5330 530e 2ee4 2ff4 +5310 530f 2dd3 2dd4 +5331 530f 2dd4 2ee4 +5311 5310 2cc3 2cc4 +5332 5310 2cc4 2dd4 +5312 5311 2bb3 2bb4 +5333 5311 2bb4 2cc4 +5313 5312 2aa3 2aa4 +5334 5312 2aa4 2bb4 +5314 5313 2993 2994 +5335 5313 2994 2aa4 +5315 5314 2883 2884 +5336 5314 2884 2994 +5316 5315 2773 2774 +5337 5315 2774 2884 +5317 5316 2663 2664 +5338 5316 2664 2774 +5318 5317 2553 2554 +5339 5317 2554 2664 +5319 5318 2443 2444 +533a 5318 2444 2554 +531a 5319 2333 2334 +533b 5319 2334 2444 +531b 531a 2223 2224 +533c 531a 2224 2334 +531c 531b 2113 2114 +533d 531b 2114 2224 +531d 531c 2003 2004 +533e 531c 2004 2114 +531e 531d 1ef3 1ef4 +533f 531d 1ef4 2004 +531f 531e 1de3 1de4 +5340 531e 1de4 1ef4 +5320 531f 1cd3 1cd4 +5341 531f 1cd4 1de4 +5321 5320 1bc3 1bc4 +5342 5320 1bc4 1cd4 +5322 5321 1ab3 1ab4 +5343 5321 1ab4 1bc4 +5323 5322 19a3 19a4 +5344 5322 19a4 1ab4 +5324 5323 1893 1894 +5345 5323 1894 19a4 +5325 5324 1783 1784 +5346 5324 1784 1894 +5326 5325 1673 1674 +5347 5325 1674 1784 +5327 5326 1563 1564 +5348 5326 1564 1674 +5328 5327 1453 1454 +5349 5327 1454 1564 +5329 5328 1343 1344 +534a 5328 1344 1454 +532a 5329 1233 1234 +534b 5329 1234 1344 +534c 532a 1124 1234 +532c 532b 3434 3435 +534d 532b 3435 3545 +532d 532c 3324 3325 +534e 532c 3325 3435 +532e 532d 3214 3215 +534f 532d 3215 3325 +532f 532e 3104 3105 +5350 532e 3105 3215 +5330 532f 2ff4 2ff5 +5351 532f 2ff5 3105 +5331 5330 2ee4 2ee5 +5352 5330 2ee5 2ff5 +5332 5331 2dd4 2dd5 +5353 5331 2dd5 2ee5 +5333 5332 2cc4 2cc5 +5354 5332 2cc5 2dd5 +5334 5333 2bb4 2bb5 +5355 5333 2bb5 2cc5 +5335 5334 2aa4 2aa5 +5356 5334 2aa5 2bb5 +5336 5335 2994 2995 +5357 5335 2995 2aa5 +5337 5336 2884 2885 +5358 5336 2885 2995 +5338 5337 2774 2775 +5359 5337 2775 2885 +5339 5338 2664 2665 +535a 5338 2665 2775 +533a 5339 2554 2555 +535b 5339 2555 2665 +533b 533a 2444 2445 +535c 533a 2445 2555 +533c 533b 2334 2335 +535d 533b 2335 2445 +533d 533c 2224 2225 +535e 533c 2225 2335 +533e 533d 2114 2115 +535f 533d 2115 2225 +533f 533e 2004 2005 +5360 533e 2005 2115 +5340 533f 1ef4 1ef5 +5361 533f 1ef5 2005 +5341 5340 1de4 1de5 +5362 5340 1de5 1ef5 +5342 5341 1cd4 1cd5 +5363 5341 1cd5 1de5 +5343 5342 1bc4 1bc5 +5364 5342 1bc5 1cd5 +5344 5343 1ab4 1ab5 +5365 5343 1ab5 1bc5 +5345 5344 19a4 19a5 +5366 5344 19a5 1ab5 +5346 5345 1894 1895 +5367 5345 1895 19a5 +5347 5346 1784 1785 +5368 5346 1785 1895 +5348 5347 1674 1675 +5369 5347 1675 1785 +5349 5348 1564 1565 +536a 5348 1565 1675 +534a 5349 1454 1455 +536b 5349 1455 1565 +534b 534a 1344 1345 +536c 534a 1345 1455 +534c 534b 1234 1235 +536d 534b 1235 1345 +536e 534c 1125 1235 +534e 534d 3435 3436 +536f 534d 3436 3546 +534f 534e 3325 3326 +5370 534e 3326 3436 +5350 534f 3215 3216 +5371 534f 3216 3326 +5351 5350 3105 3106 +5372 5350 3106 3216 +5352 5351 2ff5 2ff6 +5373 5351 2ff6 3106 +5353 5352 2ee5 2ee6 +5374 5352 2ee6 2ff6 +5354 5353 2dd5 2dd6 +5375 5353 2dd6 2ee6 +5355 5354 2cc5 2cc6 +5376 5354 2cc6 2dd6 +5356 5355 2bb5 2bb6 +5377 5355 2bb6 2cc6 +5357 5356 2aa5 2aa6 +5378 5356 2aa6 2bb6 +5358 5357 2995 2996 +5379 5357 2996 2aa6 +5359 5358 2885 2886 +537a 5358 2886 2996 +535a 5359 2775 2776 +537b 5359 2776 2886 +535b 535a 2665 2666 +537c 535a 2666 2776 +535c 535b 2555 2556 +537d 535b 2556 2666 +535d 535c 2445 2446 +537e 535c 2446 2556 +535e 535d 2335 2336 +537f 535d 2336 2446 +535f 535e 2225 2226 +5380 535e 2226 2336 +5360 535f 2115 2116 +5381 535f 2116 2226 +5361 5360 2005 2006 +5382 5360 2006 2116 +5362 5361 1ef5 1ef6 +5383 5361 1ef6 2006 +5363 5362 1de5 1de6 +5384 5362 1de6 1ef6 +5364 5363 1cd5 1cd6 +5385 5363 1cd6 1de6 +5365 5364 1bc5 1bc6 +5386 5364 1bc6 1cd6 +5366 5365 1ab5 1ab6 +5387 5365 1ab6 1bc6 +5367 5366 19a5 19a6 +5388 5366 19a6 1ab6 +5368 5367 1895 1896 +5389 5367 1896 19a6 +5369 5368 1785 1786 +538a 5368 1786 1896 +536a 5369 1675 1676 +538b 5369 1676 1786 +536b 536a 1565 1566 +538c 536a 1566 1676 +536c 536b 1455 1456 +538d 536b 1456 1566 +536d 536c 1345 1346 +538e 536c 1346 1456 +536e 536d 1235 1236 +538f 536d 1236 1346 +5390 536e 1126 1236 +5370 536f 3436 3437 +5391 536f 3437 3547 +5371 5370 3326 3327 +5392 5370 3327 3437 +5372 5371 3216 3217 +5393 5371 3217 3327 +5373 5372 3106 3107 +5394 5372 3107 3217 +5374 5373 2ff6 2ff7 +5395 5373 2ff7 3107 +5375 5374 2ee6 2ee7 +5396 5374 2ee7 2ff7 +5376 5375 2dd6 2dd7 +5397 5375 2dd7 2ee7 +5377 5376 2cc6 2cc7 +5398 5376 2cc7 2dd7 +5378 5377 2bb6 2bb7 +5399 5377 2bb7 2cc7 +5379 5378 2aa6 2aa7 +539a 5378 2aa7 2bb7 +537a 5379 2996 2997 +539b 5379 2997 2aa7 +537b 537a 2886 2887 +539c 537a 2887 2997 +537c 537b 2776 2777 +539d 537b 2777 2887 +537d 537c 2666 2667 +539e 537c 2667 2777 +537e 537d 2556 2557 +539f 537d 2557 2667 +537f 537e 2446 2447 +53a0 537e 2447 2557 +5380 537f 2336 2337 +53a1 537f 2337 2447 +5381 5380 2226 2227 +53a2 5380 2227 2337 +5382 5381 2116 2117 +53a3 5381 2117 2227 +5383 5382 2006 2007 +53a4 5382 2007 2117 +5384 5383 1ef6 1ef7 +53a5 5383 1ef7 2007 +5385 5384 1de6 1de7 +53a6 5384 1de7 1ef7 +5386 5385 1cd6 1cd7 +53a7 5385 1cd7 1de7 +5387 5386 1bc6 1bc7 +53a8 5386 1bc7 1cd7 +5388 5387 1ab6 1ab7 +53a9 5387 1ab7 1bc7 +5389 5388 19a6 19a7 +53aa 5388 19a7 1ab7 +538a 5389 1896 1897 +53ab 5389 1897 19a7 +538b 538a 1786 1787 +53ac 538a 1787 1897 +538c 538b 1676 1677 +53ad 538b 1677 1787 +538d 538c 1566 1567 +53ae 538c 1567 1677 +538e 538d 1456 1457 +53af 538d 1457 1567 +538f 538e 1346 1347 +53b0 538e 1347 1457 +5390 538f 1236 1237 +53b1 538f 1237 1347 +53b2 5390 1127 1237 +5392 5391 3437 3438 +53b3 5391 3438 3548 +5393 5392 3327 3328 +53b4 5392 3328 3438 +5394 5393 3217 3218 +53b5 5393 3218 3328 +5395 5394 3107 3108 +53b6 5394 3108 3218 +5396 5395 2ff7 2ff8 +53b7 5395 2ff8 3108 +5397 5396 2ee7 2ee8 +53b8 5396 2ee8 2ff8 +5398 5397 2dd7 2dd8 +53b9 5397 2dd8 2ee8 +5399 5398 2cc7 2cc8 +53ba 5398 2cc8 2dd8 +539a 5399 2bb7 2bb8 +53bb 5399 2bb8 2cc8 +539b 539a 2aa7 2aa8 +53bc 539a 2aa8 2bb8 +539c 539b 2997 2998 +53bd 539b 2998 2aa8 +539d 539c 2887 2888 +53be 539c 2888 2998 +539e 539d 2777 2778 +53bf 539d 2778 2888 +539f 539e 2667 2668 +53c0 539e 2668 2778 +53a0 539f 2557 2558 +53c1 539f 2558 2668 +53a1 53a0 2447 2448 +53c2 53a0 2448 2558 +53a2 53a1 2337 2338 +53c3 53a1 2338 2448 +53a3 53a2 2227 2228 +53c4 53a2 2228 2338 +53a4 53a3 2117 2118 +53c5 53a3 2118 2228 +53a5 53a4 2007 2008 +53c6 53a4 2008 2118 +53a6 53a5 1ef7 1ef8 +53c7 53a5 1ef8 2008 +53a7 53a6 1de7 1de8 +53c8 53a6 1de8 1ef8 +53a8 53a7 1cd7 1cd8 +53c9 53a7 1cd8 1de8 +53a9 53a8 1bc7 1bc8 +53ca 53a8 1bc8 1cd8 +53aa 53a9 1ab7 1ab8 +53cb 53a9 1ab8 1bc8 +53ab 53aa 19a7 19a8 +53cc 53aa 19a8 1ab8 +53ac 53ab 1897 1898 +53cd 53ab 1898 19a8 +53ad 53ac 1787 1788 +53ce 53ac 1788 1898 +53ae 53ad 1677 1678 +53cf 53ad 1678 1788 +53af 53ae 1567 1568 +53d0 53ae 1568 1678 +53b0 53af 1457 1458 +53d1 53af 1458 1568 +53b1 53b0 1347 1348 +53d2 53b0 1348 1458 +53b2 53b1 1237 1238 +53d3 53b1 1238 1348 +53d4 53b2 1128 1238 +53b4 53b3 3438 3439 +53d5 53b3 3439 3549 +53b5 53b4 3328 3329 +53d6 53b4 3329 3439 +53b6 53b5 3218 3219 +53d7 53b5 3219 3329 +53b7 53b6 3108 3109 +53d8 53b6 3109 3219 +53b8 53b7 2ff8 2ff9 +53d9 53b7 2ff9 3109 +53b9 53b8 2ee8 2ee9 +53da 53b8 2ee9 2ff9 +53ba 53b9 2dd8 2dd9 +53db 53b9 2dd9 2ee9 +53bb 53ba 2cc8 2cc9 +53dc 53ba 2cc9 2dd9 +53bc 53bb 2bb8 2bb9 +53dd 53bb 2bb9 2cc9 +53bd 53bc 2aa8 2aa9 +53de 53bc 2aa9 2bb9 +53be 53bd 2998 2999 +53df 53bd 2999 2aa9 +53bf 53be 2888 2889 +53e0 53be 2889 2999 +53c0 53bf 2778 2779 +53e1 53bf 2779 2889 +53c1 53c0 2668 2669 +53e2 53c0 2669 2779 +53c2 53c1 2558 2559 +53e3 53c1 2559 2669 +53c3 53c2 2448 2449 +53e4 53c2 2449 2559 +53c4 53c3 2338 2339 +53e5 53c3 2339 2449 +53c5 53c4 2228 2229 +53e6 53c4 2229 2339 +53c6 53c5 2118 2119 +53e7 53c5 2119 2229 +53c7 53c6 2008 2009 +53e8 53c6 2009 2119 +53c8 53c7 1ef8 1ef9 +53e9 53c7 1ef9 2009 +53c9 53c8 1de8 1de9 +53ea 53c8 1de9 1ef9 +53ca 53c9 1cd8 1cd9 +53eb 53c9 1cd9 1de9 +53cb 53ca 1bc8 1bc9 +53ec 53ca 1bc9 1cd9 +53cc 53cb 1ab8 1ab9 +53ed 53cb 1ab9 1bc9 +53cd 53cc 19a8 19a9 +53ee 53cc 19a9 1ab9 +53ce 53cd 1898 1899 +53ef 53cd 1899 19a9 +53cf 53ce 1788 1789 +53f0 53ce 1789 1899 +53d0 53cf 1678 1679 +53f1 53cf 1679 1789 +53d1 53d0 1568 1569 +53f2 53d0 1569 1679 +53d2 53d1 1458 1459 +53f3 53d1 1459 1569 +53d3 53d2 1348 1349 +53f4 53d2 1349 1459 +53d4 53d3 1238 1239 +53f5 53d3 1239 1349 +53f6 53d4 1129 1239 +53d6 53d5 3439 343a +53f7 53d5 343a 354a +53d7 53d6 3329 332a +53f8 53d6 332a 343a +53d8 53d7 3219 321a +53f9 53d7 321a 332a +53d9 53d8 3109 310a +53fa 53d8 310a 321a +53da 53d9 2ff9 2ffa +53fb 53d9 2ffa 310a +53db 53da 2ee9 2eea +53fc 53da 2eea 2ffa +53dc 53db 2dd9 2dda +53fd 53db 2dda 2eea +53dd 53dc 2cc9 2cca +53fe 53dc 2cca 2dda +53de 53dd 2bb9 2bba +53ff 53dd 2bba 2cca +53df 53de 2aa9 2aaa +5400 53de 2aaa 2bba +53e0 53df 2999 299a +5401 53df 299a 2aaa +53e1 53e0 2889 288a +5402 53e0 288a 299a +53e2 53e1 2779 277a +5403 53e1 277a 288a +53e3 53e2 2669 266a +5404 53e2 266a 277a +53e4 53e3 2559 255a +5405 53e3 255a 266a +53e5 53e4 2449 244a +5406 53e4 244a 255a +53e6 53e5 2339 233a +5407 53e5 233a 244a +53e7 53e6 2229 222a +5408 53e6 222a 233a +53e8 53e7 2119 211a +5409 53e7 211a 222a +53e9 53e8 2009 200a +540a 53e8 200a 211a +53ea 53e9 1ef9 1efa +540b 53e9 1efa 200a +53eb 53ea 1de9 1dea +540c 53ea 1dea 1efa +53ec 53eb 1cd9 1cda +540d 53eb 1cda 1dea +53ed 53ec 1bc9 1bca +540e 53ec 1bca 1cda +53ee 53ed 1ab9 1aba +540f 53ed 1aba 1bca +53ef 53ee 19a9 19aa +5410 53ee 19aa 1aba +53f0 53ef 1899 189a +5411 53ef 189a 19aa +53f1 53f0 1789 178a +5412 53f0 178a 189a +53f2 53f1 1679 167a +5413 53f1 167a 178a +53f3 53f2 1569 156a +5414 53f2 156a 167a +53f4 53f3 1459 145a +5415 53f3 145a 156a +53f5 53f4 1349 134a +5416 53f4 134a 145a +53f6 53f5 1239 123a +5417 53f5 123a 134a +5418 53f6 112a 123a +53f8 53f7 343a 343b +5419 53f7 343b 354b +53f9 53f8 332a 332b +541a 53f8 332b 343b +53fa 53f9 321a 321b +541b 53f9 321b 332b +53fb 53fa 310a 310b +541c 53fa 310b 321b +53fc 53fb 2ffa 2ffb +541d 53fb 2ffb 310b +53fd 53fc 2eea 2eeb +541e 53fc 2eeb 2ffb +53fe 53fd 2dda 2ddb +541f 53fd 2ddb 2eeb +53ff 53fe 2cca 2ccb +5420 53fe 2ccb 2ddb +5400 53ff 2bba 2bbb +5421 53ff 2bbb 2ccb +5401 5400 2aaa 2aab +5422 5400 2aab 2bbb +5402 5401 299a 299b +5423 5401 299b 2aab +5403 5402 288a 288b +5424 5402 288b 299b +5404 5403 277a 277b +5425 5403 277b 288b +5405 5404 266a 266b +5426 5404 266b 277b +5406 5405 255a 255b +5427 5405 255b 266b +5407 5406 244a 244b +5428 5406 244b 255b +5408 5407 233a 233b +5429 5407 233b 244b +5409 5408 222a 222b +542a 5408 222b 233b +540a 5409 211a 211b +542b 5409 211b 222b +540b 540a 200a 200b +542c 540a 200b 211b +540c 540b 1efa 1efb +542d 540b 1efb 200b +540d 540c 1dea 1deb +542e 540c 1deb 1efb +540e 540d 1cda 1cdb +542f 540d 1cdb 1deb +540f 540e 1bca 1bcb +5430 540e 1bcb 1cdb +5410 540f 1aba 1abb +5431 540f 1abb 1bcb +5411 5410 19aa 19ab +5432 5410 19ab 1abb +5412 5411 189a 189b +5433 5411 189b 19ab +5413 5412 178a 178b +5434 5412 178b 189b +5414 5413 167a 167b +5435 5413 167b 178b +5415 5414 156a 156b +5436 5414 156b 167b +5416 5415 145a 145b +5437 5415 145b 156b +5417 5416 134a 134b +5438 5416 134b 145b +5418 5417 123a 123b +5439 5417 123b 134b +543a 5418 112b 123b +541a 5419 343b 343c +543b 5419 343c 354c +541b 541a 332b 332c +543c 541a 332c 343c +541c 541b 321b 321c +543d 541b 321c 332c +541d 541c 310b 310c +543e 541c 310c 321c +541e 541d 2ffb 2ffc +543f 541d 2ffc 310c +541f 541e 2eeb 2eec +5440 541e 2eec 2ffc +5420 541f 2ddb 2ddc +5441 541f 2ddc 2eec +5421 5420 2ccb 2ccc +5442 5420 2ccc 2ddc +5422 5421 2bbb 2bbc +5443 5421 2bbc 2ccc +5423 5422 2aab 2aac +5444 5422 2aac 2bbc +5424 5423 299b 299c +5445 5423 299c 2aac +5425 5424 288b 288c +5446 5424 288c 299c +5426 5425 277b 277c +5447 5425 277c 288c +5427 5426 266b 266c +5448 5426 266c 277c +5428 5427 255b 255c +5449 5427 255c 266c +5429 5428 244b 244c +544a 5428 244c 255c +542a 5429 233b 233c +544b 5429 233c 244c +542b 542a 222b 222c +544c 542a 222c 233c +542c 542b 211b 211c +544d 542b 211c 222c +542d 542c 200b 200c +544e 542c 200c 211c +542e 542d 1efb 1efc +544f 542d 1efc 200c +542f 542e 1deb 1dec +5450 542e 1dec 1efc +5430 542f 1cdb 1cdc +5451 542f 1cdc 1dec +5431 5430 1bcb 1bcc +5452 5430 1bcc 1cdc +5432 5431 1abb 1abc +5453 5431 1abc 1bcc +5433 5432 19ab 19ac +5454 5432 19ac 1abc +5434 5433 189b 189c +5455 5433 189c 19ac +5435 5434 178b 178c +5456 5434 178c 189c +5436 5435 167b 167c +5457 5435 167c 178c +5437 5436 156b 156c +5458 5436 156c 167c +5438 5437 145b 145c +5459 5437 145c 156c +5439 5438 134b 134c +545a 5438 134c 145c +543a 5439 123b 123c +545b 5439 123c 134c +545c 543a 112c 123c +543c 543b 343c 343d +545d 543b 343d 354d +543d 543c 332c 332d +545e 543c 332d 343d +543e 543d 321c 321d +545f 543d 321d 332d +543f 543e 310c 310d +5460 543e 310d 321d +5440 543f 2ffc 2ffd +5461 543f 2ffd 310d +5441 5440 2eec 2eed +5462 5440 2eed 2ffd +5442 5441 2ddc 2ddd +5463 5441 2ddd 2eed +5443 5442 2ccc 2ccd +5464 5442 2ccd 2ddd +5444 5443 2bbc 2bbd +5465 5443 2bbd 2ccd +5445 5444 2aac 2aad +5466 5444 2aad 2bbd +5446 5445 299c 299d +5467 5445 299d 2aad +5447 5446 288c 288d +5468 5446 288d 299d +5448 5447 277c 277d +5469 5447 277d 288d +5449 5448 266c 266d +546a 5448 266d 277d +544a 5449 255c 255d +546b 5449 255d 266d +544b 544a 244c 244d +546c 544a 244d 255d +544c 544b 233c 233d +546d 544b 233d 244d +544d 544c 222c 222d +546e 544c 222d 233d +544e 544d 211c 211d +546f 544d 211d 222d +544f 544e 200c 200d +5470 544e 200d 211d +5450 544f 1efc 1efd +5471 544f 1efd 200d +5451 5450 1dec 1ded +5472 5450 1ded 1efd +5452 5451 1cdc 1cdd +5473 5451 1cdd 1ded +5453 5452 1bcc 1bcd +5474 5452 1bcd 1cdd +5454 5453 1abc 1abd +5475 5453 1abd 1bcd +5455 5454 19ac 19ad +5476 5454 19ad 1abd +5456 5455 189c 189d +5477 5455 189d 19ad +5457 5456 178c 178d +5478 5456 178d 189d +5458 5457 167c 167d +5479 5457 167d 178d +5459 5458 156c 156d +547a 5458 156d 167d +545a 5459 145c 145d +547b 5459 145d 156d +545b 545a 134c 134d +547c 545a 134d 145d +545c 545b 123c 123d +547d 545b 123d 134d +547e 545c 112d 123d +545e 545d 343d 343e +547f 545d 343e 354e +545f 545e 332d 332e +5480 545e 332e 343e +5460 545f 321d 321e +5481 545f 321e 332e +5461 5460 310d 310e +5482 5460 310e 321e +5462 5461 2ffd 2ffe +5483 5461 2ffe 310e +5463 5462 2eed 2eee +5484 5462 2eee 2ffe +5464 5463 2ddd 2dde +5485 5463 2dde 2eee +5465 5464 2ccd 2cce +5486 5464 2cce 2dde +5466 5465 2bbd 2bbe +5487 5465 2bbe 2cce +5467 5466 2aad 2aae +5488 5466 2aae 2bbe +5468 5467 299d 299e +5489 5467 299e 2aae +5469 5468 288d 288e +548a 5468 288e 299e +546a 5469 277d 277e +548b 5469 277e 288e +546b 546a 266d 266e +548c 546a 266e 277e +546c 546b 255d 255e +548d 546b 255e 266e +546d 546c 244d 244e +548e 546c 244e 255e +546e 546d 233d 233e +548f 546d 233e 244e +546f 546e 222d 222e +5490 546e 222e 233e +5470 546f 211d 211e +5491 546f 211e 222e +5471 5470 200d 200e +5492 5470 200e 211e +5472 5471 1efd 1efe +5493 5471 1efe 200e +5473 5472 1ded 1dee +5494 5472 1dee 1efe +5474 5473 1cdd 1cde +5495 5473 1cde 1dee +5475 5474 1bcd 1bce +5496 5474 1bce 1cde +5476 5475 1abd 1abe +5497 5475 1abe 1bce +5477 5476 19ad 19ae +5498 5476 19ae 1abe +5478 5477 189d 189e +5499 5477 189e 19ae +5479 5478 178d 178e +549a 5478 178e 189e +547a 5479 167d 167e +549b 5479 167e 178e +547b 547a 156d 156e +549c 547a 156e 167e +547c 547b 145d 145e +549d 547b 145e 156e +547d 547c 134d 134e +549e 547c 134e 145e +547e 547d 123d 123e +549f 547d 123e 134e +54a0 547e 112e 123e +5480 547f 343e 343f +54a1 547f 343f 354f +5481 5480 332e 332f +54a2 5480 332f 343f +5482 5481 321e 321f +54a3 5481 321f 332f +5483 5482 310e 310f +54a4 5482 310f 321f +5484 5483 2ffe 2fff +54a5 5483 2fff 310f +5485 5484 2eee 2eef +54a6 5484 2eef 2fff +5486 5485 2dde 2ddf +54a7 5485 2ddf 2eef +5487 5486 2cce 2ccf +54a8 5486 2ccf 2ddf +5488 5487 2bbe 2bbf +54a9 5487 2bbf 2ccf +5489 5488 2aae 2aaf +54aa 5488 2aaf 2bbf +548a 5489 299e 299f +54ab 5489 299f 2aaf +548b 548a 288e 288f +54ac 548a 288f 299f +548c 548b 277e 277f +54ad 548b 277f 288f +548d 548c 266e 266f +54ae 548c 266f 277f +548e 548d 255e 255f +54af 548d 255f 266f +548f 548e 244e 244f +54b0 548e 244f 255f +5490 548f 233e 233f +54b1 548f 233f 244f +5491 5490 222e 222f +54b2 5490 222f 233f +5492 5491 211e 211f +54b3 5491 211f 222f +5493 5492 200e 200f +54b4 5492 200f 211f +5494 5493 1efe 1eff +54b5 5493 1eff 200f +5495 5494 1dee 1def +54b6 5494 1def 1eff +5496 5495 1cde 1cdf +54b7 5495 1cdf 1def +5497 5496 1bce 1bcf +54b8 5496 1bcf 1cdf +5498 5497 1abe 1abf +54b9 5497 1abf 1bcf +5499 5498 19ae 19af +54ba 5498 19af 1abf +549a 5499 189e 189f +54bb 5499 189f 19af +549b 549a 178e 178f +54bc 549a 178f 189f +549c 549b 167e 167f +54bd 549b 167f 178f +549d 549c 156e 156f +54be 549c 156f 167f +549e 549d 145e 145f +54bf 549d 145f 156f +549f 549e 134e 134f +54c0 549e 134f 145f +54a0 549f 123e 123f +54c1 549f 123f 134f +54c2 54a0 112f 123f +54a2 54a1 343f 3440 +54c3 54a1 3440 3550 +54a3 54a2 332f 3330 +54c4 54a2 3330 3440 +54a4 54a3 321f 3220 +54c5 54a3 3220 3330 +54a5 54a4 310f 3110 +54c6 54a4 3110 3220 +54a6 54a5 2fff 3000 +54c7 54a5 3000 3110 +54a7 54a6 2eef 2ef0 +54c8 54a6 2ef0 3000 +54a8 54a7 2ddf 2de0 +54c9 54a7 2de0 2ef0 +54a9 54a8 2ccf 2cd0 +54ca 54a8 2cd0 2de0 +54aa 54a9 2bbf 2bc0 +54cb 54a9 2bc0 2cd0 +54ab 54aa 2aaf 2ab0 +54cc 54aa 2ab0 2bc0 +54ac 54ab 299f 29a0 +54cd 54ab 29a0 2ab0 +54ad 54ac 288f 2890 +54ce 54ac 2890 29a0 +54ae 54ad 277f 2780 +54cf 54ad 2780 2890 +54af 54ae 266f 2670 +54d0 54ae 2670 2780 +54b0 54af 255f 2560 +54d1 54af 2560 2670 +54b1 54b0 244f 2450 +54d2 54b0 2450 2560 +54b2 54b1 233f 2340 +54d3 54b1 2340 2450 +54b3 54b2 222f 2230 +54d4 54b2 2230 2340 +54b4 54b3 211f 2120 +54d5 54b3 2120 2230 +54b5 54b4 200f 2010 +54d6 54b4 2010 2120 +54b6 54b5 1eff 1f00 +54d7 54b5 1f00 2010 +54b7 54b6 1def 1df0 +54d8 54b6 1df0 1f00 +54b8 54b7 1cdf 1ce0 +54d9 54b7 1ce0 1df0 +54b9 54b8 1bcf 1bd0 +54da 54b8 1bd0 1ce0 +54ba 54b9 1abf 1ac0 +54db 54b9 1ac0 1bd0 +54bb 54ba 19af 19b0 +54dc 54ba 19b0 1ac0 +54bc 54bb 189f 18a0 +54dd 54bb 18a0 19b0 +54bd 54bc 178f 1790 +54de 54bc 1790 18a0 +54be 54bd 167f 1680 +54df 54bd 1680 1790 +54bf 54be 156f 1570 +54e0 54be 1570 1680 +54c0 54bf 145f 1460 +54e1 54bf 1460 1570 +54c1 54c0 134f 1350 +54e2 54c0 1350 1460 +54c2 54c1 123f 1240 +54e3 54c1 1240 1350 +54e4 54c2 1130 1240 +54c4 54c3 3440 3441 +54e5 54c3 3441 3551 +54c5 54c4 3330 3331 +54e6 54c4 3331 3441 +54c6 54c5 3220 3221 +54e7 54c5 3221 3331 +54c7 54c6 3110 3111 +54e8 54c6 3111 3221 +54c8 54c7 3000 3001 +54e9 54c7 3001 3111 +54c9 54c8 2ef0 2ef1 +54ea 54c8 2ef1 3001 +54ca 54c9 2de0 2de1 +54eb 54c9 2de1 2ef1 +54cb 54ca 2cd0 2cd1 +54ec 54ca 2cd1 2de1 +54cc 54cb 2bc0 2bc1 +54ed 54cb 2bc1 2cd1 +54cd 54cc 2ab0 2ab1 +54ee 54cc 2ab1 2bc1 +54ce 54cd 29a0 29a1 +54ef 54cd 29a1 2ab1 +54cf 54ce 2890 2891 +54f0 54ce 2891 29a1 +54d0 54cf 2780 2781 +54f1 54cf 2781 2891 +54d1 54d0 2670 2671 +54f2 54d0 2671 2781 +54d2 54d1 2560 2561 +54f3 54d1 2561 2671 +54d3 54d2 2450 2451 +54f4 54d2 2451 2561 +54d4 54d3 2340 2341 +54f5 54d3 2341 2451 +54d5 54d4 2230 2231 +54f6 54d4 2231 2341 +54d6 54d5 2120 2121 +54f7 54d5 2121 2231 +54d7 54d6 2010 2011 +54f8 54d6 2011 2121 +54d8 54d7 1f00 1f01 +54f9 54d7 1f01 2011 +54d9 54d8 1df0 1df1 +54fa 54d8 1df1 1f01 +54da 54d9 1ce0 1ce1 +54fb 54d9 1ce1 1df1 +54db 54da 1bd0 1bd1 +54fc 54da 1bd1 1ce1 +54dc 54db 1ac0 1ac1 +54fd 54db 1ac1 1bd1 +54dd 54dc 19b0 19b1 +54fe 54dc 19b1 1ac1 +54de 54dd 18a0 18a1 +54ff 54dd 18a1 19b1 +54df 54de 1790 1791 +5500 54de 1791 18a1 +54e0 54df 1680 1681 +5501 54df 1681 1791 +54e1 54e0 1570 1571 +5502 54e0 1571 1681 +54e2 54e1 1460 1461 +5503 54e1 1461 1571 +54e3 54e2 1350 1351 +5504 54e2 1351 1461 +54e4 54e3 1240 1241 +5505 54e3 1241 1351 +5506 54e4 1131 1241 +54e6 54e5 3441 3442 +5507 54e5 3442 3552 +54e7 54e6 3331 3332 +5508 54e6 3332 3442 +54e8 54e7 3221 3222 +5509 54e7 3222 3332 +54e9 54e8 3111 3112 +550a 54e8 3112 3222 +54ea 54e9 3001 3002 +550b 54e9 3002 3112 +54eb 54ea 2ef1 2ef2 +550c 54ea 2ef2 3002 +54ec 54eb 2de1 2de2 +550d 54eb 2de2 2ef2 +54ed 54ec 2cd1 2cd2 +550e 54ec 2cd2 2de2 +54ee 54ed 2bc1 2bc2 +550f 54ed 2bc2 2cd2 +54ef 54ee 2ab1 2ab2 +5510 54ee 2ab2 2bc2 +54f0 54ef 29a1 29a2 +5511 54ef 29a2 2ab2 +54f1 54f0 2891 2892 +5512 54f0 2892 29a2 +54f2 54f1 2781 2782 +5513 54f1 2782 2892 +54f3 54f2 2671 2672 +5514 54f2 2672 2782 +54f4 54f3 2561 2562 +5515 54f3 2562 2672 +54f5 54f4 2451 2452 +5516 54f4 2452 2562 +54f6 54f5 2341 2342 +5517 54f5 2342 2452 +54f7 54f6 2231 2232 +5518 54f6 2232 2342 +54f8 54f7 2121 2122 +5519 54f7 2122 2232 +54f9 54f8 2011 2012 +551a 54f8 2012 2122 +54fa 54f9 1f01 1f02 +551b 54f9 1f02 2012 +54fb 54fa 1df1 1df2 +551c 54fa 1df2 1f02 +54fc 54fb 1ce1 1ce2 +551d 54fb 1ce2 1df2 +54fd 54fc 1bd1 1bd2 +551e 54fc 1bd2 1ce2 +54fe 54fd 1ac1 1ac2 +551f 54fd 1ac2 1bd2 +54ff 54fe 19b1 19b2 +5520 54fe 19b2 1ac2 +5500 54ff 18a1 18a2 +5521 54ff 18a2 19b2 +5501 5500 1791 1792 +5522 5500 1792 18a2 +5502 5501 1681 1682 +5523 5501 1682 1792 +5503 5502 1571 1572 +5524 5502 1572 1682 +5504 5503 1461 1462 +5525 5503 1462 1572 +5505 5504 1351 1352 +5526 5504 1352 1462 +5506 5505 1241 1242 +5527 5505 1242 1352 +5528 5506 1132 1242 +5508 5507 3442 3443 +5529 5507 3443 3553 +5509 5508 3332 3333 +552a 5508 3333 3443 +550a 5509 3222 3223 +552b 5509 3223 3333 +550b 550a 3112 3113 +552c 550a 3113 3223 +550c 550b 3002 3003 +552d 550b 3003 3113 +550d 550c 2ef2 2ef3 +552e 550c 2ef3 3003 +550e 550d 2de2 2de3 +552f 550d 2de3 2ef3 +550f 550e 2cd2 2cd3 +5530 550e 2cd3 2de3 +5510 550f 2bc2 2bc3 +5531 550f 2bc3 2cd3 +5511 5510 2ab2 2ab3 +5532 5510 2ab3 2bc3 +5512 5511 29a2 29a3 +5533 5511 29a3 2ab3 +5513 5512 2892 2893 +5534 5512 2893 29a3 +5514 5513 2782 2783 +5535 5513 2783 2893 +5515 5514 2672 2673 +5536 5514 2673 2783 +5516 5515 2562 2563 +5537 5515 2563 2673 +5517 5516 2452 2453 +5538 5516 2453 2563 +5518 5517 2342 2343 +5539 5517 2343 2453 +5519 5518 2232 2233 +553a 5518 2233 2343 +551a 5519 2122 2123 +553b 5519 2123 2233 +551b 551a 2012 2013 +553c 551a 2013 2123 +551c 551b 1f02 1f03 +553d 551b 1f03 2013 +551d 551c 1df2 1df3 +553e 551c 1df3 1f03 +551e 551d 1ce2 1ce3 +553f 551d 1ce3 1df3 +551f 551e 1bd2 1bd3 +5540 551e 1bd3 1ce3 +5520 551f 1ac2 1ac3 +5541 551f 1ac3 1bd3 +5521 5520 19b2 19b3 +5542 5520 19b3 1ac3 +5522 5521 18a2 18a3 +5543 5521 18a3 19b3 +5523 5522 1792 1793 +5544 5522 1793 18a3 +5524 5523 1682 1683 +5545 5523 1683 1793 +5525 5524 1572 1573 +5546 5524 1573 1683 +5526 5525 1462 1463 +5547 5525 1463 1573 +5527 5526 1352 1353 +5548 5526 1353 1463 +5528 5527 1242 1243 +5549 5527 1243 1353 +554a 5528 1133 1243 +552a 5529 3443 3444 +554b 5529 3444 3554 +552b 552a 3333 3334 +554c 552a 3334 3444 +552c 552b 3223 3224 +554d 552b 3224 3334 +552d 552c 3113 3114 +554e 552c 3114 3224 +552e 552d 3003 3004 +554f 552d 3004 3114 +552f 552e 2ef3 2ef4 +5550 552e 2ef4 3004 +5530 552f 2de3 2de4 +5551 552f 2de4 2ef4 +5531 5530 2cd3 2cd4 +5552 5530 2cd4 2de4 +5532 5531 2bc3 2bc4 +5553 5531 2bc4 2cd4 +5533 5532 2ab3 2ab4 +5554 5532 2ab4 2bc4 +5534 5533 29a3 29a4 +5555 5533 29a4 2ab4 +5535 5534 2893 2894 +5556 5534 2894 29a4 +5536 5535 2783 2784 +5557 5535 2784 2894 +5537 5536 2673 2674 +5558 5536 2674 2784 +5538 5537 2563 2564 +5559 5537 2564 2674 +5539 5538 2453 2454 +555a 5538 2454 2564 +553a 5539 2343 2344 +555b 5539 2344 2454 +553b 553a 2233 2234 +555c 553a 2234 2344 +553c 553b 2123 2124 +555d 553b 2124 2234 +553d 553c 2013 2014 +555e 553c 2014 2124 +553e 553d 1f03 1f04 +555f 553d 1f04 2014 +553f 553e 1df3 1df4 +5560 553e 1df4 1f04 +5540 553f 1ce3 1ce4 +5561 553f 1ce4 1df4 +5541 5540 1bd3 1bd4 +5562 5540 1bd4 1ce4 +5542 5541 1ac3 1ac4 +5563 5541 1ac4 1bd4 +5543 5542 19b3 19b4 +5564 5542 19b4 1ac4 +5544 5543 18a3 18a4 +5565 5543 18a4 19b4 +5545 5544 1793 1794 +5566 5544 1794 18a4 +5546 5545 1683 1684 +5567 5545 1684 1794 +5547 5546 1573 1574 +5568 5546 1574 1684 +5548 5547 1463 1464 +5569 5547 1464 1574 +5549 5548 1353 1354 +556a 5548 1354 1464 +554a 5549 1243 1244 +556b 5549 1244 1354 +556c 554a 1134 1244 +554c 554b 3444 3445 +556d 554b 3445 3555 +554d 554c 3334 3335 +556e 554c 3335 3445 +554e 554d 3224 3225 +556f 554d 3225 3335 +554f 554e 3114 3115 +5570 554e 3115 3225 +5550 554f 3004 3005 +5571 554f 3005 3115 +5551 5550 2ef4 2ef5 +5572 5550 2ef5 3005 +5552 5551 2de4 2de5 +5573 5551 2de5 2ef5 +5553 5552 2cd4 2cd5 +5574 5552 2cd5 2de5 +5554 5553 2bc4 2bc5 +5575 5553 2bc5 2cd5 +5555 5554 2ab4 2ab5 +5576 5554 2ab5 2bc5 +5556 5555 29a4 29a5 +5577 5555 29a5 2ab5 +5557 5556 2894 2895 +5578 5556 2895 29a5 +5558 5557 2784 2785 +5579 5557 2785 2895 +5559 5558 2674 2675 +557a 5558 2675 2785 +555a 5559 2564 2565 +557b 5559 2565 2675 +555b 555a 2454 2455 +557c 555a 2455 2565 +555c 555b 2344 2345 +557d 555b 2345 2455 +555d 555c 2234 2235 +557e 555c 2235 2345 +555e 555d 2124 2125 +557f 555d 2125 2235 +555f 555e 2014 2015 +5580 555e 2015 2125 +5560 555f 1f04 1f05 +5581 555f 1f05 2015 +5561 5560 1df4 1df5 +5582 5560 1df5 1f05 +5562 5561 1ce4 1ce5 +5583 5561 1ce5 1df5 +5563 5562 1bd4 1bd5 +5584 5562 1bd5 1ce5 +5564 5563 1ac4 1ac5 +5585 5563 1ac5 1bd5 +5565 5564 19b4 19b5 +5586 5564 19b5 1ac5 +5566 5565 18a4 18a5 +5587 5565 18a5 19b5 +5567 5566 1794 1795 +5588 5566 1795 18a5 +5568 5567 1684 1685 +5589 5567 1685 1795 +5569 5568 1574 1575 +558a 5568 1575 1685 +556a 5569 1464 1465 +558b 5569 1465 1575 +556b 556a 1354 1355 +558c 556a 1355 1465 +556c 556b 1244 1245 +558d 556b 1245 1355 +558e 556c 1135 1245 +556e 556d 3445 3446 +558f 556d 3446 3556 +556f 556e 3335 3336 +5590 556e 3336 3446 +5570 556f 3225 3226 +5591 556f 3226 3336 +5571 5570 3115 3116 +5592 5570 3116 3226 +5572 5571 3005 3006 +5593 5571 3006 3116 +5573 5572 2ef5 2ef6 +5594 5572 2ef6 3006 +5574 5573 2de5 2de6 +5595 5573 2de6 2ef6 +5575 5574 2cd5 2cd6 +5596 5574 2cd6 2de6 +5576 5575 2bc5 2bc6 +5597 5575 2bc6 2cd6 +5577 5576 2ab5 2ab6 +5598 5576 2ab6 2bc6 +5578 5577 29a5 29a6 +5599 5577 29a6 2ab6 +5579 5578 2895 2896 +559a 5578 2896 29a6 +557a 5579 2785 2786 +559b 5579 2786 2896 +557b 557a 2675 2676 +559c 557a 2676 2786 +557c 557b 2565 2566 +559d 557b 2566 2676 +557d 557c 2455 2456 +559e 557c 2456 2566 +557e 557d 2345 2346 +559f 557d 2346 2456 +557f 557e 2235 2236 +55a0 557e 2236 2346 +5580 557f 2125 2126 +55a1 557f 2126 2236 +5581 5580 2015 2016 +55a2 5580 2016 2126 +5582 5581 1f05 1f06 +55a3 5581 1f06 2016 +5583 5582 1df5 1df6 +55a4 5582 1df6 1f06 +5584 5583 1ce5 1ce6 +55a5 5583 1ce6 1df6 +5585 5584 1bd5 1bd6 +55a6 5584 1bd6 1ce6 +5586 5585 1ac5 1ac6 +55a7 5585 1ac6 1bd6 +5587 5586 19b5 19b6 +55a8 5586 19b6 1ac6 +5588 5587 18a5 18a6 +55a9 5587 18a6 19b6 +5589 5588 1795 1796 +55aa 5588 1796 18a6 +558a 5589 1685 1686 +55ab 5589 1686 1796 +558b 558a 1575 1576 +55ac 558a 1576 1686 +558c 558b 1465 1466 +55ad 558b 1466 1576 +558d 558c 1355 1356 +55ae 558c 1356 1466 +558e 558d 1245 1246 +55af 558d 1246 1356 +55b0 558e 1136 1246 +5590 558f 3446 3447 +55b1 558f 3447 3557 +5591 5590 3336 3337 +55b2 5590 3337 3447 +5592 5591 3226 3227 +55b3 5591 3227 3337 +5593 5592 3116 3117 +55b4 5592 3117 3227 +5594 5593 3006 3007 +55b5 5593 3007 3117 +5595 5594 2ef6 2ef7 +55b6 5594 2ef7 3007 +5596 5595 2de6 2de7 +55b7 5595 2de7 2ef7 +5597 5596 2cd6 2cd7 +55b8 5596 2cd7 2de7 +5598 5597 2bc6 2bc7 +55b9 5597 2bc7 2cd7 +5599 5598 2ab6 2ab7 +55ba 5598 2ab7 2bc7 +559a 5599 29a6 29a7 +55bb 5599 29a7 2ab7 +559b 559a 2896 2897 +55bc 559a 2897 29a7 +559c 559b 2786 2787 +55bd 559b 2787 2897 +559d 559c 2676 2677 +55be 559c 2677 2787 +559e 559d 2566 2567 +55bf 559d 2567 2677 +559f 559e 2456 2457 +55c0 559e 2457 2567 +55a0 559f 2346 2347 +55c1 559f 2347 2457 +55a1 55a0 2236 2237 +55c2 55a0 2237 2347 +55a2 55a1 2126 2127 +55c3 55a1 2127 2237 +55a3 55a2 2016 2017 +55c4 55a2 2017 2127 +55a4 55a3 1f06 1f07 +55c5 55a3 1f07 2017 +55a5 55a4 1df6 1df7 +55c6 55a4 1df7 1f07 +55a6 55a5 1ce6 1ce7 +55c7 55a5 1ce7 1df7 +55a7 55a6 1bd6 1bd7 +55c8 55a6 1bd7 1ce7 +55a8 55a7 1ac6 1ac7 +55c9 55a7 1ac7 1bd7 +55a9 55a8 19b6 19b7 +55ca 55a8 19b7 1ac7 +55aa 55a9 18a6 18a7 +55cb 55a9 18a7 19b7 +55ab 55aa 1796 1797 +55cc 55aa 1797 18a7 +55ac 55ab 1686 1687 +55cd 55ab 1687 1797 +55ad 55ac 1576 1577 +55ce 55ac 1577 1687 +55ae 55ad 1466 1467 +55cf 55ad 1467 1577 +55af 55ae 1356 1357 +55d0 55ae 1357 1467 +55b0 55af 1246 1247 +55d1 55af 1247 1357 +55d2 55b0 1137 1247 +55b2 55b1 3447 3448 +55d3 55b1 3448 3558 +55b3 55b2 3337 3338 +55d4 55b2 3338 3448 +55b4 55b3 3227 3228 +55d5 55b3 3228 3338 +55b5 55b4 3117 3118 +55d6 55b4 3118 3228 +55b6 55b5 3007 3008 +55d7 55b5 3008 3118 +55b7 55b6 2ef7 2ef8 +55d8 55b6 2ef8 3008 +55b8 55b7 2de7 2de8 +55d9 55b7 2de8 2ef8 +55b9 55b8 2cd7 2cd8 +55da 55b8 2cd8 2de8 +55ba 55b9 2bc7 2bc8 +55db 55b9 2bc8 2cd8 +55bb 55ba 2ab7 2ab8 +55dc 55ba 2ab8 2bc8 +55bc 55bb 29a7 29a8 +55dd 55bb 29a8 2ab8 +55bd 55bc 2897 2898 +55de 55bc 2898 29a8 +55be 55bd 2787 2788 +55df 55bd 2788 2898 +55bf 55be 2677 2678 +55e0 55be 2678 2788 +55c0 55bf 2567 2568 +55e1 55bf 2568 2678 +55c1 55c0 2457 2458 +55e2 55c0 2458 2568 +55c2 55c1 2347 2348 +55e3 55c1 2348 2458 +55c3 55c2 2237 2238 +55e4 55c2 2238 2348 +55c4 55c3 2127 2128 +55e5 55c3 2128 2238 +55c5 55c4 2017 2018 +55e6 55c4 2018 2128 +55c6 55c5 1f07 1f08 +55e7 55c5 1f08 2018 +55c7 55c6 1df7 1df8 +55e8 55c6 1df8 1f08 +55c8 55c7 1ce7 1ce8 +55e9 55c7 1ce8 1df8 +55c9 55c8 1bd7 1bd8 +55ea 55c8 1bd8 1ce8 +55ca 55c9 1ac7 1ac8 +55eb 55c9 1ac8 1bd8 +55cb 55ca 19b7 19b8 +55ec 55ca 19b8 1ac8 +55cc 55cb 18a7 18a8 +55ed 55cb 18a8 19b8 +55cd 55cc 1797 1798 +55ee 55cc 1798 18a8 +55ce 55cd 1687 1688 +55ef 55cd 1688 1798 +55cf 55ce 1577 1578 +55f0 55ce 1578 1688 +55d0 55cf 1467 1468 +55f1 55cf 1468 1578 +55d1 55d0 1357 1358 +55f2 55d0 1358 1468 +55d2 55d1 1247 1248 +55f3 55d1 1248 1358 +55f4 55d2 1138 1248 +55d4 55d3 3448 3449 +55f5 55d3 3449 3559 +55d5 55d4 3338 3339 +55f6 55d4 3339 3449 +55d6 55d5 3228 3229 +55f7 55d5 3229 3339 +55d7 55d6 3118 3119 +55f8 55d6 3119 3229 +55d8 55d7 3008 3009 +55f9 55d7 3009 3119 +55d9 55d8 2ef8 2ef9 +55fa 55d8 2ef9 3009 +55da 55d9 2de8 2de9 +55fb 55d9 2de9 2ef9 +55db 55da 2cd8 2cd9 +55fc 55da 2cd9 2de9 +55dc 55db 2bc8 2bc9 +55fd 55db 2bc9 2cd9 +55dd 55dc 2ab8 2ab9 +55fe 55dc 2ab9 2bc9 +55de 55dd 29a8 29a9 +55ff 55dd 29a9 2ab9 +55df 55de 2898 2899 +5600 55de 2899 29a9 +55e0 55df 2788 2789 +5601 55df 2789 2899 +55e1 55e0 2678 2679 +5602 55e0 2679 2789 +55e2 55e1 2568 2569 +5603 55e1 2569 2679 +55e3 55e2 2458 2459 +5604 55e2 2459 2569 +55e4 55e3 2348 2349 +5605 55e3 2349 2459 +55e5 55e4 2238 2239 +5606 55e4 2239 2349 +55e6 55e5 2128 2129 +5607 55e5 2129 2239 +55e7 55e6 2018 2019 +5608 55e6 2019 2129 +55e8 55e7 1f08 1f09 +5609 55e7 1f09 2019 +55e9 55e8 1df8 1df9 +560a 55e8 1df9 1f09 +55ea 55e9 1ce8 1ce9 +560b 55e9 1ce9 1df9 +55eb 55ea 1bd8 1bd9 +560c 55ea 1bd9 1ce9 +55ec 55eb 1ac8 1ac9 +560d 55eb 1ac9 1bd9 +55ed 55ec 19b8 19b9 +560e 55ec 19b9 1ac9 +55ee 55ed 18a8 18a9 +560f 55ed 18a9 19b9 +55ef 55ee 1798 1799 +5610 55ee 1799 18a9 +55f0 55ef 1688 1689 +5611 55ef 1689 1799 +55f1 55f0 1578 1579 +5612 55f0 1579 1689 +55f2 55f1 1468 1469 +5613 55f1 1469 1579 +55f3 55f2 1358 1359 +5614 55f2 1359 1469 +55f4 55f3 1248 1249 +5615 55f3 1249 1359 +5616 55f4 1139 1249 +55f6 55f5 3449 344a +5617 55f5 344a 355a +55f7 55f6 3339 333a +5618 55f6 333a 344a +55f8 55f7 3229 322a +5619 55f7 322a 333a +55f9 55f8 3119 311a +561a 55f8 311a 322a +55fa 55f9 3009 300a +561b 55f9 300a 311a +55fb 55fa 2ef9 2efa +561c 55fa 2efa 300a +55fc 55fb 2de9 2dea +561d 55fb 2dea 2efa +55fd 55fc 2cd9 2cda +561e 55fc 2cda 2dea +55fe 55fd 2bc9 2bca +561f 55fd 2bca 2cda +55ff 55fe 2ab9 2aba +5620 55fe 2aba 2bca +5600 55ff 29a9 29aa +5621 55ff 29aa 2aba +5601 5600 2899 289a +5622 5600 289a 29aa +5602 5601 2789 278a +5623 5601 278a 289a +5603 5602 2679 267a +5624 5602 267a 278a +5604 5603 2569 256a +5625 5603 256a 267a +5605 5604 2459 245a +5626 5604 245a 256a +5606 5605 2349 234a +5627 5605 234a 245a +5607 5606 2239 223a +5628 5606 223a 234a +5608 5607 2129 212a +5629 5607 212a 223a +5609 5608 2019 201a +562a 5608 201a 212a +560a 5609 1f09 1f0a +562b 5609 1f0a 201a +560b 560a 1df9 1dfa +562c 560a 1dfa 1f0a +560c 560b 1ce9 1cea +562d 560b 1cea 1dfa +560d 560c 1bd9 1bda +562e 560c 1bda 1cea +560e 560d 1ac9 1aca +562f 560d 1aca 1bda +560f 560e 19b9 19ba +5630 560e 19ba 1aca +5610 560f 18a9 18aa +5631 560f 18aa 19ba +5611 5610 1799 179a +5632 5610 179a 18aa +5612 5611 1689 168a +5633 5611 168a 179a +5613 5612 1579 157a +5634 5612 157a 168a +5614 5613 1469 146a +5635 5613 146a 157a +5615 5614 1359 135a +5636 5614 135a 146a +5616 5615 1249 124a +5637 5615 124a 135a +5638 5616 113a 124a +5618 5617 344a 344b +5639 5617 344b 355b +5619 5618 333a 333b +563a 5618 333b 344b +561a 5619 322a 322b +563b 5619 322b 333b +561b 561a 311a 311b +563c 561a 311b 322b +561c 561b 300a 300b +563d 561b 300b 311b +561d 561c 2efa 2efb +563e 561c 2efb 300b +561e 561d 2dea 2deb +563f 561d 2deb 2efb +561f 561e 2cda 2cdb +5640 561e 2cdb 2deb +5620 561f 2bca 2bcb +5641 561f 2bcb 2cdb +5621 5620 2aba 2abb +5642 5620 2abb 2bcb +5622 5621 29aa 29ab +5643 5621 29ab 2abb +5623 5622 289a 289b +5644 5622 289b 29ab +5624 5623 278a 278b +5645 5623 278b 289b +5625 5624 267a 267b +5646 5624 267b 278b +5626 5625 256a 256b +5647 5625 256b 267b +5627 5626 245a 245b +5648 5626 245b 256b +5628 5627 234a 234b +5649 5627 234b 245b +5629 5628 223a 223b +564a 5628 223b 234b +562a 5629 212a 212b +564b 5629 212b 223b +562b 562a 201a 201b +564c 562a 201b 212b +562c 562b 1f0a 1f0b +564d 562b 1f0b 201b +562d 562c 1dfa 1dfb +564e 562c 1dfb 1f0b +562e 562d 1cea 1ceb +564f 562d 1ceb 1dfb +562f 562e 1bda 1bdb +5650 562e 1bdb 1ceb +5630 562f 1aca 1acb +5651 562f 1acb 1bdb +5631 5630 19ba 19bb +5652 5630 19bb 1acb +5632 5631 18aa 18ab +5653 5631 18ab 19bb +5633 5632 179a 179b +5654 5632 179b 18ab +5634 5633 168a 168b +5655 5633 168b 179b +5635 5634 157a 157b +5656 5634 157b 168b +5636 5635 146a 146b +5657 5635 146b 157b +5637 5636 135a 135b +5658 5636 135b 146b +5638 5637 124a 124b +5659 5637 124b 135b +565a 5638 113b 124b +563a 5639 344b 344c +565b 5639 344c 355c +563b 563a 333b 333c +565c 563a 333c 344c +563c 563b 322b 322c +565d 563b 322c 333c +563d 563c 311b 311c +565e 563c 311c 322c +563e 563d 300b 300c +565f 563d 300c 311c +563f 563e 2efb 2efc +5660 563e 2efc 300c +5640 563f 2deb 2dec +5661 563f 2dec 2efc +5641 5640 2cdb 2cdc +5662 5640 2cdc 2dec +5642 5641 2bcb 2bcc +5663 5641 2bcc 2cdc +5643 5642 2abb 2abc +5664 5642 2abc 2bcc +5644 5643 29ab 29ac +5665 5643 29ac 2abc +5645 5644 289b 289c +5666 5644 289c 29ac +5646 5645 278b 278c +5667 5645 278c 289c +5647 5646 267b 267c +5668 5646 267c 278c +5648 5647 256b 256c +5669 5647 256c 267c +5649 5648 245b 245c +566a 5648 245c 256c +564a 5649 234b 234c +566b 5649 234c 245c +564b 564a 223b 223c +566c 564a 223c 234c +564c 564b 212b 212c +566d 564b 212c 223c +564d 564c 201b 201c +566e 564c 201c 212c +564e 564d 1f0b 1f0c +566f 564d 1f0c 201c +564f 564e 1dfb 1dfc +5670 564e 1dfc 1f0c +5650 564f 1ceb 1cec +5671 564f 1cec 1dfc +5651 5650 1bdb 1bdc +5672 5650 1bdc 1cec +5652 5651 1acb 1acc +5673 5651 1acc 1bdc +5653 5652 19bb 19bc +5674 5652 19bc 1acc +5654 5653 18ab 18ac +5675 5653 18ac 19bc +5655 5654 179b 179c +5676 5654 179c 18ac +5656 5655 168b 168c +5677 5655 168c 179c +5657 5656 157b 157c +5678 5656 157c 168c +5658 5657 146b 146c +5679 5657 146c 157c +5659 5658 135b 135c +567a 5658 135c 146c +565a 5659 124b 124c +567b 5659 124c 135c +567c 565a 113c 124c +565c 565b 344c 344d +567d 565b 344d 355d +565d 565c 333c 333d +567e 565c 333d 344d +565e 565d 322c 322d +567f 565d 322d 333d +565f 565e 311c 311d +5680 565e 311d 322d +5660 565f 300c 300d +5681 565f 300d 311d +5661 5660 2efc 2efd +5682 5660 2efd 300d +5662 5661 2dec 2ded +5683 5661 2ded 2efd +5663 5662 2cdc 2cdd +5684 5662 2cdd 2ded +5664 5663 2bcc 2bcd +5685 5663 2bcd 2cdd +5665 5664 2abc 2abd +5686 5664 2abd 2bcd +5666 5665 29ac 29ad +5687 5665 29ad 2abd +5667 5666 289c 289d +5688 5666 289d 29ad +5668 5667 278c 278d +5689 5667 278d 289d +5669 5668 267c 267d +568a 5668 267d 278d +566a 5669 256c 256d +568b 5669 256d 267d +566b 566a 245c 245d +568c 566a 245d 256d +566c 566b 234c 234d +568d 566b 234d 245d +566d 566c 223c 223d +568e 566c 223d 234d +566e 566d 212c 212d +568f 566d 212d 223d +566f 566e 201c 201d +5690 566e 201d 212d +5670 566f 1f0c 1f0d +5691 566f 1f0d 201d +5671 5670 1dfc 1dfd +5692 5670 1dfd 1f0d +5672 5671 1cec 1ced +5693 5671 1ced 1dfd +5673 5672 1bdc 1bdd +5694 5672 1bdd 1ced +5674 5673 1acc 1acd +5695 5673 1acd 1bdd +5675 5674 19bc 19bd +5696 5674 19bd 1acd +5676 5675 18ac 18ad +5697 5675 18ad 19bd +5677 5676 179c 179d +5698 5676 179d 18ad +5678 5677 168c 168d +5699 5677 168d 179d +5679 5678 157c 157d +569a 5678 157d 168d +567a 5679 146c 146d +569b 5679 146d 157d +567b 567a 135c 135d +569c 567a 135d 146d +567c 567b 124c 124d +569d 567b 124d 135d +569e 567c 113d 124d +567e 567d 344d 344e +569f 567d 344e 355e +567f 567e 333d 333e +56a0 567e 333e 344e +5680 567f 322d 322e +56a1 567f 322e 333e +5681 5680 311d 311e +56a2 5680 311e 322e +5682 5681 300d 300e +56a3 5681 300e 311e +5683 5682 2efd 2efe +56a4 5682 2efe 300e +5684 5683 2ded 2dee +56a5 5683 2dee 2efe +5685 5684 2cdd 2cde +56a6 5684 2cde 2dee +5686 5685 2bcd 2bce +56a7 5685 2bce 2cde +5687 5686 2abd 2abe +56a8 5686 2abe 2bce +5688 5687 29ad 29ae +56a9 5687 29ae 2abe +5689 5688 289d 289e +56aa 5688 289e 29ae +568a 5689 278d 278e +56ab 5689 278e 289e +568b 568a 267d 267e +56ac 568a 267e 278e +568c 568b 256d 256e +56ad 568b 256e 267e +568d 568c 245d 245e +56ae 568c 245e 256e +568e 568d 234d 234e +56af 568d 234e 245e +568f 568e 223d 223e +56b0 568e 223e 234e +5690 568f 212d 212e +56b1 568f 212e 223e +5691 5690 201d 201e +56b2 5690 201e 212e +5692 5691 1f0d 1f0e +56b3 5691 1f0e 201e +5693 5692 1dfd 1dfe +56b4 5692 1dfe 1f0e +5694 5693 1ced 1cee +56b5 5693 1cee 1dfe +5695 5694 1bdd 1bde +56b6 5694 1bde 1cee +5696 5695 1acd 1ace +56b7 5695 1ace 1bde +5697 5696 19bd 19be +56b8 5696 19be 1ace +5698 5697 18ad 18ae +56b9 5697 18ae 19be +5699 5698 179d 179e +56ba 5698 179e 18ae +569a 5699 168d 168e +56bb 5699 168e 179e +569b 569a 157d 157e +56bc 569a 157e 168e +569c 569b 146d 146e +56bd 569b 146e 157e +569d 569c 135d 135e +56be 569c 135e 146e +569e 569d 124d 124e +56bf 569d 124e 135e +56c0 569e 113e 124e +56a0 569f 344e 344f +56c1 569f 344f 355f +56a1 56a0 333e 333f +56c2 56a0 333f 344f +56a2 56a1 322e 322f +56c3 56a1 322f 333f +56a3 56a2 311e 311f +56c4 56a2 311f 322f +56a4 56a3 300e 300f +56c5 56a3 300f 311f +56a5 56a4 2efe 2eff +56c6 56a4 2eff 300f +56a6 56a5 2dee 2def +56c7 56a5 2def 2eff +56a7 56a6 2cde 2cdf +56c8 56a6 2cdf 2def +56a8 56a7 2bce 2bcf +56c9 56a7 2bcf 2cdf +56a9 56a8 2abe 2abf +56ca 56a8 2abf 2bcf +56aa 56a9 29ae 29af +56cb 56a9 29af 2abf +56ab 56aa 289e 289f +56cc 56aa 289f 29af +56ac 56ab 278e 278f +56cd 56ab 278f 289f +56ad 56ac 267e 267f +56ce 56ac 267f 278f +56ae 56ad 256e 256f +56cf 56ad 256f 267f +56af 56ae 245e 245f +56d0 56ae 245f 256f +56b0 56af 234e 234f +56d1 56af 234f 245f +56b1 56b0 223e 223f +56d2 56b0 223f 234f +56b2 56b1 212e 212f +56d3 56b1 212f 223f +56b3 56b2 201e 201f +56d4 56b2 201f 212f +56b4 56b3 1f0e 1f0f +56d5 56b3 1f0f 201f +56b5 56b4 1dfe 1dff +56d6 56b4 1dff 1f0f +56b6 56b5 1cee 1cef +56d7 56b5 1cef 1dff +56b7 56b6 1bde 1bdf +56d8 56b6 1bdf 1cef +56b8 56b7 1ace 1acf +56d9 56b7 1acf 1bdf +56b9 56b8 19be 19bf +56da 56b8 19bf 1acf +56ba 56b9 18ae 18af +56db 56b9 18af 19bf +56bb 56ba 179e 179f +56dc 56ba 179f 18af +56bc 56bb 168e 168f +56dd 56bb 168f 179f +56bd 56bc 157e 157f +56de 56bc 157f 168f +56be 56bd 146e 146f +56df 56bd 146f 157f +56bf 56be 135e 135f +56e0 56be 135f 146f +56c0 56bf 124e 124f +56e1 56bf 124f 135f +56e2 56c0 113f 124f +56c2 56c1 344f 3450 +56e3 56c1 3450 3560 +56c3 56c2 333f 3340 +56e4 56c2 3340 3450 +56c4 56c3 322f 3230 +56e5 56c3 3230 3340 +56c5 56c4 311f 3120 +56e6 56c4 3120 3230 +56c6 56c5 300f 3010 +56e7 56c5 3010 3120 +56c7 56c6 2eff 2f00 +56e8 56c6 2f00 3010 +56c8 56c7 2def 2df0 +56e9 56c7 2df0 2f00 +56c9 56c8 2cdf 2ce0 +56ea 56c8 2ce0 2df0 +56ca 56c9 2bcf 2bd0 +56eb 56c9 2bd0 2ce0 +56cb 56ca 2abf 2ac0 +56ec 56ca 2ac0 2bd0 +56cc 56cb 29af 29b0 +56ed 56cb 29b0 2ac0 +56cd 56cc 289f 28a0 +56ee 56cc 28a0 29b0 +56ce 56cd 278f 2790 +56ef 56cd 2790 28a0 +56cf 56ce 267f 2680 +56f0 56ce 2680 2790 +56d0 56cf 256f 2570 +56f1 56cf 2570 2680 +56d1 56d0 245f 2460 +56f2 56d0 2460 2570 +56d2 56d1 234f 2350 +56f3 56d1 2350 2460 +56d3 56d2 223f 2240 +56f4 56d2 2240 2350 +56d4 56d3 212f 2130 +56f5 56d3 2130 2240 +56d5 56d4 201f 2020 +56f6 56d4 2020 2130 +56d6 56d5 1f0f 1f10 +56f7 56d5 1f10 2020 +56d7 56d6 1dff 1e00 +56f8 56d6 1e00 1f10 +56d8 56d7 1cef 1cf0 +56f9 56d7 1cf0 1e00 +56d9 56d8 1bdf 1be0 +56fa 56d8 1be0 1cf0 +56da 56d9 1acf 1ad0 +56fb 56d9 1ad0 1be0 +56db 56da 19bf 19c0 +56fc 56da 19c0 1ad0 +56dc 56db 18af 18b0 +56fd 56db 18b0 19c0 +56dd 56dc 179f 17a0 +56fe 56dc 17a0 18b0 +56de 56dd 168f 1690 +56ff 56dd 1690 17a0 +56df 56de 157f 1580 +5700 56de 1580 1690 +56e0 56df 146f 1470 +5701 56df 1470 1580 +56e1 56e0 135f 1360 +5702 56e0 1360 1470 +56e2 56e1 124f 1250 +5703 56e1 1250 1360 +5704 56e2 1140 1250 +56e4 56e3 3450 3451 +5705 56e3 3451 3561 +56e5 56e4 3340 3341 +5706 56e4 3341 3451 +56e6 56e5 3230 3231 +5707 56e5 3231 3341 +56e7 56e6 3120 3121 +5708 56e6 3121 3231 +56e8 56e7 3010 3011 +5709 56e7 3011 3121 +56e9 56e8 2f00 2f01 +570a 56e8 2f01 3011 +56ea 56e9 2df0 2df1 +570b 56e9 2df1 2f01 +56eb 56ea 2ce0 2ce1 +570c 56ea 2ce1 2df1 +56ec 56eb 2bd0 2bd1 +570d 56eb 2bd1 2ce1 +56ed 56ec 2ac0 2ac1 +570e 56ec 2ac1 2bd1 +56ee 56ed 29b0 29b1 +570f 56ed 29b1 2ac1 +56ef 56ee 28a0 28a1 +5710 56ee 28a1 29b1 +56f0 56ef 2790 2791 +5711 56ef 2791 28a1 +56f1 56f0 2680 2681 +5712 56f0 2681 2791 +56f2 56f1 2570 2571 +5713 56f1 2571 2681 +56f3 56f2 2460 2461 +5714 56f2 2461 2571 +56f4 56f3 2350 2351 +5715 56f3 2351 2461 +56f5 56f4 2240 2241 +5716 56f4 2241 2351 +56f6 56f5 2130 2131 +5717 56f5 2131 2241 +56f7 56f6 2020 2021 +5718 56f6 2021 2131 +56f8 56f7 1f10 1f11 +5719 56f7 1f11 2021 +56f9 56f8 1e00 1e01 +571a 56f8 1e01 1f11 +56fa 56f9 1cf0 1cf1 +571b 56f9 1cf1 1e01 +56fb 56fa 1be0 1be1 +571c 56fa 1be1 1cf1 +56fc 56fb 1ad0 1ad1 +571d 56fb 1ad1 1be1 +56fd 56fc 19c0 19c1 +571e 56fc 19c1 1ad1 +56fe 56fd 18b0 18b1 +571f 56fd 18b1 19c1 +56ff 56fe 17a0 17a1 +5720 56fe 17a1 18b1 +5700 56ff 1690 1691 +5721 56ff 1691 17a1 +5701 5700 1580 1581 +5722 5700 1581 1691 +5702 5701 1470 1471 +5723 5701 1471 1581 +5703 5702 1360 1361 +5724 5702 1361 1471 +5704 5703 1250 1251 +5725 5703 1251 1361 +5726 5704 1141 1251 +5706 5705 3451 3452 +5727 5705 3452 3562 +5707 5706 3341 3342 +5728 5706 3342 3452 +5708 5707 3231 3232 +5729 5707 3232 3342 +5709 5708 3121 3122 +572a 5708 3122 3232 +570a 5709 3011 3012 +572b 5709 3012 3122 +570b 570a 2f01 2f02 +572c 570a 2f02 3012 +570c 570b 2df1 2df2 +572d 570b 2df2 2f02 +570d 570c 2ce1 2ce2 +572e 570c 2ce2 2df2 +570e 570d 2bd1 2bd2 +572f 570d 2bd2 2ce2 +570f 570e 2ac1 2ac2 +5730 570e 2ac2 2bd2 +5710 570f 29b1 29b2 +5731 570f 29b2 2ac2 +5711 5710 28a1 28a2 +5732 5710 28a2 29b2 +5712 5711 2791 2792 +5733 5711 2792 28a2 +5713 5712 2681 2682 +5734 5712 2682 2792 +5714 5713 2571 2572 +5735 5713 2572 2682 +5715 5714 2461 2462 +5736 5714 2462 2572 +5716 5715 2351 2352 +5737 5715 2352 2462 +5717 5716 2241 2242 +5738 5716 2242 2352 +5718 5717 2131 2132 +5739 5717 2132 2242 +5719 5718 2021 2022 +573a 5718 2022 2132 +571a 5719 1f11 1f12 +573b 5719 1f12 2022 +571b 571a 1e01 1e02 +573c 571a 1e02 1f12 +571c 571b 1cf1 1cf2 +573d 571b 1cf2 1e02 +571d 571c 1be1 1be2 +573e 571c 1be2 1cf2 +571e 571d 1ad1 1ad2 +573f 571d 1ad2 1be2 +571f 571e 19c1 19c2 +5740 571e 19c2 1ad2 +5720 571f 18b1 18b2 +5741 571f 18b2 19c2 +5721 5720 17a1 17a2 +5742 5720 17a2 18b2 +5722 5721 1691 1692 +5743 5721 1692 17a2 +5723 5722 1581 1582 +5744 5722 1582 1692 +5724 5723 1471 1472 +5745 5723 1472 1582 +5725 5724 1361 1362 +5746 5724 1362 1472 +5726 5725 1251 1252 +5747 5725 1252 1362 +5748 5726 1142 1252 +5728 5727 3452 3453 +5749 5727 3453 3563 +5729 5728 3342 3343 +574a 5728 3343 3453 +572a 5729 3232 3233 +574b 5729 3233 3343 +572b 572a 3122 3123 +574c 572a 3123 3233 +572c 572b 3012 3013 +574d 572b 3013 3123 +572d 572c 2f02 2f03 +574e 572c 2f03 3013 +572e 572d 2df2 2df3 +574f 572d 2df3 2f03 +572f 572e 2ce2 2ce3 +5750 572e 2ce3 2df3 +5730 572f 2bd2 2bd3 +5751 572f 2bd3 2ce3 +5731 5730 2ac2 2ac3 +5752 5730 2ac3 2bd3 +5732 5731 29b2 29b3 +5753 5731 29b3 2ac3 +5733 5732 28a2 28a3 +5754 5732 28a3 29b3 +5734 5733 2792 2793 +5755 5733 2793 28a3 +5735 5734 2682 2683 +5756 5734 2683 2793 +5736 5735 2572 2573 +5757 5735 2573 2683 +5737 5736 2462 2463 +5758 5736 2463 2573 +5738 5737 2352 2353 +5759 5737 2353 2463 +5739 5738 2242 2243 +575a 5738 2243 2353 +573a 5739 2132 2133 +575b 5739 2133 2243 +573b 573a 2022 2023 +575c 573a 2023 2133 +573c 573b 1f12 1f13 +575d 573b 1f13 2023 +573d 573c 1e02 1e03 +575e 573c 1e03 1f13 +573e 573d 1cf2 1cf3 +575f 573d 1cf3 1e03 +573f 573e 1be2 1be3 +5760 573e 1be3 1cf3 +5740 573f 1ad2 1ad3 +5761 573f 1ad3 1be3 +5741 5740 19c2 19c3 +5762 5740 19c3 1ad3 +5742 5741 18b2 18b3 +5763 5741 18b3 19c3 +5743 5742 17a2 17a3 +5764 5742 17a3 18b3 +5744 5743 1692 1693 +5765 5743 1693 17a3 +5745 5744 1582 1583 +5766 5744 1583 1693 +5746 5745 1472 1473 +5767 5745 1473 1583 +5747 5746 1362 1363 +5768 5746 1363 1473 +5748 5747 1252 1253 +5769 5747 1253 1363 +576a 5748 1143 1253 +574a 5749 3453 3454 +576b 5749 3454 3564 +574b 574a 3343 3344 +576c 574a 3344 3454 +574c 574b 3233 3234 +576d 574b 3234 3344 +574d 574c 3123 3124 +576e 574c 3124 3234 +574e 574d 3013 3014 +576f 574d 3014 3124 +574f 574e 2f03 2f04 +5770 574e 2f04 3014 +5750 574f 2df3 2df4 +5771 574f 2df4 2f04 +5751 5750 2ce3 2ce4 +5772 5750 2ce4 2df4 +5752 5751 2bd3 2bd4 +5773 5751 2bd4 2ce4 +5753 5752 2ac3 2ac4 +5774 5752 2ac4 2bd4 +5754 5753 29b3 29b4 +5775 5753 29b4 2ac4 +5755 5754 28a3 28a4 +5776 5754 28a4 29b4 +5756 5755 2793 2794 +5777 5755 2794 28a4 +5757 5756 2683 2684 +5778 5756 2684 2794 +5758 5757 2573 2574 +5779 5757 2574 2684 +5759 5758 2463 2464 +577a 5758 2464 2574 +575a 5759 2353 2354 +577b 5759 2354 2464 +575b 575a 2243 2244 +577c 575a 2244 2354 +575c 575b 2133 2134 +577d 575b 2134 2244 +575d 575c 2023 2024 +577e 575c 2024 2134 +575e 575d 1f13 1f14 +577f 575d 1f14 2024 +575f 575e 1e03 1e04 +5780 575e 1e04 1f14 +5760 575f 1cf3 1cf4 +5781 575f 1cf4 1e04 +5761 5760 1be3 1be4 +5782 5760 1be4 1cf4 +5762 5761 1ad3 1ad4 +5783 5761 1ad4 1be4 +5763 5762 19c3 19c4 +5784 5762 19c4 1ad4 +5764 5763 18b3 18b4 +5785 5763 18b4 19c4 +5765 5764 17a3 17a4 +5786 5764 17a4 18b4 +5766 5765 1693 1694 +5787 5765 1694 17a4 +5767 5766 1583 1584 +5788 5766 1584 1694 +5768 5767 1473 1474 +5789 5767 1474 1584 +5769 5768 1363 1364 +578a 5768 1364 1474 +576a 5769 1253 1254 +578b 5769 1254 1364 +578c 576a 1144 1254 +576c 576b 3454 3455 +578d 576b 3455 3565 +576d 576c 3344 3345 +578e 576c 3345 3455 +576e 576d 3234 3235 +578f 576d 3235 3345 +576f 576e 3124 3125 +5790 576e 3125 3235 +5770 576f 3014 3015 +5791 576f 3015 3125 +5771 5770 2f04 2f05 +5792 5770 2f05 3015 +5772 5771 2df4 2df5 +5793 5771 2df5 2f05 +5773 5772 2ce4 2ce5 +5794 5772 2ce5 2df5 +5774 5773 2bd4 2bd5 +5795 5773 2bd5 2ce5 +5775 5774 2ac4 2ac5 +5796 5774 2ac5 2bd5 +5776 5775 29b4 29b5 +5797 5775 29b5 2ac5 +5777 5776 28a4 28a5 +5798 5776 28a5 29b5 +5778 5777 2794 2795 +5799 5777 2795 28a5 +5779 5778 2684 2685 +579a 5778 2685 2795 +577a 5779 2574 2575 +579b 5779 2575 2685 +577b 577a 2464 2465 +579c 577a 2465 2575 +577c 577b 2354 2355 +579d 577b 2355 2465 +577d 577c 2244 2245 +579e 577c 2245 2355 +577e 577d 2134 2135 +579f 577d 2135 2245 +577f 577e 2024 2025 +57a0 577e 2025 2135 +5780 577f 1f14 1f15 +57a1 577f 1f15 2025 +5781 5780 1e04 1e05 +57a2 5780 1e05 1f15 +5782 5781 1cf4 1cf5 +57a3 5781 1cf5 1e05 +5783 5782 1be4 1be5 +57a4 5782 1be5 1cf5 +5784 5783 1ad4 1ad5 +57a5 5783 1ad5 1be5 +5785 5784 19c4 19c5 +57a6 5784 19c5 1ad5 +5786 5785 18b4 18b5 +57a7 5785 18b5 19c5 +5787 5786 17a4 17a5 +57a8 5786 17a5 18b5 +5788 5787 1694 1695 +57a9 5787 1695 17a5 +5789 5788 1584 1585 +57aa 5788 1585 1695 +578a 5789 1474 1475 +57ab 5789 1475 1585 +578b 578a 1364 1365 +57ac 578a 1365 1475 +578c 578b 1254 1255 +57ad 578b 1255 1365 +57ae 578c 1145 1255 +578e 578d 3455 3456 +57af 578d 3456 3566 +578f 578e 3345 3346 +57b0 578e 3346 3456 +5790 578f 3235 3236 +57b1 578f 3236 3346 +5791 5790 3125 3126 +57b2 5790 3126 3236 +5792 5791 3015 3016 +57b3 5791 3016 3126 +5793 5792 2f05 2f06 +57b4 5792 2f06 3016 +5794 5793 2df5 2df6 +57b5 5793 2df6 2f06 +5795 5794 2ce5 2ce6 +57b6 5794 2ce6 2df6 +5796 5795 2bd5 2bd6 +57b7 5795 2bd6 2ce6 +5797 5796 2ac5 2ac6 +57b8 5796 2ac6 2bd6 +5798 5797 29b5 29b6 +57b9 5797 29b6 2ac6 +5799 5798 28a5 28a6 +57ba 5798 28a6 29b6 +579a 5799 2795 2796 +57bb 5799 2796 28a6 +579b 579a 2685 2686 +57bc 579a 2686 2796 +579c 579b 2575 2576 +57bd 579b 2576 2686 +579d 579c 2465 2466 +57be 579c 2466 2576 +579e 579d 2355 2356 +57bf 579d 2356 2466 +579f 579e 2245 2246 +57c0 579e 2246 2356 +57a0 579f 2135 2136 +57c1 579f 2136 2246 +57a1 57a0 2025 2026 +57c2 57a0 2026 2136 +57a2 57a1 1f15 1f16 +57c3 57a1 1f16 2026 +57a3 57a2 1e05 1e06 +57c4 57a2 1e06 1f16 +57a4 57a3 1cf5 1cf6 +57c5 57a3 1cf6 1e06 +57a5 57a4 1be5 1be6 +57c6 57a4 1be6 1cf6 +57a6 57a5 1ad5 1ad6 +57c7 57a5 1ad6 1be6 +57a7 57a6 19c5 19c6 +57c8 57a6 19c6 1ad6 +57a8 57a7 18b5 18b6 +57c9 57a7 18b6 19c6 +57a9 57a8 17a5 17a6 +57ca 57a8 17a6 18b6 +57aa 57a9 1695 1696 +57cb 57a9 1696 17a6 +57ab 57aa 1585 1586 +57cc 57aa 1586 1696 +57ac 57ab 1475 1476 +57cd 57ab 1476 1586 +57ad 57ac 1365 1366 +57ce 57ac 1366 1476 +57ae 57ad 1255 1256 +57cf 57ad 1256 1366 +57d0 57ae 1146 1256 +57b0 57af 3456 3457 +57d1 57af 3457 3567 +57b1 57b0 3346 3347 +57d2 57b0 3347 3457 +57b2 57b1 3236 3237 +57d3 57b1 3237 3347 +57b3 57b2 3126 3127 +57d4 57b2 3127 3237 +57b4 57b3 3016 3017 +57d5 57b3 3017 3127 +57b5 57b4 2f06 2f07 +57d6 57b4 2f07 3017 +57b6 57b5 2df6 2df7 +57d7 57b5 2df7 2f07 +57b7 57b6 2ce6 2ce7 +57d8 57b6 2ce7 2df7 +57b8 57b7 2bd6 2bd7 +57d9 57b7 2bd7 2ce7 +57b9 57b8 2ac6 2ac7 +57da 57b8 2ac7 2bd7 +57ba 57b9 29b6 29b7 +57db 57b9 29b7 2ac7 +57bb 57ba 28a6 28a7 +57dc 57ba 28a7 29b7 +57bc 57bb 2796 2797 +57dd 57bb 2797 28a7 +57bd 57bc 2686 2687 +57de 57bc 2687 2797 +57be 57bd 2576 2577 +57df 57bd 2577 2687 +57bf 57be 2466 2467 +57e0 57be 2467 2577 +57c0 57bf 2356 2357 +57e1 57bf 2357 2467 +57c1 57c0 2246 2247 +57e2 57c0 2247 2357 +57c2 57c1 2136 2137 +57e3 57c1 2137 2247 +57c3 57c2 2026 2027 +57e4 57c2 2027 2137 +57c4 57c3 1f16 1f17 +57e5 57c3 1f17 2027 +57c5 57c4 1e06 1e07 +57e6 57c4 1e07 1f17 +57c6 57c5 1cf6 1cf7 +57e7 57c5 1cf7 1e07 +57c7 57c6 1be6 1be7 +57e8 57c6 1be7 1cf7 +57c8 57c7 1ad6 1ad7 +57e9 57c7 1ad7 1be7 +57c9 57c8 19c6 19c7 +57ea 57c8 19c7 1ad7 +57ca 57c9 18b6 18b7 +57eb 57c9 18b7 19c7 +57cb 57ca 17a6 17a7 +57ec 57ca 17a7 18b7 +57cc 57cb 1696 1697 +57ed 57cb 1697 17a7 +57cd 57cc 1586 1587 +57ee 57cc 1587 1697 +57ce 57cd 1476 1477 +57ef 57cd 1477 1587 +57cf 57ce 1366 1367 +57f0 57ce 1367 1477 +57d0 57cf 1256 1257 +57f1 57cf 1257 1367 +57f2 57d0 1147 1257 +57d2 57d1 3457 3458 +57d3 57d2 3347 3348 +57d4 57d3 3237 3238 +57d5 57d4 3127 3128 +57d6 57d5 3017 3018 +57d7 57d6 2f07 2f08 +57d8 57d7 2df7 2df8 +57d9 57d8 2ce7 2ce8 +57da 57d9 2bd7 2bd8 +57db 57da 2ac7 2ac8 +57dc 57db 29b7 29b8 +57dd 57dc 28a7 28a8 +57de 57dd 2797 2798 +57df 57de 2687 2688 +57e0 57df 2577 2578 +57e1 57e0 2467 2468 +57e2 57e1 2357 2358 +57e3 57e2 2247 2248 +57e4 57e3 2137 2138 +57e5 57e4 2027 2028 +57e6 57e5 1f17 1f18 +57e7 57e6 1e07 1e08 +57e8 57e7 1cf7 1cf8 +57e9 57e8 1be7 1be8 +57ea 57e9 1ad7 1ad8 +57eb 57ea 19c7 19c8 +57ec 57eb 18b7 18b8 +57ed 57ec 17a7 17a8 +57ee 57ed 1697 1698 +57ef 57ee 1587 1588 +57f0 57ef 1477 1478 +57f1 57f0 1367 1368 +57f2 57f1 1257 1258 +57f4 57f3 3427 3428 +57f3 5815 3427 3537 +57f5 57f4 3317 3318 +57f4 5816 3317 3427 +57f6 57f5 3207 3208 +57f5 5817 3207 3317 +57f7 57f6 30f7 30f8 +57f6 5818 30f7 3207 +57f8 57f7 2fe7 2fe8 +57f7 5819 2fe7 30f7 +57f9 57f8 2ed7 2ed8 +57f8 581a 2ed7 2fe7 +57fa 57f9 2dc7 2dc8 +57f9 581b 2dc7 2ed7 +57fb 57fa 2cb7 2cb8 +57fa 581c 2cb7 2dc7 +57fc 57fb 2ba7 2ba8 +57fb 581d 2ba7 2cb7 +57fd 57fc 2a97 2a98 +57fc 581e 2a97 2ba7 +57fe 57fd 2987 2988 +57fd 581f 2987 2a97 +57ff 57fe 2877 2878 +57fe 5820 2877 2987 +5800 57ff 2767 2768 +57ff 5821 2767 2877 +5801 5800 2657 2658 +5800 5822 2657 2767 +5802 5801 2547 2548 +5801 5823 2547 2657 +5803 5802 2437 2438 +5802 5824 2437 2547 +5804 5803 2327 2328 +5803 5825 2327 2437 +5805 5804 2217 2218 +5804 5826 2217 2327 +5806 5805 2107 2108 +5805 5827 2107 2217 +5807 5806 1ff7 1ff8 +5806 5828 1ff7 2107 +5808 5807 1ee7 1ee8 +5807 5829 1ee7 1ff7 +5809 5808 1dd7 1dd8 +5808 582a 1dd7 1ee7 +580a 5809 1cc7 1cc8 +5809 582b 1cc7 1dd7 +580b 580a 1bb7 1bb8 +580a 582c 1bb7 1cc7 +580c 580b 1aa7 1aa8 +580b 582d 1aa7 1bb7 +580d 580c 1997 1998 +580c 582e 1997 1aa7 +580e 580d 1887 1888 +580d 582f 1887 1997 +580f 580e 1777 1778 +580e 5830 1777 1887 +5810 580f 1667 1668 +580f 5831 1667 1777 +5811 5810 1557 1558 +5810 5832 1557 1667 +5812 5811 1447 1448 +5811 5833 1447 1557 +5813 5812 1337 1338 +5812 5834 1337 1447 +5814 5813 1227 1228 +5813 5835 1227 1337 +5814 5836 1117 1227 +5816 5815 3426 3427 +5815 5837 3426 3536 +5817 5816 3316 3317 +5816 5838 3316 3426 +5818 5817 3206 3207 +5817 5839 3206 3316 +5819 5818 30f6 30f7 +5818 583a 30f6 3206 +581a 5819 2fe6 2fe7 +5819 583b 2fe6 30f6 +581b 581a 2ed6 2ed7 +581a 583c 2ed6 2fe6 +581c 581b 2dc6 2dc7 +581b 583d 2dc6 2ed6 +581d 581c 2cb6 2cb7 +581c 583e 2cb6 2dc6 +581e 581d 2ba6 2ba7 +581d 583f 2ba6 2cb6 +581f 581e 2a96 2a97 +581e 5840 2a96 2ba6 +5820 581f 2986 2987 +581f 5841 2986 2a96 +5821 5820 2876 2877 +5820 5842 2876 2986 +5822 5821 2766 2767 +5821 5843 2766 2876 +5823 5822 2656 2657 +5822 5844 2656 2766 +5824 5823 2546 2547 +5823 5845 2546 2656 +5825 5824 2436 2437 +5824 5846 2436 2546 +5826 5825 2326 2327 +5825 5847 2326 2436 +5827 5826 2216 2217 +5826 5848 2216 2326 +5828 5827 2106 2107 +5827 5849 2106 2216 +5829 5828 1ff6 1ff7 +5828 584a 1ff6 2106 +582a 5829 1ee6 1ee7 +5829 584b 1ee6 1ff6 +582b 582a 1dd6 1dd7 +582a 584c 1dd6 1ee6 +582c 582b 1cc6 1cc7 +582b 584d 1cc6 1dd6 +582d 582c 1bb6 1bb7 +582c 584e 1bb6 1cc6 +582e 582d 1aa6 1aa7 +582d 584f 1aa6 1bb6 +582f 582e 1996 1997 +582e 5850 1996 1aa6 +5830 582f 1886 1887 +582f 5851 1886 1996 +5831 5830 1776 1777 +5830 5852 1776 1886 +5832 5831 1666 1667 +5831 5853 1666 1776 +5833 5832 1556 1557 +5832 5854 1556 1666 +5834 5833 1446 1447 +5833 5855 1446 1556 +5835 5834 1336 1337 +5834 5856 1336 1446 +5836 5835 1226 1227 +5835 5857 1226 1336 +5836 5858 1116 1226 +5838 5837 3425 3426 +5837 5859 3425 3535 +5839 5838 3315 3316 +5838 585a 3315 3425 +583a 5839 3205 3206 +5839 585b 3205 3315 +583b 583a 30f5 30f6 +583a 585c 30f5 3205 +583c 583b 2fe5 2fe6 +583b 585d 2fe5 30f5 +583d 583c 2ed5 2ed6 +583c 585e 2ed5 2fe5 +583e 583d 2dc5 2dc6 +583d 585f 2dc5 2ed5 +583f 583e 2cb5 2cb6 +583e 5860 2cb5 2dc5 +5840 583f 2ba5 2ba6 +583f 5861 2ba5 2cb5 +5841 5840 2a95 2a96 +5840 5862 2a95 2ba5 +5842 5841 2985 2986 +5841 5863 2985 2a95 +5843 5842 2875 2876 +5842 5864 2875 2985 +5844 5843 2765 2766 +5843 5865 2765 2875 +5845 5844 2655 2656 +5844 5866 2655 2765 +5846 5845 2545 2546 +5845 5867 2545 2655 +5847 5846 2435 2436 +5846 5868 2435 2545 +5848 5847 2325 2326 +5847 5869 2325 2435 +5849 5848 2215 2216 +5848 586a 2215 2325 +584a 5849 2105 2106 +5849 586b 2105 2215 +584b 584a 1ff5 1ff6 +584a 586c 1ff5 2105 +584c 584b 1ee5 1ee6 +584b 586d 1ee5 1ff5 +584d 584c 1dd5 1dd6 +584c 586e 1dd5 1ee5 +584e 584d 1cc5 1cc6 +584d 586f 1cc5 1dd5 +584f 584e 1bb5 1bb6 +584e 5870 1bb5 1cc5 +5850 584f 1aa5 1aa6 +584f 5871 1aa5 1bb5 +5851 5850 1995 1996 +5850 5872 1995 1aa5 +5852 5851 1885 1886 +5851 5873 1885 1995 +5853 5852 1775 1776 +5852 5874 1775 1885 +5854 5853 1665 1666 +5853 5875 1665 1775 +5855 5854 1555 1556 +5854 5876 1555 1665 +5856 5855 1445 1446 +5855 5877 1445 1555 +5857 5856 1335 1336 +5856 5878 1335 1445 +5858 5857 1225 1226 +5857 5879 1225 1335 +5858 587a 1115 1225 +585a 5859 3424 3425 +5859 587b 3424 3534 +585b 585a 3314 3315 +585a 587c 3314 3424 +585c 585b 3204 3205 +585b 587d 3204 3314 +585d 585c 30f4 30f5 +585c 587e 30f4 3204 +585e 585d 2fe4 2fe5 +585d 587f 2fe4 30f4 +585f 585e 2ed4 2ed5 +585e 5880 2ed4 2fe4 +5860 585f 2dc4 2dc5 +585f 5881 2dc4 2ed4 +5861 5860 2cb4 2cb5 +5860 5882 2cb4 2dc4 +5862 5861 2ba4 2ba5 +5861 5883 2ba4 2cb4 +5863 5862 2a94 2a95 +5862 5884 2a94 2ba4 +5864 5863 2984 2985 +5863 5885 2984 2a94 +5865 5864 2874 2875 +5864 5886 2874 2984 +5866 5865 2764 2765 +5865 5887 2764 2874 +5867 5866 2654 2655 +5866 5888 2654 2764 +5868 5867 2544 2545 +5867 5889 2544 2654 +5869 5868 2434 2435 +5868 588a 2434 2544 +586a 5869 2324 2325 +5869 588b 2324 2434 +586b 586a 2214 2215 +586a 588c 2214 2324 +586c 586b 2104 2105 +586b 588d 2104 2214 +586d 586c 1ff4 1ff5 +586c 588e 1ff4 2104 +586e 586d 1ee4 1ee5 +586d 588f 1ee4 1ff4 +586f 586e 1dd4 1dd5 +586e 5890 1dd4 1ee4 +5870 586f 1cc4 1cc5 +586f 5891 1cc4 1dd4 +5871 5870 1bb4 1bb5 +5870 5892 1bb4 1cc4 +5872 5871 1aa4 1aa5 +5871 5893 1aa4 1bb4 +5873 5872 1994 1995 +5872 5894 1994 1aa4 +5874 5873 1884 1885 +5873 5895 1884 1994 +5875 5874 1774 1775 +5874 5896 1774 1884 +5876 5875 1664 1665 +5875 5897 1664 1774 +5877 5876 1554 1555 +5876 5898 1554 1664 +5878 5877 1444 1445 +5877 5899 1444 1554 +5879 5878 1334 1335 +5878 589a 1334 1444 +587a 5879 1224 1225 +5879 589b 1224 1334 +587a 589c 1114 1224 +587c 587b 3423 3424 +587b 589d 3423 3533 +587d 587c 3313 3314 +587c 589e 3313 3423 +587e 587d 3203 3204 +587d 589f 3203 3313 +587f 587e 30f3 30f4 +587e 58a0 30f3 3203 +5880 587f 2fe3 2fe4 +587f 58a1 2fe3 30f3 +5881 5880 2ed3 2ed4 +5880 58a2 2ed3 2fe3 +5882 5881 2dc3 2dc4 +5881 58a3 2dc3 2ed3 +5883 5882 2cb3 2cb4 +5882 58a4 2cb3 2dc3 +5884 5883 2ba3 2ba4 +5883 58a5 2ba3 2cb3 +5885 5884 2a93 2a94 +5884 58a6 2a93 2ba3 +5886 5885 2983 2984 +5885 58a7 2983 2a93 +5887 5886 2873 2874 +5886 58a8 2873 2983 +5888 5887 2763 2764 +5887 58a9 2763 2873 +5889 5888 2653 2654 +5888 58aa 2653 2763 +588a 5889 2543 2544 +5889 58ab 2543 2653 +588b 588a 2433 2434 +588a 58ac 2433 2543 +588c 588b 2323 2324 +588b 58ad 2323 2433 +588d 588c 2213 2214 +588c 58ae 2213 2323 +588e 588d 2103 2104 +588d 58af 2103 2213 +588f 588e 1ff3 1ff4 +588e 58b0 1ff3 2103 +5890 588f 1ee3 1ee4 +588f 58b1 1ee3 1ff3 +5891 5890 1dd3 1dd4 +5890 58b2 1dd3 1ee3 +5892 5891 1cc3 1cc4 +5891 58b3 1cc3 1dd3 +5893 5892 1bb3 1bb4 +5892 58b4 1bb3 1cc3 +5894 5893 1aa3 1aa4 +5893 58b5 1aa3 1bb3 +5895 5894 1993 1994 +5894 58b6 1993 1aa3 +5896 5895 1883 1884 +5895 58b7 1883 1993 +5897 5896 1773 1774 +5896 58b8 1773 1883 +5898 5897 1663 1664 +5897 58b9 1663 1773 +5899 5898 1553 1554 +5898 58ba 1553 1663 +589a 5899 1443 1444 +5899 58bb 1443 1553 +589b 589a 1333 1334 +589a 58bc 1333 1443 +589c 589b 1223 1224 +589b 58bd 1223 1333 +589c 58be 1113 1223 +589e 589d 3422 3423 +589d 58bf 3422 3532 +589f 589e 3312 3313 +589e 58c0 3312 3422 +58a0 589f 3202 3203 +589f 58c1 3202 3312 +58a1 58a0 30f2 30f3 +58a0 58c2 30f2 3202 +58a2 58a1 2fe2 2fe3 +58a1 58c3 2fe2 30f2 +58a3 58a2 2ed2 2ed3 +58a2 58c4 2ed2 2fe2 +58a4 58a3 2dc2 2dc3 +58a3 58c5 2dc2 2ed2 +58a5 58a4 2cb2 2cb3 +58a4 58c6 2cb2 2dc2 +58a6 58a5 2ba2 2ba3 +58a5 58c7 2ba2 2cb2 +58a7 58a6 2a92 2a93 +58a6 58c8 2a92 2ba2 +58a8 58a7 2982 2983 +58a7 58c9 2982 2a92 +58a9 58a8 2872 2873 +58a8 58ca 2872 2982 +58aa 58a9 2762 2763 +58a9 58cb 2762 2872 +58ab 58aa 2652 2653 +58aa 58cc 2652 2762 +58ac 58ab 2542 2543 +58ab 58cd 2542 2652 +58ad 58ac 2432 2433 +58ac 58ce 2432 2542 +58ae 58ad 2322 2323 +58ad 58cf 2322 2432 +58af 58ae 2212 2213 +58ae 58d0 2212 2322 +58b0 58af 2102 2103 +58af 58d1 2102 2212 +58b1 58b0 1ff2 1ff3 +58b0 58d2 1ff2 2102 +58b2 58b1 1ee2 1ee3 +58b1 58d3 1ee2 1ff2 +58b3 58b2 1dd2 1dd3 +58b2 58d4 1dd2 1ee2 +58b4 58b3 1cc2 1cc3 +58b3 58d5 1cc2 1dd2 +58b5 58b4 1bb2 1bb3 +58b4 58d6 1bb2 1cc2 +58b6 58b5 1aa2 1aa3 +58b5 58d7 1aa2 1bb2 +58b7 58b6 1992 1993 +58b6 58d8 1992 1aa2 +58b8 58b7 1882 1883 +58b7 58d9 1882 1992 +58b9 58b8 1772 1773 +58b8 58da 1772 1882 +58ba 58b9 1662 1663 +58b9 58db 1662 1772 +58bb 58ba 1552 1553 +58ba 58dc 1552 1662 +58bc 58bb 1442 1443 +58bb 58dd 1442 1552 +58bd 58bc 1332 1333 +58bc 58de 1332 1442 +58be 58bd 1222 1223 +58bd 58df 1222 1332 +58be 58e0 1112 1222 +58c0 58bf 3421 3422 +58bf 58e1 3421 3531 +58c1 58c0 3311 3312 +58c0 58e2 3311 3421 +58c2 58c1 3201 3202 +58c1 58e3 3201 3311 +58c3 58c2 30f1 30f2 +58c2 58e4 30f1 3201 +58c4 58c3 2fe1 2fe2 +58c3 58e5 2fe1 30f1 +58c5 58c4 2ed1 2ed2 +58c4 58e6 2ed1 2fe1 +58c6 58c5 2dc1 2dc2 +58c5 58e7 2dc1 2ed1 +58c7 58c6 2cb1 2cb2 +58c6 58e8 2cb1 2dc1 +58c8 58c7 2ba1 2ba2 +58c7 58e9 2ba1 2cb1 +58c9 58c8 2a91 2a92 +58c8 58ea 2a91 2ba1 +58ca 58c9 2981 2982 +58c9 58eb 2981 2a91 +58cb 58ca 2871 2872 +58ca 58ec 2871 2981 +58cc 58cb 2761 2762 +58cb 58ed 2761 2871 +58cd 58cc 2651 2652 +58cc 58ee 2651 2761 +58ce 58cd 2541 2542 +58cd 58ef 2541 2651 +58cf 58ce 2431 2432 +58ce 58f0 2431 2541 +58d0 58cf 2321 2322 +58cf 58f1 2321 2431 +58d1 58d0 2211 2212 +58d0 58f2 2211 2321 +58d2 58d1 2101 2102 +58d1 58f3 2101 2211 +58d3 58d2 1ff1 1ff2 +58d2 58f4 1ff1 2101 +58d4 58d3 1ee1 1ee2 +58d3 58f5 1ee1 1ff1 +58d5 58d4 1dd1 1dd2 +58d4 58f6 1dd1 1ee1 +58d6 58d5 1cc1 1cc2 +58d5 58f7 1cc1 1dd1 +58d7 58d6 1bb1 1bb2 +58d6 58f8 1bb1 1cc1 +58d8 58d7 1aa1 1aa2 +58d7 58f9 1aa1 1bb1 +58d9 58d8 1991 1992 +58d8 58fa 1991 1aa1 +58da 58d9 1881 1882 +58d9 58fb 1881 1991 +58db 58da 1771 1772 +58da 58fc 1771 1881 +58dc 58db 1661 1662 +58db 58fd 1661 1771 +58dd 58dc 1551 1552 +58dc 58fe 1551 1661 +58de 58dd 1441 1442 +58dd 58ff 1441 1551 +58df 58de 1331 1332 +58de 5900 1331 1441 +58e0 58df 1221 1222 +58df 5901 1221 1331 +58e0 5902 1111 1221 +58e2 58e1 3420 3421 +58e1 5903 3420 3530 +58e3 58e2 3310 3311 +58e2 5904 3310 3420 +58e4 58e3 3200 3201 +58e3 5905 3200 3310 +58e5 58e4 30f0 30f1 +58e4 5906 30f0 3200 +58e6 58e5 2fe0 2fe1 +58e5 5907 2fe0 30f0 +58e7 58e6 2ed0 2ed1 +58e6 5908 2ed0 2fe0 +58e8 58e7 2dc0 2dc1 +58e7 5909 2dc0 2ed0 +58e9 58e8 2cb0 2cb1 +58e8 590a 2cb0 2dc0 +58ea 58e9 2ba0 2ba1 +58e9 590b 2ba0 2cb0 +58eb 58ea 2a90 2a91 +58ea 590c 2a90 2ba0 +58ec 58eb 2980 2981 +58eb 590d 2980 2a90 +58ed 58ec 2870 2871 +58ec 590e 2870 2980 +58ee 58ed 2760 2761 +58ed 590f 2760 2870 +58ef 58ee 2650 2651 +58ee 5910 2650 2760 +58f0 58ef 2540 2541 +58ef 5911 2540 2650 +58f1 58f0 2430 2431 +58f0 5912 2430 2540 +58f2 58f1 2320 2321 +58f1 5913 2320 2430 +58f3 58f2 2210 2211 +58f2 5914 2210 2320 +58f4 58f3 2100 2101 +58f3 5915 2100 2210 +58f5 58f4 1ff0 1ff1 +58f4 5916 1ff0 2100 +58f6 58f5 1ee0 1ee1 +58f5 5917 1ee0 1ff0 +58f7 58f6 1dd0 1dd1 +58f6 5918 1dd0 1ee0 +58f8 58f7 1cc0 1cc1 +58f7 5919 1cc0 1dd0 +58f9 58f8 1bb0 1bb1 +58f8 591a 1bb0 1cc0 +58fa 58f9 1aa0 1aa1 +58f9 591b 1aa0 1bb0 +58fb 58fa 1990 1991 +58fa 591c 1990 1aa0 +58fc 58fb 1880 1881 +58fb 591d 1880 1990 +58fd 58fc 1770 1771 +58fc 591e 1770 1880 +58fe 58fd 1660 1661 +58fd 591f 1660 1770 +58ff 58fe 1550 1551 +58fe 5920 1550 1660 +5900 58ff 1440 1441 +58ff 5921 1440 1550 +5901 5900 1330 1331 +5900 5922 1330 1440 +5902 5901 1220 1221 +5901 5923 1220 1330 +5902 5924 1110 1220 +5904 5903 341f 3420 +5903 5925 341f 352f +5905 5904 330f 3310 +5904 5926 330f 341f +5906 5905 31ff 3200 +5905 5927 31ff 330f +5907 5906 30ef 30f0 +5906 5928 30ef 31ff +5908 5907 2fdf 2fe0 +5907 5929 2fdf 30ef +5909 5908 2ecf 2ed0 +5908 592a 2ecf 2fdf +590a 5909 2dbf 2dc0 +5909 592b 2dbf 2ecf +590b 590a 2caf 2cb0 +590a 592c 2caf 2dbf +590c 590b 2b9f 2ba0 +590b 592d 2b9f 2caf +590d 590c 2a8f 2a90 +590c 592e 2a8f 2b9f +590e 590d 297f 2980 +590d 592f 297f 2a8f +590f 590e 286f 2870 +590e 5930 286f 297f +5910 590f 275f 2760 +590f 5931 275f 286f +5911 5910 264f 2650 +5910 5932 264f 275f +5912 5911 253f 2540 +5911 5933 253f 264f +5913 5912 242f 2430 +5912 5934 242f 253f +5914 5913 231f 2320 +5913 5935 231f 242f +5915 5914 220f 2210 +5914 5936 220f 231f +5916 5915 20ff 2100 +5915 5937 20ff 220f +5917 5916 1fef 1ff0 +5916 5938 1fef 20ff +5918 5917 1edf 1ee0 +5917 5939 1edf 1fef +5919 5918 1dcf 1dd0 +5918 593a 1dcf 1edf +591a 5919 1cbf 1cc0 +5919 593b 1cbf 1dcf +591b 591a 1baf 1bb0 +591a 593c 1baf 1cbf +591c 591b 1a9f 1aa0 +591b 593d 1a9f 1baf +591d 591c 198f 1990 +591c 593e 198f 1a9f +591e 591d 187f 1880 +591d 593f 187f 198f +591f 591e 176f 1770 +591e 5940 176f 187f +5920 591f 165f 1660 +591f 5941 165f 176f +5921 5920 154f 1550 +5920 5942 154f 165f +5922 5921 143f 1440 +5921 5943 143f 154f +5923 5922 132f 1330 +5922 5944 132f 143f +5924 5923 121f 1220 +5923 5945 121f 132f +5924 5946 110f 121f +5926 5925 341e 341f +5925 5947 341e 352e +5927 5926 330e 330f +5926 5948 330e 341e +5928 5927 31fe 31ff +5927 5949 31fe 330e +5929 5928 30ee 30ef +5928 594a 30ee 31fe +592a 5929 2fde 2fdf +5929 594b 2fde 30ee +592b 592a 2ece 2ecf +592a 594c 2ece 2fde +592c 592b 2dbe 2dbf +592b 594d 2dbe 2ece +592d 592c 2cae 2caf +592c 594e 2cae 2dbe +592e 592d 2b9e 2b9f +592d 594f 2b9e 2cae +592f 592e 2a8e 2a8f +592e 5950 2a8e 2b9e +5930 592f 297e 297f +592f 5951 297e 2a8e +5931 5930 286e 286f +5930 5952 286e 297e +5932 5931 275e 275f +5931 5953 275e 286e +5933 5932 264e 264f +5932 5954 264e 275e +5934 5933 253e 253f +5933 5955 253e 264e +5935 5934 242e 242f +5934 5956 242e 253e +5936 5935 231e 231f +5935 5957 231e 242e +5937 5936 220e 220f +5936 5958 220e 231e +5938 5937 20fe 20ff +5937 5959 20fe 220e +5939 5938 1fee 1fef +5938 595a 1fee 20fe +593a 5939 1ede 1edf +5939 595b 1ede 1fee +593b 593a 1dce 1dcf +593a 595c 1dce 1ede +593c 593b 1cbe 1cbf +593b 595d 1cbe 1dce +593d 593c 1bae 1baf +593c 595e 1bae 1cbe +593e 593d 1a9e 1a9f +593d 595f 1a9e 1bae +593f 593e 198e 198f +593e 5960 198e 1a9e +5940 593f 187e 187f +593f 5961 187e 198e +5941 5940 176e 176f +5940 5962 176e 187e +5942 5941 165e 165f +5941 5963 165e 176e +5943 5942 154e 154f +5942 5964 154e 165e +5944 5943 143e 143f +5943 5965 143e 154e +5945 5944 132e 132f +5944 5966 132e 143e +5946 5945 121e 121f +5945 5967 121e 132e +5946 5968 110e 121e +5948 5947 341d 341e +5947 5969 341d 352d +5949 5948 330d 330e +5948 596a 330d 341d +594a 5949 31fd 31fe +5949 596b 31fd 330d +594b 594a 30ed 30ee +594a 596c 30ed 31fd +594c 594b 2fdd 2fde +594b 596d 2fdd 30ed +594d 594c 2ecd 2ece +594c 596e 2ecd 2fdd +594e 594d 2dbd 2dbe +594d 596f 2dbd 2ecd +594f 594e 2cad 2cae +594e 5970 2cad 2dbd +5950 594f 2b9d 2b9e +594f 5971 2b9d 2cad +5951 5950 2a8d 2a8e +5950 5972 2a8d 2b9d +5952 5951 297d 297e +5951 5973 297d 2a8d +5953 5952 286d 286e +5952 5974 286d 297d +5954 5953 275d 275e +5953 5975 275d 286d +5955 5954 264d 264e +5954 5976 264d 275d +5956 5955 253d 253e +5955 5977 253d 264d +5957 5956 242d 242e +5956 5978 242d 253d +5958 5957 231d 231e +5957 5979 231d 242d +5959 5958 220d 220e +5958 597a 220d 231d +595a 5959 20fd 20fe +5959 597b 20fd 220d +595b 595a 1fed 1fee +595a 597c 1fed 20fd +595c 595b 1edd 1ede +595b 597d 1edd 1fed +595d 595c 1dcd 1dce +595c 597e 1dcd 1edd +595e 595d 1cbd 1cbe +595d 597f 1cbd 1dcd +595f 595e 1bad 1bae +595e 5980 1bad 1cbd +5960 595f 1a9d 1a9e +595f 5981 1a9d 1bad +5961 5960 198d 198e +5960 5982 198d 1a9d +5962 5961 187d 187e +5961 5983 187d 198d +5963 5962 176d 176e +5962 5984 176d 187d +5964 5963 165d 165e +5963 5985 165d 176d +5965 5964 154d 154e +5964 5986 154d 165d +5966 5965 143d 143e +5965 5987 143d 154d +5967 5966 132d 132e +5966 5988 132d 143d +5968 5967 121d 121e +5967 5989 121d 132d +5968 598a 110d 121d +596a 5969 341c 341d +5969 598b 341c 352c +596b 596a 330c 330d +596a 598c 330c 341c +596c 596b 31fc 31fd +596b 598d 31fc 330c +596d 596c 30ec 30ed +596c 598e 30ec 31fc +596e 596d 2fdc 2fdd +596d 598f 2fdc 30ec +596f 596e 2ecc 2ecd +596e 5990 2ecc 2fdc +5970 596f 2dbc 2dbd +596f 5991 2dbc 2ecc +5971 5970 2cac 2cad +5970 5992 2cac 2dbc +5972 5971 2b9c 2b9d +5971 5993 2b9c 2cac +5973 5972 2a8c 2a8d +5972 5994 2a8c 2b9c +5974 5973 297c 297d +5973 5995 297c 2a8c +5975 5974 286c 286d +5974 5996 286c 297c +5976 5975 275c 275d +5975 5997 275c 286c +5977 5976 264c 264d +5976 5998 264c 275c +5978 5977 253c 253d +5977 5999 253c 264c +5979 5978 242c 242d +5978 599a 242c 253c +597a 5979 231c 231d +5979 599b 231c 242c +597b 597a 220c 220d +597a 599c 220c 231c +597c 597b 20fc 20fd +597b 599d 20fc 220c +597d 597c 1fec 1fed +597c 599e 1fec 20fc +597e 597d 1edc 1edd +597d 599f 1edc 1fec +597f 597e 1dcc 1dcd +597e 59a0 1dcc 1edc +5980 597f 1cbc 1cbd +597f 59a1 1cbc 1dcc +5981 5980 1bac 1bad +5980 59a2 1bac 1cbc +5982 5981 1a9c 1a9d +5981 59a3 1a9c 1bac +5983 5982 198c 198d +5982 59a4 198c 1a9c +5984 5983 187c 187d +5983 59a5 187c 198c +5985 5984 176c 176d +5984 59a6 176c 187c +5986 5985 165c 165d +5985 59a7 165c 176c +5987 5986 154c 154d +5986 59a8 154c 165c +5988 5987 143c 143d +5987 59a9 143c 154c +5989 5988 132c 132d +5988 59aa 132c 143c +598a 5989 121c 121d +5989 59ab 121c 132c +598a 59ac 110c 121c +598c 598b 341b 341c +598b 59ad 341b 352b +598d 598c 330b 330c +598c 59ae 330b 341b +598e 598d 31fb 31fc +598d 59af 31fb 330b +598f 598e 30eb 30ec +598e 59b0 30eb 31fb +5990 598f 2fdb 2fdc +598f 59b1 2fdb 30eb +5991 5990 2ecb 2ecc +5990 59b2 2ecb 2fdb +5992 5991 2dbb 2dbc +5991 59b3 2dbb 2ecb +5993 5992 2cab 2cac +5992 59b4 2cab 2dbb +5994 5993 2b9b 2b9c +5993 59b5 2b9b 2cab +5995 5994 2a8b 2a8c +5994 59b6 2a8b 2b9b +5996 5995 297b 297c +5995 59b7 297b 2a8b +5997 5996 286b 286c +5996 59b8 286b 297b +5998 5997 275b 275c +5997 59b9 275b 286b +5999 5998 264b 264c +5998 59ba 264b 275b +599a 5999 253b 253c +5999 59bb 253b 264b +599b 599a 242b 242c +599a 59bc 242b 253b +599c 599b 231b 231c +599b 59bd 231b 242b +599d 599c 220b 220c +599c 59be 220b 231b +599e 599d 20fb 20fc +599d 59bf 20fb 220b +599f 599e 1feb 1fec +599e 59c0 1feb 20fb +59a0 599f 1edb 1edc +599f 59c1 1edb 1feb +59a1 59a0 1dcb 1dcc +59a0 59c2 1dcb 1edb +59a2 59a1 1cbb 1cbc +59a1 59c3 1cbb 1dcb +59a3 59a2 1bab 1bac +59a2 59c4 1bab 1cbb +59a4 59a3 1a9b 1a9c +59a3 59c5 1a9b 1bab +59a5 59a4 198b 198c +59a4 59c6 198b 1a9b +59a6 59a5 187b 187c +59a5 59c7 187b 198b +59a7 59a6 176b 176c +59a6 59c8 176b 187b +59a8 59a7 165b 165c +59a7 59c9 165b 176b +59a9 59a8 154b 154c +59a8 59ca 154b 165b +59aa 59a9 143b 143c +59a9 59cb 143b 154b +59ab 59aa 132b 132c +59aa 59cc 132b 143b +59ac 59ab 121b 121c +59ab 59cd 121b 132b +59ac 59ce 110b 121b +59ae 59ad 341a 341b +59ad 59cf 341a 352a +59af 59ae 330a 330b +59ae 59d0 330a 341a +59b0 59af 31fa 31fb +59af 59d1 31fa 330a +59b1 59b0 30ea 30eb +59b0 59d2 30ea 31fa +59b2 59b1 2fda 2fdb +59b1 59d3 2fda 30ea +59b3 59b2 2eca 2ecb +59b2 59d4 2eca 2fda +59b4 59b3 2dba 2dbb +59b3 59d5 2dba 2eca +59b5 59b4 2caa 2cab +59b4 59d6 2caa 2dba +59b6 59b5 2b9a 2b9b +59b5 59d7 2b9a 2caa +59b7 59b6 2a8a 2a8b +59b6 59d8 2a8a 2b9a +59b8 59b7 297a 297b +59b7 59d9 297a 2a8a +59b9 59b8 286a 286b +59b8 59da 286a 297a +59ba 59b9 275a 275b +59b9 59db 275a 286a +59bb 59ba 264a 264b +59ba 59dc 264a 275a +59bc 59bb 253a 253b +59bb 59dd 253a 264a +59bd 59bc 242a 242b +59bc 59de 242a 253a +59be 59bd 231a 231b +59bd 59df 231a 242a +59bf 59be 220a 220b +59be 59e0 220a 231a +59c0 59bf 20fa 20fb +59bf 59e1 20fa 220a +59c1 59c0 1fea 1feb +59c0 59e2 1fea 20fa +59c2 59c1 1eda 1edb +59c1 59e3 1eda 1fea +59c3 59c2 1dca 1dcb +59c2 59e4 1dca 1eda +59c4 59c3 1cba 1cbb +59c3 59e5 1cba 1dca +59c5 59c4 1baa 1bab +59c4 59e6 1baa 1cba +59c6 59c5 1a9a 1a9b +59c5 59e7 1a9a 1baa +59c7 59c6 198a 198b +59c6 59e8 198a 1a9a +59c8 59c7 187a 187b +59c7 59e9 187a 198a +59c9 59c8 176a 176b +59c8 59ea 176a 187a +59ca 59c9 165a 165b +59c9 59eb 165a 176a +59cb 59ca 154a 154b +59ca 59ec 154a 165a +59cc 59cb 143a 143b +59cb 59ed 143a 154a +59cd 59cc 132a 132b +59cc 59ee 132a 143a +59ce 59cd 121a 121b +59cd 59ef 121a 132a +59ce 59f0 110a 121a +59d0 59cf 3419 341a +59cf 59f1 3419 3529 +59d1 59d0 3309 330a +59d0 59f2 3309 3419 +59d2 59d1 31f9 31fa +59d1 59f3 31f9 3309 +59d3 59d2 30e9 30ea +59d2 59f4 30e9 31f9 +59d4 59d3 2fd9 2fda +59d3 59f5 2fd9 30e9 +59d5 59d4 2ec9 2eca +59d4 59f6 2ec9 2fd9 +59d6 59d5 2db9 2dba +59d5 59f7 2db9 2ec9 +59d7 59d6 2ca9 2caa +59d6 59f8 2ca9 2db9 +59d8 59d7 2b99 2b9a +59d7 59f9 2b99 2ca9 +59d9 59d8 2a89 2a8a +59d8 59fa 2a89 2b99 +59da 59d9 2979 297a +59d9 59fb 2979 2a89 +59db 59da 2869 286a +59da 59fc 2869 2979 +59dc 59db 2759 275a +59db 59fd 2759 2869 +59dd 59dc 2649 264a +59dc 59fe 2649 2759 +59de 59dd 2539 253a +59dd 59ff 2539 2649 +59df 59de 2429 242a +59de 5a00 2429 2539 +59e0 59df 2319 231a +59df 5a01 2319 2429 +59e1 59e0 2209 220a +59e0 5a02 2209 2319 +59e2 59e1 20f9 20fa +59e1 5a03 20f9 2209 +59e3 59e2 1fe9 1fea +59e2 5a04 1fe9 20f9 +59e4 59e3 1ed9 1eda +59e3 5a05 1ed9 1fe9 +59e5 59e4 1dc9 1dca +59e4 5a06 1dc9 1ed9 +59e6 59e5 1cb9 1cba +59e5 5a07 1cb9 1dc9 +59e7 59e6 1ba9 1baa +59e6 5a08 1ba9 1cb9 +59e8 59e7 1a99 1a9a +59e7 5a09 1a99 1ba9 +59e9 59e8 1989 198a +59e8 5a0a 1989 1a99 +59ea 59e9 1879 187a +59e9 5a0b 1879 1989 +59eb 59ea 1769 176a +59ea 5a0c 1769 1879 +59ec 59eb 1659 165a +59eb 5a0d 1659 1769 +59ed 59ec 1549 154a +59ec 5a0e 1549 1659 +59ee 59ed 1439 143a +59ed 5a0f 1439 1549 +59ef 59ee 1329 132a +59ee 5a10 1329 1439 +59f0 59ef 1219 121a +59ef 5a11 1219 1329 +59f0 5a12 1109 1219 +59f2 59f1 3418 3419 +59f1 5a13 3418 3528 +59f3 59f2 3308 3309 +59f2 5a14 3308 3418 +59f4 59f3 31f8 31f9 +59f3 5a15 31f8 3308 +59f5 59f4 30e8 30e9 +59f4 5a16 30e8 31f8 +59f6 59f5 2fd8 2fd9 +59f5 5a17 2fd8 30e8 +59f7 59f6 2ec8 2ec9 +59f6 5a18 2ec8 2fd8 +59f8 59f7 2db8 2db9 +59f7 5a19 2db8 2ec8 +59f9 59f8 2ca8 2ca9 +59f8 5a1a 2ca8 2db8 +59fa 59f9 2b98 2b99 +59f9 5a1b 2b98 2ca8 +59fb 59fa 2a88 2a89 +59fa 5a1c 2a88 2b98 +59fc 59fb 2978 2979 +59fb 5a1d 2978 2a88 +59fd 59fc 2868 2869 +59fc 5a1e 2868 2978 +59fe 59fd 2758 2759 +59fd 5a1f 2758 2868 +59ff 59fe 2648 2649 +59fe 5a20 2648 2758 +5a00 59ff 2538 2539 +59ff 5a21 2538 2648 +5a01 5a00 2428 2429 +5a00 5a22 2428 2538 +5a02 5a01 2318 2319 +5a01 5a23 2318 2428 +5a03 5a02 2208 2209 +5a02 5a24 2208 2318 +5a04 5a03 20f8 20f9 +5a03 5a25 20f8 2208 +5a05 5a04 1fe8 1fe9 +5a04 5a26 1fe8 20f8 +5a06 5a05 1ed8 1ed9 +5a05 5a27 1ed8 1fe8 +5a07 5a06 1dc8 1dc9 +5a06 5a28 1dc8 1ed8 +5a08 5a07 1cb8 1cb9 +5a07 5a29 1cb8 1dc8 +5a09 5a08 1ba8 1ba9 +5a08 5a2a 1ba8 1cb8 +5a0a 5a09 1a98 1a99 +5a09 5a2b 1a98 1ba8 +5a0b 5a0a 1988 1989 +5a0a 5a2c 1988 1a98 +5a0c 5a0b 1878 1879 +5a0b 5a2d 1878 1988 +5a0d 5a0c 1768 1769 +5a0c 5a2e 1768 1878 +5a0e 5a0d 1658 1659 +5a0d 5a2f 1658 1768 +5a0f 5a0e 1548 1549 +5a0e 5a30 1548 1658 +5a10 5a0f 1438 1439 +5a0f 5a31 1438 1548 +5a11 5a10 1328 1329 +5a10 5a32 1328 1438 +5a12 5a11 1218 1219 +5a11 5a33 1218 1328 +5a12 5a34 1108 1218 +5a14 5a13 3417 3418 +5a13 5a35 3417 3527 +5a15 5a14 3307 3308 +5a14 5a36 3307 3417 +5a16 5a15 31f7 31f8 +5a15 5a37 31f7 3307 +5a17 5a16 30e7 30e8 +5a16 5a38 30e7 31f7 +5a18 5a17 2fd7 2fd8 +5a17 5a39 2fd7 30e7 +5a19 5a18 2ec7 2ec8 +5a18 5a3a 2ec7 2fd7 +5a1a 5a19 2db7 2db8 +5a19 5a3b 2db7 2ec7 +5a1b 5a1a 2ca7 2ca8 +5a1a 5a3c 2ca7 2db7 +5a1c 5a1b 2b97 2b98 +5a1b 5a3d 2b97 2ca7 +5a1d 5a1c 2a87 2a88 +5a1c 5a3e 2a87 2b97 +5a1e 5a1d 2977 2978 +5a1d 5a3f 2977 2a87 +5a1f 5a1e 2867 2868 +5a1e 5a40 2867 2977 +5a20 5a1f 2757 2758 +5a1f 5a41 2757 2867 +5a21 5a20 2647 2648 +5a20 5a42 2647 2757 +5a22 5a21 2537 2538 +5a21 5a43 2537 2647 +5a23 5a22 2427 2428 +5a22 5a44 2427 2537 +5a24 5a23 2317 2318 +5a23 5a45 2317 2427 +5a25 5a24 2207 2208 +5a24 5a46 2207 2317 +5a26 5a25 20f7 20f8 +5a25 5a47 20f7 2207 +5a27 5a26 1fe7 1fe8 +5a26 5a48 1fe7 20f7 +5a28 5a27 1ed7 1ed8 +5a27 5a49 1ed7 1fe7 +5a29 5a28 1dc7 1dc8 +5a28 5a4a 1dc7 1ed7 +5a2a 5a29 1cb7 1cb8 +5a29 5a4b 1cb7 1dc7 +5a2b 5a2a 1ba7 1ba8 +5a2a 5a4c 1ba7 1cb7 +5a2c 5a2b 1a97 1a98 +5a2b 5a4d 1a97 1ba7 +5a2d 5a2c 1987 1988 +5a2c 5a4e 1987 1a97 +5a2e 5a2d 1877 1878 +5a2d 5a4f 1877 1987 +5a2f 5a2e 1767 1768 +5a2e 5a50 1767 1877 +5a30 5a2f 1657 1658 +5a2f 5a51 1657 1767 +5a31 5a30 1547 1548 +5a30 5a52 1547 1657 +5a32 5a31 1437 1438 +5a31 5a53 1437 1547 +5a33 5a32 1327 1328 +5a32 5a54 1327 1437 +5a34 5a33 1217 1218 +5a33 5a55 1217 1327 +5a34 5a56 1107 1217 +5a36 5a35 3416 3417 +5a35 5a57 3416 3526 +5a37 5a36 3306 3307 +5a36 5a58 3306 3416 +5a38 5a37 31f6 31f7 +5a37 5a59 31f6 3306 +5a39 5a38 30e6 30e7 +5a38 5a5a 30e6 31f6 +5a3a 5a39 2fd6 2fd7 +5a39 5a5b 2fd6 30e6 +5a3b 5a3a 2ec6 2ec7 +5a3a 5a5c 2ec6 2fd6 +5a3c 5a3b 2db6 2db7 +5a3b 5a5d 2db6 2ec6 +5a3d 5a3c 2ca6 2ca7 +5a3c 5a5e 2ca6 2db6 +5a3e 5a3d 2b96 2b97 +5a3d 5a5f 2b96 2ca6 +5a3f 5a3e 2a86 2a87 +5a3e 5a60 2a86 2b96 +5a40 5a3f 2976 2977 +5a3f 5a61 2976 2a86 +5a41 5a40 2866 2867 +5a40 5a62 2866 2976 +5a42 5a41 2756 2757 +5a41 5a63 2756 2866 +5a43 5a42 2646 2647 +5a42 5a64 2646 2756 +5a44 5a43 2536 2537 +5a43 5a65 2536 2646 +5a45 5a44 2426 2427 +5a44 5a66 2426 2536 +5a46 5a45 2316 2317 +5a45 5a67 2316 2426 +5a47 5a46 2206 2207 +5a46 5a68 2206 2316 +5a48 5a47 20f6 20f7 +5a47 5a69 20f6 2206 +5a49 5a48 1fe6 1fe7 +5a48 5a6a 1fe6 20f6 +5a4a 5a49 1ed6 1ed7 +5a49 5a6b 1ed6 1fe6 +5a4b 5a4a 1dc6 1dc7 +5a4a 5a6c 1dc6 1ed6 +5a4c 5a4b 1cb6 1cb7 +5a4b 5a6d 1cb6 1dc6 +5a4d 5a4c 1ba6 1ba7 +5a4c 5a6e 1ba6 1cb6 +5a4e 5a4d 1a96 1a97 +5a4d 5a6f 1a96 1ba6 +5a4f 5a4e 1986 1987 +5a4e 5a70 1986 1a96 +5a50 5a4f 1876 1877 +5a4f 5a71 1876 1986 +5a51 5a50 1766 1767 +5a50 5a72 1766 1876 +5a52 5a51 1656 1657 +5a51 5a73 1656 1766 +5a53 5a52 1546 1547 +5a52 5a74 1546 1656 +5a54 5a53 1436 1437 +5a53 5a75 1436 1546 +5a55 5a54 1326 1327 +5a54 5a76 1326 1436 +5a56 5a55 1216 1217 +5a55 5a77 1216 1326 +5a56 5a78 1106 1216 +5a58 5a57 3415 3416 +5a57 5a79 3415 3525 +5a59 5a58 3305 3306 +5a58 5a7a 3305 3415 +5a5a 5a59 31f5 31f6 +5a59 5a7b 31f5 3305 +5a5b 5a5a 30e5 30e6 +5a5a 5a7c 30e5 31f5 +5a5c 5a5b 2fd5 2fd6 +5a5b 5a7d 2fd5 30e5 +5a5d 5a5c 2ec5 2ec6 +5a5c 5a7e 2ec5 2fd5 +5a5e 5a5d 2db5 2db6 +5a5d 5a7f 2db5 2ec5 +5a5f 5a5e 2ca5 2ca6 +5a5e 5a80 2ca5 2db5 +5a60 5a5f 2b95 2b96 +5a5f 5a81 2b95 2ca5 +5a61 5a60 2a85 2a86 +5a60 5a82 2a85 2b95 +5a62 5a61 2975 2976 +5a61 5a83 2975 2a85 +5a63 5a62 2865 2866 +5a62 5a84 2865 2975 +5a64 5a63 2755 2756 +5a63 5a85 2755 2865 +5a65 5a64 2645 2646 +5a64 5a86 2645 2755 +5a66 5a65 2535 2536 +5a65 5a87 2535 2645 +5a67 5a66 2425 2426 +5a66 5a88 2425 2535 +5a68 5a67 2315 2316 +5a67 5a89 2315 2425 +5a69 5a68 2205 2206 +5a68 5a8a 2205 2315 +5a6a 5a69 20f5 20f6 +5a69 5a8b 20f5 2205 +5a6b 5a6a 1fe5 1fe6 +5a6a 5a8c 1fe5 20f5 +5a6c 5a6b 1ed5 1ed6 +5a6b 5a8d 1ed5 1fe5 +5a6d 5a6c 1dc5 1dc6 +5a6c 5a8e 1dc5 1ed5 +5a6e 5a6d 1cb5 1cb6 +5a6d 5a8f 1cb5 1dc5 +5a6f 5a6e 1ba5 1ba6 +5a6e 5a90 1ba5 1cb5 +5a70 5a6f 1a95 1a96 +5a6f 5a91 1a95 1ba5 +5a71 5a70 1985 1986 +5a70 5a92 1985 1a95 +5a72 5a71 1875 1876 +5a71 5a93 1875 1985 +5a73 5a72 1765 1766 +5a72 5a94 1765 1875 +5a74 5a73 1655 1656 +5a73 5a95 1655 1765 +5a75 5a74 1545 1546 +5a74 5a96 1545 1655 +5a76 5a75 1435 1436 +5a75 5a97 1435 1545 +5a77 5a76 1325 1326 +5a76 5a98 1325 1435 +5a78 5a77 1215 1216 +5a77 5a99 1215 1325 +5a78 5a9a 1105 1215 +5a7a 5a79 3414 3415 +5a79 5a9b 3414 3524 +5a7b 5a7a 3304 3305 +5a7a 5a9c 3304 3414 +5a7c 5a7b 31f4 31f5 +5a7b 5a9d 31f4 3304 +5a7d 5a7c 30e4 30e5 +5a7c 5a9e 30e4 31f4 +5a7e 5a7d 2fd4 2fd5 +5a7d 5a9f 2fd4 30e4 +5a7f 5a7e 2ec4 2ec5 +5a7e 5aa0 2ec4 2fd4 +5a80 5a7f 2db4 2db5 +5a7f 5aa1 2db4 2ec4 +5a81 5a80 2ca4 2ca5 +5a80 5aa2 2ca4 2db4 +5a82 5a81 2b94 2b95 +5a81 5aa3 2b94 2ca4 +5a83 5a82 2a84 2a85 +5a82 5aa4 2a84 2b94 +5a84 5a83 2974 2975 +5a83 5aa5 2974 2a84 +5a85 5a84 2864 2865 +5a84 5aa6 2864 2974 +5a86 5a85 2754 2755 +5a85 5aa7 2754 2864 +5a87 5a86 2644 2645 +5a86 5aa8 2644 2754 +5a88 5a87 2534 2535 +5a87 5aa9 2534 2644 +5a89 5a88 2424 2425 +5a88 5aaa 2424 2534 +5a8a 5a89 2314 2315 +5a89 5aab 2314 2424 +5a8b 5a8a 2204 2205 +5a8a 5aac 2204 2314 +5a8c 5a8b 20f4 20f5 +5a8b 5aad 20f4 2204 +5a8d 5a8c 1fe4 1fe5 +5a8c 5aae 1fe4 20f4 +5a8e 5a8d 1ed4 1ed5 +5a8d 5aaf 1ed4 1fe4 +5a8f 5a8e 1dc4 1dc5 +5a8e 5ab0 1dc4 1ed4 +5a90 5a8f 1cb4 1cb5 +5a8f 5ab1 1cb4 1dc4 +5a91 5a90 1ba4 1ba5 +5a90 5ab2 1ba4 1cb4 +5a92 5a91 1a94 1a95 +5a91 5ab3 1a94 1ba4 +5a93 5a92 1984 1985 +5a92 5ab4 1984 1a94 +5a94 5a93 1874 1875 +5a93 5ab5 1874 1984 +5a95 5a94 1764 1765 +5a94 5ab6 1764 1874 +5a96 5a95 1654 1655 +5a95 5ab7 1654 1764 +5a97 5a96 1544 1545 +5a96 5ab8 1544 1654 +5a98 5a97 1434 1435 +5a97 5ab9 1434 1544 +5a99 5a98 1324 1325 +5a98 5aba 1324 1434 +5a9a 5a99 1214 1215 +5a99 5abb 1214 1324 +5a9a 5abc 1104 1214 +5a9c 5a9b 3413 3414 +5a9b 5abd 3413 3523 +5a9d 5a9c 3303 3304 +5a9c 5abe 3303 3413 +5a9e 5a9d 31f3 31f4 +5a9d 5abf 31f3 3303 +5a9f 5a9e 30e3 30e4 +5a9e 5ac0 30e3 31f3 +5aa0 5a9f 2fd3 2fd4 +5a9f 5ac1 2fd3 30e3 +5aa1 5aa0 2ec3 2ec4 +5aa0 5ac2 2ec3 2fd3 +5aa2 5aa1 2db3 2db4 +5aa1 5ac3 2db3 2ec3 +5aa3 5aa2 2ca3 2ca4 +5aa2 5ac4 2ca3 2db3 +5aa4 5aa3 2b93 2b94 +5aa3 5ac5 2b93 2ca3 +5aa5 5aa4 2a83 2a84 +5aa4 5ac6 2a83 2b93 +5aa6 5aa5 2973 2974 +5aa5 5ac7 2973 2a83 +5aa7 5aa6 2863 2864 +5aa6 5ac8 2863 2973 +5aa8 5aa7 2753 2754 +5aa7 5ac9 2753 2863 +5aa9 5aa8 2643 2644 +5aa8 5aca 2643 2753 +5aaa 5aa9 2533 2534 +5aa9 5acb 2533 2643 +5aab 5aaa 2423 2424 +5aaa 5acc 2423 2533 +5aac 5aab 2313 2314 +5aab 5acd 2313 2423 +5aad 5aac 2203 2204 +5aac 5ace 2203 2313 +5aae 5aad 20f3 20f4 +5aad 5acf 20f3 2203 +5aaf 5aae 1fe3 1fe4 +5aae 5ad0 1fe3 20f3 +5ab0 5aaf 1ed3 1ed4 +5aaf 5ad1 1ed3 1fe3 +5ab1 5ab0 1dc3 1dc4 +5ab0 5ad2 1dc3 1ed3 +5ab2 5ab1 1cb3 1cb4 +5ab1 5ad3 1cb3 1dc3 +5ab3 5ab2 1ba3 1ba4 +5ab2 5ad4 1ba3 1cb3 +5ab4 5ab3 1a93 1a94 +5ab3 5ad5 1a93 1ba3 +5ab5 5ab4 1983 1984 +5ab4 5ad6 1983 1a93 +5ab6 5ab5 1873 1874 +5ab5 5ad7 1873 1983 +5ab7 5ab6 1763 1764 +5ab6 5ad8 1763 1873 +5ab8 5ab7 1653 1654 +5ab7 5ad9 1653 1763 +5ab9 5ab8 1543 1544 +5ab8 5ada 1543 1653 +5aba 5ab9 1433 1434 +5ab9 5adb 1433 1543 +5abb 5aba 1323 1324 +5aba 5adc 1323 1433 +5abc 5abb 1213 1214 +5abb 5add 1213 1323 +5abc 5ade 1103 1213 +5abe 5abd 3412 3413 +5abd 5adf 3412 3522 +5abf 5abe 3302 3303 +5abe 5ae0 3302 3412 +5ac0 5abf 31f2 31f3 +5abf 5ae1 31f2 3302 +5ac1 5ac0 30e2 30e3 +5ac0 5ae2 30e2 31f2 +5ac2 5ac1 2fd2 2fd3 +5ac1 5ae3 2fd2 30e2 +5ac3 5ac2 2ec2 2ec3 +5ac2 5ae4 2ec2 2fd2 +5ac4 5ac3 2db2 2db3 +5ac3 5ae5 2db2 2ec2 +5ac5 5ac4 2ca2 2ca3 +5ac4 5ae6 2ca2 2db2 +5ac6 5ac5 2b92 2b93 +5ac5 5ae7 2b92 2ca2 +5ac7 5ac6 2a82 2a83 +5ac6 5ae8 2a82 2b92 +5ac8 5ac7 2972 2973 +5ac7 5ae9 2972 2a82 +5ac9 5ac8 2862 2863 +5ac8 5aea 2862 2972 +5aca 5ac9 2752 2753 +5ac9 5aeb 2752 2862 +5acb 5aca 2642 2643 +5aca 5aec 2642 2752 +5acc 5acb 2532 2533 +5acb 5aed 2532 2642 +5acd 5acc 2422 2423 +5acc 5aee 2422 2532 +5ace 5acd 2312 2313 +5acd 5aef 2312 2422 +5acf 5ace 2202 2203 +5ace 5af0 2202 2312 +5ad0 5acf 20f2 20f3 +5acf 5af1 20f2 2202 +5ad1 5ad0 1fe2 1fe3 +5ad0 5af2 1fe2 20f2 +5ad2 5ad1 1ed2 1ed3 +5ad1 5af3 1ed2 1fe2 +5ad3 5ad2 1dc2 1dc3 +5ad2 5af4 1dc2 1ed2 +5ad4 5ad3 1cb2 1cb3 +5ad3 5af5 1cb2 1dc2 +5ad5 5ad4 1ba2 1ba3 +5ad4 5af6 1ba2 1cb2 +5ad6 5ad5 1a92 1a93 +5ad5 5af7 1a92 1ba2 +5ad7 5ad6 1982 1983 +5ad6 5af8 1982 1a92 +5ad8 5ad7 1872 1873 +5ad7 5af9 1872 1982 +5ad9 5ad8 1762 1763 +5ad8 5afa 1762 1872 +5ada 5ad9 1652 1653 +5ad9 5afb 1652 1762 +5adb 5ada 1542 1543 +5ada 5afc 1542 1652 +5adc 5adb 1432 1433 +5adb 5afd 1432 1542 +5add 5adc 1322 1323 +5adc 5afe 1322 1432 +5ade 5add 1212 1213 +5add 5aff 1212 1322 +5ade 5b00 1102 1212 +5ae0 5adf 3411 3412 +5ae1 5ae0 3301 3302 +5ae2 5ae1 31f1 31f2 +5ae3 5ae2 30e1 30e2 +5ae4 5ae3 2fd1 2fd2 +5ae5 5ae4 2ec1 2ec2 +5ae6 5ae5 2db1 2db2 +5ae7 5ae6 2ca1 2ca2 +5ae8 5ae7 2b91 2b92 +5ae9 5ae8 2a81 2a82 +5aea 5ae9 2971 2972 +5aeb 5aea 2861 2862 +5aec 5aeb 2751 2752 +5aed 5aec 2641 2642 +5aee 5aed 2531 2532 +5aef 5aee 2421 2422 +5af0 5aef 2311 2312 +5af1 5af0 2201 2202 +5af2 5af1 20f1 20f2 +5af3 5af2 1fe1 1fe2 +5af4 5af3 1ed1 1ed2 +5af5 5af4 1dc1 1dc2 +5af6 5af5 1cb1 1cb2 +5af7 5af6 1ba1 1ba2 +5af8 5af7 1a91 1a92 +5af9 5af8 1981 1982 +5afa 5af9 1871 1872 +5afb 5afa 1761 1762 +5afc 5afb 1651 1652 +5afd 5afc 1541 1542 +5afe 5afd 1431 1432 +5aff 5afe 1321 1322 +5b00 5aff 1211 1212 +5b02 5b01 33f2 3502 +5b20 5b01 33f1 33f2 +5b03 5b02 33f3 3503 +5b21 5b02 33f2 33f3 +5b04 5b03 33f4 3504 +5b22 5b03 33f3 33f4 +5b05 5b04 33f5 3505 +5b23 5b04 33f4 33f5 +5b06 5b05 33f6 3506 +5b24 5b05 33f5 33f6 +5b07 5b06 33f7 3507 +5b25 5b06 33f6 33f7 +5b08 5b07 33f8 3508 +5b26 5b07 33f7 33f8 +5b09 5b08 33f9 3509 +5b27 5b08 33f8 33f9 +5b0a 5b09 33fa 350a +5b28 5b09 33f9 33fa +5b0b 5b0a 33fb 350b +5b29 5b0a 33fa 33fb +5b0c 5b0b 33fc 350c +5b2a 5b0b 33fb 33fc +5b0d 5b0c 33fd 350d +5b2b 5b0c 33fc 33fd +5b0e 5b0d 33fe 350e +5b2c 5b0d 33fd 33fe +5b0f 5b0e 33ff 350f +5b2d 5b0e 33fe 33ff +5b10 5b0f 3400 3510 +5b2e 5b0f 33ff 3400 +5b11 5b10 3401 3511 +5b2f 5b10 3400 3401 +5b12 5b11 3402 3512 +5b30 5b11 3401 3402 +5b13 5b12 3403 3513 +5b31 5b12 3402 3403 +5b14 5b13 3404 3514 +5b32 5b13 3403 3404 +5b15 5b14 3405 3515 +5b33 5b14 3404 3405 +5b16 5b15 3406 3516 +5b34 5b15 3405 3406 +5b17 5b16 3407 3517 +5b35 5b16 3406 3407 +5b18 5b17 3408 3518 +5b36 5b17 3407 3408 +5b19 5b18 3409 3519 +5b37 5b18 3408 3409 +5b1a 5b19 340a 351a +5b38 5b19 3409 340a +5b1b 5b1a 340b 351b +5b39 5b1a 340a 340b +5b1c 5b1b 340c 351c +5b3a 5b1b 340b 340c +5b1d 5b1c 340d 351d +5b3b 5b1c 340c 340d +5b1e 5b1d 340e 351e +5b3c 5b1d 340d 340e +5b1f 5b1e 340f 351f +5b3d 5b1e 340e 340f +5b3e 5b1f 340f 3410 +5b21 5b20 32e2 33f2 +5b3f 5b20 32e1 32e2 +5b22 5b21 32e3 33f3 +5b40 5b21 32e2 32e3 +5b23 5b22 32e4 33f4 +5b41 5b22 32e3 32e4 +5b24 5b23 32e5 33f5 +5b42 5b23 32e4 32e5 +5b25 5b24 32e6 33f6 +5b43 5b24 32e5 32e6 +5b26 5b25 32e7 33f7 +5b44 5b25 32e6 32e7 +5b27 5b26 32e8 33f8 +5b45 5b26 32e7 32e8 +5b28 5b27 32e9 33f9 +5b46 5b27 32e8 32e9 +5b29 5b28 32ea 33fa +5b47 5b28 32e9 32ea +5b2a 5b29 32eb 33fb +5b48 5b29 32ea 32eb +5b2b 5b2a 32ec 33fc +5b49 5b2a 32eb 32ec +5b2c 5b2b 32ed 33fd +5b4a 5b2b 32ec 32ed +5b2d 5b2c 32ee 33fe +5b4b 5b2c 32ed 32ee +5b2e 5b2d 32ef 33ff +5b4c 5b2d 32ee 32ef +5b2f 5b2e 32f0 3400 +5b4d 5b2e 32ef 32f0 +5b30 5b2f 32f1 3401 +5b4e 5b2f 32f0 32f1 +5b31 5b30 32f2 3402 +5b4f 5b30 32f1 32f2 +5b32 5b31 32f3 3403 +5b50 5b31 32f2 32f3 +5b33 5b32 32f4 3404 +5b51 5b32 32f3 32f4 +5b34 5b33 32f5 3405 +5b52 5b33 32f4 32f5 +5b35 5b34 32f6 3406 +5b53 5b34 32f5 32f6 +5b36 5b35 32f7 3407 +5b54 5b35 32f6 32f7 +5b37 5b36 32f8 3408 +5b55 5b36 32f7 32f8 +5b38 5b37 32f9 3409 +5b56 5b37 32f8 32f9 +5b39 5b38 32fa 340a +5b57 5b38 32f9 32fa +5b3a 5b39 32fb 340b +5b58 5b39 32fa 32fb +5b3b 5b3a 32fc 340c +5b59 5b3a 32fb 32fc +5b3c 5b3b 32fd 340d +5b5a 5b3b 32fc 32fd +5b3d 5b3c 32fe 340e +5b5b 5b3c 32fd 32fe +5b3e 5b3d 32ff 340f +5b5c 5b3d 32fe 32ff +5b5d 5b3e 32ff 3300 +5b40 5b3f 31d2 32e2 +5b5e 5b3f 31d1 31d2 +5b41 5b40 31d3 32e3 +5b5f 5b40 31d2 31d3 +5b42 5b41 31d4 32e4 +5b60 5b41 31d3 31d4 +5b43 5b42 31d5 32e5 +5b61 5b42 31d4 31d5 +5b44 5b43 31d6 32e6 +5b62 5b43 31d5 31d6 +5b45 5b44 31d7 32e7 +5b63 5b44 31d6 31d7 +5b46 5b45 31d8 32e8 +5b64 5b45 31d7 31d8 +5b47 5b46 31d9 32e9 +5b65 5b46 31d8 31d9 +5b48 5b47 31da 32ea +5b66 5b47 31d9 31da +5b49 5b48 31db 32eb +5b67 5b48 31da 31db +5b4a 5b49 31dc 32ec +5b68 5b49 31db 31dc +5b4b 5b4a 31dd 32ed +5b69 5b4a 31dc 31dd +5b4c 5b4b 31de 32ee +5b6a 5b4b 31dd 31de +5b4d 5b4c 31df 32ef +5b6b 5b4c 31de 31df +5b4e 5b4d 31e0 32f0 +5b6c 5b4d 31df 31e0 +5b4f 5b4e 31e1 32f1 +5b6d 5b4e 31e0 31e1 +5b50 5b4f 31e2 32f2 +5b6e 5b4f 31e1 31e2 +5b51 5b50 31e3 32f3 +5b6f 5b50 31e2 31e3 +5b52 5b51 31e4 32f4 +5b70 5b51 31e3 31e4 +5b53 5b52 31e5 32f5 +5b71 5b52 31e4 31e5 +5b54 5b53 31e6 32f6 +5b72 5b53 31e5 31e6 +5b55 5b54 31e7 32f7 +5b73 5b54 31e6 31e7 +5b56 5b55 31e8 32f8 +5b74 5b55 31e7 31e8 +5b57 5b56 31e9 32f9 +5b75 5b56 31e8 31e9 +5b58 5b57 31ea 32fa +5b76 5b57 31e9 31ea +5b59 5b58 31eb 32fb +5b77 5b58 31ea 31eb +5b5a 5b59 31ec 32fc +5b78 5b59 31eb 31ec +5b5b 5b5a 31ed 32fd +5b79 5b5a 31ec 31ed +5b5c 5b5b 31ee 32fe +5b7a 5b5b 31ed 31ee +5b5d 5b5c 31ef 32ff +5b7b 5b5c 31ee 31ef +5b7c 5b5d 31ef 31f0 +5b5f 5b5e 30c2 31d2 +5b7d 5b5e 30c1 30c2 +5b60 5b5f 30c3 31d3 +5b7e 5b5f 30c2 30c3 +5b61 5b60 30c4 31d4 +5b7f 5b60 30c3 30c4 +5b62 5b61 30c5 31d5 +5b80 5b61 30c4 30c5 +5b63 5b62 30c6 31d6 +5b81 5b62 30c5 30c6 +5b64 5b63 30c7 31d7 +5b82 5b63 30c6 30c7 +5b65 5b64 30c8 31d8 +5b83 5b64 30c7 30c8 +5b66 5b65 30c9 31d9 +5b84 5b65 30c8 30c9 +5b67 5b66 30ca 31da +5b85 5b66 30c9 30ca +5b68 5b67 30cb 31db +5b86 5b67 30ca 30cb +5b69 5b68 30cc 31dc +5b87 5b68 30cb 30cc +5b6a 5b69 30cd 31dd +5b88 5b69 30cc 30cd +5b6b 5b6a 30ce 31de +5b89 5b6a 30cd 30ce +5b6c 5b6b 30cf 31df +5b8a 5b6b 30ce 30cf +5b6d 5b6c 30d0 31e0 +5b8b 5b6c 30cf 30d0 +5b6e 5b6d 30d1 31e1 +5b8c 5b6d 30d0 30d1 +5b6f 5b6e 30d2 31e2 +5b8d 5b6e 30d1 30d2 +5b70 5b6f 30d3 31e3 +5b8e 5b6f 30d2 30d3 +5b71 5b70 30d4 31e4 +5b8f 5b70 30d3 30d4 +5b72 5b71 30d5 31e5 +5b90 5b71 30d4 30d5 +5b73 5b72 30d6 31e6 +5b91 5b72 30d5 30d6 +5b74 5b73 30d7 31e7 +5b92 5b73 30d6 30d7 +5b75 5b74 30d8 31e8 +5b93 5b74 30d7 30d8 +5b76 5b75 30d9 31e9 +5b94 5b75 30d8 30d9 +5b77 5b76 30da 31ea +5b95 5b76 30d9 30da +5b78 5b77 30db 31eb +5b96 5b77 30da 30db +5b79 5b78 30dc 31ec +5b97 5b78 30db 30dc +5b7a 5b79 30dd 31ed +5b98 5b79 30dc 30dd +5b7b 5b7a 30de 31ee +5b99 5b7a 30dd 30de +5b7c 5b7b 30df 31ef +5b9a 5b7b 30de 30df +5b9b 5b7c 30df 30e0 +5b7e 5b7d 2fb2 30c2 +5b9c 5b7d 2fb1 2fb2 +5b7f 5b7e 2fb3 30c3 +5b9d 5b7e 2fb2 2fb3 +5b80 5b7f 2fb4 30c4 +5b9e 5b7f 2fb3 2fb4 +5b81 5b80 2fb5 30c5 +5b9f 5b80 2fb4 2fb5 +5b82 5b81 2fb6 30c6 +5ba0 5b81 2fb5 2fb6 +5b83 5b82 2fb7 30c7 +5ba1 5b82 2fb6 2fb7 +5b84 5b83 2fb8 30c8 +5ba2 5b83 2fb7 2fb8 +5b85 5b84 2fb9 30c9 +5ba3 5b84 2fb8 2fb9 +5b86 5b85 2fba 30ca +5ba4 5b85 2fb9 2fba +5b87 5b86 2fbb 30cb +5ba5 5b86 2fba 2fbb +5b88 5b87 2fbc 30cc +5ba6 5b87 2fbb 2fbc +5b89 5b88 2fbd 30cd +5ba7 5b88 2fbc 2fbd +5b8a 5b89 2fbe 30ce +5ba8 5b89 2fbd 2fbe +5b8b 5b8a 2fbf 30cf +5ba9 5b8a 2fbe 2fbf +5b8c 5b8b 2fc0 30d0 +5baa 5b8b 2fbf 2fc0 +5b8d 5b8c 2fc1 30d1 +5bab 5b8c 2fc0 2fc1 +5b8e 5b8d 2fc2 30d2 +5bac 5b8d 2fc1 2fc2 +5b8f 5b8e 2fc3 30d3 +5bad 5b8e 2fc2 2fc3 +5b90 5b8f 2fc4 30d4 +5bae 5b8f 2fc3 2fc4 +5b91 5b90 2fc5 30d5 +5baf 5b90 2fc4 2fc5 +5b92 5b91 2fc6 30d6 +5bb0 5b91 2fc5 2fc6 +5b93 5b92 2fc7 30d7 +5bb1 5b92 2fc6 2fc7 +5b94 5b93 2fc8 30d8 +5bb2 5b93 2fc7 2fc8 +5b95 5b94 2fc9 30d9 +5bb3 5b94 2fc8 2fc9 +5b96 5b95 2fca 30da +5bb4 5b95 2fc9 2fca +5b97 5b96 2fcb 30db +5bb5 5b96 2fca 2fcb +5b98 5b97 2fcc 30dc +5bb6 5b97 2fcb 2fcc +5b99 5b98 2fcd 30dd +5bb7 5b98 2fcc 2fcd +5b9a 5b99 2fce 30de +5bb8 5b99 2fcd 2fce +5b9b 5b9a 2fcf 30df +5bb9 5b9a 2fce 2fcf +5bba 5b9b 2fcf 2fd0 +5b9d 5b9c 2ea2 2fb2 +5bbb 5b9c 2ea1 2ea2 +5b9e 5b9d 2ea3 2fb3 +5bbc 5b9d 2ea2 2ea3 +5b9f 5b9e 2ea4 2fb4 +5bbd 5b9e 2ea3 2ea4 +5ba0 5b9f 2ea5 2fb5 +5bbe 5b9f 2ea4 2ea5 +5ba1 5ba0 2ea6 2fb6 +5bbf 5ba0 2ea5 2ea6 +5ba2 5ba1 2ea7 2fb7 +5bc0 5ba1 2ea6 2ea7 +5ba3 5ba2 2ea8 2fb8 +5bc1 5ba2 2ea7 2ea8 +5ba4 5ba3 2ea9 2fb9 +5bc2 5ba3 2ea8 2ea9 +5ba5 5ba4 2eaa 2fba +5bc3 5ba4 2ea9 2eaa +5ba6 5ba5 2eab 2fbb +5bc4 5ba5 2eaa 2eab +5ba7 5ba6 2eac 2fbc +5bc5 5ba6 2eab 2eac +5ba8 5ba7 2ead 2fbd +5bc6 5ba7 2eac 2ead +5ba9 5ba8 2eae 2fbe +5bc7 5ba8 2ead 2eae +5baa 5ba9 2eaf 2fbf +5bc8 5ba9 2eae 2eaf +5bab 5baa 2eb0 2fc0 +5bc9 5baa 2eaf 2eb0 +5bac 5bab 2eb1 2fc1 +5bca 5bab 2eb0 2eb1 +5bad 5bac 2eb2 2fc2 +5bcb 5bac 2eb1 2eb2 +5bae 5bad 2eb3 2fc3 +5bcc 5bad 2eb2 2eb3 +5baf 5bae 2eb4 2fc4 +5bcd 5bae 2eb3 2eb4 +5bb0 5baf 2eb5 2fc5 +5bce 5baf 2eb4 2eb5 +5bb1 5bb0 2eb6 2fc6 +5bcf 5bb0 2eb5 2eb6 +5bb2 5bb1 2eb7 2fc7 +5bd0 5bb1 2eb6 2eb7 +5bb3 5bb2 2eb8 2fc8 +5bd1 5bb2 2eb7 2eb8 +5bb4 5bb3 2eb9 2fc9 +5bd2 5bb3 2eb8 2eb9 +5bb5 5bb4 2eba 2fca +5bd3 5bb4 2eb9 2eba +5bb6 5bb5 2ebb 2fcb +5bd4 5bb5 2eba 2ebb +5bb7 5bb6 2ebc 2fcc +5bd5 5bb6 2ebb 2ebc +5bb8 5bb7 2ebd 2fcd +5bd6 5bb7 2ebc 2ebd +5bb9 5bb8 2ebe 2fce +5bd7 5bb8 2ebd 2ebe +5bba 5bb9 2ebf 2fcf +5bd8 5bb9 2ebe 2ebf +5bd9 5bba 2ebf 2ec0 +5bbc 5bbb 2d92 2ea2 +5bda 5bbb 2d91 2d92 +5bbd 5bbc 2d93 2ea3 +5bdb 5bbc 2d92 2d93 +5bbe 5bbd 2d94 2ea4 +5bdc 5bbd 2d93 2d94 +5bbf 5bbe 2d95 2ea5 +5bdd 5bbe 2d94 2d95 +5bc0 5bbf 2d96 2ea6 +5bde 5bbf 2d95 2d96 +5bc1 5bc0 2d97 2ea7 +5bdf 5bc0 2d96 2d97 +5bc2 5bc1 2d98 2ea8 +5be0 5bc1 2d97 2d98 +5bc3 5bc2 2d99 2ea9 +5be1 5bc2 2d98 2d99 +5bc4 5bc3 2d9a 2eaa +5be2 5bc3 2d99 2d9a +5bc5 5bc4 2d9b 2eab +5be3 5bc4 2d9a 2d9b +5bc6 5bc5 2d9c 2eac +5be4 5bc5 2d9b 2d9c +5bc7 5bc6 2d9d 2ead +5be5 5bc6 2d9c 2d9d +5bc8 5bc7 2d9e 2eae +5be6 5bc7 2d9d 2d9e +5bc9 5bc8 2d9f 2eaf +5be7 5bc8 2d9e 2d9f +5bca 5bc9 2da0 2eb0 +5be8 5bc9 2d9f 2da0 +5bcb 5bca 2da1 2eb1 +5be9 5bca 2da0 2da1 +5bcc 5bcb 2da2 2eb2 +5bea 5bcb 2da1 2da2 +5bcd 5bcc 2da3 2eb3 +5beb 5bcc 2da2 2da3 +5bce 5bcd 2da4 2eb4 +5bec 5bcd 2da3 2da4 +5bcf 5bce 2da5 2eb5 +5bed 5bce 2da4 2da5 +5bd0 5bcf 2da6 2eb6 +5bee 5bcf 2da5 2da6 +5bd1 5bd0 2da7 2eb7 +5bef 5bd0 2da6 2da7 +5bd2 5bd1 2da8 2eb8 +5bf0 5bd1 2da7 2da8 +5bd3 5bd2 2da9 2eb9 +5bf1 5bd2 2da8 2da9 +5bd4 5bd3 2daa 2eba +5bf2 5bd3 2da9 2daa +5bd5 5bd4 2dab 2ebb +5bf3 5bd4 2daa 2dab +5bd6 5bd5 2dac 2ebc +5bf4 5bd5 2dab 2dac +5bd7 5bd6 2dad 2ebd +5bf5 5bd6 2dac 2dad +5bd8 5bd7 2dae 2ebe +5bf6 5bd7 2dad 2dae +5bd9 5bd8 2daf 2ebf +5bf7 5bd8 2dae 2daf +5bf8 5bd9 2daf 2db0 +5bdb 5bda 2c82 2d92 +5bf9 5bda 2c81 2c82 +5bdc 5bdb 2c83 2d93 +5bfa 5bdb 2c82 2c83 +5bdd 5bdc 2c84 2d94 +5bfb 5bdc 2c83 2c84 +5bde 5bdd 2c85 2d95 +5bfc 5bdd 2c84 2c85 +5bdf 5bde 2c86 2d96 +5bfd 5bde 2c85 2c86 +5be0 5bdf 2c87 2d97 +5bfe 5bdf 2c86 2c87 +5be1 5be0 2c88 2d98 +5bff 5be0 2c87 2c88 +5be2 5be1 2c89 2d99 +5c00 5be1 2c88 2c89 +5be3 5be2 2c8a 2d9a +5c01 5be2 2c89 2c8a +5be4 5be3 2c8b 2d9b +5c02 5be3 2c8a 2c8b +5be5 5be4 2c8c 2d9c +5c03 5be4 2c8b 2c8c +5be6 5be5 2c8d 2d9d +5c04 5be5 2c8c 2c8d +5be7 5be6 2c8e 2d9e +5c05 5be6 2c8d 2c8e +5be8 5be7 2c8f 2d9f +5c06 5be7 2c8e 2c8f +5be9 5be8 2c90 2da0 +5c07 5be8 2c8f 2c90 +5bea 5be9 2c91 2da1 +5c08 5be9 2c90 2c91 +5beb 5bea 2c92 2da2 +5c09 5bea 2c91 2c92 +5bec 5beb 2c93 2da3 +5c0a 5beb 2c92 2c93 +5bed 5bec 2c94 2da4 +5c0b 5bec 2c93 2c94 +5bee 5bed 2c95 2da5 +5c0c 5bed 2c94 2c95 +5bef 5bee 2c96 2da6 +5c0d 5bee 2c95 2c96 +5bf0 5bef 2c97 2da7 +5c0e 5bef 2c96 2c97 +5bf1 5bf0 2c98 2da8 +5c0f 5bf0 2c97 2c98 +5bf2 5bf1 2c99 2da9 +5c10 5bf1 2c98 2c99 +5bf3 5bf2 2c9a 2daa +5c11 5bf2 2c99 2c9a +5bf4 5bf3 2c9b 2dab +5c12 5bf3 2c9a 2c9b +5bf5 5bf4 2c9c 2dac +5c13 5bf4 2c9b 2c9c +5bf6 5bf5 2c9d 2dad +5c14 5bf5 2c9c 2c9d +5bf7 5bf6 2c9e 2dae +5c15 5bf6 2c9d 2c9e +5bf8 5bf7 2c9f 2daf +5c16 5bf7 2c9e 2c9f +5c17 5bf8 2c9f 2ca0 +5bfa 5bf9 2b72 2c82 +5c18 5bf9 2b71 2b72 +5bfb 5bfa 2b73 2c83 +5c19 5bfa 2b72 2b73 +5bfc 5bfb 2b74 2c84 +5c1a 5bfb 2b73 2b74 +5bfd 5bfc 2b75 2c85 +5c1b 5bfc 2b74 2b75 +5bfe 5bfd 2b76 2c86 +5c1c 5bfd 2b75 2b76 +5bff 5bfe 2b77 2c87 +5c1d 5bfe 2b76 2b77 +5c00 5bff 2b78 2c88 +5c1e 5bff 2b77 2b78 +5c01 5c00 2b79 2c89 +5c1f 5c00 2b78 2b79 +5c02 5c01 2b7a 2c8a +5c20 5c01 2b79 2b7a +5c03 5c02 2b7b 2c8b +5c21 5c02 2b7a 2b7b +5c04 5c03 2b7c 2c8c +5c22 5c03 2b7b 2b7c +5c05 5c04 2b7d 2c8d +5c23 5c04 2b7c 2b7d +5c06 5c05 2b7e 2c8e +5c24 5c05 2b7d 2b7e +5c07 5c06 2b7f 2c8f +5c25 5c06 2b7e 2b7f +5c08 5c07 2b80 2c90 +5c26 5c07 2b7f 2b80 +5c09 5c08 2b81 2c91 +5c27 5c08 2b80 2b81 +5c0a 5c09 2b82 2c92 +5c28 5c09 2b81 2b82 +5c0b 5c0a 2b83 2c93 +5c29 5c0a 2b82 2b83 +5c0c 5c0b 2b84 2c94 +5c2a 5c0b 2b83 2b84 +5c0d 5c0c 2b85 2c95 +5c2b 5c0c 2b84 2b85 +5c0e 5c0d 2b86 2c96 +5c2c 5c0d 2b85 2b86 +5c0f 5c0e 2b87 2c97 +5c2d 5c0e 2b86 2b87 +5c10 5c0f 2b88 2c98 +5c2e 5c0f 2b87 2b88 +5c11 5c10 2b89 2c99 +5c2f 5c10 2b88 2b89 +5c12 5c11 2b8a 2c9a +5c30 5c11 2b89 2b8a +5c13 5c12 2b8b 2c9b +5c31 5c12 2b8a 2b8b +5c14 5c13 2b8c 2c9c +5c32 5c13 2b8b 2b8c +5c15 5c14 2b8d 2c9d +5c33 5c14 2b8c 2b8d +5c16 5c15 2b8e 2c9e +5c34 5c15 2b8d 2b8e +5c17 5c16 2b8f 2c9f +5c35 5c16 2b8e 2b8f +5c36 5c17 2b8f 2b90 +5c19 5c18 2a62 2b72 +5c37 5c18 2a61 2a62 +5c1a 5c19 2a63 2b73 +5c38 5c19 2a62 2a63 +5c1b 5c1a 2a64 2b74 +5c39 5c1a 2a63 2a64 +5c1c 5c1b 2a65 2b75 +5c3a 5c1b 2a64 2a65 +5c1d 5c1c 2a66 2b76 +5c3b 5c1c 2a65 2a66 +5c1e 5c1d 2a67 2b77 +5c3c 5c1d 2a66 2a67 +5c1f 5c1e 2a68 2b78 +5c3d 5c1e 2a67 2a68 +5c20 5c1f 2a69 2b79 +5c3e 5c1f 2a68 2a69 +5c21 5c20 2a6a 2b7a +5c3f 5c20 2a69 2a6a +5c22 5c21 2a6b 2b7b +5c40 5c21 2a6a 2a6b +5c23 5c22 2a6c 2b7c +5c41 5c22 2a6b 2a6c +5c24 5c23 2a6d 2b7d +5c42 5c23 2a6c 2a6d +5c25 5c24 2a6e 2b7e +5c43 5c24 2a6d 2a6e +5c26 5c25 2a6f 2b7f +5c44 5c25 2a6e 2a6f +5c27 5c26 2a70 2b80 +5c45 5c26 2a6f 2a70 +5c28 5c27 2a71 2b81 +5c46 5c27 2a70 2a71 +5c29 5c28 2a72 2b82 +5c47 5c28 2a71 2a72 +5c2a 5c29 2a73 2b83 +5c48 5c29 2a72 2a73 +5c2b 5c2a 2a74 2b84 +5c49 5c2a 2a73 2a74 +5c2c 5c2b 2a75 2b85 +5c4a 5c2b 2a74 2a75 +5c2d 5c2c 2a76 2b86 +5c4b 5c2c 2a75 2a76 +5c2e 5c2d 2a77 2b87 +5c4c 5c2d 2a76 2a77 +5c2f 5c2e 2a78 2b88 +5c4d 5c2e 2a77 2a78 +5c30 5c2f 2a79 2b89 +5c4e 5c2f 2a78 2a79 +5c31 5c30 2a7a 2b8a +5c4f 5c30 2a79 2a7a +5c32 5c31 2a7b 2b8b +5c50 5c31 2a7a 2a7b +5c33 5c32 2a7c 2b8c +5c51 5c32 2a7b 2a7c +5c34 5c33 2a7d 2b8d +5c52 5c33 2a7c 2a7d +5c35 5c34 2a7e 2b8e +5c53 5c34 2a7d 2a7e +5c36 5c35 2a7f 2b8f +5c54 5c35 2a7e 2a7f +5c55 5c36 2a7f 2a80 +5c38 5c37 2952 2a62 +5c56 5c37 2951 2952 +5c39 5c38 2953 2a63 +5c57 5c38 2952 2953 +5c3a 5c39 2954 2a64 +5c58 5c39 2953 2954 +5c3b 5c3a 2955 2a65 +5c59 5c3a 2954 2955 +5c3c 5c3b 2956 2a66 +5c5a 5c3b 2955 2956 +5c3d 5c3c 2957 2a67 +5c5b 5c3c 2956 2957 +5c3e 5c3d 2958 2a68 +5c5c 5c3d 2957 2958 +5c3f 5c3e 2959 2a69 +5c5d 5c3e 2958 2959 +5c40 5c3f 295a 2a6a +5c5e 5c3f 2959 295a +5c41 5c40 295b 2a6b +5c5f 5c40 295a 295b +5c42 5c41 295c 2a6c +5c60 5c41 295b 295c +5c43 5c42 295d 2a6d +5c61 5c42 295c 295d +5c44 5c43 295e 2a6e +5c62 5c43 295d 295e +5c45 5c44 295f 2a6f +5c63 5c44 295e 295f +5c46 5c45 2960 2a70 +5c64 5c45 295f 2960 +5c47 5c46 2961 2a71 +5c65 5c46 2960 2961 +5c48 5c47 2962 2a72 +5c66 5c47 2961 2962 +5c49 5c48 2963 2a73 +5c67 5c48 2962 2963 +5c4a 5c49 2964 2a74 +5c68 5c49 2963 2964 +5c4b 5c4a 2965 2a75 +5c69 5c4a 2964 2965 +5c4c 5c4b 2966 2a76 +5c6a 5c4b 2965 2966 +5c4d 5c4c 2967 2a77 +5c6b 5c4c 2966 2967 +5c4e 5c4d 2968 2a78 +5c6c 5c4d 2967 2968 +5c4f 5c4e 2969 2a79 +5c6d 5c4e 2968 2969 +5c50 5c4f 296a 2a7a +5c6e 5c4f 2969 296a +5c51 5c50 296b 2a7b +5c6f 5c50 296a 296b +5c52 5c51 296c 2a7c +5c70 5c51 296b 296c +5c53 5c52 296d 2a7d +5c71 5c52 296c 296d +5c54 5c53 296e 2a7e +5c72 5c53 296d 296e +5c55 5c54 296f 2a7f +5c73 5c54 296e 296f +5c74 5c55 296f 2970 +5c57 5c56 2842 2952 +5c75 5c56 2841 2842 +5c58 5c57 2843 2953 +5c76 5c57 2842 2843 +5c59 5c58 2844 2954 +5c77 5c58 2843 2844 +5c5a 5c59 2845 2955 +5c78 5c59 2844 2845 +5c5b 5c5a 2846 2956 +5c79 5c5a 2845 2846 +5c5c 5c5b 2847 2957 +5c7a 5c5b 2846 2847 +5c5d 5c5c 2848 2958 +5c7b 5c5c 2847 2848 +5c5e 5c5d 2849 2959 +5c7c 5c5d 2848 2849 +5c5f 5c5e 284a 295a +5c7d 5c5e 2849 284a +5c60 5c5f 284b 295b +5c7e 5c5f 284a 284b +5c61 5c60 284c 295c +5c7f 5c60 284b 284c +5c62 5c61 284d 295d +5c80 5c61 284c 284d +5c63 5c62 284e 295e +5c81 5c62 284d 284e +5c64 5c63 284f 295f +5c82 5c63 284e 284f +5c65 5c64 2850 2960 +5c83 5c64 284f 2850 +5c66 5c65 2851 2961 +5c84 5c65 2850 2851 +5c67 5c66 2852 2962 +5c85 5c66 2851 2852 +5c68 5c67 2853 2963 +5c86 5c67 2852 2853 +5c69 5c68 2854 2964 +5c87 5c68 2853 2854 +5c6a 5c69 2855 2965 +5c88 5c69 2854 2855 +5c6b 5c6a 2856 2966 +5c89 5c6a 2855 2856 +5c6c 5c6b 2857 2967 +5c8a 5c6b 2856 2857 +5c6d 5c6c 2858 2968 +5c8b 5c6c 2857 2858 +5c6e 5c6d 2859 2969 +5c8c 5c6d 2858 2859 +5c6f 5c6e 285a 296a +5c8d 5c6e 2859 285a +5c70 5c6f 285b 296b +5c8e 5c6f 285a 285b +5c71 5c70 285c 296c +5c8f 5c70 285b 285c +5c72 5c71 285d 296d +5c90 5c71 285c 285d +5c73 5c72 285e 296e +5c91 5c72 285d 285e +5c74 5c73 285f 296f +5c92 5c73 285e 285f +5c93 5c74 285f 2860 +5c76 5c75 2732 2842 +5c94 5c75 2731 2732 +5c77 5c76 2733 2843 +5c95 5c76 2732 2733 +5c78 5c77 2734 2844 +5c96 5c77 2733 2734 +5c79 5c78 2735 2845 +5c97 5c78 2734 2735 +5c7a 5c79 2736 2846 +5c98 5c79 2735 2736 +5c7b 5c7a 2737 2847 +5c99 5c7a 2736 2737 +5c7c 5c7b 2738 2848 +5c9a 5c7b 2737 2738 +5c7d 5c7c 2739 2849 +5c9b 5c7c 2738 2739 +5c7e 5c7d 273a 284a +5c9c 5c7d 2739 273a +5c7f 5c7e 273b 284b +5c9d 5c7e 273a 273b +5c80 5c7f 273c 284c +5c9e 5c7f 273b 273c +5c81 5c80 273d 284d +5c9f 5c80 273c 273d +5c82 5c81 273e 284e +5ca0 5c81 273d 273e +5c83 5c82 273f 284f +5ca1 5c82 273e 273f +5c84 5c83 2740 2850 +5ca2 5c83 273f 2740 +5c85 5c84 2741 2851 +5ca3 5c84 2740 2741 +5c86 5c85 2742 2852 +5ca4 5c85 2741 2742 +5c87 5c86 2743 2853 +5ca5 5c86 2742 2743 +5c88 5c87 2744 2854 +5ca6 5c87 2743 2744 +5c89 5c88 2745 2855 +5ca7 5c88 2744 2745 +5c8a 5c89 2746 2856 +5ca8 5c89 2745 2746 +5c8b 5c8a 2747 2857 +5ca9 5c8a 2746 2747 +5c8c 5c8b 2748 2858 +5caa 5c8b 2747 2748 +5c8d 5c8c 2749 2859 +5cab 5c8c 2748 2749 +5c8e 5c8d 274a 285a +5cac 5c8d 2749 274a +5c8f 5c8e 274b 285b +5cad 5c8e 274a 274b +5c90 5c8f 274c 285c +5cae 5c8f 274b 274c +5c91 5c90 274d 285d +5caf 5c90 274c 274d +5c92 5c91 274e 285e +5cb0 5c91 274d 274e +5c93 5c92 274f 285f +5cb1 5c92 274e 274f +5cb2 5c93 274f 2750 +5c95 5c94 2622 2732 +5cb3 5c94 2621 2622 +5c96 5c95 2623 2733 +5cb4 5c95 2622 2623 +5c97 5c96 2624 2734 +5cb5 5c96 2623 2624 +5c98 5c97 2625 2735 +5cb6 5c97 2624 2625 +5c99 5c98 2626 2736 +5cb7 5c98 2625 2626 +5c9a 5c99 2627 2737 +5cb8 5c99 2626 2627 +5c9b 5c9a 2628 2738 +5cb9 5c9a 2627 2628 +5c9c 5c9b 2629 2739 +5cba 5c9b 2628 2629 +5c9d 5c9c 262a 273a +5cbb 5c9c 2629 262a +5c9e 5c9d 262b 273b +5cbc 5c9d 262a 262b +5c9f 5c9e 262c 273c +5cbd 5c9e 262b 262c +5ca0 5c9f 262d 273d +5cbe 5c9f 262c 262d +5ca1 5ca0 262e 273e +5cbf 5ca0 262d 262e +5ca2 5ca1 262f 273f +5cc0 5ca1 262e 262f +5ca3 5ca2 2630 2740 +5cc1 5ca2 262f 2630 +5ca4 5ca3 2631 2741 +5cc2 5ca3 2630 2631 +5ca5 5ca4 2632 2742 +5cc3 5ca4 2631 2632 +5ca6 5ca5 2633 2743 +5cc4 5ca5 2632 2633 +5ca7 5ca6 2634 2744 +5cc5 5ca6 2633 2634 +5ca8 5ca7 2635 2745 +5cc6 5ca7 2634 2635 +5ca9 5ca8 2636 2746 +5cc7 5ca8 2635 2636 +5caa 5ca9 2637 2747 +5cc8 5ca9 2636 2637 +5cab 5caa 2638 2748 +5cc9 5caa 2637 2638 +5cac 5cab 2639 2749 +5cca 5cab 2638 2639 +5cad 5cac 263a 274a +5ccb 5cac 2639 263a +5cae 5cad 263b 274b +5ccc 5cad 263a 263b +5caf 5cae 263c 274c +5ccd 5cae 263b 263c +5cb0 5caf 263d 274d +5cce 5caf 263c 263d +5cb1 5cb0 263e 274e +5ccf 5cb0 263d 263e +5cb2 5cb1 263f 274f +5cd0 5cb1 263e 263f +5cd1 5cb2 263f 2640 +5cb4 5cb3 2512 2622 +5cd2 5cb3 2511 2512 +5cb5 5cb4 2513 2623 +5cd3 5cb4 2512 2513 +5cb6 5cb5 2514 2624 +5cd4 5cb5 2513 2514 +5cb7 5cb6 2515 2625 +5cd5 5cb6 2514 2515 +5cb8 5cb7 2516 2626 +5cd6 5cb7 2515 2516 +5cb9 5cb8 2517 2627 +5cd7 5cb8 2516 2517 +5cba 5cb9 2518 2628 +5cd8 5cb9 2517 2518 +5cbb 5cba 2519 2629 +5cd9 5cba 2518 2519 +5cbc 5cbb 251a 262a +5cda 5cbb 2519 251a +5cbd 5cbc 251b 262b +5cdb 5cbc 251a 251b +5cbe 5cbd 251c 262c +5cdc 5cbd 251b 251c +5cbf 5cbe 251d 262d +5cdd 5cbe 251c 251d +5cc0 5cbf 251e 262e +5cde 5cbf 251d 251e +5cc1 5cc0 251f 262f +5cdf 5cc0 251e 251f +5cc2 5cc1 2520 2630 +5ce0 5cc1 251f 2520 +5cc3 5cc2 2521 2631 +5ce1 5cc2 2520 2521 +5cc4 5cc3 2522 2632 +5ce2 5cc3 2521 2522 +5cc5 5cc4 2523 2633 +5ce3 5cc4 2522 2523 +5cc6 5cc5 2524 2634 +5ce4 5cc5 2523 2524 +5cc7 5cc6 2525 2635 +5ce5 5cc6 2524 2525 +5cc8 5cc7 2526 2636 +5ce6 5cc7 2525 2526 +5cc9 5cc8 2527 2637 +5ce7 5cc8 2526 2527 +5cca 5cc9 2528 2638 +5ce8 5cc9 2527 2528 +5ccb 5cca 2529 2639 +5ce9 5cca 2528 2529 +5ccc 5ccb 252a 263a +5cea 5ccb 2529 252a +5ccd 5ccc 252b 263b +5ceb 5ccc 252a 252b +5cce 5ccd 252c 263c +5cec 5ccd 252b 252c +5ccf 5cce 252d 263d +5ced 5cce 252c 252d +5cd0 5ccf 252e 263e +5cee 5ccf 252d 252e +5cd1 5cd0 252f 263f +5cef 5cd0 252e 252f +5cf0 5cd1 252f 2530 +5cd3 5cd2 2402 2512 +5cf1 5cd2 2401 2402 +5cd4 5cd3 2403 2513 +5cf2 5cd3 2402 2403 +5cd5 5cd4 2404 2514 +5cf3 5cd4 2403 2404 +5cd6 5cd5 2405 2515 +5cf4 5cd5 2404 2405 +5cd7 5cd6 2406 2516 +5cf5 5cd6 2405 2406 +5cd8 5cd7 2407 2517 +5cf6 5cd7 2406 2407 +5cd9 5cd8 2408 2518 +5cf7 5cd8 2407 2408 +5cda 5cd9 2409 2519 +5cf8 5cd9 2408 2409 +5cdb 5cda 240a 251a +5cf9 5cda 2409 240a +5cdc 5cdb 240b 251b +5cfa 5cdb 240a 240b +5cdd 5cdc 240c 251c +5cfb 5cdc 240b 240c +5cde 5cdd 240d 251d +5cfc 5cdd 240c 240d +5cdf 5cde 240e 251e +5cfd 5cde 240d 240e +5ce0 5cdf 240f 251f +5cfe 5cdf 240e 240f +5ce1 5ce0 2410 2520 +5cff 5ce0 240f 2410 +5ce2 5ce1 2411 2521 +5d00 5ce1 2410 2411 +5ce3 5ce2 2412 2522 +5d01 5ce2 2411 2412 +5ce4 5ce3 2413 2523 +5d02 5ce3 2412 2413 +5ce5 5ce4 2414 2524 +5d03 5ce4 2413 2414 +5ce6 5ce5 2415 2525 +5d04 5ce5 2414 2415 +5ce7 5ce6 2416 2526 +5d05 5ce6 2415 2416 +5ce8 5ce7 2417 2527 +5d06 5ce7 2416 2417 +5ce9 5ce8 2418 2528 +5d07 5ce8 2417 2418 +5cea 5ce9 2419 2529 +5d08 5ce9 2418 2419 +5ceb 5cea 241a 252a +5d09 5cea 2419 241a +5cec 5ceb 241b 252b +5d0a 5ceb 241a 241b +5ced 5cec 241c 252c +5d0b 5cec 241b 241c +5cee 5ced 241d 252d +5d0c 5ced 241c 241d +5cef 5cee 241e 252e +5d0d 5cee 241d 241e +5cf0 5cef 241f 252f +5d0e 5cef 241e 241f +5d0f 5cf0 241f 2420 +5cf2 5cf1 22f2 2402 +5d10 5cf1 22f1 22f2 +5cf3 5cf2 22f3 2403 +5d11 5cf2 22f2 22f3 +5cf4 5cf3 22f4 2404 +5d12 5cf3 22f3 22f4 +5cf5 5cf4 22f5 2405 +5d13 5cf4 22f4 22f5 +5cf6 5cf5 22f6 2406 +5d14 5cf5 22f5 22f6 +5cf7 5cf6 22f7 2407 +5d15 5cf6 22f6 22f7 +5cf8 5cf7 22f8 2408 +5d16 5cf7 22f7 22f8 +5cf9 5cf8 22f9 2409 +5d17 5cf8 22f8 22f9 +5cfa 5cf9 22fa 240a +5d18 5cf9 22f9 22fa +5cfb 5cfa 22fb 240b +5d19 5cfa 22fa 22fb +5cfc 5cfb 22fc 240c +5d1a 5cfb 22fb 22fc +5cfd 5cfc 22fd 240d +5d1b 5cfc 22fc 22fd +5cfe 5cfd 22fe 240e +5d1c 5cfd 22fd 22fe +5cff 5cfe 22ff 240f +5d1d 5cfe 22fe 22ff +5d00 5cff 2300 2410 +5d1e 5cff 22ff 2300 +5d01 5d00 2301 2411 +5d1f 5d00 2300 2301 +5d02 5d01 2302 2412 +5d20 5d01 2301 2302 +5d03 5d02 2303 2413 +5d21 5d02 2302 2303 +5d04 5d03 2304 2414 +5d22 5d03 2303 2304 +5d05 5d04 2305 2415 +5d23 5d04 2304 2305 +5d06 5d05 2306 2416 +5d24 5d05 2305 2306 +5d07 5d06 2307 2417 +5d25 5d06 2306 2307 +5d08 5d07 2308 2418 +5d26 5d07 2307 2308 +5d09 5d08 2309 2419 +5d27 5d08 2308 2309 +5d0a 5d09 230a 241a +5d28 5d09 2309 230a +5d0b 5d0a 230b 241b +5d29 5d0a 230a 230b +5d0c 5d0b 230c 241c +5d2a 5d0b 230b 230c +5d0d 5d0c 230d 241d +5d2b 5d0c 230c 230d +5d0e 5d0d 230e 241e +5d2c 5d0d 230d 230e +5d0f 5d0e 230f 241f +5d2d 5d0e 230e 230f +5d2e 5d0f 230f 2310 +5d11 5d10 21e2 22f2 +5d2f 5d10 21e1 21e2 +5d12 5d11 21e3 22f3 +5d30 5d11 21e2 21e3 +5d13 5d12 21e4 22f4 +5d31 5d12 21e3 21e4 +5d14 5d13 21e5 22f5 +5d32 5d13 21e4 21e5 +5d15 5d14 21e6 22f6 +5d33 5d14 21e5 21e6 +5d16 5d15 21e7 22f7 +5d34 5d15 21e6 21e7 +5d17 5d16 21e8 22f8 +5d35 5d16 21e7 21e8 +5d18 5d17 21e9 22f9 +5d36 5d17 21e8 21e9 +5d19 5d18 21ea 22fa +5d37 5d18 21e9 21ea +5d1a 5d19 21eb 22fb +5d38 5d19 21ea 21eb +5d1b 5d1a 21ec 22fc +5d39 5d1a 21eb 21ec +5d1c 5d1b 21ed 22fd +5d3a 5d1b 21ec 21ed +5d1d 5d1c 21ee 22fe +5d3b 5d1c 21ed 21ee +5d1e 5d1d 21ef 22ff +5d3c 5d1d 21ee 21ef +5d1f 5d1e 21f0 2300 +5d3d 5d1e 21ef 21f0 +5d20 5d1f 21f1 2301 +5d3e 5d1f 21f0 21f1 +5d21 5d20 21f2 2302 +5d3f 5d20 21f1 21f2 +5d22 5d21 21f3 2303 +5d40 5d21 21f2 21f3 +5d23 5d22 21f4 2304 +5d41 5d22 21f3 21f4 +5d24 5d23 21f5 2305 +5d42 5d23 21f4 21f5 +5d25 5d24 21f6 2306 +5d43 5d24 21f5 21f6 +5d26 5d25 21f7 2307 +5d44 5d25 21f6 21f7 +5d27 5d26 21f8 2308 +5d45 5d26 21f7 21f8 +5d28 5d27 21f9 2309 +5d46 5d27 21f8 21f9 +5d29 5d28 21fa 230a +5d47 5d28 21f9 21fa +5d2a 5d29 21fb 230b +5d48 5d29 21fa 21fb +5d2b 5d2a 21fc 230c +5d49 5d2a 21fb 21fc +5d2c 5d2b 21fd 230d +5d4a 5d2b 21fc 21fd +5d2d 5d2c 21fe 230e +5d4b 5d2c 21fd 21fe +5d2e 5d2d 21ff 230f +5d4c 5d2d 21fe 21ff +5d4d 5d2e 21ff 2200 +5d30 5d2f 20d2 21e2 +5d4e 5d2f 20d1 20d2 +5d31 5d30 20d3 21e3 +5d4f 5d30 20d2 20d3 +5d32 5d31 20d4 21e4 +5d50 5d31 20d3 20d4 +5d33 5d32 20d5 21e5 +5d51 5d32 20d4 20d5 +5d34 5d33 20d6 21e6 +5d52 5d33 20d5 20d6 +5d35 5d34 20d7 21e7 +5d53 5d34 20d6 20d7 +5d36 5d35 20d8 21e8 +5d54 5d35 20d7 20d8 +5d37 5d36 20d9 21e9 +5d55 5d36 20d8 20d9 +5d38 5d37 20da 21ea +5d56 5d37 20d9 20da +5d39 5d38 20db 21eb +5d57 5d38 20da 20db +5d3a 5d39 20dc 21ec +5d58 5d39 20db 20dc +5d3b 5d3a 20dd 21ed +5d59 5d3a 20dc 20dd +5d3c 5d3b 20de 21ee +5d5a 5d3b 20dd 20de +5d3d 5d3c 20df 21ef +5d5b 5d3c 20de 20df +5d3e 5d3d 20e0 21f0 +5d5c 5d3d 20df 20e0 +5d3f 5d3e 20e1 21f1 +5d5d 5d3e 20e0 20e1 +5d40 5d3f 20e2 21f2 +5d5e 5d3f 20e1 20e2 +5d41 5d40 20e3 21f3 +5d5f 5d40 20e2 20e3 +5d42 5d41 20e4 21f4 +5d60 5d41 20e3 20e4 +5d43 5d42 20e5 21f5 +5d61 5d42 20e4 20e5 +5d44 5d43 20e6 21f6 +5d62 5d43 20e5 20e6 +5d45 5d44 20e7 21f7 +5d63 5d44 20e6 20e7 +5d46 5d45 20e8 21f8 +5d64 5d45 20e7 20e8 +5d47 5d46 20e9 21f9 +5d65 5d46 20e8 20e9 +5d48 5d47 20ea 21fa +5d66 5d47 20e9 20ea +5d49 5d48 20eb 21fb +5d67 5d48 20ea 20eb +5d4a 5d49 20ec 21fc +5d68 5d49 20eb 20ec +5d4b 5d4a 20ed 21fd +5d69 5d4a 20ec 20ed +5d4c 5d4b 20ee 21fe +5d6a 5d4b 20ed 20ee +5d4d 5d4c 20ef 21ff +5d6b 5d4c 20ee 20ef +5d6c 5d4d 20ef 20f0 +5d4f 5d4e 1fc2 20d2 +5d6d 5d4e 1fc1 1fc2 +5d50 5d4f 1fc3 20d3 +5d6e 5d4f 1fc2 1fc3 +5d51 5d50 1fc4 20d4 +5d6f 5d50 1fc3 1fc4 +5d52 5d51 1fc5 20d5 +5d70 5d51 1fc4 1fc5 +5d53 5d52 1fc6 20d6 +5d71 5d52 1fc5 1fc6 +5d54 5d53 1fc7 20d7 +5d72 5d53 1fc6 1fc7 +5d55 5d54 1fc8 20d8 +5d73 5d54 1fc7 1fc8 +5d56 5d55 1fc9 20d9 +5d74 5d55 1fc8 1fc9 +5d57 5d56 1fca 20da +5d75 5d56 1fc9 1fca +5d58 5d57 1fcb 20db +5d76 5d57 1fca 1fcb +5d59 5d58 1fcc 20dc +5d77 5d58 1fcb 1fcc +5d5a 5d59 1fcd 20dd +5d78 5d59 1fcc 1fcd +5d5b 5d5a 1fce 20de +5d79 5d5a 1fcd 1fce +5d5c 5d5b 1fcf 20df +5d7a 5d5b 1fce 1fcf +5d5d 5d5c 1fd0 20e0 +5d7b 5d5c 1fcf 1fd0 +5d5e 5d5d 1fd1 20e1 +5d7c 5d5d 1fd0 1fd1 +5d5f 5d5e 1fd2 20e2 +5d7d 5d5e 1fd1 1fd2 +5d60 5d5f 1fd3 20e3 +5d7e 5d5f 1fd2 1fd3 +5d61 5d60 1fd4 20e4 +5d7f 5d60 1fd3 1fd4 +5d62 5d61 1fd5 20e5 +5d80 5d61 1fd4 1fd5 +5d63 5d62 1fd6 20e6 +5d81 5d62 1fd5 1fd6 +5d64 5d63 1fd7 20e7 +5d82 5d63 1fd6 1fd7 +5d65 5d64 1fd8 20e8 +5d83 5d64 1fd7 1fd8 +5d66 5d65 1fd9 20e9 +5d84 5d65 1fd8 1fd9 +5d67 5d66 1fda 20ea +5d85 5d66 1fd9 1fda +5d68 5d67 1fdb 20eb +5d86 5d67 1fda 1fdb +5d69 5d68 1fdc 20ec +5d87 5d68 1fdb 1fdc +5d6a 5d69 1fdd 20ed +5d88 5d69 1fdc 1fdd +5d6b 5d6a 1fde 20ee +5d89 5d6a 1fdd 1fde +5d6c 5d6b 1fdf 20ef +5d8a 5d6b 1fde 1fdf +5d8b 5d6c 1fdf 1fe0 +5d6e 5d6d 1eb2 1fc2 +5d8c 5d6d 1eb1 1eb2 +5d6f 5d6e 1eb3 1fc3 +5d8d 5d6e 1eb2 1eb3 +5d70 5d6f 1eb4 1fc4 +5d8e 5d6f 1eb3 1eb4 +5d71 5d70 1eb5 1fc5 +5d8f 5d70 1eb4 1eb5 +5d72 5d71 1eb6 1fc6 +5d90 5d71 1eb5 1eb6 +5d73 5d72 1eb7 1fc7 +5d91 5d72 1eb6 1eb7 +5d74 5d73 1eb8 1fc8 +5d92 5d73 1eb7 1eb8 +5d75 5d74 1eb9 1fc9 +5d93 5d74 1eb8 1eb9 +5d76 5d75 1eba 1fca +5d94 5d75 1eb9 1eba +5d77 5d76 1ebb 1fcb +5d95 5d76 1eba 1ebb +5d78 5d77 1ebc 1fcc +5d96 5d77 1ebb 1ebc +5d79 5d78 1ebd 1fcd +5d97 5d78 1ebc 1ebd +5d7a 5d79 1ebe 1fce +5d98 5d79 1ebd 1ebe +5d7b 5d7a 1ebf 1fcf +5d99 5d7a 1ebe 1ebf +5d7c 5d7b 1ec0 1fd0 +5d9a 5d7b 1ebf 1ec0 +5d7d 5d7c 1ec1 1fd1 +5d9b 5d7c 1ec0 1ec1 +5d7e 5d7d 1ec2 1fd2 +5d9c 5d7d 1ec1 1ec2 +5d7f 5d7e 1ec3 1fd3 +5d9d 5d7e 1ec2 1ec3 +5d80 5d7f 1ec4 1fd4 +5d9e 5d7f 1ec3 1ec4 +5d81 5d80 1ec5 1fd5 +5d9f 5d80 1ec4 1ec5 +5d82 5d81 1ec6 1fd6 +5da0 5d81 1ec5 1ec6 +5d83 5d82 1ec7 1fd7 +5da1 5d82 1ec6 1ec7 +5d84 5d83 1ec8 1fd8 +5da2 5d83 1ec7 1ec8 +5d85 5d84 1ec9 1fd9 +5da3 5d84 1ec8 1ec9 +5d86 5d85 1eca 1fda +5da4 5d85 1ec9 1eca +5d87 5d86 1ecb 1fdb +5da5 5d86 1eca 1ecb +5d88 5d87 1ecc 1fdc +5da6 5d87 1ecb 1ecc +5d89 5d88 1ecd 1fdd +5da7 5d88 1ecc 1ecd +5d8a 5d89 1ece 1fde +5da8 5d89 1ecd 1ece +5d8b 5d8a 1ecf 1fdf +5da9 5d8a 1ece 1ecf +5daa 5d8b 1ecf 1ed0 +5d8d 5d8c 1da2 1eb2 +5dab 5d8c 1da1 1da2 +5d8e 5d8d 1da3 1eb3 +5dac 5d8d 1da2 1da3 +5d8f 5d8e 1da4 1eb4 +5dad 5d8e 1da3 1da4 +5d90 5d8f 1da5 1eb5 +5dae 5d8f 1da4 1da5 +5d91 5d90 1da6 1eb6 +5daf 5d90 1da5 1da6 +5d92 5d91 1da7 1eb7 +5db0 5d91 1da6 1da7 +5d93 5d92 1da8 1eb8 +5db1 5d92 1da7 1da8 +5d94 5d93 1da9 1eb9 +5db2 5d93 1da8 1da9 +5d95 5d94 1daa 1eba +5db3 5d94 1da9 1daa +5d96 5d95 1dab 1ebb +5db4 5d95 1daa 1dab +5d97 5d96 1dac 1ebc +5db5 5d96 1dab 1dac +5d98 5d97 1dad 1ebd +5db6 5d97 1dac 1dad +5d99 5d98 1dae 1ebe +5db7 5d98 1dad 1dae +5d9a 5d99 1daf 1ebf +5db8 5d99 1dae 1daf +5d9b 5d9a 1db0 1ec0 +5db9 5d9a 1daf 1db0 +5d9c 5d9b 1db1 1ec1 +5dba 5d9b 1db0 1db1 +5d9d 5d9c 1db2 1ec2 +5dbb 5d9c 1db1 1db2 +5d9e 5d9d 1db3 1ec3 +5dbc 5d9d 1db2 1db3 +5d9f 5d9e 1db4 1ec4 +5dbd 5d9e 1db3 1db4 +5da0 5d9f 1db5 1ec5 +5dbe 5d9f 1db4 1db5 +5da1 5da0 1db6 1ec6 +5dbf 5da0 1db5 1db6 +5da2 5da1 1db7 1ec7 +5dc0 5da1 1db6 1db7 +5da3 5da2 1db8 1ec8 +5dc1 5da2 1db7 1db8 +5da4 5da3 1db9 1ec9 +5dc2 5da3 1db8 1db9 +5da5 5da4 1dba 1eca +5dc3 5da4 1db9 1dba +5da6 5da5 1dbb 1ecb +5dc4 5da5 1dba 1dbb +5da7 5da6 1dbc 1ecc +5dc5 5da6 1dbb 1dbc +5da8 5da7 1dbd 1ecd +5dc6 5da7 1dbc 1dbd +5da9 5da8 1dbe 1ece +5dc7 5da8 1dbd 1dbe +5daa 5da9 1dbf 1ecf +5dc8 5da9 1dbe 1dbf +5dc9 5daa 1dbf 1dc0 +5dac 5dab 1c92 1da2 +5dca 5dab 1c91 1c92 +5dad 5dac 1c93 1da3 +5dcb 5dac 1c92 1c93 +5dae 5dad 1c94 1da4 +5dcc 5dad 1c93 1c94 +5daf 5dae 1c95 1da5 +5dcd 5dae 1c94 1c95 +5db0 5daf 1c96 1da6 +5dce 5daf 1c95 1c96 +5db1 5db0 1c97 1da7 +5dcf 5db0 1c96 1c97 +5db2 5db1 1c98 1da8 +5dd0 5db1 1c97 1c98 +5db3 5db2 1c99 1da9 +5dd1 5db2 1c98 1c99 +5db4 5db3 1c9a 1daa +5dd2 5db3 1c99 1c9a +5db5 5db4 1c9b 1dab +5dd3 5db4 1c9a 1c9b +5db6 5db5 1c9c 1dac +5dd4 5db5 1c9b 1c9c +5db7 5db6 1c9d 1dad +5dd5 5db6 1c9c 1c9d +5db8 5db7 1c9e 1dae +5dd6 5db7 1c9d 1c9e +5db9 5db8 1c9f 1daf +5dd7 5db8 1c9e 1c9f +5dba 5db9 1ca0 1db0 +5dd8 5db9 1c9f 1ca0 +5dbb 5dba 1ca1 1db1 +5dd9 5dba 1ca0 1ca1 +5dbc 5dbb 1ca2 1db2 +5dda 5dbb 1ca1 1ca2 +5dbd 5dbc 1ca3 1db3 +5ddb 5dbc 1ca2 1ca3 +5dbe 5dbd 1ca4 1db4 +5ddc 5dbd 1ca3 1ca4 +5dbf 5dbe 1ca5 1db5 +5ddd 5dbe 1ca4 1ca5 +5dc0 5dbf 1ca6 1db6 +5dde 5dbf 1ca5 1ca6 +5dc1 5dc0 1ca7 1db7 +5ddf 5dc0 1ca6 1ca7 +5dc2 5dc1 1ca8 1db8 +5de0 5dc1 1ca7 1ca8 +5dc3 5dc2 1ca9 1db9 +5de1 5dc2 1ca8 1ca9 +5dc4 5dc3 1caa 1dba +5de2 5dc3 1ca9 1caa +5dc5 5dc4 1cab 1dbb +5de3 5dc4 1caa 1cab +5dc6 5dc5 1cac 1dbc +5de4 5dc5 1cab 1cac +5dc7 5dc6 1cad 1dbd +5de5 5dc6 1cac 1cad +5dc8 5dc7 1cae 1dbe +5de6 5dc7 1cad 1cae +5dc9 5dc8 1caf 1dbf +5de7 5dc8 1cae 1caf +5de8 5dc9 1caf 1cb0 +5dcb 5dca 1b82 1c92 +5de9 5dca 1b81 1b82 +5dcc 5dcb 1b83 1c93 +5dea 5dcb 1b82 1b83 +5dcd 5dcc 1b84 1c94 +5deb 5dcc 1b83 1b84 +5dce 5dcd 1b85 1c95 +5dec 5dcd 1b84 1b85 +5dcf 5dce 1b86 1c96 +5ded 5dce 1b85 1b86 +5dd0 5dcf 1b87 1c97 +5dee 5dcf 1b86 1b87 +5dd1 5dd0 1b88 1c98 +5def 5dd0 1b87 1b88 +5dd2 5dd1 1b89 1c99 +5df0 5dd1 1b88 1b89 +5dd3 5dd2 1b8a 1c9a +5df1 5dd2 1b89 1b8a +5dd4 5dd3 1b8b 1c9b +5df2 5dd3 1b8a 1b8b +5dd5 5dd4 1b8c 1c9c +5df3 5dd4 1b8b 1b8c +5dd6 5dd5 1b8d 1c9d +5df4 5dd5 1b8c 1b8d +5dd7 5dd6 1b8e 1c9e +5df5 5dd6 1b8d 1b8e +5dd8 5dd7 1b8f 1c9f +5df6 5dd7 1b8e 1b8f +5dd9 5dd8 1b90 1ca0 +5df7 5dd8 1b8f 1b90 +5dda 5dd9 1b91 1ca1 +5df8 5dd9 1b90 1b91 +5ddb 5dda 1b92 1ca2 +5df9 5dda 1b91 1b92 +5ddc 5ddb 1b93 1ca3 +5dfa 5ddb 1b92 1b93 +5ddd 5ddc 1b94 1ca4 +5dfb 5ddc 1b93 1b94 +5dde 5ddd 1b95 1ca5 +5dfc 5ddd 1b94 1b95 +5ddf 5dde 1b96 1ca6 +5dfd 5dde 1b95 1b96 +5de0 5ddf 1b97 1ca7 +5dfe 5ddf 1b96 1b97 +5de1 5de0 1b98 1ca8 +5dff 5de0 1b97 1b98 +5de2 5de1 1b99 1ca9 +5e00 5de1 1b98 1b99 +5de3 5de2 1b9a 1caa +5e01 5de2 1b99 1b9a +5de4 5de3 1b9b 1cab +5e02 5de3 1b9a 1b9b +5de5 5de4 1b9c 1cac +5e03 5de4 1b9b 1b9c +5de6 5de5 1b9d 1cad +5e04 5de5 1b9c 1b9d +5de7 5de6 1b9e 1cae +5e05 5de6 1b9d 1b9e +5de8 5de7 1b9f 1caf +5e06 5de7 1b9e 1b9f +5e07 5de8 1b9f 1ba0 +5dea 5de9 1a72 1b82 +5e08 5de9 1a71 1a72 +5deb 5dea 1a73 1b83 +5e09 5dea 1a72 1a73 +5dec 5deb 1a74 1b84 +5e0a 5deb 1a73 1a74 +5ded 5dec 1a75 1b85 +5e0b 5dec 1a74 1a75 +5dee 5ded 1a76 1b86 +5e0c 5ded 1a75 1a76 +5def 5dee 1a77 1b87 +5e0d 5dee 1a76 1a77 +5df0 5def 1a78 1b88 +5e0e 5def 1a77 1a78 +5df1 5df0 1a79 1b89 +5e0f 5df0 1a78 1a79 +5df2 5df1 1a7a 1b8a +5e10 5df1 1a79 1a7a +5df3 5df2 1a7b 1b8b +5e11 5df2 1a7a 1a7b +5df4 5df3 1a7c 1b8c +5e12 5df3 1a7b 1a7c +5df5 5df4 1a7d 1b8d +5e13 5df4 1a7c 1a7d +5df6 5df5 1a7e 1b8e +5e14 5df5 1a7d 1a7e +5df7 5df6 1a7f 1b8f +5e15 5df6 1a7e 1a7f +5df8 5df7 1a80 1b90 +5e16 5df7 1a7f 1a80 +5df9 5df8 1a81 1b91 +5e17 5df8 1a80 1a81 +5dfa 5df9 1a82 1b92 +5e18 5df9 1a81 1a82 +5dfb 5dfa 1a83 1b93 +5e19 5dfa 1a82 1a83 +5dfc 5dfb 1a84 1b94 +5e1a 5dfb 1a83 1a84 +5dfd 5dfc 1a85 1b95 +5e1b 5dfc 1a84 1a85 +5dfe 5dfd 1a86 1b96 +5e1c 5dfd 1a85 1a86 +5dff 5dfe 1a87 1b97 +5e1d 5dfe 1a86 1a87 +5e00 5dff 1a88 1b98 +5e1e 5dff 1a87 1a88 +5e01 5e00 1a89 1b99 +5e1f 5e00 1a88 1a89 +5e02 5e01 1a8a 1b9a +5e20 5e01 1a89 1a8a +5e03 5e02 1a8b 1b9b +5e21 5e02 1a8a 1a8b +5e04 5e03 1a8c 1b9c +5e22 5e03 1a8b 1a8c +5e05 5e04 1a8d 1b9d +5e23 5e04 1a8c 1a8d +5e06 5e05 1a8e 1b9e +5e24 5e05 1a8d 1a8e +5e07 5e06 1a8f 1b9f +5e25 5e06 1a8e 1a8f +5e26 5e07 1a8f 1a90 +5e09 5e08 1962 1a72 +5e27 5e08 1961 1962 +5e0a 5e09 1963 1a73 +5e28 5e09 1962 1963 +5e0b 5e0a 1964 1a74 +5e29 5e0a 1963 1964 +5e0c 5e0b 1965 1a75 +5e2a 5e0b 1964 1965 +5e0d 5e0c 1966 1a76 +5e2b 5e0c 1965 1966 +5e0e 5e0d 1967 1a77 +5e2c 5e0d 1966 1967 +5e0f 5e0e 1968 1a78 +5e2d 5e0e 1967 1968 +5e10 5e0f 1969 1a79 +5e2e 5e0f 1968 1969 +5e11 5e10 196a 1a7a +5e2f 5e10 1969 196a +5e12 5e11 196b 1a7b +5e30 5e11 196a 196b +5e13 5e12 196c 1a7c +5e31 5e12 196b 196c +5e14 5e13 196d 1a7d +5e32 5e13 196c 196d +5e15 5e14 196e 1a7e +5e33 5e14 196d 196e +5e16 5e15 196f 1a7f +5e34 5e15 196e 196f +5e17 5e16 1970 1a80 +5e35 5e16 196f 1970 +5e18 5e17 1971 1a81 +5e36 5e17 1970 1971 +5e19 5e18 1972 1a82 +5e37 5e18 1971 1972 +5e1a 5e19 1973 1a83 +5e38 5e19 1972 1973 +5e1b 5e1a 1974 1a84 +5e39 5e1a 1973 1974 +5e1c 5e1b 1975 1a85 +5e3a 5e1b 1974 1975 +5e1d 5e1c 1976 1a86 +5e3b 5e1c 1975 1976 +5e1e 5e1d 1977 1a87 +5e3c 5e1d 1976 1977 +5e1f 5e1e 1978 1a88 +5e3d 5e1e 1977 1978 +5e20 5e1f 1979 1a89 +5e3e 5e1f 1978 1979 +5e21 5e20 197a 1a8a +5e3f 5e20 1979 197a +5e22 5e21 197b 1a8b +5e40 5e21 197a 197b +5e23 5e22 197c 1a8c +5e41 5e22 197b 197c +5e24 5e23 197d 1a8d +5e42 5e23 197c 197d +5e25 5e24 197e 1a8e +5e43 5e24 197d 197e +5e26 5e25 197f 1a8f +5e44 5e25 197e 197f +5e45 5e26 197f 1980 +5e28 5e27 1852 1962 +5e46 5e27 1851 1852 +5e29 5e28 1853 1963 +5e47 5e28 1852 1853 +5e2a 5e29 1854 1964 +5e48 5e29 1853 1854 +5e2b 5e2a 1855 1965 +5e49 5e2a 1854 1855 +5e2c 5e2b 1856 1966 +5e4a 5e2b 1855 1856 +5e2d 5e2c 1857 1967 +5e4b 5e2c 1856 1857 +5e2e 5e2d 1858 1968 +5e4c 5e2d 1857 1858 +5e2f 5e2e 1859 1969 +5e4d 5e2e 1858 1859 +5e30 5e2f 185a 196a +5e4e 5e2f 1859 185a +5e31 5e30 185b 196b +5e4f 5e30 185a 185b +5e32 5e31 185c 196c +5e50 5e31 185b 185c +5e33 5e32 185d 196d +5e51 5e32 185c 185d +5e34 5e33 185e 196e +5e52 5e33 185d 185e +5e35 5e34 185f 196f +5e53 5e34 185e 185f +5e36 5e35 1860 1970 +5e54 5e35 185f 1860 +5e37 5e36 1861 1971 +5e55 5e36 1860 1861 +5e38 5e37 1862 1972 +5e56 5e37 1861 1862 +5e39 5e38 1863 1973 +5e57 5e38 1862 1863 +5e3a 5e39 1864 1974 +5e58 5e39 1863 1864 +5e3b 5e3a 1865 1975 +5e59 5e3a 1864 1865 +5e3c 5e3b 1866 1976 +5e5a 5e3b 1865 1866 +5e3d 5e3c 1867 1977 +5e5b 5e3c 1866 1867 +5e3e 5e3d 1868 1978 +5e5c 5e3d 1867 1868 +5e3f 5e3e 1869 1979 +5e5d 5e3e 1868 1869 +5e40 5e3f 186a 197a +5e5e 5e3f 1869 186a +5e41 5e40 186b 197b +5e5f 5e40 186a 186b +5e42 5e41 186c 197c +5e60 5e41 186b 186c +5e43 5e42 186d 197d +5e61 5e42 186c 186d +5e44 5e43 186e 197e +5e62 5e43 186d 186e +5e45 5e44 186f 197f +5e63 5e44 186e 186f +5e64 5e45 186f 1870 +5e47 5e46 1742 1852 +5e65 5e46 1741 1742 +5e48 5e47 1743 1853 +5e66 5e47 1742 1743 +5e49 5e48 1744 1854 +5e67 5e48 1743 1744 +5e4a 5e49 1745 1855 +5e68 5e49 1744 1745 +5e4b 5e4a 1746 1856 +5e69 5e4a 1745 1746 +5e4c 5e4b 1747 1857 +5e6a 5e4b 1746 1747 +5e4d 5e4c 1748 1858 +5e6b 5e4c 1747 1748 +5e4e 5e4d 1749 1859 +5e6c 5e4d 1748 1749 +5e4f 5e4e 174a 185a +5e6d 5e4e 1749 174a +5e50 5e4f 174b 185b +5e6e 5e4f 174a 174b +5e51 5e50 174c 185c +5e6f 5e50 174b 174c +5e52 5e51 174d 185d +5e70 5e51 174c 174d +5e53 5e52 174e 185e +5e71 5e52 174d 174e +5e54 5e53 174f 185f +5e72 5e53 174e 174f +5e55 5e54 1750 1860 +5e73 5e54 174f 1750 +5e56 5e55 1751 1861 +5e74 5e55 1750 1751 +5e57 5e56 1752 1862 +5e75 5e56 1751 1752 +5e58 5e57 1753 1863 +5e76 5e57 1752 1753 +5e59 5e58 1754 1864 +5e77 5e58 1753 1754 +5e5a 5e59 1755 1865 +5e78 5e59 1754 1755 +5e5b 5e5a 1756 1866 +5e79 5e5a 1755 1756 +5e5c 5e5b 1757 1867 +5e7a 5e5b 1756 1757 +5e5d 5e5c 1758 1868 +5e7b 5e5c 1757 1758 +5e5e 5e5d 1759 1869 +5e7c 5e5d 1758 1759 +5e5f 5e5e 175a 186a +5e7d 5e5e 1759 175a +5e60 5e5f 175b 186b +5e7e 5e5f 175a 175b +5e61 5e60 175c 186c +5e7f 5e60 175b 175c +5e62 5e61 175d 186d +5e80 5e61 175c 175d +5e63 5e62 175e 186e +5e81 5e62 175d 175e +5e64 5e63 175f 186f +5e82 5e63 175e 175f +5e83 5e64 175f 1760 +5e66 5e65 1632 1742 +5e84 5e65 1631 1632 +5e67 5e66 1633 1743 +5e85 5e66 1632 1633 +5e68 5e67 1634 1744 +5e86 5e67 1633 1634 +5e69 5e68 1635 1745 +5e87 5e68 1634 1635 +5e6a 5e69 1636 1746 +5e88 5e69 1635 1636 +5e6b 5e6a 1637 1747 +5e89 5e6a 1636 1637 +5e6c 5e6b 1638 1748 +5e8a 5e6b 1637 1638 +5e6d 5e6c 1639 1749 +5e8b 5e6c 1638 1639 +5e6e 5e6d 163a 174a +5e8c 5e6d 1639 163a +5e6f 5e6e 163b 174b +5e8d 5e6e 163a 163b +5e70 5e6f 163c 174c +5e8e 5e6f 163b 163c +5e71 5e70 163d 174d +5e8f 5e70 163c 163d +5e72 5e71 163e 174e +5e90 5e71 163d 163e +5e73 5e72 163f 174f +5e91 5e72 163e 163f +5e74 5e73 1640 1750 +5e92 5e73 163f 1640 +5e75 5e74 1641 1751 +5e93 5e74 1640 1641 +5e76 5e75 1642 1752 +5e94 5e75 1641 1642 +5e77 5e76 1643 1753 +5e95 5e76 1642 1643 +5e78 5e77 1644 1754 +5e96 5e77 1643 1644 +5e79 5e78 1645 1755 +5e97 5e78 1644 1645 +5e7a 5e79 1646 1756 +5e98 5e79 1645 1646 +5e7b 5e7a 1647 1757 +5e99 5e7a 1646 1647 +5e7c 5e7b 1648 1758 +5e9a 5e7b 1647 1648 +5e7d 5e7c 1649 1759 +5e9b 5e7c 1648 1649 +5e7e 5e7d 164a 175a +5e9c 5e7d 1649 164a +5e7f 5e7e 164b 175b +5e9d 5e7e 164a 164b +5e80 5e7f 164c 175c +5e9e 5e7f 164b 164c +5e81 5e80 164d 175d +5e9f 5e80 164c 164d +5e82 5e81 164e 175e +5ea0 5e81 164d 164e +5e83 5e82 164f 175f +5ea1 5e82 164e 164f +5ea2 5e83 164f 1650 +5e85 5e84 1522 1632 +5ea3 5e84 1521 1522 +5e86 5e85 1523 1633 +5ea4 5e85 1522 1523 +5e87 5e86 1524 1634 +5ea5 5e86 1523 1524 +5e88 5e87 1525 1635 +5ea6 5e87 1524 1525 +5e89 5e88 1526 1636 +5ea7 5e88 1525 1526 +5e8a 5e89 1527 1637 +5ea8 5e89 1526 1527 +5e8b 5e8a 1528 1638 +5ea9 5e8a 1527 1528 +5e8c 5e8b 1529 1639 +5eaa 5e8b 1528 1529 +5e8d 5e8c 152a 163a +5eab 5e8c 1529 152a +5e8e 5e8d 152b 163b +5eac 5e8d 152a 152b +5e8f 5e8e 152c 163c +5ead 5e8e 152b 152c +5e90 5e8f 152d 163d +5eae 5e8f 152c 152d +5e91 5e90 152e 163e +5eaf 5e90 152d 152e +5e92 5e91 152f 163f +5eb0 5e91 152e 152f +5e93 5e92 1530 1640 +5eb1 5e92 152f 1530 +5e94 5e93 1531 1641 +5eb2 5e93 1530 1531 +5e95 5e94 1532 1642 +5eb3 5e94 1531 1532 +5e96 5e95 1533 1643 +5eb4 5e95 1532 1533 +5e97 5e96 1534 1644 +5eb5 5e96 1533 1534 +5e98 5e97 1535 1645 +5eb6 5e97 1534 1535 +5e99 5e98 1536 1646 +5eb7 5e98 1535 1536 +5e9a 5e99 1537 1647 +5eb8 5e99 1536 1537 +5e9b 5e9a 1538 1648 +5eb9 5e9a 1537 1538 +5e9c 5e9b 1539 1649 +5eba 5e9b 1538 1539 +5e9d 5e9c 153a 164a +5ebb 5e9c 1539 153a +5e9e 5e9d 153b 164b +5ebc 5e9d 153a 153b +5e9f 5e9e 153c 164c +5ebd 5e9e 153b 153c +5ea0 5e9f 153d 164d +5ebe 5e9f 153c 153d +5ea1 5ea0 153e 164e +5ebf 5ea0 153d 153e +5ea2 5ea1 153f 164f +5ec0 5ea1 153e 153f +5ec1 5ea2 153f 1540 +5ea4 5ea3 1412 1522 +5ec2 5ea3 1411 1412 +5ea5 5ea4 1413 1523 +5ec3 5ea4 1412 1413 +5ea6 5ea5 1414 1524 +5ec4 5ea5 1413 1414 +5ea7 5ea6 1415 1525 +5ec5 5ea6 1414 1415 +5ea8 5ea7 1416 1526 +5ec6 5ea7 1415 1416 +5ea9 5ea8 1417 1527 +5ec7 5ea8 1416 1417 +5eaa 5ea9 1418 1528 +5ec8 5ea9 1417 1418 +5eab 5eaa 1419 1529 +5ec9 5eaa 1418 1419 +5eac 5eab 141a 152a +5eca 5eab 1419 141a +5ead 5eac 141b 152b +5ecb 5eac 141a 141b +5eae 5ead 141c 152c +5ecc 5ead 141b 141c +5eaf 5eae 141d 152d +5ecd 5eae 141c 141d +5eb0 5eaf 141e 152e +5ece 5eaf 141d 141e +5eb1 5eb0 141f 152f +5ecf 5eb0 141e 141f +5eb2 5eb1 1420 1530 +5ed0 5eb1 141f 1420 +5eb3 5eb2 1421 1531 +5ed1 5eb2 1420 1421 +5eb4 5eb3 1422 1532 +5ed2 5eb3 1421 1422 +5eb5 5eb4 1423 1533 +5ed3 5eb4 1422 1423 +5eb6 5eb5 1424 1534 +5ed4 5eb5 1423 1424 +5eb7 5eb6 1425 1535 +5ed5 5eb6 1424 1425 +5eb8 5eb7 1426 1536 +5ed6 5eb7 1425 1426 +5eb9 5eb8 1427 1537 +5ed7 5eb8 1426 1427 +5eba 5eb9 1428 1538 +5ed8 5eb9 1427 1428 +5ebb 5eba 1429 1539 +5ed9 5eba 1428 1429 +5ebc 5ebb 142a 153a +5eda 5ebb 1429 142a +5ebd 5ebc 142b 153b +5edb 5ebc 142a 142b +5ebe 5ebd 142c 153c +5edc 5ebd 142b 142c +5ebf 5ebe 142d 153d +5edd 5ebe 142c 142d +5ec0 5ebf 142e 153e +5ede 5ebf 142d 142e +5ec1 5ec0 142f 153f +5edf 5ec0 142e 142f +5ee0 5ec1 142f 1430 +5ec3 5ec2 1302 1412 +5ee1 5ec2 1301 1302 +5ec4 5ec3 1303 1413 +5ee2 5ec3 1302 1303 +5ec5 5ec4 1304 1414 +5ee3 5ec4 1303 1304 +5ec6 5ec5 1305 1415 +5ee4 5ec5 1304 1305 +5ec7 5ec6 1306 1416 +5ee5 5ec6 1305 1306 +5ec8 5ec7 1307 1417 +5ee6 5ec7 1306 1307 +5ec9 5ec8 1308 1418 +5ee7 5ec8 1307 1308 +5eca 5ec9 1309 1419 +5ee8 5ec9 1308 1309 +5ecb 5eca 130a 141a +5ee9 5eca 1309 130a +5ecc 5ecb 130b 141b +5eea 5ecb 130a 130b +5ecd 5ecc 130c 141c +5eeb 5ecc 130b 130c +5ece 5ecd 130d 141d +5eec 5ecd 130c 130d +5ecf 5ece 130e 141e +5eed 5ece 130d 130e +5ed0 5ecf 130f 141f +5eee 5ecf 130e 130f +5ed1 5ed0 1310 1420 +5eef 5ed0 130f 1310 +5ed2 5ed1 1311 1421 +5ef0 5ed1 1310 1311 +5ed3 5ed2 1312 1422 +5ef1 5ed2 1311 1312 +5ed4 5ed3 1313 1423 +5ef2 5ed3 1312 1313 +5ed5 5ed4 1314 1424 +5ef3 5ed4 1313 1314 +5ed6 5ed5 1315 1425 +5ef4 5ed5 1314 1315 +5ed7 5ed6 1316 1426 +5ef5 5ed6 1315 1316 +5ed8 5ed7 1317 1427 +5ef6 5ed7 1316 1317 +5ed9 5ed8 1318 1428 +5ef7 5ed8 1317 1318 +5eda 5ed9 1319 1429 +5ef8 5ed9 1318 1319 +5edb 5eda 131a 142a +5ef9 5eda 1319 131a +5edc 5edb 131b 142b +5efa 5edb 131a 131b +5edd 5edc 131c 142c +5efb 5edc 131b 131c +5ede 5edd 131d 142d +5efc 5edd 131c 131d +5edf 5ede 131e 142e +5efd 5ede 131d 131e +5ee0 5edf 131f 142f +5efe 5edf 131e 131f +5eff 5ee0 131f 1320 +5ee2 5ee1 11f2 1302 +5f00 5ee1 11f1 11f2 +5ee3 5ee2 11f3 1303 +5f01 5ee2 11f2 11f3 +5ee4 5ee3 11f4 1304 +5f02 5ee3 11f3 11f4 +5ee5 5ee4 11f5 1305 +5f03 5ee4 11f4 11f5 +5ee6 5ee5 11f6 1306 +5f04 5ee5 11f5 11f6 +5ee7 5ee6 11f7 1307 +5f05 5ee6 11f6 11f7 +5ee8 5ee7 11f8 1308 +5f06 5ee7 11f7 11f8 +5ee9 5ee8 11f9 1309 +5f07 5ee8 11f8 11f9 +5eea 5ee9 11fa 130a +5f08 5ee9 11f9 11fa +5eeb 5eea 11fb 130b +5f09 5eea 11fa 11fb +5eec 5eeb 11fc 130c +5f0a 5eeb 11fb 11fc +5eed 5eec 11fd 130d +5f0b 5eec 11fc 11fd +5eee 5eed 11fe 130e +5f0c 5eed 11fd 11fe +5eef 5eee 11ff 130f +5f0d 5eee 11fe 11ff +5ef0 5eef 1200 1310 +5f0e 5eef 11ff 1200 +5ef1 5ef0 1201 1311 +5f0f 5ef0 1200 1201 +5ef2 5ef1 1202 1312 +5f10 5ef1 1201 1202 +5ef3 5ef2 1203 1313 +5f11 5ef2 1202 1203 +5ef4 5ef3 1204 1314 +5f12 5ef3 1203 1204 +5ef5 5ef4 1205 1315 +5f13 5ef4 1204 1205 +5ef6 5ef5 1206 1316 +5f14 5ef5 1205 1206 +5ef7 5ef6 1207 1317 +5f15 5ef6 1206 1207 +5ef8 5ef7 1208 1318 +5f16 5ef7 1207 1208 +5ef9 5ef8 1209 1319 +5f17 5ef8 1208 1209 +5efa 5ef9 120a 131a +5f18 5ef9 1209 120a +5efb 5efa 120b 131b +5f19 5efa 120a 120b +5efc 5efb 120c 131c +5f1a 5efb 120b 120c +5efd 5efc 120d 131d +5f1b 5efc 120c 120d +5efe 5efd 120e 131e +5f1c 5efd 120d 120e +5eff 5efe 120f 131f +5f1d 5efe 120e 120f +5f1e 5eff 120f 1210 +5f01 5f00 10e2 11f2 +5f02 5f01 10e3 11f3 +5f03 5f02 10e4 11f4 +5f04 5f03 10e5 11f5 +5f05 5f04 10e6 11f6 +5f06 5f05 10e7 11f7 +5f07 5f06 10e8 11f8 +5f08 5f07 10e9 11f9 +5f09 5f08 10ea 11fa +5f0a 5f09 10eb 11fb +5f0b 5f0a 10ec 11fc +5f0c 5f0b 10ed 11fd +5f0d 5f0c 10ee 11fe +5f0e 5f0d 10ef 11ff +5f0f 5f0e 10f0 1200 +5f10 5f0f 10f1 1201 +5f11 5f10 10f2 1202 +5f12 5f11 10f3 1203 +5f13 5f12 10f4 1204 +5f14 5f13 10f5 1205 +5f15 5f14 10f6 1206 +5f16 5f15 10f7 1207 +5f17 5f16 10f8 1208 +5f18 5f17 10f9 1209 +5f19 5f18 10fa 120a +5f1a 5f19 10fb 120b +5f1b 5f1a 10fc 120c +5f1c 5f1b 10fd 120d +5f1d 5f1c 10fe 120e +5f1e 5f1d 10ff 120f +5f1f 5f20 101f 10af +5f3e 5f1f 101f 1020 +5f20 5f21 101e 10ae +5f3f 5f20 101e 101f +5f21 5f22 101d 10ad +5f40 5f21 101d 101e +5f22 5f23 101c 10ac +5f41 5f22 101c 101d +5f23 5f24 101b 10ab +5f42 5f23 101b 101c +5f24 5f25 101a 10aa +5f43 5f24 101a 101b +5f25 5f26 1019 10a9 +5f44 5f25 1019 101a +5f26 5f27 1018 10a8 +5f45 5f26 1018 1019 +5f27 5f28 1017 10a7 +5f46 5f27 1017 1018 +5f28 5f29 1016 10a6 +5f47 5f28 1016 1017 +5f29 5f2a 1015 10a5 +5f48 5f29 1015 1016 +5f2a 5f2b 1014 10a4 +5f49 5f2a 1014 1015 +5f2b 5f2c 1013 10a3 +5f4a 5f2b 1013 1014 +5f2c 5f2d 1012 10a2 +5f4b 5f2c 1012 1013 +5f2d 5f2e 1011 10a1 +5f4c 5f2d 1011 1012 +5f2e 5f2f 1010 10a0 +5f4d 5f2e 1010 1011 +5f2f 5f30 100f 109f +5f4e 5f2f 100f 1010 +5f30 5f31 100e 109e +5f4f 5f30 100e 100f +5f31 5f32 100d 109d +5f50 5f31 100d 100e +5f32 5f33 100c 109c +5f51 5f32 100c 100d +5f33 5f34 100b 109b +5f52 5f33 100b 100c +5f34 5f35 100a 109a +5f53 5f34 100a 100b +5f35 5f36 1009 1099 +5f54 5f35 1009 100a +5f36 5f37 1008 1098 +5f55 5f36 1008 1009 +5f37 5f38 1007 1097 +5f56 5f37 1007 1008 +5f38 5f39 1006 1096 +5f57 5f38 1006 1007 +5f39 5f3a 1005 1095 +5f58 5f39 1005 1006 +5f3a 5f3b 1004 1094 +5f59 5f3a 1004 1005 +5f3b 5f3c 1003 1093 +5f5a 5f3b 1003 1004 +5f3c 5f3d 1002 1092 +5f5b 5f3c 1002 1003 +5f5c 5f3d 1001 1002 +5f3e 5f3f f8f 101f +5f5d 5f3e f8f f90 +5f3f 5f40 f8e 101e +5f5e 5f3f f8e f8f +5f40 5f41 f8d 101d +5f5f 5f40 f8d f8e +5f41 5f42 f8c 101c +5f60 5f41 f8c f8d +5f42 5f43 f8b 101b +5f61 5f42 f8b f8c +5f43 5f44 f8a 101a +5f62 5f43 f8a f8b +5f44 5f45 f89 1019 +5f63 5f44 f89 f8a +5f45 5f46 f88 1018 +5f64 5f45 f88 f89 +5f46 5f47 f87 1017 +5f65 5f46 f87 f88 +5f47 5f48 f86 1016 +5f66 5f47 f86 f87 +5f48 5f49 f85 1015 +5f67 5f48 f85 f86 +5f49 5f4a f84 1014 +5f68 5f49 f84 f85 +5f4a 5f4b f83 1013 +5f69 5f4a f83 f84 +5f4b 5f4c f82 1012 +5f6a 5f4b f82 f83 +5f4c 5f4d f81 1011 +5f6b 5f4c f81 f82 +5f4d 5f4e f80 1010 +5f6c 5f4d f80 f81 +5f4e 5f4f f7f 100f +5f6d 5f4e f7f f80 +5f4f 5f50 f7e 100e +5f6e 5f4f f7e f7f +5f50 5f51 f7d 100d +5f6f 5f50 f7d f7e +5f51 5f52 f7c 100c +5f70 5f51 f7c f7d +5f52 5f53 f7b 100b +5f71 5f52 f7b f7c +5f53 5f54 f7a 100a +5f72 5f53 f7a f7b +5f54 5f55 f79 1009 +5f73 5f54 f79 f7a +5f55 5f56 f78 1008 +5f74 5f55 f78 f79 +5f56 5f57 f77 1007 +5f75 5f56 f77 f78 +5f57 5f58 f76 1006 +5f76 5f57 f76 f77 +5f58 5f59 f75 1005 +5f77 5f58 f75 f76 +5f59 5f5a f74 1004 +5f78 5f59 f74 f75 +5f5a 5f5b f73 1003 +5f79 5f5a f73 f74 +5f5b 5f5c f72 1002 +5f7a 5f5b f72 f73 +5f7b 5f5c f71 f72 +5f5d 5f5e eff f8f +5f7c 5f5d eff f00 +5f5e 5f5f efe f8e +5f7d 5f5e efe eff +5f5f 5f60 efd f8d +5f7e 5f5f efd efe +5f60 5f61 efc f8c +5f7f 5f60 efc efd +5f61 5f62 efb f8b +5f80 5f61 efb efc +5f62 5f63 efa f8a +5f81 5f62 efa efb +5f63 5f64 ef9 f89 +5f82 5f63 ef9 efa +5f64 5f65 ef8 f88 +5f83 5f64 ef8 ef9 +5f65 5f66 ef7 f87 +5f84 5f65 ef7 ef8 +5f66 5f67 ef6 f86 +5f85 5f66 ef6 ef7 +5f67 5f68 ef5 f85 +5f86 5f67 ef5 ef6 +5f68 5f69 ef4 f84 +5f87 5f68 ef4 ef5 +5f69 5f6a ef3 f83 +5f88 5f69 ef3 ef4 +5f6a 5f6b ef2 f82 +5f89 5f6a ef2 ef3 +5f6b 5f6c ef1 f81 +5f8a 5f6b ef1 ef2 +5f6c 5f6d ef0 f80 +5f8b 5f6c ef0 ef1 +5f6d 5f6e eef f7f +5f8c 5f6d eef ef0 +5f6e 5f6f eee f7e +5f8d 5f6e eee eef +5f6f 5f70 eed f7d +5f8e 5f6f eed eee +5f70 5f71 eec f7c +5f8f 5f70 eec eed +5f71 5f72 eeb f7b +5f90 5f71 eeb eec +5f72 5f73 eea f7a +5f91 5f72 eea eeb +5f73 5f74 ee9 f79 +5f92 5f73 ee9 eea +5f74 5f75 ee8 f78 +5f93 5f74 ee8 ee9 +5f75 5f76 ee7 f77 +5f94 5f75 ee7 ee8 +5f76 5f77 ee6 f76 +5f95 5f76 ee6 ee7 +5f77 5f78 ee5 f75 +5f96 5f77 ee5 ee6 +5f78 5f79 ee4 f74 +5f97 5f78 ee4 ee5 +5f79 5f7a ee3 f73 +5f98 5f79 ee3 ee4 +5f7a 5f7b ee2 f72 +5f99 5f7a ee2 ee3 +5f9a 5f7b ee1 ee2 +5f7c 5f7d e6f eff +5f9b 5f7c e6f e70 +5f7d 5f7e e6e efe +5f9c 5f7d e6e e6f +5f7e 5f7f e6d efd +5f9d 5f7e e6d e6e +5f7f 5f80 e6c efc +5f9e 5f7f e6c e6d +5f80 5f81 e6b efb +5f9f 5f80 e6b e6c +5f81 5f82 e6a efa +5fa0 5f81 e6a e6b +5f82 5f83 e69 ef9 +5fa1 5f82 e69 e6a +5f83 5f84 e68 ef8 +5fa2 5f83 e68 e69 +5f84 5f85 e67 ef7 +5fa3 5f84 e67 e68 +5f85 5f86 e66 ef6 +5fa4 5f85 e66 e67 +5f86 5f87 e65 ef5 +5fa5 5f86 e65 e66 +5f87 5f88 e64 ef4 +5fa6 5f87 e64 e65 +5f88 5f89 e63 ef3 +5fa7 5f88 e63 e64 +5f89 5f8a e62 ef2 +5fa8 5f89 e62 e63 +5f8a 5f8b e61 ef1 +5fa9 5f8a e61 e62 +5f8b 5f8c e60 ef0 +5faa 5f8b e60 e61 +5f8c 5f8d e5f eef +5fab 5f8c e5f e60 +5f8d 5f8e e5e eee +5fac 5f8d e5e e5f +5f8e 5f8f e5d eed +5fad 5f8e e5d e5e +5f8f 5f90 e5c eec +5fae 5f8f e5c e5d +5f90 5f91 e5b eeb +5faf 5f90 e5b e5c +5f91 5f92 e5a eea +5fb0 5f91 e5a e5b +5f92 5f93 e59 ee9 +5fb1 5f92 e59 e5a +5f93 5f94 e58 ee8 +5fb2 5f93 e58 e59 +5f94 5f95 e57 ee7 +5fb3 5f94 e57 e58 +5f95 5f96 e56 ee6 +5fb4 5f95 e56 e57 +5f96 5f97 e55 ee5 +5fb5 5f96 e55 e56 +5f97 5f98 e54 ee4 +5fb6 5f97 e54 e55 +5f98 5f99 e53 ee3 +5fb7 5f98 e53 e54 +5f99 5f9a e52 ee2 +5fb8 5f99 e52 e53 +5fb9 5f9a e51 e52 +5f9b 5f9c ddf e6f +5fba 5f9b ddf de0 +5f9c 5f9d dde e6e +5fbb 5f9c dde ddf +5f9d 5f9e ddd e6d +5fbc 5f9d ddd dde +5f9e 5f9f ddc e6c +5fbd 5f9e ddc ddd +5f9f 5fa0 ddb e6b +5fbe 5f9f ddb ddc +5fa0 5fa1 dda e6a +5fbf 5fa0 dda ddb +5fa1 5fa2 dd9 e69 +5fc0 5fa1 dd9 dda +5fa2 5fa3 dd8 e68 +5fc1 5fa2 dd8 dd9 +5fa3 5fa4 dd7 e67 +5fc2 5fa3 dd7 dd8 +5fa4 5fa5 dd6 e66 +5fc3 5fa4 dd6 dd7 +5fa5 5fa6 dd5 e65 +5fc4 5fa5 dd5 dd6 +5fa6 5fa7 dd4 e64 +5fc5 5fa6 dd4 dd5 +5fa7 5fa8 dd3 e63 +5fc6 5fa7 dd3 dd4 +5fa8 5fa9 dd2 e62 +5fc7 5fa8 dd2 dd3 +5fa9 5faa dd1 e61 +5fc8 5fa9 dd1 dd2 +5faa 5fab dd0 e60 +5fc9 5faa dd0 dd1 +5fab 5fac dcf e5f +5fca 5fab dcf dd0 +5fac 5fad dce e5e +5fcb 5fac dce dcf +5fad 5fae dcd e5d +5fcc 5fad dcd dce +5fae 5faf dcc e5c +5fcd 5fae dcc dcd +5faf 5fb0 dcb e5b +5fce 5faf dcb dcc +5fb0 5fb1 dca e5a +5fcf 5fb0 dca dcb +5fb1 5fb2 dc9 e59 +5fd0 5fb1 dc9 dca +5fb2 5fb3 dc8 e58 +5fd1 5fb2 dc8 dc9 +5fb3 5fb4 dc7 e57 +5fd2 5fb3 dc7 dc8 +5fb4 5fb5 dc6 e56 +5fd3 5fb4 dc6 dc7 +5fb5 5fb6 dc5 e55 +5fd4 5fb5 dc5 dc6 +5fb6 5fb7 dc4 e54 +5fd5 5fb6 dc4 dc5 +5fb7 5fb8 dc3 e53 +5fd6 5fb7 dc3 dc4 +5fb8 5fb9 dc2 e52 +5fd7 5fb8 dc2 dc3 +5fd8 5fb9 dc1 dc2 +5fba 5fbb d4f ddf +5fd9 5fba d4f d50 +5fbb 5fbc d4e dde +5fda 5fbb d4e d4f +5fbc 5fbd d4d ddd +5fdb 5fbc d4d d4e +5fbd 5fbe d4c ddc +5fdc 5fbd d4c d4d +5fbe 5fbf d4b ddb +5fdd 5fbe d4b d4c +5fbf 5fc0 d4a dda +5fde 5fbf d4a d4b +5fc0 5fc1 d49 dd9 +5fdf 5fc0 d49 d4a +5fc1 5fc2 d48 dd8 +5fe0 5fc1 d48 d49 +5fc2 5fc3 d47 dd7 +5fe1 5fc2 d47 d48 +5fc3 5fc4 d46 dd6 +5fe2 5fc3 d46 d47 +5fc4 5fc5 d45 dd5 +5fe3 5fc4 d45 d46 +5fc5 5fc6 d44 dd4 +5fe4 5fc5 d44 d45 +5fc6 5fc7 d43 dd3 +5fe5 5fc6 d43 d44 +5fc7 5fc8 d42 dd2 +5fe6 5fc7 d42 d43 +5fc8 5fc9 d41 dd1 +5fe7 5fc8 d41 d42 +5fc9 5fca d40 dd0 +5fe8 5fc9 d40 d41 +5fca 5fcb d3f dcf +5fe9 5fca d3f d40 +5fcb 5fcc d3e dce +5fea 5fcb d3e d3f +5fcc 5fcd d3d dcd +5feb 5fcc d3d d3e +5fcd 5fce d3c dcc +5fec 5fcd d3c d3d +5fce 5fcf d3b dcb +5fed 5fce d3b d3c +5fcf 5fd0 d3a dca +5fee 5fcf d3a d3b +5fd0 5fd1 d39 dc9 +5fef 5fd0 d39 d3a +5fd1 5fd2 d38 dc8 +5ff0 5fd1 d38 d39 +5fd2 5fd3 d37 dc7 +5ff1 5fd2 d37 d38 +5fd3 5fd4 d36 dc6 +5ff2 5fd3 d36 d37 +5fd4 5fd5 d35 dc5 +5ff3 5fd4 d35 d36 +5fd5 5fd6 d34 dc4 +5ff4 5fd5 d34 d35 +5fd6 5fd7 d33 dc3 +5ff5 5fd6 d33 d34 +5fd7 5fd8 d32 dc2 +5ff6 5fd7 d32 d33 +5ff7 5fd8 d31 d32 +5fd9 5fda cbf d4f +5ff8 5fd9 cbf cc0 +5fda 5fdb cbe d4e +5ff9 5fda cbe cbf +5fdb 5fdc cbd d4d +5ffa 5fdb cbd cbe +5fdc 5fdd cbc d4c +5ffb 5fdc cbc cbd +5fdd 5fde cbb d4b +5ffc 5fdd cbb cbc +5fde 5fdf cba d4a +5ffd 5fde cba cbb +5fdf 5fe0 cb9 d49 +5ffe 5fdf cb9 cba +5fe0 5fe1 cb8 d48 +5fff 5fe0 cb8 cb9 +5fe1 5fe2 cb7 d47 +6000 5fe1 cb7 cb8 +5fe2 5fe3 cb6 d46 +6001 5fe2 cb6 cb7 +5fe3 5fe4 cb5 d45 +6002 5fe3 cb5 cb6 +5fe4 5fe5 cb4 d44 +6003 5fe4 cb4 cb5 +5fe5 5fe6 cb3 d43 +6004 5fe5 cb3 cb4 +5fe6 5fe7 cb2 d42 +6005 5fe6 cb2 cb3 +5fe7 5fe8 cb1 d41 +6006 5fe7 cb1 cb2 +5fe8 5fe9 cb0 d40 +6007 5fe8 cb0 cb1 +5fe9 5fea caf d3f +6008 5fe9 caf cb0 +5fea 5feb cae d3e +6009 5fea cae caf +5feb 5fec cad d3d +600a 5feb cad cae +5fec 5fed cac d3c +600b 5fec cac cad +5fed 5fee cab d3b +600c 5fed cab cac +5fee 5fef caa d3a +600d 5fee caa cab +5fef 5ff0 ca9 d39 +600e 5fef ca9 caa +5ff0 5ff1 ca8 d38 +600f 5ff0 ca8 ca9 +5ff1 5ff2 ca7 d37 +6010 5ff1 ca7 ca8 +5ff2 5ff3 ca6 d36 +6011 5ff2 ca6 ca7 +5ff3 5ff4 ca5 d35 +6012 5ff3 ca5 ca6 +5ff4 5ff5 ca4 d34 +6013 5ff4 ca4 ca5 +5ff5 5ff6 ca3 d33 +6014 5ff5 ca3 ca4 +5ff6 5ff7 ca2 d32 +6015 5ff6 ca2 ca3 +6016 5ff7 ca1 ca2 +5ff8 5ff9 c2f cbf +6017 5ff8 c2f c30 +5ff9 5ffa c2e cbe +6018 5ff9 c2e c2f +5ffa 5ffb c2d cbd +6019 5ffa c2d c2e +5ffb 5ffc c2c cbc +601a 5ffb c2c c2d +5ffc 5ffd c2b cbb +601b 5ffc c2b c2c +5ffd 5ffe c2a cba +601c 5ffd c2a c2b +5ffe 5fff c29 cb9 +601d 5ffe c29 c2a +5fff 6000 c28 cb8 +601e 5fff c28 c29 +6000 6001 c27 cb7 +601f 6000 c27 c28 +6001 6002 c26 cb6 +6020 6001 c26 c27 +6002 6003 c25 cb5 +6021 6002 c25 c26 +6003 6004 c24 cb4 +6022 6003 c24 c25 +6004 6005 c23 cb3 +6023 6004 c23 c24 +6005 6006 c22 cb2 +6024 6005 c22 c23 +6006 6007 c21 cb1 +6025 6006 c21 c22 +6007 6008 c20 cb0 +6026 6007 c20 c21 +6008 6009 c1f caf +6027 6008 c1f c20 +6009 600a c1e cae +6028 6009 c1e c1f +600a 600b c1d cad +6029 600a c1d c1e +600b 600c c1c cac +602a 600b c1c c1d +600c 600d c1b cab +602b 600c c1b c1c +600d 600e c1a caa +602c 600d c1a c1b +600e 600f c19 ca9 +602d 600e c19 c1a +600f 6010 c18 ca8 +602e 600f c18 c19 +6010 6011 c17 ca7 +602f 6010 c17 c18 +6011 6012 c16 ca6 +6030 6011 c16 c17 +6012 6013 c15 ca5 +6031 6012 c15 c16 +6013 6014 c14 ca4 +6032 6013 c14 c15 +6014 6015 c13 ca3 +6033 6014 c13 c14 +6015 6016 c12 ca2 +6034 6015 c12 c13 +6035 6016 c11 c12 +6017 6018 b9f c2f +6036 6017 b9f ba0 +6018 6019 b9e c2e +6037 6018 b9e b9f +6019 601a b9d c2d +6038 6019 b9d b9e +601a 601b b9c c2c +6039 601a b9c b9d +601b 601c b9b c2b +603a 601b b9b b9c +601c 601d b9a c2a +603b 601c b9a b9b +601d 601e b99 c29 +603c 601d b99 b9a +601e 601f b98 c28 +603d 601e b98 b99 +601f 6020 b97 c27 +603e 601f b97 b98 +6020 6021 b96 c26 +603f 6020 b96 b97 +6021 6022 b95 c25 +6040 6021 b95 b96 +6022 6023 b94 c24 +6041 6022 b94 b95 +6023 6024 b93 c23 +6042 6023 b93 b94 +6024 6025 b92 c22 +6043 6024 b92 b93 +6025 6026 b91 c21 +6044 6025 b91 b92 +6026 6027 b90 c20 +6045 6026 b90 b91 +6027 6028 b8f c1f +6046 6027 b8f b90 +6028 6029 b8e c1e +6047 6028 b8e b8f +6029 602a b8d c1d +6048 6029 b8d b8e +602a 602b b8c c1c +6049 602a b8c b8d +602b 602c b8b c1b +604a 602b b8b b8c +602c 602d b8a c1a +604b 602c b8a b8b +602d 602e b89 c19 +604c 602d b89 b8a +602e 602f b88 c18 +604d 602e b88 b89 +602f 6030 b87 c17 +604e 602f b87 b88 +6030 6031 b86 c16 +604f 6030 b86 b87 +6031 6032 b85 c15 +6050 6031 b85 b86 +6032 6033 b84 c14 +6051 6032 b84 b85 +6033 6034 b83 c13 +6052 6033 b83 b84 +6034 6035 b82 c12 +6053 6034 b82 b83 +6054 6035 b81 b82 +6036 6037 b0f b9f +6055 6036 b0f b10 +6037 6038 b0e b9e +6056 6037 b0e b0f +6038 6039 b0d b9d +6057 6038 b0d b0e +6039 603a b0c b9c +6058 6039 b0c b0d +603a 603b b0b b9b +6059 603a b0b b0c +603b 603c b0a b9a +605a 603b b0a b0b +603c 603d b09 b99 +605b 603c b09 b0a +603d 603e b08 b98 +605c 603d b08 b09 +603e 603f b07 b97 +605d 603e b07 b08 +603f 6040 b06 b96 +605e 603f b06 b07 +6040 6041 b05 b95 +605f 6040 b05 b06 +6041 6042 b04 b94 +6060 6041 b04 b05 +6042 6043 b03 b93 +6061 6042 b03 b04 +6043 6044 b02 b92 +6062 6043 b02 b03 +6044 6045 b01 b91 +6063 6044 b01 b02 +6045 6046 b00 b90 +6064 6045 b00 b01 +6046 6047 aff b8f +6065 6046 aff b00 +6047 6048 afe b8e +6066 6047 afe aff +6048 6049 afd b8d +6067 6048 afd afe +6049 604a afc b8c +6068 6049 afc afd +604a 604b afb b8b +6069 604a afb afc +604b 604c afa b8a +606a 604b afa afb +604c 604d af9 b89 +606b 604c af9 afa +604d 604e af8 b88 +606c 604d af8 af9 +604e 604f af7 b87 +606d 604e af7 af8 +604f 6050 af6 b86 +606e 604f af6 af7 +6050 6051 af5 b85 +606f 6050 af5 af6 +6051 6052 af4 b84 +6070 6051 af4 af5 +6052 6053 af3 b83 +6071 6052 af3 af4 +6053 6054 af2 b82 +6072 6053 af2 af3 +6073 6054 af1 af2 +6055 6056 a7f b0f +6074 6055 a7f a80 +6056 6057 a7e b0e +6075 6056 a7e a7f +6057 6058 a7d b0d +6076 6057 a7d a7e +6058 6059 a7c b0c +6077 6058 a7c a7d +6059 605a a7b b0b +6078 6059 a7b a7c +605a 605b a7a b0a +6079 605a a7a a7b +605b 605c a79 b09 +607a 605b a79 a7a +605c 605d a78 b08 +607b 605c a78 a79 +605d 605e a77 b07 +607c 605d a77 a78 +605e 605f a76 b06 +607d 605e a76 a77 +605f 6060 a75 b05 +607e 605f a75 a76 +6060 6061 a74 b04 +607f 6060 a74 a75 +6061 6062 a73 b03 +6080 6061 a73 a74 +6062 6063 a72 b02 +6081 6062 a72 a73 +6063 6064 a71 b01 +6082 6063 a71 a72 +6064 6065 a70 b00 +6083 6064 a70 a71 +6065 6066 a6f aff +6084 6065 a6f a70 +6066 6067 a6e afe +6085 6066 a6e a6f +6067 6068 a6d afd +6086 6067 a6d a6e +6068 6069 a6c afc +6087 6068 a6c a6d +6069 606a a6b afb +6088 6069 a6b a6c +606a 606b a6a afa +6089 606a a6a a6b +606b 606c a69 af9 +608a 606b a69 a6a +606c 606d a68 af8 +608b 606c a68 a69 +606d 606e a67 af7 +608c 606d a67 a68 +606e 606f a66 af6 +608d 606e a66 a67 +606f 6070 a65 af5 +608e 606f a65 a66 +6070 6071 a64 af4 +608f 6070 a64 a65 +6071 6072 a63 af3 +6090 6071 a63 a64 +6072 6073 a62 af2 +6091 6072 a62 a63 +6092 6073 a61 a62 +6074 6075 9ef a7f +6093 6074 9ef 9f0 +6075 6076 9ee a7e +6094 6075 9ee 9ef +6076 6077 9ed a7d +6095 6076 9ed 9ee +6077 6078 9ec a7c +6096 6077 9ec 9ed +6078 6079 9eb a7b +6097 6078 9eb 9ec +6079 607a 9ea a7a +6098 6079 9ea 9eb +607a 607b 9e9 a79 +6099 607a 9e9 9ea +607b 607c 9e8 a78 +609a 607b 9e8 9e9 +607c 607d 9e7 a77 +609b 607c 9e7 9e8 +607d 607e 9e6 a76 +609c 607d 9e6 9e7 +607e 607f 9e5 a75 +609d 607e 9e5 9e6 +607f 6080 9e4 a74 +609e 607f 9e4 9e5 +6080 6081 9e3 a73 +609f 6080 9e3 9e4 +6081 6082 9e2 a72 +60a0 6081 9e2 9e3 +6082 6083 9e1 a71 +60a1 6082 9e1 9e2 +6083 6084 9e0 a70 +60a2 6083 9e0 9e1 +6084 6085 9df a6f +60a3 6084 9df 9e0 +6085 6086 9de a6e +60a4 6085 9de 9df +6086 6087 9dd a6d +60a5 6086 9dd 9de +6087 6088 9dc a6c +60a6 6087 9dc 9dd +6088 6089 9db a6b +60a7 6088 9db 9dc +6089 608a 9da a6a +60a8 6089 9da 9db +608a 608b 9d9 a69 +60a9 608a 9d9 9da +608b 608c 9d8 a68 +60aa 608b 9d8 9d9 +608c 608d 9d7 a67 +60ab 608c 9d7 9d8 +608d 608e 9d6 a66 +60ac 608d 9d6 9d7 +608e 608f 9d5 a65 +60ad 608e 9d5 9d6 +608f 6090 9d4 a64 +60ae 608f 9d4 9d5 +6090 6091 9d3 a63 +60af 6090 9d3 9d4 +6091 6092 9d2 a62 +60b0 6091 9d2 9d3 +60b1 6092 9d1 9d2 +6093 6094 95f 9ef +60b2 6093 95f 960 +6094 6095 95e 9ee +60b3 6094 95e 95f +6095 6096 95d 9ed +60b4 6095 95d 95e +6096 6097 95c 9ec +60b5 6096 95c 95d +6097 6098 95b 9eb +60b6 6097 95b 95c +6098 6099 95a 9ea +60b7 6098 95a 95b +6099 609a 959 9e9 +60b8 6099 959 95a +609a 609b 958 9e8 +60b9 609a 958 959 +609b 609c 957 9e7 +60ba 609b 957 958 +609c 609d 956 9e6 +60bb 609c 956 957 +609d 609e 955 9e5 +60bc 609d 955 956 +609e 609f 954 9e4 +60bd 609e 954 955 +609f 60a0 953 9e3 +60be 609f 953 954 +60a0 60a1 952 9e2 +60bf 60a0 952 953 +60a1 60a2 951 9e1 +60c0 60a1 951 952 +60a2 60a3 950 9e0 +60c1 60a2 950 951 +60a3 60a4 94f 9df +60c2 60a3 94f 950 +60a4 60a5 94e 9de +60c3 60a4 94e 94f +60a5 60a6 94d 9dd +60c4 60a5 94d 94e +60a6 60a7 94c 9dc +60c5 60a6 94c 94d +60a7 60a8 94b 9db +60c6 60a7 94b 94c +60a8 60a9 94a 9da +60c7 60a8 94a 94b +60a9 60aa 949 9d9 +60c8 60a9 949 94a +60aa 60ab 948 9d8 +60c9 60aa 948 949 +60ab 60ac 947 9d7 +60ca 60ab 947 948 +60ac 60ad 946 9d6 +60cb 60ac 946 947 +60ad 60ae 945 9d5 +60cc 60ad 945 946 +60ae 60af 944 9d4 +60cd 60ae 944 945 +60af 60b0 943 9d3 +60ce 60af 943 944 +60b0 60b1 942 9d2 +60cf 60b0 942 943 +60d0 60b1 941 942 +60b2 60b3 8cf 95f +60d1 60b2 8cf 8d0 +60b3 60b4 8ce 95e +60d2 60b3 8ce 8cf +60b4 60b5 8cd 95d +60d3 60b4 8cd 8ce +60b5 60b6 8cc 95c +60d4 60b5 8cc 8cd +60b6 60b7 8cb 95b +60d5 60b6 8cb 8cc +60b7 60b8 8ca 95a +60d6 60b7 8ca 8cb +60b8 60b9 8c9 959 +60d7 60b8 8c9 8ca +60b9 60ba 8c8 958 +60d8 60b9 8c8 8c9 +60ba 60bb 8c7 957 +60d9 60ba 8c7 8c8 +60bb 60bc 8c6 956 +60da 60bb 8c6 8c7 +60bc 60bd 8c5 955 +60db 60bc 8c5 8c6 +60bd 60be 8c4 954 +60dc 60bd 8c4 8c5 +60be 60bf 8c3 953 +60dd 60be 8c3 8c4 +60bf 60c0 8c2 952 +60de 60bf 8c2 8c3 +60c0 60c1 8c1 951 +60df 60c0 8c1 8c2 +60c1 60c2 8c0 950 +60e0 60c1 8c0 8c1 +60c2 60c3 8bf 94f +60e1 60c2 8bf 8c0 +60c3 60c4 8be 94e +60e2 60c3 8be 8bf +60c4 60c5 8bd 94d +60e3 60c4 8bd 8be +60c5 60c6 8bc 94c +60e4 60c5 8bc 8bd +60c6 60c7 8bb 94b +60e5 60c6 8bb 8bc +60c7 60c8 8ba 94a +60e6 60c7 8ba 8bb +60c8 60c9 8b9 949 +60e7 60c8 8b9 8ba +60c9 60ca 8b8 948 +60e8 60c9 8b8 8b9 +60ca 60cb 8b7 947 +60e9 60ca 8b7 8b8 +60cb 60cc 8b6 946 +60ea 60cb 8b6 8b7 +60cc 60cd 8b5 945 +60eb 60cc 8b5 8b6 +60cd 60ce 8b4 944 +60ec 60cd 8b4 8b5 +60ce 60cf 8b3 943 +60ed 60ce 8b3 8b4 +60cf 60d0 8b2 942 +60ee 60cf 8b2 8b3 +60ef 60d0 8b1 8b2 +60d1 60d2 83f 8cf +60f0 60d1 83f 840 +60d2 60d3 83e 8ce +60f1 60d2 83e 83f +60d3 60d4 83d 8cd +60f2 60d3 83d 83e +60d4 60d5 83c 8cc +60f3 60d4 83c 83d +60d5 60d6 83b 8cb +60f4 60d5 83b 83c +60d6 60d7 83a 8ca +60f5 60d6 83a 83b +60d7 60d8 839 8c9 +60f6 60d7 839 83a +60d8 60d9 838 8c8 +60f7 60d8 838 839 +60d9 60da 837 8c7 +60f8 60d9 837 838 +60da 60db 836 8c6 +60f9 60da 836 837 +60db 60dc 835 8c5 +60fa 60db 835 836 +60dc 60dd 834 8c4 +60fb 60dc 834 835 +60dd 60de 833 8c3 +60fc 60dd 833 834 +60de 60df 832 8c2 +60fd 60de 832 833 +60df 60e0 831 8c1 +60fe 60df 831 832 +60e0 60e1 830 8c0 +60ff 60e0 830 831 +60e1 60e2 82f 8bf +6100 60e1 82f 830 +60e2 60e3 82e 8be +6101 60e2 82e 82f +60e3 60e4 82d 8bd +6102 60e3 82d 82e +60e4 60e5 82c 8bc +6103 60e4 82c 82d +60e5 60e6 82b 8bb +6104 60e5 82b 82c +60e6 60e7 82a 8ba +6105 60e6 82a 82b +60e7 60e8 829 8b9 +6106 60e7 829 82a +60e8 60e9 828 8b8 +6107 60e8 828 829 +60e9 60ea 827 8b7 +6108 60e9 827 828 +60ea 60eb 826 8b6 +6109 60ea 826 827 +60eb 60ec 825 8b5 +610a 60eb 825 826 +60ec 60ed 824 8b4 +610b 60ec 824 825 +60ed 60ee 823 8b3 +610c 60ed 823 824 +60ee 60ef 822 8b2 +610d 60ee 822 823 +610e 60ef 821 822 +60f0 60f1 7af 83f +610f 60f0 7af 7b0 +60f1 60f2 7ae 83e +6110 60f1 7ae 7af +60f2 60f3 7ad 83d +6111 60f2 7ad 7ae +60f3 60f4 7ac 83c +6112 60f3 7ac 7ad +60f4 60f5 7ab 83b +6113 60f4 7ab 7ac +60f5 60f6 7aa 83a +6114 60f5 7aa 7ab +60f6 60f7 7a9 839 +6115 60f6 7a9 7aa +60f7 60f8 7a8 838 +6116 60f7 7a8 7a9 +60f8 60f9 7a7 837 +6117 60f8 7a7 7a8 +60f9 60fa 7a6 836 +6118 60f9 7a6 7a7 +60fa 60fb 7a5 835 +6119 60fa 7a5 7a6 +60fb 60fc 7a4 834 +611a 60fb 7a4 7a5 +60fc 60fd 7a3 833 +611b 60fc 7a3 7a4 +60fd 60fe 7a2 832 +611c 60fd 7a2 7a3 +60fe 60ff 7a1 831 +611d 60fe 7a1 7a2 +60ff 6100 7a0 830 +611e 60ff 7a0 7a1 +6100 6101 79f 82f +611f 6100 79f 7a0 +6101 6102 79e 82e +6120 6101 79e 79f +6102 6103 79d 82d +6121 6102 79d 79e +6103 6104 79c 82c +6122 6103 79c 79d +6104 6105 79b 82b +6123 6104 79b 79c +6105 6106 79a 82a +6124 6105 79a 79b +6106 6107 799 829 +6125 6106 799 79a +6107 6108 798 828 +6126 6107 798 799 +6108 6109 797 827 +6127 6108 797 798 +6109 610a 796 826 +6128 6109 796 797 +610a 610b 795 825 +6129 610a 795 796 +610b 610c 794 824 +612a 610b 794 795 +610c 610d 793 823 +612b 610c 793 794 +610d 610e 792 822 +612c 610d 792 793 +612d 610e 791 792 +610f 6110 71f 7af +612e 610f 71f 720 +6110 6111 71e 7ae +612f 6110 71e 71f +6111 6112 71d 7ad +6130 6111 71d 71e +6112 6113 71c 7ac +6131 6112 71c 71d +6113 6114 71b 7ab +6132 6113 71b 71c +6114 6115 71a 7aa +6133 6114 71a 71b +6115 6116 719 7a9 +6134 6115 719 71a +6116 6117 718 7a8 +6135 6116 718 719 +6117 6118 717 7a7 +6136 6117 717 718 +6118 6119 716 7a6 +6137 6118 716 717 +6119 611a 715 7a5 +6138 6119 715 716 +611a 611b 714 7a4 +6139 611a 714 715 +611b 611c 713 7a3 +613a 611b 713 714 +611c 611d 712 7a2 +613b 611c 712 713 +611d 611e 711 7a1 +613c 611d 711 712 +611e 611f 710 7a0 +613d 611e 710 711 +611f 6120 70f 79f +613e 611f 70f 710 +6120 6121 70e 79e +613f 6120 70e 70f +6121 6122 70d 79d +6140 6121 70d 70e +6122 6123 70c 79c +6141 6122 70c 70d +6123 6124 70b 79b +6142 6123 70b 70c +6124 6125 70a 79a +6143 6124 70a 70b +6125 6126 709 799 +6144 6125 709 70a +6126 6127 708 798 +6145 6126 708 709 +6127 6128 707 797 +6146 6127 707 708 +6128 6129 706 796 +6147 6128 706 707 +6129 612a 705 795 +6148 6129 705 706 +612a 612b 704 794 +6149 612a 704 705 +612b 612c 703 793 +614a 612b 703 704 +612c 612d 702 792 +614b 612c 702 703 +614c 612d 701 702 +612e 612f 68f 71f +614d 612e 68f 690 +612f 6130 68e 71e +614e 612f 68e 68f +6130 6131 68d 71d +614f 6130 68d 68e +6131 6132 68c 71c +6150 6131 68c 68d +6132 6133 68b 71b +6151 6132 68b 68c +6133 6134 68a 71a +6152 6133 68a 68b +6134 6135 689 719 +6153 6134 689 68a +6135 6136 688 718 +6154 6135 688 689 +6136 6137 687 717 +6155 6136 687 688 +6137 6138 686 716 +6156 6137 686 687 +6138 6139 685 715 +6157 6138 685 686 +6139 613a 684 714 +6158 6139 684 685 +613a 613b 683 713 +6159 613a 683 684 +613b 613c 682 712 +615a 613b 682 683 +613c 613d 681 711 +615b 613c 681 682 +613d 613e 680 710 +615c 613d 680 681 +613e 613f 67f 70f +615d 613e 67f 680 +613f 6140 67e 70e +615e 613f 67e 67f +6140 6141 67d 70d +615f 6140 67d 67e +6141 6142 67c 70c +6160 6141 67c 67d +6142 6143 67b 70b +6161 6142 67b 67c +6143 6144 67a 70a +6162 6143 67a 67b +6144 6145 679 709 +6163 6144 679 67a +6145 6146 678 708 +6164 6145 678 679 +6146 6147 677 707 +6165 6146 677 678 +6147 6148 676 706 +6166 6147 676 677 +6148 6149 675 705 +6167 6148 675 676 +6149 614a 674 704 +6168 6149 674 675 +614a 614b 673 703 +6169 614a 673 674 +614b 614c 672 702 +616a 614b 672 673 +616b 614c 671 672 +614d 614e 5ff 68f +616c 614d 5ff 600 +614e 614f 5fe 68e +616d 614e 5fe 5ff +614f 6150 5fd 68d +616e 614f 5fd 5fe +6150 6151 5fc 68c +616f 6150 5fc 5fd +6151 6152 5fb 68b +6170 6151 5fb 5fc +6152 6153 5fa 68a +6171 6152 5fa 5fb +6153 6154 5f9 689 +6172 6153 5f9 5fa +6154 6155 5f8 688 +6173 6154 5f8 5f9 +6155 6156 5f7 687 +6174 6155 5f7 5f8 +6156 6157 5f6 686 +6175 6156 5f6 5f7 +6157 6158 5f5 685 +6176 6157 5f5 5f6 +6158 6159 5f4 684 +6177 6158 5f4 5f5 +6159 615a 5f3 683 +6178 6159 5f3 5f4 +615a 615b 5f2 682 +6179 615a 5f2 5f3 +615b 615c 5f1 681 +617a 615b 5f1 5f2 +615c 615d 5f0 680 +617b 615c 5f0 5f1 +615d 615e 5ef 67f +617c 615d 5ef 5f0 +615e 615f 5ee 67e +617d 615e 5ee 5ef +615f 6160 5ed 67d +617e 615f 5ed 5ee +6160 6161 5ec 67c +617f 6160 5ec 5ed +6161 6162 5eb 67b +6180 6161 5eb 5ec +6162 6163 5ea 67a +6181 6162 5ea 5eb +6163 6164 5e9 679 +6182 6163 5e9 5ea +6164 6165 5e8 678 +6183 6164 5e8 5e9 +6165 6166 5e7 677 +6184 6165 5e7 5e8 +6166 6167 5e6 676 +6185 6166 5e6 5e7 +6167 6168 5e5 675 +6186 6167 5e5 5e6 +6168 6169 5e4 674 +6187 6168 5e4 5e5 +6169 616a 5e3 673 +6188 6169 5e3 5e4 +616a 616b 5e2 672 +6189 616a 5e2 5e3 +618a 616b 5e1 5e2 +616c 616d 56f 5ff +618b 616c 56f 570 +616d 616e 56e 5fe +618c 616d 56e 56f +616e 616f 56d 5fd +618d 616e 56d 56e +616f 6170 56c 5fc +618e 616f 56c 56d +6170 6171 56b 5fb +618f 6170 56b 56c +6171 6172 56a 5fa +6190 6171 56a 56b +6172 6173 569 5f9 +6191 6172 569 56a +6173 6174 568 5f8 +6192 6173 568 569 +6174 6175 567 5f7 +6193 6174 567 568 +6175 6176 566 5f6 +6194 6175 566 567 +6176 6177 565 5f5 +6195 6176 565 566 +6177 6178 564 5f4 +6196 6177 564 565 +6178 6179 563 5f3 +6197 6178 563 564 +6179 617a 562 5f2 +6198 6179 562 563 +617a 617b 561 5f1 +6199 617a 561 562 +617b 617c 560 5f0 +619a 617b 560 561 +617c 617d 55f 5ef +619b 617c 55f 560 +617d 617e 55e 5ee +619c 617d 55e 55f +617e 617f 55d 5ed +619d 617e 55d 55e +617f 6180 55c 5ec +619e 617f 55c 55d +6180 6181 55b 5eb +619f 6180 55b 55c +6181 6182 55a 5ea +61a0 6181 55a 55b +6182 6183 559 5e9 +61a1 6182 559 55a +6183 6184 558 5e8 +61a2 6183 558 559 +6184 6185 557 5e7 +61a3 6184 557 558 +6185 6186 556 5e6 +61a4 6185 556 557 +6186 6187 555 5e5 +61a5 6186 555 556 +6187 6188 554 5e4 +61a6 6187 554 555 +6188 6189 553 5e3 +61a7 6188 553 554 +6189 618a 552 5e2 +61a8 6189 552 553 +61a9 618a 551 552 +618b 618c 4df 56f +61aa 618b 4df 4e0 +618c 618d 4de 56e +61ab 618c 4de 4df +618d 618e 4dd 56d +61ac 618d 4dd 4de +618e 618f 4dc 56c +61ad 618e 4dc 4dd +618f 6190 4db 56b +61ae 618f 4db 4dc +6190 6191 4da 56a +61af 6190 4da 4db +6191 6192 4d9 569 +61b0 6191 4d9 4da +6192 6193 4d8 568 +61b1 6192 4d8 4d9 +6193 6194 4d7 567 +61b2 6193 4d7 4d8 +6194 6195 4d6 566 +61b3 6194 4d6 4d7 +6195 6196 4d5 565 +61b4 6195 4d5 4d6 +6196 6197 4d4 564 +61b5 6196 4d4 4d5 +6197 6198 4d3 563 +61b6 6197 4d3 4d4 +6198 6199 4d2 562 +61b7 6198 4d2 4d3 +6199 619a 4d1 561 +61b8 6199 4d1 4d2 +619a 619b 4d0 560 +61b9 619a 4d0 4d1 +619b 619c 4cf 55f +61ba 619b 4cf 4d0 +619c 619d 4ce 55e +61bb 619c 4ce 4cf +619d 619e 4cd 55d +61bc 619d 4cd 4ce +619e 619f 4cc 55c +61bd 619e 4cc 4cd +619f 61a0 4cb 55b +61be 619f 4cb 4cc +61a0 61a1 4ca 55a +61bf 61a0 4ca 4cb +61a1 61a2 4c9 559 +61c0 61a1 4c9 4ca +61a2 61a3 4c8 558 +61c1 61a2 4c8 4c9 +61a3 61a4 4c7 557 +61c2 61a3 4c7 4c8 +61a4 61a5 4c6 556 +61c3 61a4 4c6 4c7 +61a5 61a6 4c5 555 +61c4 61a5 4c5 4c6 +61a6 61a7 4c4 554 +61c5 61a6 4c4 4c5 +61a7 61a8 4c3 553 +61c6 61a7 4c3 4c4 +61a8 61a9 4c2 552 +61c7 61a8 4c2 4c3 +61c8 61a9 4c1 4c2 +61aa 61ab 44f 4df +61c9 61aa 44f 450 +61ab 61ac 44e 4de +61ca 61ab 44e 44f +61ac 61ad 44d 4dd +61cb 61ac 44d 44e +61ad 61ae 44c 4dc +61cc 61ad 44c 44d +61ae 61af 44b 4db +61cd 61ae 44b 44c +61af 61b0 44a 4da +61ce 61af 44a 44b +61b0 61b1 449 4d9 +61cf 61b0 449 44a +61b1 61b2 448 4d8 +61d0 61b1 448 449 +61b2 61b3 447 4d7 +61d1 61b2 447 448 +61b3 61b4 446 4d6 +61d2 61b3 446 447 +61b4 61b5 445 4d5 +61d3 61b4 445 446 +61b5 61b6 444 4d4 +61d4 61b5 444 445 +61b6 61b7 443 4d3 +61d5 61b6 443 444 +61b7 61b8 442 4d2 +61d6 61b7 442 443 +61b8 61b9 441 4d1 +61d7 61b8 441 442 +61b9 61ba 440 4d0 +61d8 61b9 440 441 +61ba 61bb 43f 4cf +61d9 61ba 43f 440 +61bb 61bc 43e 4ce +61da 61bb 43e 43f +61bc 61bd 43d 4cd +61db 61bc 43d 43e +61bd 61be 43c 4cc +61dc 61bd 43c 43d +61be 61bf 43b 4cb +61dd 61be 43b 43c +61bf 61c0 43a 4ca +61de 61bf 43a 43b +61c0 61c1 439 4c9 +61df 61c0 439 43a +61c1 61c2 438 4c8 +61e0 61c1 438 439 +61c2 61c3 437 4c7 +61e1 61c2 437 438 +61c3 61c4 436 4c6 +61e2 61c3 436 437 +61c4 61c5 435 4c5 +61e3 61c4 435 436 +61c5 61c6 434 4c4 +61e4 61c5 434 435 +61c6 61c7 433 4c3 +61e5 61c6 433 434 +61c7 61c8 432 4c2 +61e6 61c7 432 433 +61e7 61c8 431 432 +61c9 61ca 3bf 44f +61e8 61c9 3bf 3c0 +61ca 61cb 3be 44e +61e9 61ca 3be 3bf +61cb 61cc 3bd 44d +61ea 61cb 3bd 3be +61cc 61cd 3bc 44c +61eb 61cc 3bc 3bd +61cd 61ce 3bb 44b +61ec 61cd 3bb 3bc +61ce 61cf 3ba 44a +61ed 61ce 3ba 3bb +61cf 61d0 3b9 449 +61ee 61cf 3b9 3ba +61d0 61d1 3b8 448 +61ef 61d0 3b8 3b9 +61d1 61d2 3b7 447 +61f0 61d1 3b7 3b8 +61d2 61d3 3b6 446 +61f1 61d2 3b6 3b7 +61d3 61d4 3b5 445 +61f2 61d3 3b5 3b6 +61d4 61d5 3b4 444 +61f3 61d4 3b4 3b5 +61d5 61d6 3b3 443 +61f4 61d5 3b3 3b4 +61d6 61d7 3b2 442 +61f5 61d6 3b2 3b3 +61d7 61d8 3b1 441 +61f6 61d7 3b1 3b2 +61d8 61d9 3b0 440 +61f7 61d8 3b0 3b1 +61d9 61da 3af 43f +61f8 61d9 3af 3b0 +61da 61db 3ae 43e +61f9 61da 3ae 3af +61db 61dc 3ad 43d +61fa 61db 3ad 3ae +61dc 61dd 3ac 43c +61fb 61dc 3ac 3ad +61dd 61de 3ab 43b +61fc 61dd 3ab 3ac +61de 61df 3aa 43a +61fd 61de 3aa 3ab +61df 61e0 3a9 439 +61fe 61df 3a9 3aa +61e0 61e1 3a8 438 +61ff 61e0 3a8 3a9 +61e1 61e2 3a7 437 +6200 61e1 3a7 3a8 +61e2 61e3 3a6 436 +6201 61e2 3a6 3a7 +61e3 61e4 3a5 435 +6202 61e3 3a5 3a6 +61e4 61e5 3a4 434 +6203 61e4 3a4 3a5 +61e5 61e6 3a3 433 +6204 61e5 3a3 3a4 +61e6 61e7 3a2 432 +6205 61e6 3a2 3a3 +6206 61e7 3a1 3a2 +61e8 61e9 32f 3bf +6207 61e8 32f 330 +61e9 61ea 32e 3be +6208 61e9 32e 32f +61ea 61eb 32d 3bd +6209 61ea 32d 32e +61eb 61ec 32c 3bc +620a 61eb 32c 32d +61ec 61ed 32b 3bb +620b 61ec 32b 32c +61ed 61ee 32a 3ba +620c 61ed 32a 32b +61ee 61ef 329 3b9 +620d 61ee 329 32a +61ef 61f0 328 3b8 +620e 61ef 328 329 +61f0 61f1 327 3b7 +620f 61f0 327 328 +61f1 61f2 326 3b6 +6210 61f1 326 327 +61f2 61f3 325 3b5 +6211 61f2 325 326 +61f3 61f4 324 3b4 +6212 61f3 324 325 +61f4 61f5 323 3b3 +6213 61f4 323 324 +61f5 61f6 322 3b2 +6214 61f5 322 323 +61f6 61f7 321 3b1 +6215 61f6 321 322 +61f7 61f8 320 3b0 +6216 61f7 320 321 +61f8 61f9 31f 3af +6217 61f8 31f 320 +61f9 61fa 31e 3ae +6218 61f9 31e 31f +61fa 61fb 31d 3ad +6219 61fa 31d 31e +61fb 61fc 31c 3ac +621a 61fb 31c 31d +61fc 61fd 31b 3ab +621b 61fc 31b 31c +61fd 61fe 31a 3aa +621c 61fd 31a 31b +61fe 61ff 319 3a9 +621d 61fe 319 31a +61ff 6200 318 3a8 +621e 61ff 318 319 +6200 6201 317 3a7 +621f 6200 317 318 +6201 6202 316 3a6 +6220 6201 316 317 +6202 6203 315 3a5 +6221 6202 315 316 +6203 6204 314 3a4 +6222 6203 314 315 +6204 6205 313 3a3 +6223 6204 313 314 +6205 6206 312 3a2 +6224 6205 312 313 +6225 6206 311 312 +6207 6208 29f 32f +6226 6207 29f 2a0 +6208 6209 29e 32e +6227 6208 29e 29f +6209 620a 29d 32d +6228 6209 29d 29e +620a 620b 29c 32c +6229 620a 29c 29d +620b 620c 29b 32b +622a 620b 29b 29c +620c 620d 29a 32a +622b 620c 29a 29b +620d 620e 299 329 +622c 620d 299 29a +620e 620f 298 328 +622d 620e 298 299 +620f 6210 297 327 +622e 620f 297 298 +6210 6211 296 326 +622f 6210 296 297 +6211 6212 295 325 +6230 6211 295 296 +6212 6213 294 324 +6231 6212 294 295 +6213 6214 293 323 +6232 6213 293 294 +6214 6215 292 322 +6233 6214 292 293 +6215 6216 291 321 +6234 6215 291 292 +6216 6217 290 320 +6235 6216 290 291 +6217 6218 28f 31f +6236 6217 28f 290 +6218 6219 28e 31e +6237 6218 28e 28f +6219 621a 28d 31d +6238 6219 28d 28e +621a 621b 28c 31c +6239 621a 28c 28d +621b 621c 28b 31b +623a 621b 28b 28c +621c 621d 28a 31a +623b 621c 28a 28b +621d 621e 289 319 +623c 621d 289 28a +621e 621f 288 318 +623d 621e 288 289 +621f 6220 287 317 +623e 621f 287 288 +6220 6221 286 316 +623f 6220 286 287 +6221 6222 285 315 +6240 6221 285 286 +6222 6223 284 314 +6241 6222 284 285 +6223 6224 283 313 +6242 6223 283 284 +6224 6225 282 312 +6243 6224 282 283 +6244 6225 281 282 +6226 6227 20f 29f +6245 6226 20f 210 +6227 6228 20e 29e +6246 6227 20e 20f +6228 6229 20d 29d +6247 6228 20d 20e +6229 622a 20c 29c +6248 6229 20c 20d +622a 622b 20b 29b +6249 622a 20b 20c +622b 622c 20a 29a +624a 622b 20a 20b +622c 622d 209 299 +624b 622c 209 20a +622d 622e 208 298 +624c 622d 208 209 +622e 622f 207 297 +624d 622e 207 208 +622f 6230 206 296 +624e 622f 206 207 +6230 6231 205 295 +624f 6230 205 206 +6231 6232 204 294 +6250 6231 204 205 +6232 6233 203 293 +6251 6232 203 204 +6233 6234 202 292 +6252 6233 202 203 +6234 6235 201 291 +6253 6234 201 202 +6235 6236 200 290 +6254 6235 200 201 +6236 6237 1ff 28f +6255 6236 1ff 200 +6237 6238 1fe 28e +6256 6237 1fe 1ff +6238 6239 1fd 28d +6257 6238 1fd 1fe +6239 623a 1fc 28c +6258 6239 1fc 1fd +623a 623b 1fb 28b +6259 623a 1fb 1fc +623b 623c 1fa 28a +625a 623b 1fa 1fb +623c 623d 1f9 289 +625b 623c 1f9 1fa +623d 623e 1f8 288 +625c 623d 1f8 1f9 +623e 623f 1f7 287 +625d 623e 1f7 1f8 +623f 6240 1f6 286 +625e 623f 1f6 1f7 +6240 6241 1f5 285 +625f 6240 1f5 1f6 +6241 6242 1f4 284 +6260 6241 1f4 1f5 +6242 6243 1f3 283 +6261 6242 1f3 1f4 +6243 6244 1f2 282 +6262 6243 1f2 1f3 +6263 6244 1f1 1f2 +6245 6246 17f 20f +6264 6245 17f 180 +6246 6247 17e 20e +6265 6246 17e 17f +6247 6248 17d 20d +6266 6247 17d 17e +6248 6249 17c 20c +6267 6248 17c 17d +6249 624a 17b 20b +6268 6249 17b 17c +624a 624b 17a 20a +6269 624a 17a 17b +624b 624c 179 209 +626a 624b 179 17a +624c 624d 178 208 +626b 624c 178 179 +624d 624e 177 207 +626c 624d 177 178 +624e 624f 176 206 +626d 624e 176 177 +624f 6250 175 205 +626e 624f 175 176 +6250 6251 174 204 +626f 6250 174 175 +6251 6252 173 203 +6270 6251 173 174 +6252 6253 172 202 +6271 6252 172 173 +6253 6254 171 201 +6272 6253 171 172 +6254 6255 170 200 +6273 6254 170 171 +6255 6256 16f 1ff +6274 6255 16f 170 +6256 6257 16e 1fe +6275 6256 16e 16f +6257 6258 16d 1fd +6276 6257 16d 16e +6258 6259 16c 1fc +6277 6258 16c 16d +6259 625a 16b 1fb +6278 6259 16b 16c +625a 625b 16a 1fa +6279 625a 16a 16b +625b 625c 169 1f9 +627a 625b 169 16a +625c 625d 168 1f8 +627b 625c 168 169 +625d 625e 167 1f7 +627c 625d 167 168 +625e 625f 166 1f6 +627d 625e 166 167 +625f 6260 165 1f5 +627e 625f 165 166 +6260 6261 164 1f4 +627f 6260 164 165 +6261 6262 163 1f3 +6280 6261 163 164 +6262 6263 162 1f2 +6281 6262 162 163 +6282 6263 161 162 +6264 6265 ef 17f +6283 6264 ef f0 +6265 6266 ee 17e +6284 6265 ee ef +6266 6267 ed 17d +6285 6266 ed ee +6267 6268 ec 17c +6286 6267 ec ed +6268 6269 eb 17b +6287 6268 eb ec +6269 626a ea 17a +6288 6269 ea eb +626a 626b e9 179 +6289 626a e9 ea +626b 626c e8 178 +628a 626b e8 e9 +626c 626d e7 177 +628b 626c e7 e8 +626d 626e e6 176 +628c 626d e6 e7 +626e 626f e5 175 +628d 626e e5 e6 +626f 6270 e4 174 +628e 626f e4 e5 +6270 6271 e3 173 +628f 6270 e3 e4 +6271 6272 e2 172 +6290 6271 e2 e3 +6272 6273 e1 171 +6291 6272 e1 e2 +6273 6274 e0 170 +6292 6273 e0 e1 +6274 6275 df 16f +6293 6274 df e0 +6275 6276 de 16e +6294 6275 de df +6276 6277 dd 16d +6295 6276 dd de +6277 6278 dc 16c +6296 6277 dc dd +6278 6279 db 16b +6297 6278 db dc +6279 627a da 16a +6298 6279 da db +627a 627b d9 169 +6299 627a d9 da +627b 627c d8 168 +629a 627b d8 d9 +627c 627d d7 167 +629b 627c d7 d8 +627d 627e d6 166 +629c 627d d6 d7 +627e 627f d5 165 +629d 627e d5 d6 +627f 6280 d4 164 +629e 627f d4 d5 +6280 6281 d3 163 +629f 6280 d3 d4 +6281 6282 d2 162 +62a0 6281 d2 d3 +62a1 6282 d1 d2 +6283 6284 5f ef +6284 6285 5e ee +6285 6286 5d ed +6286 6287 5c ec +6287 6288 5b eb +6288 6289 5a ea +6289 628a 59 e9 +628a 628b 58 e8 +628b 628c 57 e7 +628c 628d 56 e6 +628d 628e 55 e5 +628e 628f 54 e4 +628f 6290 53 e3 +6290 6291 52 e2 +6291 6292 51 e1 +6292 6293 50 e0 +6293 6294 4f df +6294 6295 4e de +6295 6296 4d dd +6296 6297 4c dc +6297 6298 4b db +6298 6299 4a da +6299 629a 49 d9 +629a 629b 48 d8 +629b 629c 47 d7 +629c 629d 46 d6 +629d 629e 45 d5 +629e 629f 44 d4 +629f 62a0 43 d3 +62a0 62a1 42 d2 +62a2 62a3 104f 10df +62d1 62a2 104f 1050 +62a3 62a4 104e 10de +62d2 62a3 104e 104f +62a4 62a5 104d 10dd +62d3 62a4 104d 104e +62a5 62a6 104c 10dc +62d4 62a5 104c 104d +62a6 62a7 104b 10db +62d5 62a6 104b 104c +62a7 62a8 104a 10da +62d6 62a7 104a 104b +62a8 62a9 1049 10d9 +62d7 62a8 1049 104a +62a9 62aa 1048 10d8 +62d8 62a9 1048 1049 +62aa 62ab 1047 10d7 +62d9 62aa 1047 1048 +62ab 62ac 1046 10d6 +62da 62ab 1046 1047 +62ac 62ad 1045 10d5 +62db 62ac 1045 1046 +62ad 62ae 1044 10d4 +62dc 62ad 1044 1045 +62ae 62af 1043 10d3 +62dd 62ae 1043 1044 +62af 62b0 1042 10d2 +62de 62af 1042 1043 +62b0 62b1 1041 10d1 +62df 62b0 1041 1042 +62b1 62b2 1040 10d0 +62e0 62b1 1040 1041 +62b2 62b3 103f 10cf +62e1 62b2 103f 1040 +62b3 62b4 103e 10ce +62e2 62b3 103e 103f +62b4 62b5 103d 10cd +62e3 62b4 103d 103e +62b5 62b6 103c 10cc +62e4 62b5 103c 103d +62b6 62b7 103b 10cb +62e5 62b6 103b 103c +62b7 62b8 103a 10ca +62e6 62b7 103a 103b +62b8 62b9 1039 10c9 +62e7 62b8 1039 103a +62b9 62ba 1038 10c8 +62e8 62b9 1038 1039 +62ba 62bb 1037 10c7 +62e9 62ba 1037 1038 +62bb 62bc 1036 10c6 +62ea 62bb 1036 1037 +62bc 62bd 1035 10c5 +62eb 62bc 1035 1036 +62bd 62be 1034 10c4 +62ec 62bd 1034 1035 +62be 62bf 1033 10c3 +62ed 62be 1033 1034 +62bf 62c0 1032 10c2 +62ee 62bf 1032 1033 +62c0 62c1 1031 10c1 +62ef 62c0 1031 1032 +62c1 62c2 1030 10c0 +62f0 62c1 1030 1031 +62c2 62c3 102f 10bf +62f1 62c2 102f 1030 +62c3 62c4 102e 10be +62f2 62c3 102e 102f +62c4 62c5 102d 10bd +62f3 62c4 102d 102e +62c5 62c6 102c 10bc +62f4 62c5 102c 102d +62c6 62c7 102b 10bb +62f5 62c6 102b 102c +62c7 62c8 102a 10ba +62f6 62c7 102a 102b +62c8 62c9 1029 10b9 +62f7 62c8 1029 102a +62c9 62ca 1028 10b8 +62f8 62c9 1028 1029 +62ca 62cb 1027 10b7 +62f9 62ca 1027 1028 +62cb 62cc 1026 10b6 +62fa 62cb 1026 1027 +62cc 62cd 1025 10b5 +62fb 62cc 1025 1026 +62cd 62ce 1024 10b4 +62fc 62cd 1024 1025 +62ce 62cf 1023 10b3 +62fd 62ce 1023 1024 +62cf 62d0 1022 10b2 +62fe 62cf 1022 1023 +62ff 62d0 1021 1022 +62d1 62d2 fbf 104f +6300 62d1 fbf fc0 +62d2 62d3 fbe 104e +6301 62d2 fbe fbf +62d3 62d4 fbd 104d +6302 62d3 fbd fbe +62d4 62d5 fbc 104c +6303 62d4 fbc fbd +62d5 62d6 fbb 104b +6304 62d5 fbb fbc +62d6 62d7 fba 104a +6305 62d6 fba fbb +62d7 62d8 fb9 1049 +6306 62d7 fb9 fba +62d8 62d9 fb8 1048 +6307 62d8 fb8 fb9 +62d9 62da fb7 1047 +6308 62d9 fb7 fb8 +62da 62db fb6 1046 +6309 62da fb6 fb7 +62db 62dc fb5 1045 +630a 62db fb5 fb6 +62dc 62dd fb4 1044 +630b 62dc fb4 fb5 +62dd 62de fb3 1043 +630c 62dd fb3 fb4 +62de 62df fb2 1042 +630d 62de fb2 fb3 +62df 62e0 fb1 1041 +630e 62df fb1 fb2 +62e0 62e1 fb0 1040 +630f 62e0 fb0 fb1 +62e1 62e2 faf 103f +6310 62e1 faf fb0 +62e2 62e3 fae 103e +6311 62e2 fae faf +62e3 62e4 fad 103d +6312 62e3 fad fae +62e4 62e5 fac 103c +6313 62e4 fac fad +62e5 62e6 fab 103b +6314 62e5 fab fac +62e6 62e7 faa 103a +6315 62e6 faa fab +62e7 62e8 fa9 1039 +6316 62e7 fa9 faa +62e8 62e9 fa8 1038 +6317 62e8 fa8 fa9 +62e9 62ea fa7 1037 +6318 62e9 fa7 fa8 +62ea 62eb fa6 1036 +6319 62ea fa6 fa7 +62eb 62ec fa5 1035 +631a 62eb fa5 fa6 +62ec 62ed fa4 1034 +631b 62ec fa4 fa5 +62ed 62ee fa3 1033 +631c 62ed fa3 fa4 +62ee 62ef fa2 1032 +631d 62ee fa2 fa3 +62ef 62f0 fa1 1031 +631e 62ef fa1 fa2 +62f0 62f1 fa0 1030 +631f 62f0 fa0 fa1 +62f1 62f2 f9f 102f +6320 62f1 f9f fa0 +62f2 62f3 f9e 102e +6321 62f2 f9e f9f +62f3 62f4 f9d 102d +6322 62f3 f9d f9e +62f4 62f5 f9c 102c +6323 62f4 f9c f9d +62f5 62f6 f9b 102b +6324 62f5 f9b f9c +62f6 62f7 f9a 102a +6325 62f6 f9a f9b +62f7 62f8 f99 1029 +6326 62f7 f99 f9a +62f8 62f9 f98 1028 +6327 62f8 f98 f99 +62f9 62fa f97 1027 +6328 62f9 f97 f98 +62fa 62fb f96 1026 +6329 62fa f96 f97 +62fb 62fc f95 1025 +632a 62fb f95 f96 +62fc 62fd f94 1024 +632b 62fc f94 f95 +62fd 62fe f93 1023 +632c 62fd f93 f94 +62fe 62ff f92 1022 +632d 62fe f92 f93 +632e 62ff f91 f92 +6300 6301 f2f fbf +632f 6300 f2f f30 +6301 6302 f2e fbe +6330 6301 f2e f2f +6302 6303 f2d fbd +6331 6302 f2d f2e +6303 6304 f2c fbc +6332 6303 f2c f2d +6304 6305 f2b fbb +6333 6304 f2b f2c +6305 6306 f2a fba +6334 6305 f2a f2b +6306 6307 f29 fb9 +6335 6306 f29 f2a +6307 6308 f28 fb8 +6336 6307 f28 f29 +6308 6309 f27 fb7 +6337 6308 f27 f28 +6309 630a f26 fb6 +6338 6309 f26 f27 +630a 630b f25 fb5 +6339 630a f25 f26 +630b 630c f24 fb4 +633a 630b f24 f25 +630c 630d f23 fb3 +633b 630c f23 f24 +630d 630e f22 fb2 +633c 630d f22 f23 +630e 630f f21 fb1 +633d 630e f21 f22 +630f 6310 f20 fb0 +633e 630f f20 f21 +6310 6311 f1f faf +633f 6310 f1f f20 +6311 6312 f1e fae +6340 6311 f1e f1f +6312 6313 f1d fad +6341 6312 f1d f1e +6313 6314 f1c fac +6342 6313 f1c f1d +6314 6315 f1b fab +6343 6314 f1b f1c +6315 6316 f1a faa +6344 6315 f1a f1b +6316 6317 f19 fa9 +6345 6316 f19 f1a +6317 6318 f18 fa8 +6346 6317 f18 f19 +6318 6319 f17 fa7 +6347 6318 f17 f18 +6319 631a f16 fa6 +6348 6319 f16 f17 +631a 631b f15 fa5 +6349 631a f15 f16 +631b 631c f14 fa4 +634a 631b f14 f15 +631c 631d f13 fa3 +634b 631c f13 f14 +631d 631e f12 fa2 +634c 631d f12 f13 +631e 631f f11 fa1 +634d 631e f11 f12 +631f 6320 f10 fa0 +634e 631f f10 f11 +6320 6321 f0f f9f +634f 6320 f0f f10 +6321 6322 f0e f9e +6350 6321 f0e f0f +6322 6323 f0d f9d +6351 6322 f0d f0e +6323 6324 f0c f9c +6352 6323 f0c f0d +6324 6325 f0b f9b +6353 6324 f0b f0c +6325 6326 f0a f9a +6354 6325 f0a f0b +6326 6327 f09 f99 +6355 6326 f09 f0a +6327 6328 f08 f98 +6356 6327 f08 f09 +6328 6329 f07 f97 +6357 6328 f07 f08 +6329 632a f06 f96 +6358 6329 f06 f07 +632a 632b f05 f95 +6359 632a f05 f06 +632b 632c f04 f94 +635a 632b f04 f05 +632c 632d f03 f93 +635b 632c f03 f04 +632d 632e f02 f92 +635c 632d f02 f03 +635d 632e f01 f02 +632f 6330 e9f f2f +635e 632f e9f ea0 +6330 6331 e9e f2e +635f 6330 e9e e9f +6331 6332 e9d f2d +6360 6331 e9d e9e +6332 6333 e9c f2c +6361 6332 e9c e9d +6333 6334 e9b f2b +6362 6333 e9b e9c +6334 6335 e9a f2a +6363 6334 e9a e9b +6335 6336 e99 f29 +6364 6335 e99 e9a +6336 6337 e98 f28 +6365 6336 e98 e99 +6337 6338 e97 f27 +6366 6337 e97 e98 +6338 6339 e96 f26 +6367 6338 e96 e97 +6339 633a e95 f25 +6368 6339 e95 e96 +633a 633b e94 f24 +6369 633a e94 e95 +633b 633c e93 f23 +636a 633b e93 e94 +633c 633d e92 f22 +636b 633c e92 e93 +633d 633e e91 f21 +636c 633d e91 e92 +633e 633f e90 f20 +636d 633e e90 e91 +633f 6340 e8f f1f +636e 633f e8f e90 +6340 6341 e8e f1e +636f 6340 e8e e8f +6341 6342 e8d f1d +6370 6341 e8d e8e +6342 6343 e8c f1c +6371 6342 e8c e8d +6343 6344 e8b f1b +6372 6343 e8b e8c +6344 6345 e8a f1a +6373 6344 e8a e8b +6345 6346 e89 f19 +6374 6345 e89 e8a +6346 6347 e88 f18 +6375 6346 e88 e89 +6347 6348 e87 f17 +6376 6347 e87 e88 +6348 6349 e86 f16 +6377 6348 e86 e87 +6349 634a e85 f15 +6378 6349 e85 e86 +634a 634b e84 f14 +6379 634a e84 e85 +634b 634c e83 f13 +637a 634b e83 e84 +634c 634d e82 f12 +637b 634c e82 e83 +634d 634e e81 f11 +637c 634d e81 e82 +634e 634f e80 f10 +637d 634e e80 e81 +634f 6350 e7f f0f +637e 634f e7f e80 +6350 6351 e7e f0e +637f 6350 e7e e7f +6351 6352 e7d f0d +6380 6351 e7d e7e +6352 6353 e7c f0c +6381 6352 e7c e7d +6353 6354 e7b f0b +6382 6353 e7b e7c +6354 6355 e7a f0a +6383 6354 e7a e7b +6355 6356 e79 f09 +6384 6355 e79 e7a +6356 6357 e78 f08 +6385 6356 e78 e79 +6357 6358 e77 f07 +6386 6357 e77 e78 +6358 6359 e76 f06 +6387 6358 e76 e77 +6359 635a e75 f05 +6388 6359 e75 e76 +635a 635b e74 f04 +6389 635a e74 e75 +635b 635c e73 f03 +638a 635b e73 e74 +635c 635d e72 f02 +638b 635c e72 e73 +638c 635d e71 e72 +635e 635f e0f e9f +638d 635e e0f e10 +635f 6360 e0e e9e +638e 635f e0e e0f +6360 6361 e0d e9d +638f 6360 e0d e0e +6361 6362 e0c e9c +6390 6361 e0c e0d +6362 6363 e0b e9b +6391 6362 e0b e0c +6363 6364 e0a e9a +6392 6363 e0a e0b +6364 6365 e09 e99 +6393 6364 e09 e0a +6365 6366 e08 e98 +6394 6365 e08 e09 +6366 6367 e07 e97 +6395 6366 e07 e08 +6367 6368 e06 e96 +6396 6367 e06 e07 +6368 6369 e05 e95 +6397 6368 e05 e06 +6369 636a e04 e94 +6398 6369 e04 e05 +636a 636b e03 e93 +6399 636a e03 e04 +636b 636c e02 e92 +639a 636b e02 e03 +636c 636d e01 e91 +639b 636c e01 e02 +636d 636e e00 e90 +639c 636d e00 e01 +636e 636f dff e8f +639d 636e dff e00 +636f 6370 dfe e8e +639e 636f dfe dff +6370 6371 dfd e8d +639f 6370 dfd dfe +6371 6372 dfc e8c +63a0 6371 dfc dfd +6372 6373 dfb e8b +63a1 6372 dfb dfc +6373 6374 dfa e8a +63a2 6373 dfa dfb +6374 6375 df9 e89 +63a3 6374 df9 dfa +6375 6376 df8 e88 +63a4 6375 df8 df9 +6376 6377 df7 e87 +63a5 6376 df7 df8 +6377 6378 df6 e86 +63a6 6377 df6 df7 +6378 6379 df5 e85 +63a7 6378 df5 df6 +6379 637a df4 e84 +63a8 6379 df4 df5 +637a 637b df3 e83 +63a9 637a df3 df4 +637b 637c df2 e82 +63aa 637b df2 df3 +637c 637d df1 e81 +63ab 637c df1 df2 +637d 637e df0 e80 +63ac 637d df0 df1 +637e 637f def e7f +63ad 637e def df0 +637f 6380 dee e7e +63ae 637f dee def +6380 6381 ded e7d +63af 6380 ded dee +6381 6382 dec e7c +63b0 6381 dec ded +6382 6383 deb e7b +63b1 6382 deb dec +6383 6384 dea e7a +63b2 6383 dea deb +6384 6385 de9 e79 +63b3 6384 de9 dea +6385 6386 de8 e78 +63b4 6385 de8 de9 +6386 6387 de7 e77 +63b5 6386 de7 de8 +6387 6388 de6 e76 +63b6 6387 de6 de7 +6388 6389 de5 e75 +63b7 6388 de5 de6 +6389 638a de4 e74 +63b8 6389 de4 de5 +638a 638b de3 e73 +63b9 638a de3 de4 +638b 638c de2 e72 +63ba 638b de2 de3 +63bb 638c de1 de2 +638d 638e d7f e0f +63bc 638d d7f d80 +638e 638f d7e e0e +63bd 638e d7e d7f +638f 6390 d7d e0d +63be 638f d7d d7e +6390 6391 d7c e0c +63bf 6390 d7c d7d +6391 6392 d7b e0b +63c0 6391 d7b d7c +6392 6393 d7a e0a +63c1 6392 d7a d7b +6393 6394 d79 e09 +63c2 6393 d79 d7a +6394 6395 d78 e08 +63c3 6394 d78 d79 +6395 6396 d77 e07 +63c4 6395 d77 d78 +6396 6397 d76 e06 +63c5 6396 d76 d77 +6397 6398 d75 e05 +63c6 6397 d75 d76 +6398 6399 d74 e04 +63c7 6398 d74 d75 +6399 639a d73 e03 +63c8 6399 d73 d74 +639a 639b d72 e02 +63c9 639a d72 d73 +639b 639c d71 e01 +63ca 639b d71 d72 +639c 639d d70 e00 +63cb 639c d70 d71 +639d 639e d6f dff +63cc 639d d6f d70 +639e 639f d6e dfe +63cd 639e d6e d6f +639f 63a0 d6d dfd +63ce 639f d6d d6e +63a0 63a1 d6c dfc +63cf 63a0 d6c d6d +63a1 63a2 d6b dfb +63d0 63a1 d6b d6c +63a2 63a3 d6a dfa +63d1 63a2 d6a d6b +63a3 63a4 d69 df9 +63d2 63a3 d69 d6a +63a4 63a5 d68 df8 +63d3 63a4 d68 d69 +63a5 63a6 d67 df7 +63d4 63a5 d67 d68 +63a6 63a7 d66 df6 +63d5 63a6 d66 d67 +63a7 63a8 d65 df5 +63d6 63a7 d65 d66 +63a8 63a9 d64 df4 +63d7 63a8 d64 d65 +63a9 63aa d63 df3 +63d8 63a9 d63 d64 +63aa 63ab d62 df2 +63d9 63aa d62 d63 +63ab 63ac d61 df1 +63da 63ab d61 d62 +63ac 63ad d60 df0 +63db 63ac d60 d61 +63ad 63ae d5f def +63dc 63ad d5f d60 +63ae 63af d5e dee +63dd 63ae d5e d5f +63af 63b0 d5d ded +63de 63af d5d d5e +63b0 63b1 d5c dec +63df 63b0 d5c d5d +63b1 63b2 d5b deb +63e0 63b1 d5b d5c +63b2 63b3 d5a dea +63e1 63b2 d5a d5b +63b3 63b4 d59 de9 +63e2 63b3 d59 d5a +63b4 63b5 d58 de8 +63e3 63b4 d58 d59 +63b5 63b6 d57 de7 +63e4 63b5 d57 d58 +63b6 63b7 d56 de6 +63e5 63b6 d56 d57 +63b7 63b8 d55 de5 +63e6 63b7 d55 d56 +63b8 63b9 d54 de4 +63e7 63b8 d54 d55 +63b9 63ba d53 de3 +63e8 63b9 d53 d54 +63ba 63bb d52 de2 +63e9 63ba d52 d53 +63ea 63bb d51 d52 +63bc 63bd cef d7f +63eb 63bc cef cf0 +63bd 63be cee d7e +63ec 63bd cee cef +63be 63bf ced d7d +63ed 63be ced cee +63bf 63c0 cec d7c +63ee 63bf cec ced +63c0 63c1 ceb d7b +63ef 63c0 ceb cec +63c1 63c2 cea d7a +63f0 63c1 cea ceb +63c2 63c3 ce9 d79 +63f1 63c2 ce9 cea +63c3 63c4 ce8 d78 +63f2 63c3 ce8 ce9 +63c4 63c5 ce7 d77 +63f3 63c4 ce7 ce8 +63c5 63c6 ce6 d76 +63f4 63c5 ce6 ce7 +63c6 63c7 ce5 d75 +63f5 63c6 ce5 ce6 +63c7 63c8 ce4 d74 +63f6 63c7 ce4 ce5 +63c8 63c9 ce3 d73 +63f7 63c8 ce3 ce4 +63c9 63ca ce2 d72 +63f8 63c9 ce2 ce3 +63ca 63cb ce1 d71 +63f9 63ca ce1 ce2 +63cb 63cc ce0 d70 +63fa 63cb ce0 ce1 +63cc 63cd cdf d6f +63fb 63cc cdf ce0 +63cd 63ce cde d6e +63fc 63cd cde cdf +63ce 63cf cdd d6d +63fd 63ce cdd cde +63cf 63d0 cdc d6c +63fe 63cf cdc cdd +63d0 63d1 cdb d6b +63ff 63d0 cdb cdc +63d1 63d2 cda d6a +6400 63d1 cda cdb +63d2 63d3 cd9 d69 +6401 63d2 cd9 cda +63d3 63d4 cd8 d68 +6402 63d3 cd8 cd9 +63d4 63d5 cd7 d67 +6403 63d4 cd7 cd8 +63d5 63d6 cd6 d66 +6404 63d5 cd6 cd7 +63d6 63d7 cd5 d65 +6405 63d6 cd5 cd6 +63d7 63d8 cd4 d64 +6406 63d7 cd4 cd5 +63d8 63d9 cd3 d63 +6407 63d8 cd3 cd4 +63d9 63da cd2 d62 +6408 63d9 cd2 cd3 +63da 63db cd1 d61 +6409 63da cd1 cd2 +63db 63dc cd0 d60 +640a 63db cd0 cd1 +63dc 63dd ccf d5f +640b 63dc ccf cd0 +63dd 63de cce d5e +640c 63dd cce ccf +63de 63df ccd d5d +640d 63de ccd cce +63df 63e0 ccc d5c +640e 63df ccc ccd +63e0 63e1 ccb d5b +640f 63e0 ccb ccc +63e1 63e2 cca d5a +6410 63e1 cca ccb +63e2 63e3 cc9 d59 +6411 63e2 cc9 cca +63e3 63e4 cc8 d58 +6412 63e3 cc8 cc9 +63e4 63e5 cc7 d57 +6413 63e4 cc7 cc8 +63e5 63e6 cc6 d56 +6414 63e5 cc6 cc7 +63e6 63e7 cc5 d55 +6415 63e6 cc5 cc6 +63e7 63e8 cc4 d54 +6416 63e7 cc4 cc5 +63e8 63e9 cc3 d53 +6417 63e8 cc3 cc4 +63e9 63ea cc2 d52 +6418 63e9 cc2 cc3 +6419 63ea cc1 cc2 +63eb 63ec c5f cef +641a 63eb c5f c60 +63ec 63ed c5e cee +641b 63ec c5e c5f +63ed 63ee c5d ced +641c 63ed c5d c5e +63ee 63ef c5c cec +641d 63ee c5c c5d +63ef 63f0 c5b ceb +641e 63ef c5b c5c +63f0 63f1 c5a cea +641f 63f0 c5a c5b +63f1 63f2 c59 ce9 +6420 63f1 c59 c5a +63f2 63f3 c58 ce8 +6421 63f2 c58 c59 +63f3 63f4 c57 ce7 +6422 63f3 c57 c58 +63f4 63f5 c56 ce6 +6423 63f4 c56 c57 +63f5 63f6 c55 ce5 +6424 63f5 c55 c56 +63f6 63f7 c54 ce4 +6425 63f6 c54 c55 +63f7 63f8 c53 ce3 +6426 63f7 c53 c54 +63f8 63f9 c52 ce2 +6427 63f8 c52 c53 +63f9 63fa c51 ce1 +6428 63f9 c51 c52 +63fa 63fb c50 ce0 +6429 63fa c50 c51 +63fb 63fc c4f cdf +642a 63fb c4f c50 +63fc 63fd c4e cde +642b 63fc c4e c4f +63fd 63fe c4d cdd +642c 63fd c4d c4e +63fe 63ff c4c cdc +642d 63fe c4c c4d +63ff 6400 c4b cdb +642e 63ff c4b c4c +6400 6401 c4a cda +642f 6400 c4a c4b +6401 6402 c49 cd9 +6430 6401 c49 c4a +6402 6403 c48 cd8 +6431 6402 c48 c49 +6403 6404 c47 cd7 +6432 6403 c47 c48 +6404 6405 c46 cd6 +6433 6404 c46 c47 +6405 6406 c45 cd5 +6434 6405 c45 c46 +6406 6407 c44 cd4 +6435 6406 c44 c45 +6407 6408 c43 cd3 +6436 6407 c43 c44 +6408 6409 c42 cd2 +6437 6408 c42 c43 +6409 640a c41 cd1 +6438 6409 c41 c42 +640a 640b c40 cd0 +6439 640a c40 c41 +640b 640c c3f ccf +643a 640b c3f c40 +640c 640d c3e cce +643b 640c c3e c3f +640d 640e c3d ccd +643c 640d c3d c3e +640e 640f c3c ccc +643d 640e c3c c3d +640f 6410 c3b ccb +643e 640f c3b c3c +6410 6411 c3a cca +643f 6410 c3a c3b +6411 6412 c39 cc9 +6440 6411 c39 c3a +6412 6413 c38 cc8 +6441 6412 c38 c39 +6413 6414 c37 cc7 +6442 6413 c37 c38 +6414 6415 c36 cc6 +6443 6414 c36 c37 +6415 6416 c35 cc5 +6444 6415 c35 c36 +6416 6417 c34 cc4 +6445 6416 c34 c35 +6417 6418 c33 cc3 +6446 6417 c33 c34 +6418 6419 c32 cc2 +6447 6418 c32 c33 +6448 6419 c31 c32 +641a 641b bcf c5f +6449 641a bcf bd0 +641b 641c bce c5e +644a 641b bce bcf +641c 641d bcd c5d +644b 641c bcd bce +641d 641e bcc c5c +644c 641d bcc bcd +641e 641f bcb c5b +644d 641e bcb bcc +641f 6420 bca c5a +644e 641f bca bcb +6420 6421 bc9 c59 +644f 6420 bc9 bca +6421 6422 bc8 c58 +6450 6421 bc8 bc9 +6422 6423 bc7 c57 +6451 6422 bc7 bc8 +6423 6424 bc6 c56 +6452 6423 bc6 bc7 +6424 6425 bc5 c55 +6453 6424 bc5 bc6 +6425 6426 bc4 c54 +6454 6425 bc4 bc5 +6426 6427 bc3 c53 +6455 6426 bc3 bc4 +6427 6428 bc2 c52 +6456 6427 bc2 bc3 +6428 6429 bc1 c51 +6457 6428 bc1 bc2 +6429 642a bc0 c50 +6458 6429 bc0 bc1 +642a 642b bbf c4f +6459 642a bbf bc0 +642b 642c bbe c4e +645a 642b bbe bbf +642c 642d bbd c4d +645b 642c bbd bbe +642d 642e bbc c4c +645c 642d bbc bbd +642e 642f bbb c4b +645d 642e bbb bbc +642f 6430 bba c4a +645e 642f bba bbb +6430 6431 bb9 c49 +645f 6430 bb9 bba +6431 6432 bb8 c48 +6460 6431 bb8 bb9 +6432 6433 bb7 c47 +6461 6432 bb7 bb8 +6433 6434 bb6 c46 +6462 6433 bb6 bb7 +6434 6435 bb5 c45 +6463 6434 bb5 bb6 +6435 6436 bb4 c44 +6464 6435 bb4 bb5 +6436 6437 bb3 c43 +6465 6436 bb3 bb4 +6437 6438 bb2 c42 +6466 6437 bb2 bb3 +6438 6439 bb1 c41 +6467 6438 bb1 bb2 +6439 643a bb0 c40 +6468 6439 bb0 bb1 +643a 643b baf c3f +6469 643a baf bb0 +643b 643c bae c3e +646a 643b bae baf +643c 643d bad c3d +646b 643c bad bae +643d 643e bac c3c +646c 643d bac bad +643e 643f bab c3b +646d 643e bab bac +643f 6440 baa c3a +646e 643f baa bab +6440 6441 ba9 c39 +646f 6440 ba9 baa +6441 6442 ba8 c38 +6470 6441 ba8 ba9 +6442 6443 ba7 c37 +6471 6442 ba7 ba8 +6443 6444 ba6 c36 +6472 6443 ba6 ba7 +6444 6445 ba5 c35 +6473 6444 ba5 ba6 +6445 6446 ba4 c34 +6474 6445 ba4 ba5 +6446 6447 ba3 c33 +6475 6446 ba3 ba4 +6447 6448 ba2 c32 +6476 6447 ba2 ba3 +6477 6448 ba1 ba2 +6449 644a b3f bcf +6478 6449 b3f b40 +644a 644b b3e bce +6479 644a b3e b3f +644b 644c b3d bcd +647a 644b b3d b3e +644c 644d b3c bcc +647b 644c b3c b3d +644d 644e b3b bcb +647c 644d b3b b3c +644e 644f b3a bca +647d 644e b3a b3b +644f 6450 b39 bc9 +647e 644f b39 b3a +6450 6451 b38 bc8 +647f 6450 b38 b39 +6451 6452 b37 bc7 +6480 6451 b37 b38 +6452 6453 b36 bc6 +6481 6452 b36 b37 +6453 6454 b35 bc5 +6482 6453 b35 b36 +6454 6455 b34 bc4 +6483 6454 b34 b35 +6455 6456 b33 bc3 +6484 6455 b33 b34 +6456 6457 b32 bc2 +6485 6456 b32 b33 +6457 6458 b31 bc1 +6486 6457 b31 b32 +6458 6459 b30 bc0 +6487 6458 b30 b31 +6459 645a b2f bbf +6488 6459 b2f b30 +645a 645b b2e bbe +6489 645a b2e b2f +645b 645c b2d bbd +648a 645b b2d b2e +645c 645d b2c bbc +648b 645c b2c b2d +645d 645e b2b bbb +648c 645d b2b b2c +645e 645f b2a bba +648d 645e b2a b2b +645f 6460 b29 bb9 +648e 645f b29 b2a +6460 6461 b28 bb8 +648f 6460 b28 b29 +6461 6462 b27 bb7 +6490 6461 b27 b28 +6462 6463 b26 bb6 +6491 6462 b26 b27 +6463 6464 b25 bb5 +6492 6463 b25 b26 +6464 6465 b24 bb4 +6493 6464 b24 b25 +6465 6466 b23 bb3 +6494 6465 b23 b24 +6466 6467 b22 bb2 +6495 6466 b22 b23 +6467 6468 b21 bb1 +6496 6467 b21 b22 +6468 6469 b20 bb0 +6497 6468 b20 b21 +6469 646a b1f baf +6498 6469 b1f b20 +646a 646b b1e bae +6499 646a b1e b1f +646b 646c b1d bad +649a 646b b1d b1e +646c 646d b1c bac +649b 646c b1c b1d +646d 646e b1b bab +649c 646d b1b b1c +646e 646f b1a baa +649d 646e b1a b1b +646f 6470 b19 ba9 +649e 646f b19 b1a +6470 6471 b18 ba8 +649f 6470 b18 b19 +6471 6472 b17 ba7 +64a0 6471 b17 b18 +6472 6473 b16 ba6 +64a1 6472 b16 b17 +6473 6474 b15 ba5 +64a2 6473 b15 b16 +6474 6475 b14 ba4 +64a3 6474 b14 b15 +6475 6476 b13 ba3 +64a4 6475 b13 b14 +6476 6477 b12 ba2 +64a5 6476 b12 b13 +64a6 6477 b11 b12 +6478 6479 aaf b3f +64a7 6478 aaf ab0 +6479 647a aae b3e +64a8 6479 aae aaf +647a 647b aad b3d +64a9 647a aad aae +647b 647c aac b3c +64aa 647b aac aad +647c 647d aab b3b +64ab 647c aab aac +647d 647e aaa b3a +64ac 647d aaa aab +647e 647f aa9 b39 +64ad 647e aa9 aaa +647f 6480 aa8 b38 +64ae 647f aa8 aa9 +6480 6481 aa7 b37 +64af 6480 aa7 aa8 +6481 6482 aa6 b36 +64b0 6481 aa6 aa7 +6482 6483 aa5 b35 +64b1 6482 aa5 aa6 +6483 6484 aa4 b34 +64b2 6483 aa4 aa5 +6484 6485 aa3 b33 +64b3 6484 aa3 aa4 +6485 6486 aa2 b32 +64b4 6485 aa2 aa3 +6486 6487 aa1 b31 +64b5 6486 aa1 aa2 +6487 6488 aa0 b30 +64b6 6487 aa0 aa1 +6488 6489 a9f b2f +64b7 6488 a9f aa0 +6489 648a a9e b2e +64b8 6489 a9e a9f +648a 648b a9d b2d +64b9 648a a9d a9e +648b 648c a9c b2c +64ba 648b a9c a9d +648c 648d a9b b2b +64bb 648c a9b a9c +648d 648e a9a b2a +64bc 648d a9a a9b +648e 648f a99 b29 +64bd 648e a99 a9a +648f 6490 a98 b28 +64be 648f a98 a99 +6490 6491 a97 b27 +64bf 6490 a97 a98 +6491 6492 a96 b26 +64c0 6491 a96 a97 +6492 6493 a95 b25 +64c1 6492 a95 a96 +6493 6494 a94 b24 +64c2 6493 a94 a95 +6494 6495 a93 b23 +64c3 6494 a93 a94 +6495 6496 a92 b22 +64c4 6495 a92 a93 +6496 6497 a91 b21 +64c5 6496 a91 a92 +6497 6498 a90 b20 +64c6 6497 a90 a91 +6498 6499 a8f b1f +64c7 6498 a8f a90 +6499 649a a8e b1e +64c8 6499 a8e a8f +649a 649b a8d b1d +64c9 649a a8d a8e +649b 649c a8c b1c +64ca 649b a8c a8d +649c 649d a8b b1b +64cb 649c a8b a8c +649d 649e a8a b1a +64cc 649d a8a a8b +649e 649f a89 b19 +64cd 649e a89 a8a +649f 64a0 a88 b18 +64ce 649f a88 a89 +64a0 64a1 a87 b17 +64cf 64a0 a87 a88 +64a1 64a2 a86 b16 +64d0 64a1 a86 a87 +64a2 64a3 a85 b15 +64d1 64a2 a85 a86 +64a3 64a4 a84 b14 +64d2 64a3 a84 a85 +64a4 64a5 a83 b13 +64d3 64a4 a83 a84 +64a5 64a6 a82 b12 +64d4 64a5 a82 a83 +64d5 64a6 a81 a82 +64a7 64a8 a1f aaf +64d6 64a7 a1f a20 +64a8 64a9 a1e aae +64d7 64a8 a1e a1f +64a9 64aa a1d aad +64d8 64a9 a1d a1e +64aa 64ab a1c aac +64d9 64aa a1c a1d +64ab 64ac a1b aab +64da 64ab a1b a1c +64ac 64ad a1a aaa +64db 64ac a1a a1b +64ad 64ae a19 aa9 +64dc 64ad a19 a1a +64ae 64af a18 aa8 +64dd 64ae a18 a19 +64af 64b0 a17 aa7 +64de 64af a17 a18 +64b0 64b1 a16 aa6 +64df 64b0 a16 a17 +64b1 64b2 a15 aa5 +64e0 64b1 a15 a16 +64b2 64b3 a14 aa4 +64e1 64b2 a14 a15 +64b3 64b4 a13 aa3 +64e2 64b3 a13 a14 +64b4 64b5 a12 aa2 +64e3 64b4 a12 a13 +64b5 64b6 a11 aa1 +64e4 64b5 a11 a12 +64b6 64b7 a10 aa0 +64e5 64b6 a10 a11 +64b7 64b8 a0f a9f +64e6 64b7 a0f a10 +64b8 64b9 a0e a9e +64e7 64b8 a0e a0f +64b9 64ba a0d a9d +64e8 64b9 a0d a0e +64ba 64bb a0c a9c +64e9 64ba a0c a0d +64bb 64bc a0b a9b +64ea 64bb a0b a0c +64bc 64bd a0a a9a +64eb 64bc a0a a0b +64bd 64be a09 a99 +64ec 64bd a09 a0a +64be 64bf a08 a98 +64ed 64be a08 a09 +64bf 64c0 a07 a97 +64ee 64bf a07 a08 +64c0 64c1 a06 a96 +64ef 64c0 a06 a07 +64c1 64c2 a05 a95 +64f0 64c1 a05 a06 +64c2 64c3 a04 a94 +64f1 64c2 a04 a05 +64c3 64c4 a03 a93 +64f2 64c3 a03 a04 +64c4 64c5 a02 a92 +64f3 64c4 a02 a03 +64c5 64c6 a01 a91 +64f4 64c5 a01 a02 +64c6 64c7 a00 a90 +64f5 64c6 a00 a01 +64c7 64c8 9ff a8f +64f6 64c7 9ff a00 +64c8 64c9 9fe a8e +64f7 64c8 9fe 9ff +64c9 64ca 9fd a8d +64f8 64c9 9fd 9fe +64ca 64cb 9fc a8c +64f9 64ca 9fc 9fd +64cb 64cc 9fb a8b +64fa 64cb 9fb 9fc +64cc 64cd 9fa a8a +64fb 64cc 9fa 9fb +64cd 64ce 9f9 a89 +64fc 64cd 9f9 9fa +64ce 64cf 9f8 a88 +64fd 64ce 9f8 9f9 +64cf 64d0 9f7 a87 +64fe 64cf 9f7 9f8 +64d0 64d1 9f6 a86 +64ff 64d0 9f6 9f7 +64d1 64d2 9f5 a85 +6500 64d1 9f5 9f6 +64d2 64d3 9f4 a84 +6501 64d2 9f4 9f5 +64d3 64d4 9f3 a83 +6502 64d3 9f3 9f4 +64d4 64d5 9f2 a82 +6503 64d4 9f2 9f3 +6504 64d5 9f1 9f2 +64d6 64d7 98f a1f +6505 64d6 98f 990 +64d7 64d8 98e a1e +6506 64d7 98e 98f +64d8 64d9 98d a1d +6507 64d8 98d 98e +64d9 64da 98c a1c +6508 64d9 98c 98d +64da 64db 98b a1b +6509 64da 98b 98c +64db 64dc 98a a1a +650a 64db 98a 98b +64dc 64dd 989 a19 +650b 64dc 989 98a +64dd 64de 988 a18 +650c 64dd 988 989 +64de 64df 987 a17 +650d 64de 987 988 +64df 64e0 986 a16 +650e 64df 986 987 +64e0 64e1 985 a15 +650f 64e0 985 986 +64e1 64e2 984 a14 +6510 64e1 984 985 +64e2 64e3 983 a13 +6511 64e2 983 984 +64e3 64e4 982 a12 +6512 64e3 982 983 +64e4 64e5 981 a11 +6513 64e4 981 982 +64e5 64e6 980 a10 +6514 64e5 980 981 +64e6 64e7 97f a0f +6515 64e6 97f 980 +64e7 64e8 97e a0e +6516 64e7 97e 97f +64e8 64e9 97d a0d +6517 64e8 97d 97e +64e9 64ea 97c a0c +6518 64e9 97c 97d +64ea 64eb 97b a0b +6519 64ea 97b 97c +64eb 64ec 97a a0a +651a 64eb 97a 97b +64ec 64ed 979 a09 +651b 64ec 979 97a +64ed 64ee 978 a08 +651c 64ed 978 979 +64ee 64ef 977 a07 +651d 64ee 977 978 +64ef 64f0 976 a06 +651e 64ef 976 977 +64f0 64f1 975 a05 +651f 64f0 975 976 +64f1 64f2 974 a04 +6520 64f1 974 975 +64f2 64f3 973 a03 +6521 64f2 973 974 +64f3 64f4 972 a02 +6522 64f3 972 973 +64f4 64f5 971 a01 +6523 64f4 971 972 +64f5 64f6 970 a00 +6524 64f5 970 971 +64f6 64f7 96f 9ff +6525 64f6 96f 970 +64f7 64f8 96e 9fe +6526 64f7 96e 96f +64f8 64f9 96d 9fd +6527 64f8 96d 96e +64f9 64fa 96c 9fc +6528 64f9 96c 96d +64fa 64fb 96b 9fb +6529 64fa 96b 96c +64fb 64fc 96a 9fa +652a 64fb 96a 96b +64fc 64fd 969 9f9 +652b 64fc 969 96a +64fd 64fe 968 9f8 +652c 64fd 968 969 +64fe 64ff 967 9f7 +652d 64fe 967 968 +64ff 6500 966 9f6 +652e 64ff 966 967 +6500 6501 965 9f5 +652f 6500 965 966 +6501 6502 964 9f4 +6530 6501 964 965 +6502 6503 963 9f3 +6531 6502 963 964 +6503 6504 962 9f2 +6532 6503 962 963 +6533 6504 961 962 +6505 6506 8ff 98f +6534 6505 8ff 900 +6506 6507 8fe 98e +6535 6506 8fe 8ff +6507 6508 8fd 98d +6536 6507 8fd 8fe +6508 6509 8fc 98c +6537 6508 8fc 8fd +6509 650a 8fb 98b +6538 6509 8fb 8fc +650a 650b 8fa 98a +6539 650a 8fa 8fb +650b 650c 8f9 989 +653a 650b 8f9 8fa +650c 650d 8f8 988 +653b 650c 8f8 8f9 +650d 650e 8f7 987 +653c 650d 8f7 8f8 +650e 650f 8f6 986 +653d 650e 8f6 8f7 +650f 6510 8f5 985 +653e 650f 8f5 8f6 +6510 6511 8f4 984 +653f 6510 8f4 8f5 +6511 6512 8f3 983 +6540 6511 8f3 8f4 +6512 6513 8f2 982 +6541 6512 8f2 8f3 +6513 6514 8f1 981 +6542 6513 8f1 8f2 +6514 6515 8f0 980 +6543 6514 8f0 8f1 +6515 6516 8ef 97f +6544 6515 8ef 8f0 +6516 6517 8ee 97e +6545 6516 8ee 8ef +6517 6518 8ed 97d +6546 6517 8ed 8ee +6518 6519 8ec 97c +6547 6518 8ec 8ed +6519 651a 8eb 97b +6548 6519 8eb 8ec +651a 651b 8ea 97a +6549 651a 8ea 8eb +651b 651c 8e9 979 +654a 651b 8e9 8ea +651c 651d 8e8 978 +654b 651c 8e8 8e9 +651d 651e 8e7 977 +654c 651d 8e7 8e8 +651e 651f 8e6 976 +654d 651e 8e6 8e7 +651f 6520 8e5 975 +654e 651f 8e5 8e6 +6520 6521 8e4 974 +654f 6520 8e4 8e5 +6521 6522 8e3 973 +6550 6521 8e3 8e4 +6522 6523 8e2 972 +6551 6522 8e2 8e3 +6523 6524 8e1 971 +6552 6523 8e1 8e2 +6524 6525 8e0 970 +6553 6524 8e0 8e1 +6525 6526 8df 96f +6554 6525 8df 8e0 +6526 6527 8de 96e +6555 6526 8de 8df +6527 6528 8dd 96d +6556 6527 8dd 8de +6528 6529 8dc 96c +6557 6528 8dc 8dd +6529 652a 8db 96b +6558 6529 8db 8dc +652a 652b 8da 96a +6559 652a 8da 8db +652b 652c 8d9 969 +655a 652b 8d9 8da +652c 652d 8d8 968 +655b 652c 8d8 8d9 +652d 652e 8d7 967 +655c 652d 8d7 8d8 +652e 652f 8d6 966 +655d 652e 8d6 8d7 +652f 6530 8d5 965 +655e 652f 8d5 8d6 +6530 6531 8d4 964 +655f 6530 8d4 8d5 +6531 6532 8d3 963 +6560 6531 8d3 8d4 +6532 6533 8d2 962 +6561 6532 8d2 8d3 +6562 6533 8d1 8d2 +6534 6535 86f 8ff +6563 6534 86f 870 +6535 6536 86e 8fe +6564 6535 86e 86f +6536 6537 86d 8fd +6565 6536 86d 86e +6537 6538 86c 8fc +6566 6537 86c 86d +6538 6539 86b 8fb +6567 6538 86b 86c +6539 653a 86a 8fa +6568 6539 86a 86b +653a 653b 869 8f9 +6569 653a 869 86a +653b 653c 868 8f8 +656a 653b 868 869 +653c 653d 867 8f7 +656b 653c 867 868 +653d 653e 866 8f6 +656c 653d 866 867 +653e 653f 865 8f5 +656d 653e 865 866 +653f 6540 864 8f4 +656e 653f 864 865 +6540 6541 863 8f3 +656f 6540 863 864 +6541 6542 862 8f2 +6570 6541 862 863 +6542 6543 861 8f1 +6571 6542 861 862 +6543 6544 860 8f0 +6572 6543 860 861 +6544 6545 85f 8ef +6573 6544 85f 860 +6545 6546 85e 8ee +6574 6545 85e 85f +6546 6547 85d 8ed +6575 6546 85d 85e +6547 6548 85c 8ec +6576 6547 85c 85d +6548 6549 85b 8eb +6577 6548 85b 85c +6549 654a 85a 8ea +6578 6549 85a 85b +654a 654b 859 8e9 +6579 654a 859 85a +654b 654c 858 8e8 +657a 654b 858 859 +654c 654d 857 8e7 +657b 654c 857 858 +654d 654e 856 8e6 +657c 654d 856 857 +654e 654f 855 8e5 +657d 654e 855 856 +654f 6550 854 8e4 +657e 654f 854 855 +6550 6551 853 8e3 +657f 6550 853 854 +6551 6552 852 8e2 +6580 6551 852 853 +6552 6553 851 8e1 +6581 6552 851 852 +6553 6554 850 8e0 +6582 6553 850 851 +6554 6555 84f 8df +6583 6554 84f 850 +6555 6556 84e 8de +6584 6555 84e 84f +6556 6557 84d 8dd +6585 6556 84d 84e +6557 6558 84c 8dc +6586 6557 84c 84d +6558 6559 84b 8db +6587 6558 84b 84c +6559 655a 84a 8da +6588 6559 84a 84b +655a 655b 849 8d9 +6589 655a 849 84a +655b 655c 848 8d8 +658a 655b 848 849 +655c 655d 847 8d7 +658b 655c 847 848 +655d 655e 846 8d6 +658c 655d 846 847 +655e 655f 845 8d5 +658d 655e 845 846 +655f 6560 844 8d4 +658e 655f 844 845 +6560 6561 843 8d3 +658f 6560 843 844 +6561 6562 842 8d2 +6590 6561 842 843 +6591 6562 841 842 +6563 6564 7df 86f +6592 6563 7df 7e0 +6564 6565 7de 86e +6593 6564 7de 7df +6565 6566 7dd 86d +6594 6565 7dd 7de +6566 6567 7dc 86c +6595 6566 7dc 7dd +6567 6568 7db 86b +6596 6567 7db 7dc +6568 6569 7da 86a +6597 6568 7da 7db +6569 656a 7d9 869 +6598 6569 7d9 7da +656a 656b 7d8 868 +6599 656a 7d8 7d9 +656b 656c 7d7 867 +659a 656b 7d7 7d8 +656c 656d 7d6 866 +659b 656c 7d6 7d7 +656d 656e 7d5 865 +659c 656d 7d5 7d6 +656e 656f 7d4 864 +659d 656e 7d4 7d5 +656f 6570 7d3 863 +659e 656f 7d3 7d4 +6570 6571 7d2 862 +659f 6570 7d2 7d3 +6571 6572 7d1 861 +65a0 6571 7d1 7d2 +6572 6573 7d0 860 +65a1 6572 7d0 7d1 +6573 6574 7cf 85f +65a2 6573 7cf 7d0 +6574 6575 7ce 85e +65a3 6574 7ce 7cf +6575 6576 7cd 85d +65a4 6575 7cd 7ce +6576 6577 7cc 85c +65a5 6576 7cc 7cd +6577 6578 7cb 85b +65a6 6577 7cb 7cc +6578 6579 7ca 85a +65a7 6578 7ca 7cb +6579 657a 7c9 859 +65a8 6579 7c9 7ca +657a 657b 7c8 858 +65a9 657a 7c8 7c9 +657b 657c 7c7 857 +65aa 657b 7c7 7c8 +657c 657d 7c6 856 +65ab 657c 7c6 7c7 +657d 657e 7c5 855 +65ac 657d 7c5 7c6 +657e 657f 7c4 854 +65ad 657e 7c4 7c5 +657f 6580 7c3 853 +65ae 657f 7c3 7c4 +6580 6581 7c2 852 +65af 6580 7c2 7c3 +6581 6582 7c1 851 +65b0 6581 7c1 7c2 +6582 6583 7c0 850 +65b1 6582 7c0 7c1 +6583 6584 7bf 84f +65b2 6583 7bf 7c0 +6584 6585 7be 84e +65b3 6584 7be 7bf +6585 6586 7bd 84d +65b4 6585 7bd 7be +6586 6587 7bc 84c +65b5 6586 7bc 7bd +6587 6588 7bb 84b +65b6 6587 7bb 7bc +6588 6589 7ba 84a +65b7 6588 7ba 7bb +6589 658a 7b9 849 +65b8 6589 7b9 7ba +658a 658b 7b8 848 +65b9 658a 7b8 7b9 +658b 658c 7b7 847 +65ba 658b 7b7 7b8 +658c 658d 7b6 846 +65bb 658c 7b6 7b7 +658d 658e 7b5 845 +65bc 658d 7b5 7b6 +658e 658f 7b4 844 +65bd 658e 7b4 7b5 +658f 6590 7b3 843 +65be 658f 7b3 7b4 +6590 6591 7b2 842 +65bf 6590 7b2 7b3 +65c0 6591 7b1 7b2 +6592 6593 74f 7df +65c1 6592 74f 750 +6593 6594 74e 7de +65c2 6593 74e 74f +6594 6595 74d 7dd +65c3 6594 74d 74e +6595 6596 74c 7dc +65c4 6595 74c 74d +6596 6597 74b 7db +65c5 6596 74b 74c +6597 6598 74a 7da +65c6 6597 74a 74b +6598 6599 749 7d9 +65c7 6598 749 74a +6599 659a 748 7d8 +65c8 6599 748 749 +659a 659b 747 7d7 +65c9 659a 747 748 +659b 659c 746 7d6 +65ca 659b 746 747 +659c 659d 745 7d5 +65cb 659c 745 746 +659d 659e 744 7d4 +65cc 659d 744 745 +659e 659f 743 7d3 +65cd 659e 743 744 +659f 65a0 742 7d2 +65ce 659f 742 743 +65a0 65a1 741 7d1 +65cf 65a0 741 742 +65a1 65a2 740 7d0 +65d0 65a1 740 741 +65a2 65a3 73f 7cf +65d1 65a2 73f 740 +65a3 65a4 73e 7ce +65d2 65a3 73e 73f +65a4 65a5 73d 7cd +65d3 65a4 73d 73e +65a5 65a6 73c 7cc +65d4 65a5 73c 73d +65a6 65a7 73b 7cb +65d5 65a6 73b 73c +65a7 65a8 73a 7ca +65d6 65a7 73a 73b +65a8 65a9 739 7c9 +65d7 65a8 739 73a +65a9 65aa 738 7c8 +65d8 65a9 738 739 +65aa 65ab 737 7c7 +65d9 65aa 737 738 +65ab 65ac 736 7c6 +65da 65ab 736 737 +65ac 65ad 735 7c5 +65db 65ac 735 736 +65ad 65ae 734 7c4 +65dc 65ad 734 735 +65ae 65af 733 7c3 +65dd 65ae 733 734 +65af 65b0 732 7c2 +65de 65af 732 733 +65b0 65b1 731 7c1 +65df 65b0 731 732 +65b1 65b2 730 7c0 +65e0 65b1 730 731 +65b2 65b3 72f 7bf +65e1 65b2 72f 730 +65b3 65b4 72e 7be +65e2 65b3 72e 72f +65b4 65b5 72d 7bd +65e3 65b4 72d 72e +65b5 65b6 72c 7bc +65e4 65b5 72c 72d +65b6 65b7 72b 7bb +65e5 65b6 72b 72c +65b7 65b8 72a 7ba +65e6 65b7 72a 72b +65b8 65b9 729 7b9 +65e7 65b8 729 72a +65b9 65ba 728 7b8 +65e8 65b9 728 729 +65ba 65bb 727 7b7 +65e9 65ba 727 728 +65bb 65bc 726 7b6 +65ea 65bb 726 727 +65bc 65bd 725 7b5 +65eb 65bc 725 726 +65bd 65be 724 7b4 +65ec 65bd 724 725 +65be 65bf 723 7b3 +65ed 65be 723 724 +65bf 65c0 722 7b2 +65ee 65bf 722 723 +65ef 65c0 721 722 +65c1 65c2 6bf 74f +65f0 65c1 6bf 6c0 +65c2 65c3 6be 74e +65f1 65c2 6be 6bf +65c3 65c4 6bd 74d +65f2 65c3 6bd 6be +65c4 65c5 6bc 74c +65f3 65c4 6bc 6bd +65c5 65c6 6bb 74b +65f4 65c5 6bb 6bc +65c6 65c7 6ba 74a +65f5 65c6 6ba 6bb +65c7 65c8 6b9 749 +65f6 65c7 6b9 6ba +65c8 65c9 6b8 748 +65f7 65c8 6b8 6b9 +65c9 65ca 6b7 747 +65f8 65c9 6b7 6b8 +65ca 65cb 6b6 746 +65f9 65ca 6b6 6b7 +65cb 65cc 6b5 745 +65fa 65cb 6b5 6b6 +65cc 65cd 6b4 744 +65fb 65cc 6b4 6b5 +65cd 65ce 6b3 743 +65fc 65cd 6b3 6b4 +65ce 65cf 6b2 742 +65fd 65ce 6b2 6b3 +65cf 65d0 6b1 741 +65fe 65cf 6b1 6b2 +65d0 65d1 6b0 740 +65ff 65d0 6b0 6b1 +65d1 65d2 6af 73f +6600 65d1 6af 6b0 +65d2 65d3 6ae 73e +6601 65d2 6ae 6af +65d3 65d4 6ad 73d +6602 65d3 6ad 6ae +65d4 65d5 6ac 73c +6603 65d4 6ac 6ad +65d5 65d6 6ab 73b +6604 65d5 6ab 6ac +65d6 65d7 6aa 73a +6605 65d6 6aa 6ab +65d7 65d8 6a9 739 +6606 65d7 6a9 6aa +65d8 65d9 6a8 738 +6607 65d8 6a8 6a9 +65d9 65da 6a7 737 +6608 65d9 6a7 6a8 +65da 65db 6a6 736 +6609 65da 6a6 6a7 +65db 65dc 6a5 735 +660a 65db 6a5 6a6 +65dc 65dd 6a4 734 +660b 65dc 6a4 6a5 +65dd 65de 6a3 733 +660c 65dd 6a3 6a4 +65de 65df 6a2 732 +660d 65de 6a2 6a3 +65df 65e0 6a1 731 +660e 65df 6a1 6a2 +65e0 65e1 6a0 730 +660f 65e0 6a0 6a1 +65e1 65e2 69f 72f +6610 65e1 69f 6a0 +65e2 65e3 69e 72e +6611 65e2 69e 69f +65e3 65e4 69d 72d +6612 65e3 69d 69e +65e4 65e5 69c 72c +6613 65e4 69c 69d +65e5 65e6 69b 72b +6614 65e5 69b 69c +65e6 65e7 69a 72a +6615 65e6 69a 69b +65e7 65e8 699 729 +6616 65e7 699 69a +65e8 65e9 698 728 +6617 65e8 698 699 +65e9 65ea 697 727 +6618 65e9 697 698 +65ea 65eb 696 726 +6619 65ea 696 697 +65eb 65ec 695 725 +661a 65eb 695 696 +65ec 65ed 694 724 +661b 65ec 694 695 +65ed 65ee 693 723 +661c 65ed 693 694 +65ee 65ef 692 722 +661d 65ee 692 693 +661e 65ef 691 692 +65f0 65f1 62f 6bf +661f 65f0 62f 630 +65f1 65f2 62e 6be +6620 65f1 62e 62f +65f2 65f3 62d 6bd +6621 65f2 62d 62e +65f3 65f4 62c 6bc +6622 65f3 62c 62d +65f4 65f5 62b 6bb +6623 65f4 62b 62c +65f5 65f6 62a 6ba +6624 65f5 62a 62b +65f6 65f7 629 6b9 +6625 65f6 629 62a +65f7 65f8 628 6b8 +6626 65f7 628 629 +65f8 65f9 627 6b7 +6627 65f8 627 628 +65f9 65fa 626 6b6 +6628 65f9 626 627 +65fa 65fb 625 6b5 +6629 65fa 625 626 +65fb 65fc 624 6b4 +662a 65fb 624 625 +65fc 65fd 623 6b3 +662b 65fc 623 624 +65fd 65fe 622 6b2 +662c 65fd 622 623 +65fe 65ff 621 6b1 +662d 65fe 621 622 +65ff 6600 620 6b0 +662e 65ff 620 621 +6600 6601 61f 6af +662f 6600 61f 620 +6601 6602 61e 6ae +6630 6601 61e 61f +6602 6603 61d 6ad +6631 6602 61d 61e +6603 6604 61c 6ac +6632 6603 61c 61d +6604 6605 61b 6ab +6633 6604 61b 61c +6605 6606 61a 6aa +6634 6605 61a 61b +6606 6607 619 6a9 +6635 6606 619 61a +6607 6608 618 6a8 +6636 6607 618 619 +6608 6609 617 6a7 +6637 6608 617 618 +6609 660a 616 6a6 +6638 6609 616 617 +660a 660b 615 6a5 +6639 660a 615 616 +660b 660c 614 6a4 +663a 660b 614 615 +660c 660d 613 6a3 +663b 660c 613 614 +660d 660e 612 6a2 +663c 660d 612 613 +660e 660f 611 6a1 +663d 660e 611 612 +660f 6610 610 6a0 +663e 660f 610 611 +6610 6611 60f 69f +663f 6610 60f 610 +6611 6612 60e 69e +6640 6611 60e 60f +6612 6613 60d 69d +6641 6612 60d 60e +6613 6614 60c 69c +6642 6613 60c 60d +6614 6615 60b 69b +6643 6614 60b 60c +6615 6616 60a 69a +6644 6615 60a 60b +6616 6617 609 699 +6645 6616 609 60a +6617 6618 608 698 +6646 6617 608 609 +6618 6619 607 697 +6647 6618 607 608 +6619 661a 606 696 +6648 6619 606 607 +661a 661b 605 695 +6649 661a 605 606 +661b 661c 604 694 +664a 661b 604 605 +661c 661d 603 693 +664b 661c 603 604 +661d 661e 602 692 +664c 661d 602 603 +664d 661e 601 602 +661f 6620 59f 62f +664e 661f 59f 5a0 +6620 6621 59e 62e +664f 6620 59e 59f +6621 6622 59d 62d +6650 6621 59d 59e +6622 6623 59c 62c +6651 6622 59c 59d +6623 6624 59b 62b +6652 6623 59b 59c +6624 6625 59a 62a +6653 6624 59a 59b +6625 6626 599 629 +6654 6625 599 59a +6626 6627 598 628 +6655 6626 598 599 +6627 6628 597 627 +6656 6627 597 598 +6628 6629 596 626 +6657 6628 596 597 +6629 662a 595 625 +6658 6629 595 596 +662a 662b 594 624 +6659 662a 594 595 +662b 662c 593 623 +665a 662b 593 594 +662c 662d 592 622 +665b 662c 592 593 +662d 662e 591 621 +665c 662d 591 592 +662e 662f 590 620 +665d 662e 590 591 +662f 6630 58f 61f +665e 662f 58f 590 +6630 6631 58e 61e +665f 6630 58e 58f +6631 6632 58d 61d +6660 6631 58d 58e +6632 6633 58c 61c +6661 6632 58c 58d +6633 6634 58b 61b +6662 6633 58b 58c +6634 6635 58a 61a +6663 6634 58a 58b +6635 6636 589 619 +6664 6635 589 58a +6636 6637 588 618 +6665 6636 588 589 +6637 6638 587 617 +6666 6637 587 588 +6638 6639 586 616 +6667 6638 586 587 +6639 663a 585 615 +6668 6639 585 586 +663a 663b 584 614 +6669 663a 584 585 +663b 663c 583 613 +666a 663b 583 584 +663c 663d 582 612 +666b 663c 582 583 +663d 663e 581 611 +666c 663d 581 582 +663e 663f 580 610 +666d 663e 580 581 +663f 6640 57f 60f +666e 663f 57f 580 +6640 6641 57e 60e +666f 6640 57e 57f +6641 6642 57d 60d +6670 6641 57d 57e +6642 6643 57c 60c +6671 6642 57c 57d +6643 6644 57b 60b +6672 6643 57b 57c +6644 6645 57a 60a +6673 6644 57a 57b +6645 6646 579 609 +6674 6645 579 57a +6646 6647 578 608 +6675 6646 578 579 +6647 6648 577 607 +6676 6647 577 578 +6648 6649 576 606 +6677 6648 576 577 +6649 664a 575 605 +6678 6649 575 576 +664a 664b 574 604 +6679 664a 574 575 +664b 664c 573 603 +667a 664b 573 574 +664c 664d 572 602 +667b 664c 572 573 +667c 664d 571 572 +664e 664f 50f 59f +667d 664e 50f 510 +664f 6650 50e 59e +667e 664f 50e 50f +6650 6651 50d 59d +667f 6650 50d 50e +6651 6652 50c 59c +6680 6651 50c 50d +6652 6653 50b 59b +6681 6652 50b 50c +6653 6654 50a 59a +6682 6653 50a 50b +6654 6655 509 599 +6683 6654 509 50a +6655 6656 508 598 +6684 6655 508 509 +6656 6657 507 597 +6685 6656 507 508 +6657 6658 506 596 +6686 6657 506 507 +6658 6659 505 595 +6687 6658 505 506 +6659 665a 504 594 +6688 6659 504 505 +665a 665b 503 593 +6689 665a 503 504 +665b 665c 502 592 +668a 665b 502 503 +665c 665d 501 591 +668b 665c 501 502 +665d 665e 500 590 +668c 665d 500 501 +665e 665f 4ff 58f +668d 665e 4ff 500 +665f 6660 4fe 58e +668e 665f 4fe 4ff +6660 6661 4fd 58d +668f 6660 4fd 4fe +6661 6662 4fc 58c +6690 6661 4fc 4fd +6662 6663 4fb 58b +6691 6662 4fb 4fc +6663 6664 4fa 58a +6692 6663 4fa 4fb +6664 6665 4f9 589 +6693 6664 4f9 4fa +6665 6666 4f8 588 +6694 6665 4f8 4f9 +6666 6667 4f7 587 +6695 6666 4f7 4f8 +6667 6668 4f6 586 +6696 6667 4f6 4f7 +6668 6669 4f5 585 +6697 6668 4f5 4f6 +6669 666a 4f4 584 +6698 6669 4f4 4f5 +666a 666b 4f3 583 +6699 666a 4f3 4f4 +666b 666c 4f2 582 +669a 666b 4f2 4f3 +666c 666d 4f1 581 +669b 666c 4f1 4f2 +666d 666e 4f0 580 +669c 666d 4f0 4f1 +666e 666f 4ef 57f +669d 666e 4ef 4f0 +666f 6670 4ee 57e +669e 666f 4ee 4ef +6670 6671 4ed 57d +669f 6670 4ed 4ee +6671 6672 4ec 57c +66a0 6671 4ec 4ed +6672 6673 4eb 57b +66a1 6672 4eb 4ec +6673 6674 4ea 57a +66a2 6673 4ea 4eb +6674 6675 4e9 579 +66a3 6674 4e9 4ea +6675 6676 4e8 578 +66a4 6675 4e8 4e9 +6676 6677 4e7 577 +66a5 6676 4e7 4e8 +6677 6678 4e6 576 +66a6 6677 4e6 4e7 +6678 6679 4e5 575 +66a7 6678 4e5 4e6 +6679 667a 4e4 574 +66a8 6679 4e4 4e5 +667a 667b 4e3 573 +66a9 667a 4e3 4e4 +667b 667c 4e2 572 +66aa 667b 4e2 4e3 +66ab 667c 4e1 4e2 +667d 667e 47f 50f +66ac 667d 47f 480 +667e 667f 47e 50e +66ad 667e 47e 47f +667f 6680 47d 50d +66ae 667f 47d 47e +6680 6681 47c 50c +66af 6680 47c 47d +6681 6682 47b 50b +66b0 6681 47b 47c +6682 6683 47a 50a +66b1 6682 47a 47b +6683 6684 479 509 +66b2 6683 479 47a +6684 6685 478 508 +66b3 6684 478 479 +6685 6686 477 507 +66b4 6685 477 478 +6686 6687 476 506 +66b5 6686 476 477 +6687 6688 475 505 +66b6 6687 475 476 +6688 6689 474 504 +66b7 6688 474 475 +6689 668a 473 503 +66b8 6689 473 474 +668a 668b 472 502 +66b9 668a 472 473 +668b 668c 471 501 +66ba 668b 471 472 +668c 668d 470 500 +66bb 668c 470 471 +668d 668e 46f 4ff +66bc 668d 46f 470 +668e 668f 46e 4fe +66bd 668e 46e 46f +668f 6690 46d 4fd +66be 668f 46d 46e +6690 6691 46c 4fc +66bf 6690 46c 46d +6691 6692 46b 4fb +66c0 6691 46b 46c +6692 6693 46a 4fa +66c1 6692 46a 46b +6693 6694 469 4f9 +66c2 6693 469 46a +6694 6695 468 4f8 +66c3 6694 468 469 +6695 6696 467 4f7 +66c4 6695 467 468 +6696 6697 466 4f6 +66c5 6696 466 467 +6697 6698 465 4f5 +66c6 6697 465 466 +6698 6699 464 4f4 +66c7 6698 464 465 +6699 669a 463 4f3 +66c8 6699 463 464 +669a 669b 462 4f2 +66c9 669a 462 463 +669b 669c 461 4f1 +66ca 669b 461 462 +669c 669d 460 4f0 +66cb 669c 460 461 +669d 669e 45f 4ef +66cc 669d 45f 460 +669e 669f 45e 4ee +66cd 669e 45e 45f +669f 66a0 45d 4ed +66ce 669f 45d 45e +66a0 66a1 45c 4ec +66cf 66a0 45c 45d +66a1 66a2 45b 4eb +66d0 66a1 45b 45c +66a2 66a3 45a 4ea +66d1 66a2 45a 45b +66a3 66a4 459 4e9 +66d2 66a3 459 45a +66a4 66a5 458 4e8 +66d3 66a4 458 459 +66a5 66a6 457 4e7 +66d4 66a5 457 458 +66a6 66a7 456 4e6 +66d5 66a6 456 457 +66a7 66a8 455 4e5 +66d6 66a7 455 456 +66a8 66a9 454 4e4 +66d7 66a8 454 455 +66a9 66aa 453 4e3 +66d8 66a9 453 454 +66aa 66ab 452 4e2 +66d9 66aa 452 453 +66da 66ab 451 452 +66ac 66ad 3ef 47f +66db 66ac 3ef 3f0 +66ad 66ae 3ee 47e +66dc 66ad 3ee 3ef +66ae 66af 3ed 47d +66dd 66ae 3ed 3ee +66af 66b0 3ec 47c +66de 66af 3ec 3ed +66b0 66b1 3eb 47b +66df 66b0 3eb 3ec +66b1 66b2 3ea 47a +66e0 66b1 3ea 3eb +66b2 66b3 3e9 479 +66e1 66b2 3e9 3ea +66b3 66b4 3e8 478 +66e2 66b3 3e8 3e9 +66b4 66b5 3e7 477 +66e3 66b4 3e7 3e8 +66b5 66b6 3e6 476 +66e4 66b5 3e6 3e7 +66b6 66b7 3e5 475 +66e5 66b6 3e5 3e6 +66b7 66b8 3e4 474 +66e6 66b7 3e4 3e5 +66b8 66b9 3e3 473 +66e7 66b8 3e3 3e4 +66b9 66ba 3e2 472 +66e8 66b9 3e2 3e3 +66ba 66bb 3e1 471 +66e9 66ba 3e1 3e2 +66bb 66bc 3e0 470 +66ea 66bb 3e0 3e1 +66bc 66bd 3df 46f +66eb 66bc 3df 3e0 +66bd 66be 3de 46e +66ec 66bd 3de 3df +66be 66bf 3dd 46d +66ed 66be 3dd 3de +66bf 66c0 3dc 46c +66ee 66bf 3dc 3dd +66c0 66c1 3db 46b +66ef 66c0 3db 3dc +66c1 66c2 3da 46a +66f0 66c1 3da 3db +66c2 66c3 3d9 469 +66f1 66c2 3d9 3da +66c3 66c4 3d8 468 +66f2 66c3 3d8 3d9 +66c4 66c5 3d7 467 +66f3 66c4 3d7 3d8 +66c5 66c6 3d6 466 +66f4 66c5 3d6 3d7 +66c6 66c7 3d5 465 +66f5 66c6 3d5 3d6 +66c7 66c8 3d4 464 +66f6 66c7 3d4 3d5 +66c8 66c9 3d3 463 +66f7 66c8 3d3 3d4 +66c9 66ca 3d2 462 +66f8 66c9 3d2 3d3 +66ca 66cb 3d1 461 +66f9 66ca 3d1 3d2 +66cb 66cc 3d0 460 +66fa 66cb 3d0 3d1 +66cc 66cd 3cf 45f +66fb 66cc 3cf 3d0 +66cd 66ce 3ce 45e +66fc 66cd 3ce 3cf +66ce 66cf 3cd 45d +66fd 66ce 3cd 3ce +66cf 66d0 3cc 45c +66fe 66cf 3cc 3cd +66d0 66d1 3cb 45b +66ff 66d0 3cb 3cc +66d1 66d2 3ca 45a +6700 66d1 3ca 3cb +66d2 66d3 3c9 459 +6701 66d2 3c9 3ca +66d3 66d4 3c8 458 +6702 66d3 3c8 3c9 +66d4 66d5 3c7 457 +6703 66d4 3c7 3c8 +66d5 66d6 3c6 456 +6704 66d5 3c6 3c7 +66d6 66d7 3c5 455 +6705 66d6 3c5 3c6 +66d7 66d8 3c4 454 +6706 66d7 3c4 3c5 +66d8 66d9 3c3 453 +6707 66d8 3c3 3c4 +66d9 66da 3c2 452 +6708 66d9 3c2 3c3 +6709 66da 3c1 3c2 +66db 66dc 35f 3ef +670a 66db 35f 360 +66dc 66dd 35e 3ee +670b 66dc 35e 35f +66dd 66de 35d 3ed +670c 66dd 35d 35e +66de 66df 35c 3ec +670d 66de 35c 35d +66df 66e0 35b 3eb +670e 66df 35b 35c +66e0 66e1 35a 3ea +670f 66e0 35a 35b +66e1 66e2 359 3e9 +6710 66e1 359 35a +66e2 66e3 358 3e8 +6711 66e2 358 359 +66e3 66e4 357 3e7 +6712 66e3 357 358 +66e4 66e5 356 3e6 +6713 66e4 356 357 +66e5 66e6 355 3e5 +6714 66e5 355 356 +66e6 66e7 354 3e4 +6715 66e6 354 355 +66e7 66e8 353 3e3 +6716 66e7 353 354 +66e8 66e9 352 3e2 +6717 66e8 352 353 +66e9 66ea 351 3e1 +6718 66e9 351 352 +66ea 66eb 350 3e0 +6719 66ea 350 351 +66eb 66ec 34f 3df +671a 66eb 34f 350 +66ec 66ed 34e 3de +671b 66ec 34e 34f +66ed 66ee 34d 3dd +671c 66ed 34d 34e +66ee 66ef 34c 3dc +671d 66ee 34c 34d +66ef 66f0 34b 3db +671e 66ef 34b 34c +66f0 66f1 34a 3da +671f 66f0 34a 34b +66f1 66f2 349 3d9 +6720 66f1 349 34a +66f2 66f3 348 3d8 +6721 66f2 348 349 +66f3 66f4 347 3d7 +6722 66f3 347 348 +66f4 66f5 346 3d6 +6723 66f4 346 347 +66f5 66f6 345 3d5 +6724 66f5 345 346 +66f6 66f7 344 3d4 +6725 66f6 344 345 +66f7 66f8 343 3d3 +6726 66f7 343 344 +66f8 66f9 342 3d2 +6727 66f8 342 343 +66f9 66fa 341 3d1 +6728 66f9 341 342 +66fa 66fb 340 3d0 +6729 66fa 340 341 +66fb 66fc 33f 3cf +672a 66fb 33f 340 +66fc 66fd 33e 3ce +672b 66fc 33e 33f +66fd 66fe 33d 3cd +672c 66fd 33d 33e +66fe 66ff 33c 3cc +672d 66fe 33c 33d +66ff 6700 33b 3cb +672e 66ff 33b 33c +6700 6701 33a 3ca +672f 6700 33a 33b +6701 6702 339 3c9 +6730 6701 339 33a +6702 6703 338 3c8 +6731 6702 338 339 +6703 6704 337 3c7 +6732 6703 337 338 +6704 6705 336 3c6 +6733 6704 336 337 +6705 6706 335 3c5 +6734 6705 335 336 +6706 6707 334 3c4 +6735 6706 334 335 +6707 6708 333 3c3 +6736 6707 333 334 +6708 6709 332 3c2 +6737 6708 332 333 +6738 6709 331 332 +670a 670b 2cf 35f +6739 670a 2cf 2d0 +670b 670c 2ce 35e +673a 670b 2ce 2cf +670c 670d 2cd 35d +673b 670c 2cd 2ce +670d 670e 2cc 35c +673c 670d 2cc 2cd +670e 670f 2cb 35b +673d 670e 2cb 2cc +670f 6710 2ca 35a +673e 670f 2ca 2cb +6710 6711 2c9 359 +673f 6710 2c9 2ca +6711 6712 2c8 358 +6740 6711 2c8 2c9 +6712 6713 2c7 357 +6741 6712 2c7 2c8 +6713 6714 2c6 356 +6742 6713 2c6 2c7 +6714 6715 2c5 355 +6743 6714 2c5 2c6 +6715 6716 2c4 354 +6744 6715 2c4 2c5 +6716 6717 2c3 353 +6745 6716 2c3 2c4 +6717 6718 2c2 352 +6746 6717 2c2 2c3 +6718 6719 2c1 351 +6747 6718 2c1 2c2 +6719 671a 2c0 350 +6748 6719 2c0 2c1 +671a 671b 2bf 34f +6749 671a 2bf 2c0 +671b 671c 2be 34e +674a 671b 2be 2bf +671c 671d 2bd 34d +674b 671c 2bd 2be +671d 671e 2bc 34c +674c 671d 2bc 2bd +671e 671f 2bb 34b +674d 671e 2bb 2bc +671f 6720 2ba 34a +674e 671f 2ba 2bb +6720 6721 2b9 349 +674f 6720 2b9 2ba +6721 6722 2b8 348 +6750 6721 2b8 2b9 +6722 6723 2b7 347 +6751 6722 2b7 2b8 +6723 6724 2b6 346 +6752 6723 2b6 2b7 +6724 6725 2b5 345 +6753 6724 2b5 2b6 +6725 6726 2b4 344 +6754 6725 2b4 2b5 +6726 6727 2b3 343 +6755 6726 2b3 2b4 +6727 6728 2b2 342 +6756 6727 2b2 2b3 +6728 6729 2b1 341 +6757 6728 2b1 2b2 +6729 672a 2b0 340 +6758 6729 2b0 2b1 +672a 672b 2af 33f +6759 672a 2af 2b0 +672b 672c 2ae 33e +675a 672b 2ae 2af +672c 672d 2ad 33d +675b 672c 2ad 2ae +672d 672e 2ac 33c +675c 672d 2ac 2ad +672e 672f 2ab 33b +675d 672e 2ab 2ac +672f 6730 2aa 33a +675e 672f 2aa 2ab +6730 6731 2a9 339 +675f 6730 2a9 2aa +6731 6732 2a8 338 +6760 6731 2a8 2a9 +6732 6733 2a7 337 +6761 6732 2a7 2a8 +6733 6734 2a6 336 +6762 6733 2a6 2a7 +6734 6735 2a5 335 +6763 6734 2a5 2a6 +6735 6736 2a4 334 +6764 6735 2a4 2a5 +6736 6737 2a3 333 +6765 6736 2a3 2a4 +6737 6738 2a2 332 +6766 6737 2a2 2a3 +6767 6738 2a1 2a2 +6739 673a 23f 2cf +6768 6739 23f 240 +673a 673b 23e 2ce +6769 673a 23e 23f +673b 673c 23d 2cd +676a 673b 23d 23e +673c 673d 23c 2cc +676b 673c 23c 23d +673d 673e 23b 2cb +676c 673d 23b 23c +673e 673f 23a 2ca +676d 673e 23a 23b +673f 6740 239 2c9 +676e 673f 239 23a +6740 6741 238 2c8 +676f 6740 238 239 +6741 6742 237 2c7 +6770 6741 237 238 +6742 6743 236 2c6 +6771 6742 236 237 +6743 6744 235 2c5 +6772 6743 235 236 +6744 6745 234 2c4 +6773 6744 234 235 +6745 6746 233 2c3 +6774 6745 233 234 +6746 6747 232 2c2 +6775 6746 232 233 +6747 6748 231 2c1 +6776 6747 231 232 +6748 6749 230 2c0 +6777 6748 230 231 +6749 674a 22f 2bf +6778 6749 22f 230 +674a 674b 22e 2be +6779 674a 22e 22f +674b 674c 22d 2bd +677a 674b 22d 22e +674c 674d 22c 2bc +677b 674c 22c 22d +674d 674e 22b 2bb +677c 674d 22b 22c +674e 674f 22a 2ba +677d 674e 22a 22b +674f 6750 229 2b9 +677e 674f 229 22a +6750 6751 228 2b8 +677f 6750 228 229 +6751 6752 227 2b7 +6780 6751 227 228 +6752 6753 226 2b6 +6781 6752 226 227 +6753 6754 225 2b5 +6782 6753 225 226 +6754 6755 224 2b4 +6783 6754 224 225 +6755 6756 223 2b3 +6784 6755 223 224 +6756 6757 222 2b2 +6785 6756 222 223 +6757 6758 221 2b1 +6786 6757 221 222 +6758 6759 220 2b0 +6787 6758 220 221 +6759 675a 21f 2af +6788 6759 21f 220 +675a 675b 21e 2ae +6789 675a 21e 21f +675b 675c 21d 2ad +678a 675b 21d 21e +675c 675d 21c 2ac +678b 675c 21c 21d +675d 675e 21b 2ab +678c 675d 21b 21c +675e 675f 21a 2aa +678d 675e 21a 21b +675f 6760 219 2a9 +678e 675f 219 21a +6760 6761 218 2a8 +678f 6760 218 219 +6761 6762 217 2a7 +6790 6761 217 218 +6762 6763 216 2a6 +6791 6762 216 217 +6763 6764 215 2a5 +6792 6763 215 216 +6764 6765 214 2a4 +6793 6764 214 215 +6765 6766 213 2a3 +6794 6765 213 214 +6766 6767 212 2a2 +6795 6766 212 213 +6796 6767 211 212 +6768 6769 1af 23f +6797 6768 1af 1b0 +6769 676a 1ae 23e +6798 6769 1ae 1af +676a 676b 1ad 23d +6799 676a 1ad 1ae +676b 676c 1ac 23c +679a 676b 1ac 1ad +676c 676d 1ab 23b +679b 676c 1ab 1ac +676d 676e 1aa 23a +679c 676d 1aa 1ab +676e 676f 1a9 239 +679d 676e 1a9 1aa +676f 6770 1a8 238 +679e 676f 1a8 1a9 +6770 6771 1a7 237 +679f 6770 1a7 1a8 +6771 6772 1a6 236 +67a0 6771 1a6 1a7 +6772 6773 1a5 235 +67a1 6772 1a5 1a6 +6773 6774 1a4 234 +67a2 6773 1a4 1a5 +6774 6775 1a3 233 +67a3 6774 1a3 1a4 +6775 6776 1a2 232 +67a4 6775 1a2 1a3 +6776 6777 1a1 231 +67a5 6776 1a1 1a2 +6777 6778 1a0 230 +67a6 6777 1a0 1a1 +6778 6779 19f 22f +67a7 6778 19f 1a0 +6779 677a 19e 22e +67a8 6779 19e 19f +677a 677b 19d 22d +67a9 677a 19d 19e +677b 677c 19c 22c +67aa 677b 19c 19d +677c 677d 19b 22b +67ab 677c 19b 19c +677d 677e 19a 22a +67ac 677d 19a 19b +677e 677f 199 229 +67ad 677e 199 19a +677f 6780 198 228 +67ae 677f 198 199 +6780 6781 197 227 +67af 6780 197 198 +6781 6782 196 226 +67b0 6781 196 197 +6782 6783 195 225 +67b1 6782 195 196 +6783 6784 194 224 +67b2 6783 194 195 +6784 6785 193 223 +67b3 6784 193 194 +6785 6786 192 222 +67b4 6785 192 193 +6786 6787 191 221 +67b5 6786 191 192 +6787 6788 190 220 +67b6 6787 190 191 +6788 6789 18f 21f +67b7 6788 18f 190 +6789 678a 18e 21e +67b8 6789 18e 18f +678a 678b 18d 21d +67b9 678a 18d 18e +678b 678c 18c 21c +67ba 678b 18c 18d +678c 678d 18b 21b +67bb 678c 18b 18c +678d 678e 18a 21a +67bc 678d 18a 18b +678e 678f 189 219 +67bd 678e 189 18a +678f 6790 188 218 +67be 678f 188 189 +6790 6791 187 217 +67bf 6790 187 188 +6791 6792 186 216 +67c0 6791 186 187 +6792 6793 185 215 +67c1 6792 185 186 +6793 6794 184 214 +67c2 6793 184 185 +6794 6795 183 213 +67c3 6794 183 184 +6795 6796 182 212 +67c4 6795 182 183 +67c5 6796 181 182 +6797 6798 11f 1af +67c6 6797 11f 120 +6798 6799 11e 1ae +67c7 6798 11e 11f +6799 679a 11d 1ad +67c8 6799 11d 11e +679a 679b 11c 1ac +67c9 679a 11c 11d +679b 679c 11b 1ab +67ca 679b 11b 11c +679c 679d 11a 1aa +67cb 679c 11a 11b +679d 679e 119 1a9 +67cc 679d 119 11a +679e 679f 118 1a8 +67cd 679e 118 119 +679f 67a0 117 1a7 +67ce 679f 117 118 +67a0 67a1 116 1a6 +67cf 67a0 116 117 +67a1 67a2 115 1a5 +67d0 67a1 115 116 +67a2 67a3 114 1a4 +67d1 67a2 114 115 +67a3 67a4 113 1a3 +67d2 67a3 113 114 +67a4 67a5 112 1a2 +67d3 67a4 112 113 +67a5 67a6 111 1a1 +67d4 67a5 111 112 +67a6 67a7 110 1a0 +67d5 67a6 110 111 +67a7 67a8 10f 19f +67d6 67a7 10f 110 +67a8 67a9 10e 19e +67d7 67a8 10e 10f +67a9 67aa 10d 19d +67d8 67a9 10d 10e +67aa 67ab 10c 19c +67d9 67aa 10c 10d +67ab 67ac 10b 19b +67da 67ab 10b 10c +67ac 67ad 10a 19a +67db 67ac 10a 10b +67ad 67ae 109 199 +67dc 67ad 109 10a +67ae 67af 108 198 +67dd 67ae 108 109 +67af 67b0 107 197 +67de 67af 107 108 +67b0 67b1 106 196 +67df 67b0 106 107 +67b1 67b2 105 195 +67e0 67b1 105 106 +67b2 67b3 104 194 +67e1 67b2 104 105 +67b3 67b4 103 193 +67e2 67b3 103 104 +67b4 67b5 102 192 +67e3 67b4 102 103 +67b5 67b6 101 191 +67e4 67b5 101 102 +67b6 67b7 100 190 +67e5 67b6 100 101 +67b7 67b8 ff 18f +67e6 67b7 ff 100 +67b8 67b9 fe 18e +67e7 67b8 fe ff +67b9 67ba fd 18d +67e8 67b9 fd fe +67ba 67bb fc 18c +67e9 67ba fc fd +67bb 67bc fb 18b +67ea 67bb fb fc +67bc 67bd fa 18a +67eb 67bc fa fb +67bd 67be f9 189 +67ec 67bd f9 fa +67be 67bf f8 188 +67ed 67be f8 f9 +67bf 67c0 f7 187 +67ee 67bf f7 f8 +67c0 67c1 f6 186 +67ef 67c0 f6 f7 +67c1 67c2 f5 185 +67f0 67c1 f5 f6 +67c2 67c3 f4 184 +67f1 67c2 f4 f5 +67c3 67c4 f3 183 +67f2 67c3 f3 f4 +67c4 67c5 f2 182 +67f3 67c4 f2 f3 +67f4 67c5 f1 f2 +67c6 67c7 8f 11f +67c7 67c8 8e 11e +67c8 67c9 8d 11d +67c9 67ca 8c 11c +67ca 67cb 8b 11b +67cb 67cc 8a 11a +67cc 67cd 89 119 +67cd 67ce 88 118 +67ce 67cf 87 117 +67cf 67d0 86 116 +67d0 67d1 85 115 +67d1 67d2 84 114 +67d2 67d3 83 113 +67d3 67d4 82 112 +67d4 67d5 81 111 +67d5 67d6 80 110 +67d6 67d7 7f 10f +67d7 67d8 7e 10e +67d8 67d9 7d 10d +67d9 67da 7c 10c +67da 67db 7b 10b +67db 67dc 7a 10a +67dc 67dd 79 109 +67dd 67de 78 108 +67de 67df 77 107 +67df 67e0 76 106 +67e0 67e1 75 105 +67e1 67e2 74 104 +67e2 67e3 73 103 +67e3 67e4 72 102 +67e4 67e5 71 101 +67e5 67e6 70 100 +67e6 67e7 6f ff +67e7 67e8 6e fe +67e8 67e9 6d fd +67e9 67ea 6c fc +67ea 67eb 6b fb +67eb 67ec 6a fa +67ec 67ed 69 f9 +67ed 67ee 68 f8 +67ee 67ef 67 f7 +67ef 67f0 66 f6 +67f0 67f1 65 f5 +67f1 67f2 64 f4 +67f2 67f3 63 f3 +67f3 67f4 62 f2 +67f5 67f6 fff 108f +6834 67f5 fff 1000 +67f6 67f7 ffe 108e +6835 67f6 ffe fff +67f7 67f8 ffd 108d +6836 67f7 ffd ffe +67f8 67f9 ffc 108c +6837 67f8 ffc ffd +67f9 67fa ffb 108b +6838 67f9 ffb ffc +67fa 67fb ffa 108a +6839 67fa ffa ffb +67fb 67fc ff9 1089 +683a 67fb ff9 ffa +67fc 67fd ff8 1088 +683b 67fc ff8 ff9 +67fd 67fe ff7 1087 +683c 67fd ff7 ff8 +67fe 67ff ff6 1086 +683d 67fe ff6 ff7 +67ff 6800 ff5 1085 +683e 67ff ff5 ff6 +6800 6801 ff4 1084 +683f 6800 ff4 ff5 +6801 6802 ff3 1083 +6840 6801 ff3 ff4 +6802 6803 ff2 1082 +6841 6802 ff2 ff3 +6803 6804 ff1 1081 +6842 6803 ff1 ff2 +6804 6805 ff0 1080 +6843 6804 ff0 ff1 +6805 6806 fef 107f +6844 6805 fef ff0 +6806 6807 fee 107e +6845 6806 fee fef +6807 6808 fed 107d +6846 6807 fed fee +6808 6809 fec 107c +6847 6808 fec fed +6809 680a feb 107b +6848 6809 feb fec +680a 680b fea 107a +6849 680a fea feb +680b 680c fe9 1079 +684a 680b fe9 fea +680c 680d fe8 1078 +684b 680c fe8 fe9 +680d 680e fe7 1077 +684c 680d fe7 fe8 +680e 680f fe6 1076 +684d 680e fe6 fe7 +680f 6810 fe5 1075 +684e 680f fe5 fe6 +6810 6811 fe4 1074 +684f 6810 fe4 fe5 +6811 6812 fe3 1073 +6850 6811 fe3 fe4 +6812 6813 fe2 1072 +6851 6812 fe2 fe3 +6813 6814 fe1 1071 +6852 6813 fe1 fe2 +6814 6815 fe0 1070 +6853 6814 fe0 fe1 +6815 6816 fdf 106f +6854 6815 fdf fe0 +6816 6817 fde 106e +6855 6816 fde fdf +6817 6818 fdd 106d +6856 6817 fdd fde +6818 6819 fdc 106c +6857 6818 fdc fdd +6819 681a fdb 106b +6858 6819 fdb fdc +681a 681b fda 106a +6859 681a fda fdb +681b 681c fd9 1069 +685a 681b fd9 fda +681c 681d fd8 1068 +685b 681c fd8 fd9 +681d 681e fd7 1067 +685c 681d fd7 fd8 +681e 681f fd6 1066 +685d 681e fd6 fd7 +681f 6820 fd5 1065 +685e 681f fd5 fd6 +6820 6821 fd4 1064 +685f 6820 fd4 fd5 +6821 6822 fd3 1063 +6860 6821 fd3 fd4 +6822 6823 fd2 1062 +6861 6822 fd2 fd3 +6823 6824 fd1 1061 +6862 6823 fd1 fd2 +6824 6825 fd0 1060 +6863 6824 fd0 fd1 +6825 6826 fcf 105f +6864 6825 fcf fd0 +6826 6827 fce 105e +6865 6826 fce fcf +6827 6828 fcd 105d +6866 6827 fcd fce +6828 6829 fcc 105c +6867 6828 fcc fcd +6829 682a fcb 105b +6868 6829 fcb fcc +682a 682b fca 105a +6869 682a fca fcb +682b 682c fc9 1059 +686a 682b fc9 fca +682c 682d fc8 1058 +686b 682c fc8 fc9 +682d 682e fc7 1057 +686c 682d fc7 fc8 +682e 682f fc6 1056 +686d 682e fc6 fc7 +682f 6830 fc5 1055 +686e 682f fc5 fc6 +6830 6831 fc4 1054 +686f 6830 fc4 fc5 +6831 6832 fc3 1053 +6870 6831 fc3 fc4 +6832 6833 fc2 1052 +6871 6832 fc2 fc3 +6872 6833 fc1 fc2 +6834 6835 f6f fff +6873 6834 f6f f70 +6835 6836 f6e ffe +6874 6835 f6e f6f +6836 6837 f6d ffd +6875 6836 f6d f6e +6837 6838 f6c ffc +6876 6837 f6c f6d +6838 6839 f6b ffb +6877 6838 f6b f6c +6839 683a f6a ffa +6878 6839 f6a f6b +683a 683b f69 ff9 +6879 683a f69 f6a +683b 683c f68 ff8 +687a 683b f68 f69 +683c 683d f67 ff7 +687b 683c f67 f68 +683d 683e f66 ff6 +687c 683d f66 f67 +683e 683f f65 ff5 +687d 683e f65 f66 +683f 6840 f64 ff4 +687e 683f f64 f65 +6840 6841 f63 ff3 +687f 6840 f63 f64 +6841 6842 f62 ff2 +6880 6841 f62 f63 +6842 6843 f61 ff1 +6881 6842 f61 f62 +6843 6844 f60 ff0 +6882 6843 f60 f61 +6844 6845 f5f fef +6883 6844 f5f f60 +6845 6846 f5e fee +6884 6845 f5e f5f +6846 6847 f5d fed +6885 6846 f5d f5e +6847 6848 f5c fec +6886 6847 f5c f5d +6848 6849 f5b feb +6887 6848 f5b f5c +6849 684a f5a fea +6888 6849 f5a f5b +684a 684b f59 fe9 +6889 684a f59 f5a +684b 684c f58 fe8 +688a 684b f58 f59 +684c 684d f57 fe7 +688b 684c f57 f58 +684d 684e f56 fe6 +688c 684d f56 f57 +684e 684f f55 fe5 +688d 684e f55 f56 +684f 6850 f54 fe4 +688e 684f f54 f55 +6850 6851 f53 fe3 +688f 6850 f53 f54 +6851 6852 f52 fe2 +6890 6851 f52 f53 +6852 6853 f51 fe1 +6891 6852 f51 f52 +6853 6854 f50 fe0 +6892 6853 f50 f51 +6854 6855 f4f fdf +6893 6854 f4f f50 +6855 6856 f4e fde +6894 6855 f4e f4f +6856 6857 f4d fdd +6895 6856 f4d f4e +6857 6858 f4c fdc +6896 6857 f4c f4d +6858 6859 f4b fdb +6897 6858 f4b f4c +6859 685a f4a fda +6898 6859 f4a f4b +685a 685b f49 fd9 +6899 685a f49 f4a +685b 685c f48 fd8 +689a 685b f48 f49 +685c 685d f47 fd7 +689b 685c f47 f48 +685d 685e f46 fd6 +689c 685d f46 f47 +685e 685f f45 fd5 +689d 685e f45 f46 +685f 6860 f44 fd4 +689e 685f f44 f45 +6860 6861 f43 fd3 +689f 6860 f43 f44 +6861 6862 f42 fd2 +68a0 6861 f42 f43 +6862 6863 f41 fd1 +68a1 6862 f41 f42 +6863 6864 f40 fd0 +68a2 6863 f40 f41 +6864 6865 f3f fcf +68a3 6864 f3f f40 +6865 6866 f3e fce +68a4 6865 f3e f3f +6866 6867 f3d fcd +68a5 6866 f3d f3e +6867 6868 f3c fcc +68a6 6867 f3c f3d +6868 6869 f3b fcb +68a7 6868 f3b f3c +6869 686a f3a fca +68a8 6869 f3a f3b +686a 686b f39 fc9 +68a9 686a f39 f3a +686b 686c f38 fc8 +68aa 686b f38 f39 +686c 686d f37 fc7 +68ab 686c f37 f38 +686d 686e f36 fc6 +68ac 686d f36 f37 +686e 686f f35 fc5 +68ad 686e f35 f36 +686f 6870 f34 fc4 +68ae 686f f34 f35 +6870 6871 f33 fc3 +68af 6870 f33 f34 +6871 6872 f32 fc2 +68b0 6871 f32 f33 +68b1 6872 f31 f32 +6873 6874 edf f6f +68b2 6873 edf ee0 +6874 6875 ede f6e +68b3 6874 ede edf +6875 6876 edd f6d +68b4 6875 edd ede +6876 6877 edc f6c +68b5 6876 edc edd +6877 6878 edb f6b +68b6 6877 edb edc +6878 6879 eda f6a +68b7 6878 eda edb +6879 687a ed9 f69 +68b8 6879 ed9 eda +687a 687b ed8 f68 +68b9 687a ed8 ed9 +687b 687c ed7 f67 +68ba 687b ed7 ed8 +687c 687d ed6 f66 +68bb 687c ed6 ed7 +687d 687e ed5 f65 +68bc 687d ed5 ed6 +687e 687f ed4 f64 +68bd 687e ed4 ed5 +687f 6880 ed3 f63 +68be 687f ed3 ed4 +6880 6881 ed2 f62 +68bf 6880 ed2 ed3 +6881 6882 ed1 f61 +68c0 6881 ed1 ed2 +6882 6883 ed0 f60 +68c1 6882 ed0 ed1 +6883 6884 ecf f5f +68c2 6883 ecf ed0 +6884 6885 ece f5e +68c3 6884 ece ecf +6885 6886 ecd f5d +68c4 6885 ecd ece +6886 6887 ecc f5c +68c5 6886 ecc ecd +6887 6888 ecb f5b +68c6 6887 ecb ecc +6888 6889 eca f5a +68c7 6888 eca ecb +6889 688a ec9 f59 +68c8 6889 ec9 eca +688a 688b ec8 f58 +68c9 688a ec8 ec9 +688b 688c ec7 f57 +68ca 688b ec7 ec8 +688c 688d ec6 f56 +68cb 688c ec6 ec7 +688d 688e ec5 f55 +68cc 688d ec5 ec6 +688e 688f ec4 f54 +68cd 688e ec4 ec5 +688f 6890 ec3 f53 +68ce 688f ec3 ec4 +6890 6891 ec2 f52 +68cf 6890 ec2 ec3 +6891 6892 ec1 f51 +68d0 6891 ec1 ec2 +6892 6893 ec0 f50 +68d1 6892 ec0 ec1 +6893 6894 ebf f4f +68d2 6893 ebf ec0 +6894 6895 ebe f4e +68d3 6894 ebe ebf +6895 6896 ebd f4d +68d4 6895 ebd ebe +6896 6897 ebc f4c +68d5 6896 ebc ebd +6897 6898 ebb f4b +68d6 6897 ebb ebc +6898 6899 eba f4a +68d7 6898 eba ebb +6899 689a eb9 f49 +68d8 6899 eb9 eba +689a 689b eb8 f48 +68d9 689a eb8 eb9 +689b 689c eb7 f47 +68da 689b eb7 eb8 +689c 689d eb6 f46 +68db 689c eb6 eb7 +689d 689e eb5 f45 +68dc 689d eb5 eb6 +689e 689f eb4 f44 +68dd 689e eb4 eb5 +689f 68a0 eb3 f43 +68de 689f eb3 eb4 +68a0 68a1 eb2 f42 +68df 68a0 eb2 eb3 +68a1 68a2 eb1 f41 +68e0 68a1 eb1 eb2 +68a2 68a3 eb0 f40 +68e1 68a2 eb0 eb1 +68a3 68a4 eaf f3f +68e2 68a3 eaf eb0 +68a4 68a5 eae f3e +68e3 68a4 eae eaf +68a5 68a6 ead f3d +68e4 68a5 ead eae +68a6 68a7 eac f3c +68e5 68a6 eac ead +68a7 68a8 eab f3b +68e6 68a7 eab eac +68a8 68a9 eaa f3a +68e7 68a8 eaa eab +68a9 68aa ea9 f39 +68e8 68a9 ea9 eaa +68aa 68ab ea8 f38 +68e9 68aa ea8 ea9 +68ab 68ac ea7 f37 +68ea 68ab ea7 ea8 +68ac 68ad ea6 f36 +68eb 68ac ea6 ea7 +68ad 68ae ea5 f35 +68ec 68ad ea5 ea6 +68ae 68af ea4 f34 +68ed 68ae ea4 ea5 +68af 68b0 ea3 f33 +68ee 68af ea3 ea4 +68b0 68b1 ea2 f32 +68ef 68b0 ea2 ea3 +68f0 68b1 ea1 ea2 +68b2 68b3 e4f edf +68f1 68b2 e4f e50 +68b3 68b4 e4e ede +68f2 68b3 e4e e4f +68b4 68b5 e4d edd +68f3 68b4 e4d e4e +68b5 68b6 e4c edc +68f4 68b5 e4c e4d +68b6 68b7 e4b edb +68f5 68b6 e4b e4c +68b7 68b8 e4a eda +68f6 68b7 e4a e4b +68b8 68b9 e49 ed9 +68f7 68b8 e49 e4a +68b9 68ba e48 ed8 +68f8 68b9 e48 e49 +68ba 68bb e47 ed7 +68f9 68ba e47 e48 +68bb 68bc e46 ed6 +68fa 68bb e46 e47 +68bc 68bd e45 ed5 +68fb 68bc e45 e46 +68bd 68be e44 ed4 +68fc 68bd e44 e45 +68be 68bf e43 ed3 +68fd 68be e43 e44 +68bf 68c0 e42 ed2 +68fe 68bf e42 e43 +68c0 68c1 e41 ed1 +68ff 68c0 e41 e42 +68c1 68c2 e40 ed0 +6900 68c1 e40 e41 +68c2 68c3 e3f ecf +6901 68c2 e3f e40 +68c3 68c4 e3e ece +6902 68c3 e3e e3f +68c4 68c5 e3d ecd +6903 68c4 e3d e3e +68c5 68c6 e3c ecc +6904 68c5 e3c e3d +68c6 68c7 e3b ecb +6905 68c6 e3b e3c +68c7 68c8 e3a eca +6906 68c7 e3a e3b +68c8 68c9 e39 ec9 +6907 68c8 e39 e3a +68c9 68ca e38 ec8 +6908 68c9 e38 e39 +68ca 68cb e37 ec7 +6909 68ca e37 e38 +68cb 68cc e36 ec6 +690a 68cb e36 e37 +68cc 68cd e35 ec5 +690b 68cc e35 e36 +68cd 68ce e34 ec4 +690c 68cd e34 e35 +68ce 68cf e33 ec3 +690d 68ce e33 e34 +68cf 68d0 e32 ec2 +690e 68cf e32 e33 +68d0 68d1 e31 ec1 +690f 68d0 e31 e32 +68d1 68d2 e30 ec0 +6910 68d1 e30 e31 +68d2 68d3 e2f ebf +6911 68d2 e2f e30 +68d3 68d4 e2e ebe +6912 68d3 e2e e2f +68d4 68d5 e2d ebd +6913 68d4 e2d e2e +68d5 68d6 e2c ebc +6914 68d5 e2c e2d +68d6 68d7 e2b ebb +6915 68d6 e2b e2c +68d7 68d8 e2a eba +6916 68d7 e2a e2b +68d8 68d9 e29 eb9 +6917 68d8 e29 e2a +68d9 68da e28 eb8 +6918 68d9 e28 e29 +68da 68db e27 eb7 +6919 68da e27 e28 +68db 68dc e26 eb6 +691a 68db e26 e27 +68dc 68dd e25 eb5 +691b 68dc e25 e26 +68dd 68de e24 eb4 +691c 68dd e24 e25 +68de 68df e23 eb3 +691d 68de e23 e24 +68df 68e0 e22 eb2 +691e 68df e22 e23 +68e0 68e1 e21 eb1 +691f 68e0 e21 e22 +68e1 68e2 e20 eb0 +6920 68e1 e20 e21 +68e2 68e3 e1f eaf +6921 68e2 e1f e20 +68e3 68e4 e1e eae +6922 68e3 e1e e1f +68e4 68e5 e1d ead +6923 68e4 e1d e1e +68e5 68e6 e1c eac +6924 68e5 e1c e1d +68e6 68e7 e1b eab +6925 68e6 e1b e1c +68e7 68e8 e1a eaa +6926 68e7 e1a e1b +68e8 68e9 e19 ea9 +6927 68e8 e19 e1a +68e9 68ea e18 ea8 +6928 68e9 e18 e19 +68ea 68eb e17 ea7 +6929 68ea e17 e18 +68eb 68ec e16 ea6 +692a 68eb e16 e17 +68ec 68ed e15 ea5 +692b 68ec e15 e16 +68ed 68ee e14 ea4 +692c 68ed e14 e15 +68ee 68ef e13 ea3 +692d 68ee e13 e14 +68ef 68f0 e12 ea2 +692e 68ef e12 e13 +692f 68f0 e11 e12 +68f1 68f2 dbf e4f +6930 68f1 dbf dc0 +68f2 68f3 dbe e4e +6931 68f2 dbe dbf +68f3 68f4 dbd e4d +6932 68f3 dbd dbe +68f4 68f5 dbc e4c +6933 68f4 dbc dbd +68f5 68f6 dbb e4b +6934 68f5 dbb dbc +68f6 68f7 dba e4a +6935 68f6 dba dbb +68f7 68f8 db9 e49 +6936 68f7 db9 dba +68f8 68f9 db8 e48 +6937 68f8 db8 db9 +68f9 68fa db7 e47 +6938 68f9 db7 db8 +68fa 68fb db6 e46 +6939 68fa db6 db7 +68fb 68fc db5 e45 +693a 68fb db5 db6 +68fc 68fd db4 e44 +693b 68fc db4 db5 +68fd 68fe db3 e43 +693c 68fd db3 db4 +68fe 68ff db2 e42 +693d 68fe db2 db3 +68ff 6900 db1 e41 +693e 68ff db1 db2 +6900 6901 db0 e40 +693f 6900 db0 db1 +6901 6902 daf e3f +6940 6901 daf db0 +6902 6903 dae e3e +6941 6902 dae daf +6903 6904 dad e3d +6942 6903 dad dae +6904 6905 dac e3c +6943 6904 dac dad +6905 6906 dab e3b +6944 6905 dab dac +6906 6907 daa e3a +6945 6906 daa dab +6907 6908 da9 e39 +6946 6907 da9 daa +6908 6909 da8 e38 +6947 6908 da8 da9 +6909 690a da7 e37 +6948 6909 da7 da8 +690a 690b da6 e36 +6949 690a da6 da7 +690b 690c da5 e35 +694a 690b da5 da6 +690c 690d da4 e34 +694b 690c da4 da5 +690d 690e da3 e33 +694c 690d da3 da4 +690e 690f da2 e32 +694d 690e da2 da3 +690f 6910 da1 e31 +694e 690f da1 da2 +6910 6911 da0 e30 +694f 6910 da0 da1 +6911 6912 d9f e2f +6950 6911 d9f da0 +6912 6913 d9e e2e +6951 6912 d9e d9f +6913 6914 d9d e2d +6952 6913 d9d d9e +6914 6915 d9c e2c +6953 6914 d9c d9d +6915 6916 d9b e2b +6954 6915 d9b d9c +6916 6917 d9a e2a +6955 6916 d9a d9b +6917 6918 d99 e29 +6956 6917 d99 d9a +6918 6919 d98 e28 +6957 6918 d98 d99 +6919 691a d97 e27 +6958 6919 d97 d98 +691a 691b d96 e26 +6959 691a d96 d97 +691b 691c d95 e25 +695a 691b d95 d96 +691c 691d d94 e24 +695b 691c d94 d95 +691d 691e d93 e23 +695c 691d d93 d94 +691e 691f d92 e22 +695d 691e d92 d93 +691f 6920 d91 e21 +695e 691f d91 d92 +6920 6921 d90 e20 +695f 6920 d90 d91 +6921 6922 d8f e1f +6960 6921 d8f d90 +6922 6923 d8e e1e +6961 6922 d8e d8f +6923 6924 d8d e1d +6962 6923 d8d d8e +6924 6925 d8c e1c +6963 6924 d8c d8d +6925 6926 d8b e1b +6964 6925 d8b d8c +6926 6927 d8a e1a +6965 6926 d8a d8b +6927 6928 d89 e19 +6966 6927 d89 d8a +6928 6929 d88 e18 +6967 6928 d88 d89 +6929 692a d87 e17 +6968 6929 d87 d88 +692a 692b d86 e16 +6969 692a d86 d87 +692b 692c d85 e15 +696a 692b d85 d86 +692c 692d d84 e14 +696b 692c d84 d85 +692d 692e d83 e13 +696c 692d d83 d84 +692e 692f d82 e12 +696d 692e d82 d83 +696e 692f d81 d82 +6930 6931 d2f dbf +696f 6930 d2f d30 +6931 6932 d2e dbe +6970 6931 d2e d2f +6932 6933 d2d dbd +6971 6932 d2d d2e +6933 6934 d2c dbc +6972 6933 d2c d2d +6934 6935 d2b dbb +6973 6934 d2b d2c +6935 6936 d2a dba +6974 6935 d2a d2b +6936 6937 d29 db9 +6975 6936 d29 d2a +6937 6938 d28 db8 +6976 6937 d28 d29 +6938 6939 d27 db7 +6977 6938 d27 d28 +6939 693a d26 db6 +6978 6939 d26 d27 +693a 693b d25 db5 +6979 693a d25 d26 +693b 693c d24 db4 +697a 693b d24 d25 +693c 693d d23 db3 +697b 693c d23 d24 +693d 693e d22 db2 +697c 693d d22 d23 +693e 693f d21 db1 +697d 693e d21 d22 +693f 6940 d20 db0 +697e 693f d20 d21 +6940 6941 d1f daf +697f 6940 d1f d20 +6941 6942 d1e dae +6980 6941 d1e d1f +6942 6943 d1d dad +6981 6942 d1d d1e +6943 6944 d1c dac +6982 6943 d1c d1d +6944 6945 d1b dab +6983 6944 d1b d1c +6945 6946 d1a daa +6984 6945 d1a d1b +6946 6947 d19 da9 +6985 6946 d19 d1a +6947 6948 d18 da8 +6986 6947 d18 d19 +6948 6949 d17 da7 +6987 6948 d17 d18 +6949 694a d16 da6 +6988 6949 d16 d17 +694a 694b d15 da5 +6989 694a d15 d16 +694b 694c d14 da4 +698a 694b d14 d15 +694c 694d d13 da3 +698b 694c d13 d14 +694d 694e d12 da2 +698c 694d d12 d13 +694e 694f d11 da1 +698d 694e d11 d12 +694f 6950 d10 da0 +698e 694f d10 d11 +6950 6951 d0f d9f +698f 6950 d0f d10 +6951 6952 d0e d9e +6990 6951 d0e d0f +6952 6953 d0d d9d +6991 6952 d0d d0e +6953 6954 d0c d9c +6992 6953 d0c d0d +6954 6955 d0b d9b +6993 6954 d0b d0c +6955 6956 d0a d9a +6994 6955 d0a d0b +6956 6957 d09 d99 +6995 6956 d09 d0a +6957 6958 d08 d98 +6996 6957 d08 d09 +6958 6959 d07 d97 +6997 6958 d07 d08 +6959 695a d06 d96 +6998 6959 d06 d07 +695a 695b d05 d95 +6999 695a d05 d06 +695b 695c d04 d94 +699a 695b d04 d05 +695c 695d d03 d93 +699b 695c d03 d04 +695d 695e d02 d92 +699c 695d d02 d03 +695e 695f d01 d91 +699d 695e d01 d02 +695f 6960 d00 d90 +699e 695f d00 d01 +6960 6961 cff d8f +699f 6960 cff d00 +6961 6962 cfe d8e +69a0 6961 cfe cff +6962 6963 cfd d8d +69a1 6962 cfd cfe +6963 6964 cfc d8c +69a2 6963 cfc cfd +6964 6965 cfb d8b +69a3 6964 cfb cfc +6965 6966 cfa d8a +69a4 6965 cfa cfb +6966 6967 cf9 d89 +69a5 6966 cf9 cfa +6967 6968 cf8 d88 +69a6 6967 cf8 cf9 +6968 6969 cf7 d87 +69a7 6968 cf7 cf8 +6969 696a cf6 d86 +69a8 6969 cf6 cf7 +696a 696b cf5 d85 +69a9 696a cf5 cf6 +696b 696c cf4 d84 +69aa 696b cf4 cf5 +696c 696d cf3 d83 +69ab 696c cf3 cf4 +696d 696e cf2 d82 +69ac 696d cf2 cf3 +69ad 696e cf1 cf2 +696f 6970 c9f d2f +69ae 696f c9f ca0 +6970 6971 c9e d2e +69af 6970 c9e c9f +6971 6972 c9d d2d +69b0 6971 c9d c9e +6972 6973 c9c d2c +69b1 6972 c9c c9d +6973 6974 c9b d2b +69b2 6973 c9b c9c +6974 6975 c9a d2a +69b3 6974 c9a c9b +6975 6976 c99 d29 +69b4 6975 c99 c9a +6976 6977 c98 d28 +69b5 6976 c98 c99 +6977 6978 c97 d27 +69b6 6977 c97 c98 +6978 6979 c96 d26 +69b7 6978 c96 c97 +6979 697a c95 d25 +69b8 6979 c95 c96 +697a 697b c94 d24 +69b9 697a c94 c95 +697b 697c c93 d23 +69ba 697b c93 c94 +697c 697d c92 d22 +69bb 697c c92 c93 +697d 697e c91 d21 +69bc 697d c91 c92 +697e 697f c90 d20 +69bd 697e c90 c91 +697f 6980 c8f d1f +69be 697f c8f c90 +6980 6981 c8e d1e +69bf 6980 c8e c8f +6981 6982 c8d d1d +69c0 6981 c8d c8e +6982 6983 c8c d1c +69c1 6982 c8c c8d +6983 6984 c8b d1b +69c2 6983 c8b c8c +6984 6985 c8a d1a +69c3 6984 c8a c8b +6985 6986 c89 d19 +69c4 6985 c89 c8a +6986 6987 c88 d18 +69c5 6986 c88 c89 +6987 6988 c87 d17 +69c6 6987 c87 c88 +6988 6989 c86 d16 +69c7 6988 c86 c87 +6989 698a c85 d15 +69c8 6989 c85 c86 +698a 698b c84 d14 +69c9 698a c84 c85 +698b 698c c83 d13 +69ca 698b c83 c84 +698c 698d c82 d12 +69cb 698c c82 c83 +698d 698e c81 d11 +69cc 698d c81 c82 +698e 698f c80 d10 +69cd 698e c80 c81 +698f 6990 c7f d0f +69ce 698f c7f c80 +6990 6991 c7e d0e +69cf 6990 c7e c7f +6991 6992 c7d d0d +69d0 6991 c7d c7e +6992 6993 c7c d0c +69d1 6992 c7c c7d +6993 6994 c7b d0b +69d2 6993 c7b c7c +6994 6995 c7a d0a +69d3 6994 c7a c7b +6995 6996 c79 d09 +69d4 6995 c79 c7a +6996 6997 c78 d08 +69d5 6996 c78 c79 +6997 6998 c77 d07 +69d6 6997 c77 c78 +6998 6999 c76 d06 +69d7 6998 c76 c77 +6999 699a c75 d05 +69d8 6999 c75 c76 +699a 699b c74 d04 +69d9 699a c74 c75 +699b 699c c73 d03 +69da 699b c73 c74 +699c 699d c72 d02 +69db 699c c72 c73 +699d 699e c71 d01 +69dc 699d c71 c72 +699e 699f c70 d00 +69dd 699e c70 c71 +699f 69a0 c6f cff +69de 699f c6f c70 +69a0 69a1 c6e cfe +69df 69a0 c6e c6f +69a1 69a2 c6d cfd +69e0 69a1 c6d c6e +69a2 69a3 c6c cfc +69e1 69a2 c6c c6d +69a3 69a4 c6b cfb +69e2 69a3 c6b c6c +69a4 69a5 c6a cfa +69e3 69a4 c6a c6b +69a5 69a6 c69 cf9 +69e4 69a5 c69 c6a +69a6 69a7 c68 cf8 +69e5 69a6 c68 c69 +69a7 69a8 c67 cf7 +69e6 69a7 c67 c68 +69a8 69a9 c66 cf6 +69e7 69a8 c66 c67 +69a9 69aa c65 cf5 +69e8 69a9 c65 c66 +69aa 69ab c64 cf4 +69e9 69aa c64 c65 +69ab 69ac c63 cf3 +69ea 69ab c63 c64 +69ac 69ad c62 cf2 +69eb 69ac c62 c63 +69ec 69ad c61 c62 +69ae 69af c0f c9f +69ed 69ae c0f c10 +69af 69b0 c0e c9e +69ee 69af c0e c0f +69b0 69b1 c0d c9d +69ef 69b0 c0d c0e +69b1 69b2 c0c c9c +69f0 69b1 c0c c0d +69b2 69b3 c0b c9b +69f1 69b2 c0b c0c +69b3 69b4 c0a c9a +69f2 69b3 c0a c0b +69b4 69b5 c09 c99 +69f3 69b4 c09 c0a +69b5 69b6 c08 c98 +69f4 69b5 c08 c09 +69b6 69b7 c07 c97 +69f5 69b6 c07 c08 +69b7 69b8 c06 c96 +69f6 69b7 c06 c07 +69b8 69b9 c05 c95 +69f7 69b8 c05 c06 +69b9 69ba c04 c94 +69f8 69b9 c04 c05 +69ba 69bb c03 c93 +69f9 69ba c03 c04 +69bb 69bc c02 c92 +69fa 69bb c02 c03 +69bc 69bd c01 c91 +69fb 69bc c01 c02 +69bd 69be c00 c90 +69fc 69bd c00 c01 +69be 69bf bff c8f +69fd 69be bff c00 +69bf 69c0 bfe c8e +69fe 69bf bfe bff +69c0 69c1 bfd c8d +69ff 69c0 bfd bfe +69c1 69c2 bfc c8c +6a00 69c1 bfc bfd +69c2 69c3 bfb c8b +6a01 69c2 bfb bfc +69c3 69c4 bfa c8a +6a02 69c3 bfa bfb +69c4 69c5 bf9 c89 +6a03 69c4 bf9 bfa +69c5 69c6 bf8 c88 +6a04 69c5 bf8 bf9 +69c6 69c7 bf7 c87 +6a05 69c6 bf7 bf8 +69c7 69c8 bf6 c86 +6a06 69c7 bf6 bf7 +69c8 69c9 bf5 c85 +6a07 69c8 bf5 bf6 +69c9 69ca bf4 c84 +6a08 69c9 bf4 bf5 +69ca 69cb bf3 c83 +6a09 69ca bf3 bf4 +69cb 69cc bf2 c82 +6a0a 69cb bf2 bf3 +69cc 69cd bf1 c81 +6a0b 69cc bf1 bf2 +69cd 69ce bf0 c80 +6a0c 69cd bf0 bf1 +69ce 69cf bef c7f +6a0d 69ce bef bf0 +69cf 69d0 bee c7e +6a0e 69cf bee bef +69d0 69d1 bed c7d +6a0f 69d0 bed bee +69d1 69d2 bec c7c +6a10 69d1 bec bed +69d2 69d3 beb c7b +6a11 69d2 beb bec +69d3 69d4 bea c7a +6a12 69d3 bea beb +69d4 69d5 be9 c79 +6a13 69d4 be9 bea +69d5 69d6 be8 c78 +6a14 69d5 be8 be9 +69d6 69d7 be7 c77 +6a15 69d6 be7 be8 +69d7 69d8 be6 c76 +6a16 69d7 be6 be7 +69d8 69d9 be5 c75 +6a17 69d8 be5 be6 +69d9 69da be4 c74 +6a18 69d9 be4 be5 +69da 69db be3 c73 +6a19 69da be3 be4 +69db 69dc be2 c72 +6a1a 69db be2 be3 +69dc 69dd be1 c71 +6a1b 69dc be1 be2 +69dd 69de be0 c70 +6a1c 69dd be0 be1 +69de 69df bdf c6f +6a1d 69de bdf be0 +69df 69e0 bde c6e +6a1e 69df bde bdf +69e0 69e1 bdd c6d +6a1f 69e0 bdd bde +69e1 69e2 bdc c6c +6a20 69e1 bdc bdd +69e2 69e3 bdb c6b +6a21 69e2 bdb bdc +69e3 69e4 bda c6a +6a22 69e3 bda bdb +69e4 69e5 bd9 c69 +6a23 69e4 bd9 bda +69e5 69e6 bd8 c68 +6a24 69e5 bd8 bd9 +69e6 69e7 bd7 c67 +6a25 69e6 bd7 bd8 +69e7 69e8 bd6 c66 +6a26 69e7 bd6 bd7 +69e8 69e9 bd5 c65 +6a27 69e8 bd5 bd6 +69e9 69ea bd4 c64 +6a28 69e9 bd4 bd5 +69ea 69eb bd3 c63 +6a29 69ea bd3 bd4 +69eb 69ec bd2 c62 +6a2a 69eb bd2 bd3 +6a2b 69ec bd1 bd2 +69ed 69ee b7f c0f +6a2c 69ed b7f b80 +69ee 69ef b7e c0e +6a2d 69ee b7e b7f +69ef 69f0 b7d c0d +6a2e 69ef b7d b7e +69f0 69f1 b7c c0c +6a2f 69f0 b7c b7d +69f1 69f2 b7b c0b +6a30 69f1 b7b b7c +69f2 69f3 b7a c0a +6a31 69f2 b7a b7b +69f3 69f4 b79 c09 +6a32 69f3 b79 b7a +69f4 69f5 b78 c08 +6a33 69f4 b78 b79 +69f5 69f6 b77 c07 +6a34 69f5 b77 b78 +69f6 69f7 b76 c06 +6a35 69f6 b76 b77 +69f7 69f8 b75 c05 +6a36 69f7 b75 b76 +69f8 69f9 b74 c04 +6a37 69f8 b74 b75 +69f9 69fa b73 c03 +6a38 69f9 b73 b74 +69fa 69fb b72 c02 +6a39 69fa b72 b73 +69fb 69fc b71 c01 +6a3a 69fb b71 b72 +69fc 69fd b70 c00 +6a3b 69fc b70 b71 +69fd 69fe b6f bff +6a3c 69fd b6f b70 +69fe 69ff b6e bfe +6a3d 69fe b6e b6f +69ff 6a00 b6d bfd +6a3e 69ff b6d b6e +6a00 6a01 b6c bfc +6a3f 6a00 b6c b6d +6a01 6a02 b6b bfb +6a40 6a01 b6b b6c +6a02 6a03 b6a bfa +6a41 6a02 b6a b6b +6a03 6a04 b69 bf9 +6a42 6a03 b69 b6a +6a04 6a05 b68 bf8 +6a43 6a04 b68 b69 +6a05 6a06 b67 bf7 +6a44 6a05 b67 b68 +6a06 6a07 b66 bf6 +6a45 6a06 b66 b67 +6a07 6a08 b65 bf5 +6a46 6a07 b65 b66 +6a08 6a09 b64 bf4 +6a47 6a08 b64 b65 +6a09 6a0a b63 bf3 +6a48 6a09 b63 b64 +6a0a 6a0b b62 bf2 +6a49 6a0a b62 b63 +6a0b 6a0c b61 bf1 +6a4a 6a0b b61 b62 +6a0c 6a0d b60 bf0 +6a4b 6a0c b60 b61 +6a0d 6a0e b5f bef +6a4c 6a0d b5f b60 +6a0e 6a0f b5e bee +6a4d 6a0e b5e b5f +6a0f 6a10 b5d bed +6a4e 6a0f b5d b5e +6a10 6a11 b5c bec +6a4f 6a10 b5c b5d +6a11 6a12 b5b beb +6a50 6a11 b5b b5c +6a12 6a13 b5a bea +6a51 6a12 b5a b5b +6a13 6a14 b59 be9 +6a52 6a13 b59 b5a +6a14 6a15 b58 be8 +6a53 6a14 b58 b59 +6a15 6a16 b57 be7 +6a54 6a15 b57 b58 +6a16 6a17 b56 be6 +6a55 6a16 b56 b57 +6a17 6a18 b55 be5 +6a56 6a17 b55 b56 +6a18 6a19 b54 be4 +6a57 6a18 b54 b55 +6a19 6a1a b53 be3 +6a58 6a19 b53 b54 +6a1a 6a1b b52 be2 +6a59 6a1a b52 b53 +6a1b 6a1c b51 be1 +6a5a 6a1b b51 b52 +6a1c 6a1d b50 be0 +6a5b 6a1c b50 b51 +6a1d 6a1e b4f bdf +6a5c 6a1d b4f b50 +6a1e 6a1f b4e bde +6a5d 6a1e b4e b4f +6a1f 6a20 b4d bdd +6a5e 6a1f b4d b4e +6a20 6a21 b4c bdc +6a5f 6a20 b4c b4d +6a21 6a22 b4b bdb +6a60 6a21 b4b b4c +6a22 6a23 b4a bda +6a61 6a22 b4a b4b +6a23 6a24 b49 bd9 +6a62 6a23 b49 b4a +6a24 6a25 b48 bd8 +6a63 6a24 b48 b49 +6a25 6a26 b47 bd7 +6a64 6a25 b47 b48 +6a26 6a27 b46 bd6 +6a65 6a26 b46 b47 +6a27 6a28 b45 bd5 +6a66 6a27 b45 b46 +6a28 6a29 b44 bd4 +6a67 6a28 b44 b45 +6a29 6a2a b43 bd3 +6a68 6a29 b43 b44 +6a2a 6a2b b42 bd2 +6a69 6a2a b42 b43 +6a6a 6a2b b41 b42 +6a2c 6a2d aef b7f +6a6b 6a2c aef af0 +6a2d 6a2e aee b7e +6a6c 6a2d aee aef +6a2e 6a2f aed b7d +6a6d 6a2e aed aee +6a2f 6a30 aec b7c +6a6e 6a2f aec aed +6a30 6a31 aeb b7b +6a6f 6a30 aeb aec +6a31 6a32 aea b7a +6a70 6a31 aea aeb +6a32 6a33 ae9 b79 +6a71 6a32 ae9 aea +6a33 6a34 ae8 b78 +6a72 6a33 ae8 ae9 +6a34 6a35 ae7 b77 +6a73 6a34 ae7 ae8 +6a35 6a36 ae6 b76 +6a74 6a35 ae6 ae7 +6a36 6a37 ae5 b75 +6a75 6a36 ae5 ae6 +6a37 6a38 ae4 b74 +6a76 6a37 ae4 ae5 +6a38 6a39 ae3 b73 +6a77 6a38 ae3 ae4 +6a39 6a3a ae2 b72 +6a78 6a39 ae2 ae3 +6a3a 6a3b ae1 b71 +6a79 6a3a ae1 ae2 +6a3b 6a3c ae0 b70 +6a7a 6a3b ae0 ae1 +6a3c 6a3d adf b6f +6a7b 6a3c adf ae0 +6a3d 6a3e ade b6e +6a7c 6a3d ade adf +6a3e 6a3f add b6d +6a7d 6a3e add ade +6a3f 6a40 adc b6c +6a7e 6a3f adc add +6a40 6a41 adb b6b +6a7f 6a40 adb adc +6a41 6a42 ada b6a +6a80 6a41 ada adb +6a42 6a43 ad9 b69 +6a81 6a42 ad9 ada +6a43 6a44 ad8 b68 +6a82 6a43 ad8 ad9 +6a44 6a45 ad7 b67 +6a83 6a44 ad7 ad8 +6a45 6a46 ad6 b66 +6a84 6a45 ad6 ad7 +6a46 6a47 ad5 b65 +6a85 6a46 ad5 ad6 +6a47 6a48 ad4 b64 +6a86 6a47 ad4 ad5 +6a48 6a49 ad3 b63 +6a87 6a48 ad3 ad4 +6a49 6a4a ad2 b62 +6a88 6a49 ad2 ad3 +6a4a 6a4b ad1 b61 +6a89 6a4a ad1 ad2 +6a4b 6a4c ad0 b60 +6a8a 6a4b ad0 ad1 +6a4c 6a4d acf b5f +6a8b 6a4c acf ad0 +6a4d 6a4e ace b5e +6a8c 6a4d ace acf +6a4e 6a4f acd b5d +6a8d 6a4e acd ace +6a4f 6a50 acc b5c +6a8e 6a4f acc acd +6a50 6a51 acb b5b +6a8f 6a50 acb acc +6a51 6a52 aca b5a +6a90 6a51 aca acb +6a52 6a53 ac9 b59 +6a91 6a52 ac9 aca +6a53 6a54 ac8 b58 +6a92 6a53 ac8 ac9 +6a54 6a55 ac7 b57 +6a93 6a54 ac7 ac8 +6a55 6a56 ac6 b56 +6a94 6a55 ac6 ac7 +6a56 6a57 ac5 b55 +6a95 6a56 ac5 ac6 +6a57 6a58 ac4 b54 +6a96 6a57 ac4 ac5 +6a58 6a59 ac3 b53 +6a97 6a58 ac3 ac4 +6a59 6a5a ac2 b52 +6a98 6a59 ac2 ac3 +6a5a 6a5b ac1 b51 +6a99 6a5a ac1 ac2 +6a5b 6a5c ac0 b50 +6a9a 6a5b ac0 ac1 +6a5c 6a5d abf b4f +6a9b 6a5c abf ac0 +6a5d 6a5e abe b4e +6a9c 6a5d abe abf +6a5e 6a5f abd b4d +6a9d 6a5e abd abe +6a5f 6a60 abc b4c +6a9e 6a5f abc abd +6a60 6a61 abb b4b +6a9f 6a60 abb abc +6a61 6a62 aba b4a +6aa0 6a61 aba abb +6a62 6a63 ab9 b49 +6aa1 6a62 ab9 aba +6a63 6a64 ab8 b48 +6aa2 6a63 ab8 ab9 +6a64 6a65 ab7 b47 +6aa3 6a64 ab7 ab8 +6a65 6a66 ab6 b46 +6aa4 6a65 ab6 ab7 +6a66 6a67 ab5 b45 +6aa5 6a66 ab5 ab6 +6a67 6a68 ab4 b44 +6aa6 6a67 ab4 ab5 +6a68 6a69 ab3 b43 +6aa7 6a68 ab3 ab4 +6a69 6a6a ab2 b42 +6aa8 6a69 ab2 ab3 +6aa9 6a6a ab1 ab2 +6a6b 6a6c a5f aef +6aaa 6a6b a5f a60 +6a6c 6a6d a5e aee +6aab 6a6c a5e a5f +6a6d 6a6e a5d aed +6aac 6a6d a5d a5e +6a6e 6a6f a5c aec +6aad 6a6e a5c a5d +6a6f 6a70 a5b aeb +6aae 6a6f a5b a5c +6a70 6a71 a5a aea +6aaf 6a70 a5a a5b +6a71 6a72 a59 ae9 +6ab0 6a71 a59 a5a +6a72 6a73 a58 ae8 +6ab1 6a72 a58 a59 +6a73 6a74 a57 ae7 +6ab2 6a73 a57 a58 +6a74 6a75 a56 ae6 +6ab3 6a74 a56 a57 +6a75 6a76 a55 ae5 +6ab4 6a75 a55 a56 +6a76 6a77 a54 ae4 +6ab5 6a76 a54 a55 +6a77 6a78 a53 ae3 +6ab6 6a77 a53 a54 +6a78 6a79 a52 ae2 +6ab7 6a78 a52 a53 +6a79 6a7a a51 ae1 +6ab8 6a79 a51 a52 +6a7a 6a7b a50 ae0 +6ab9 6a7a a50 a51 +6a7b 6a7c a4f adf +6aba 6a7b a4f a50 +6a7c 6a7d a4e ade +6abb 6a7c a4e a4f +6a7d 6a7e a4d add +6abc 6a7d a4d a4e +6a7e 6a7f a4c adc +6abd 6a7e a4c a4d +6a7f 6a80 a4b adb +6abe 6a7f a4b a4c +6a80 6a81 a4a ada +6abf 6a80 a4a a4b +6a81 6a82 a49 ad9 +6ac0 6a81 a49 a4a +6a82 6a83 a48 ad8 +6ac1 6a82 a48 a49 +6a83 6a84 a47 ad7 +6ac2 6a83 a47 a48 +6a84 6a85 a46 ad6 +6ac3 6a84 a46 a47 +6a85 6a86 a45 ad5 +6ac4 6a85 a45 a46 +6a86 6a87 a44 ad4 +6ac5 6a86 a44 a45 +6a87 6a88 a43 ad3 +6ac6 6a87 a43 a44 +6a88 6a89 a42 ad2 +6ac7 6a88 a42 a43 +6a89 6a8a a41 ad1 +6ac8 6a89 a41 a42 +6a8a 6a8b a40 ad0 +6ac9 6a8a a40 a41 +6a8b 6a8c a3f acf +6aca 6a8b a3f a40 +6a8c 6a8d a3e ace +6acb 6a8c a3e a3f +6a8d 6a8e a3d acd +6acc 6a8d a3d a3e +6a8e 6a8f a3c acc +6acd 6a8e a3c a3d +6a8f 6a90 a3b acb +6ace 6a8f a3b a3c +6a90 6a91 a3a aca +6acf 6a90 a3a a3b +6a91 6a92 a39 ac9 +6ad0 6a91 a39 a3a +6a92 6a93 a38 ac8 +6ad1 6a92 a38 a39 +6a93 6a94 a37 ac7 +6ad2 6a93 a37 a38 +6a94 6a95 a36 ac6 +6ad3 6a94 a36 a37 +6a95 6a96 a35 ac5 +6ad4 6a95 a35 a36 +6a96 6a97 a34 ac4 +6ad5 6a96 a34 a35 +6a97 6a98 a33 ac3 +6ad6 6a97 a33 a34 +6a98 6a99 a32 ac2 +6ad7 6a98 a32 a33 +6a99 6a9a a31 ac1 +6ad8 6a99 a31 a32 +6a9a 6a9b a30 ac0 +6ad9 6a9a a30 a31 +6a9b 6a9c a2f abf +6ada 6a9b a2f a30 +6a9c 6a9d a2e abe +6adb 6a9c a2e a2f +6a9d 6a9e a2d abd +6adc 6a9d a2d a2e +6a9e 6a9f a2c abc +6add 6a9e a2c a2d +6a9f 6aa0 a2b abb +6ade 6a9f a2b a2c +6aa0 6aa1 a2a aba +6adf 6aa0 a2a a2b +6aa1 6aa2 a29 ab9 +6ae0 6aa1 a29 a2a +6aa2 6aa3 a28 ab8 +6ae1 6aa2 a28 a29 +6aa3 6aa4 a27 ab7 +6ae2 6aa3 a27 a28 +6aa4 6aa5 a26 ab6 +6ae3 6aa4 a26 a27 +6aa5 6aa6 a25 ab5 +6ae4 6aa5 a25 a26 +6aa6 6aa7 a24 ab4 +6ae5 6aa6 a24 a25 +6aa7 6aa8 a23 ab3 +6ae6 6aa7 a23 a24 +6aa8 6aa9 a22 ab2 +6ae7 6aa8 a22 a23 +6ae8 6aa9 a21 a22 +6aaa 6aab 9cf a5f +6ae9 6aaa 9cf 9d0 +6aab 6aac 9ce a5e +6aea 6aab 9ce 9cf +6aac 6aad 9cd a5d +6aeb 6aac 9cd 9ce +6aad 6aae 9cc a5c +6aec 6aad 9cc 9cd +6aae 6aaf 9cb a5b +6aed 6aae 9cb 9cc +6aaf 6ab0 9ca a5a +6aee 6aaf 9ca 9cb +6ab0 6ab1 9c9 a59 +6aef 6ab0 9c9 9ca +6ab1 6ab2 9c8 a58 +6af0 6ab1 9c8 9c9 +6ab2 6ab3 9c7 a57 +6af1 6ab2 9c7 9c8 +6ab3 6ab4 9c6 a56 +6af2 6ab3 9c6 9c7 +6ab4 6ab5 9c5 a55 +6af3 6ab4 9c5 9c6 +6ab5 6ab6 9c4 a54 +6af4 6ab5 9c4 9c5 +6ab6 6ab7 9c3 a53 +6af5 6ab6 9c3 9c4 +6ab7 6ab8 9c2 a52 +6af6 6ab7 9c2 9c3 +6ab8 6ab9 9c1 a51 +6af7 6ab8 9c1 9c2 +6ab9 6aba 9c0 a50 +6af8 6ab9 9c0 9c1 +6aba 6abb 9bf a4f +6af9 6aba 9bf 9c0 +6abb 6abc 9be a4e +6afa 6abb 9be 9bf +6abc 6abd 9bd a4d +6afb 6abc 9bd 9be +6abd 6abe 9bc a4c +6afc 6abd 9bc 9bd +6abe 6abf 9bb a4b +6afd 6abe 9bb 9bc +6abf 6ac0 9ba a4a +6afe 6abf 9ba 9bb +6ac0 6ac1 9b9 a49 +6aff 6ac0 9b9 9ba +6ac1 6ac2 9b8 a48 +6b00 6ac1 9b8 9b9 +6ac2 6ac3 9b7 a47 +6b01 6ac2 9b7 9b8 +6ac3 6ac4 9b6 a46 +6b02 6ac3 9b6 9b7 +6ac4 6ac5 9b5 a45 +6b03 6ac4 9b5 9b6 +6ac5 6ac6 9b4 a44 +6b04 6ac5 9b4 9b5 +6ac6 6ac7 9b3 a43 +6b05 6ac6 9b3 9b4 +6ac7 6ac8 9b2 a42 +6b06 6ac7 9b2 9b3 +6ac8 6ac9 9b1 a41 +6b07 6ac8 9b1 9b2 +6ac9 6aca 9b0 a40 +6b08 6ac9 9b0 9b1 +6aca 6acb 9af a3f +6b09 6aca 9af 9b0 +6acb 6acc 9ae a3e +6b0a 6acb 9ae 9af +6acc 6acd 9ad a3d +6b0b 6acc 9ad 9ae +6acd 6ace 9ac a3c +6b0c 6acd 9ac 9ad +6ace 6acf 9ab a3b +6b0d 6ace 9ab 9ac +6acf 6ad0 9aa a3a +6b0e 6acf 9aa 9ab +6ad0 6ad1 9a9 a39 +6b0f 6ad0 9a9 9aa +6ad1 6ad2 9a8 a38 +6b10 6ad1 9a8 9a9 +6ad2 6ad3 9a7 a37 +6b11 6ad2 9a7 9a8 +6ad3 6ad4 9a6 a36 +6b12 6ad3 9a6 9a7 +6ad4 6ad5 9a5 a35 +6b13 6ad4 9a5 9a6 +6ad5 6ad6 9a4 a34 +6b14 6ad5 9a4 9a5 +6ad6 6ad7 9a3 a33 +6b15 6ad6 9a3 9a4 +6ad7 6ad8 9a2 a32 +6b16 6ad7 9a2 9a3 +6ad8 6ad9 9a1 a31 +6b17 6ad8 9a1 9a2 +6ad9 6ada 9a0 a30 +6b18 6ad9 9a0 9a1 +6ada 6adb 99f a2f +6b19 6ada 99f 9a0 +6adb 6adc 99e a2e +6b1a 6adb 99e 99f +6adc 6add 99d a2d +6b1b 6adc 99d 99e +6add 6ade 99c a2c +6b1c 6add 99c 99d +6ade 6adf 99b a2b +6b1d 6ade 99b 99c +6adf 6ae0 99a a2a +6b1e 6adf 99a 99b +6ae0 6ae1 999 a29 +6b1f 6ae0 999 99a +6ae1 6ae2 998 a28 +6b20 6ae1 998 999 +6ae2 6ae3 997 a27 +6b21 6ae2 997 998 +6ae3 6ae4 996 a26 +6b22 6ae3 996 997 +6ae4 6ae5 995 a25 +6b23 6ae4 995 996 +6ae5 6ae6 994 a24 +6b24 6ae5 994 995 +6ae6 6ae7 993 a23 +6b25 6ae6 993 994 +6ae7 6ae8 992 a22 +6b26 6ae7 992 993 +6b27 6ae8 991 992 +6ae9 6aea 93f 9cf +6b28 6ae9 93f 940 +6aea 6aeb 93e 9ce +6b29 6aea 93e 93f +6aeb 6aec 93d 9cd +6b2a 6aeb 93d 93e +6aec 6aed 93c 9cc +6b2b 6aec 93c 93d +6aed 6aee 93b 9cb +6b2c 6aed 93b 93c +6aee 6aef 93a 9ca +6b2d 6aee 93a 93b +6aef 6af0 939 9c9 +6b2e 6aef 939 93a +6af0 6af1 938 9c8 +6b2f 6af0 938 939 +6af1 6af2 937 9c7 +6b30 6af1 937 938 +6af2 6af3 936 9c6 +6b31 6af2 936 937 +6af3 6af4 935 9c5 +6b32 6af3 935 936 +6af4 6af5 934 9c4 +6b33 6af4 934 935 +6af5 6af6 933 9c3 +6b34 6af5 933 934 +6af6 6af7 932 9c2 +6b35 6af6 932 933 +6af7 6af8 931 9c1 +6b36 6af7 931 932 +6af8 6af9 930 9c0 +6b37 6af8 930 931 +6af9 6afa 92f 9bf +6b38 6af9 92f 930 +6afa 6afb 92e 9be +6b39 6afa 92e 92f +6afb 6afc 92d 9bd +6b3a 6afb 92d 92e +6afc 6afd 92c 9bc +6b3b 6afc 92c 92d +6afd 6afe 92b 9bb +6b3c 6afd 92b 92c +6afe 6aff 92a 9ba +6b3d 6afe 92a 92b +6aff 6b00 929 9b9 +6b3e 6aff 929 92a +6b00 6b01 928 9b8 +6b3f 6b00 928 929 +6b01 6b02 927 9b7 +6b40 6b01 927 928 +6b02 6b03 926 9b6 +6b41 6b02 926 927 +6b03 6b04 925 9b5 +6b42 6b03 925 926 +6b04 6b05 924 9b4 +6b43 6b04 924 925 +6b05 6b06 923 9b3 +6b44 6b05 923 924 +6b06 6b07 922 9b2 +6b45 6b06 922 923 +6b07 6b08 921 9b1 +6b46 6b07 921 922 +6b08 6b09 920 9b0 +6b47 6b08 920 921 +6b09 6b0a 91f 9af +6b48 6b09 91f 920 +6b0a 6b0b 91e 9ae +6b49 6b0a 91e 91f +6b0b 6b0c 91d 9ad +6b4a 6b0b 91d 91e +6b0c 6b0d 91c 9ac +6b4b 6b0c 91c 91d +6b0d 6b0e 91b 9ab +6b4c 6b0d 91b 91c +6b0e 6b0f 91a 9aa +6b4d 6b0e 91a 91b +6b0f 6b10 919 9a9 +6b4e 6b0f 919 91a +6b10 6b11 918 9a8 +6b4f 6b10 918 919 +6b11 6b12 917 9a7 +6b50 6b11 917 918 +6b12 6b13 916 9a6 +6b51 6b12 916 917 +6b13 6b14 915 9a5 +6b52 6b13 915 916 +6b14 6b15 914 9a4 +6b53 6b14 914 915 +6b15 6b16 913 9a3 +6b54 6b15 913 914 +6b16 6b17 912 9a2 +6b55 6b16 912 913 +6b17 6b18 911 9a1 +6b56 6b17 911 912 +6b18 6b19 910 9a0 +6b57 6b18 910 911 +6b19 6b1a 90f 99f +6b58 6b19 90f 910 +6b1a 6b1b 90e 99e +6b59 6b1a 90e 90f +6b1b 6b1c 90d 99d +6b5a 6b1b 90d 90e +6b1c 6b1d 90c 99c +6b5b 6b1c 90c 90d +6b1d 6b1e 90b 99b +6b5c 6b1d 90b 90c +6b1e 6b1f 90a 99a +6b5d 6b1e 90a 90b +6b1f 6b20 909 999 +6b5e 6b1f 909 90a +6b20 6b21 908 998 +6b5f 6b20 908 909 +6b21 6b22 907 997 +6b60 6b21 907 908 +6b22 6b23 906 996 +6b61 6b22 906 907 +6b23 6b24 905 995 +6b62 6b23 905 906 +6b24 6b25 904 994 +6b63 6b24 904 905 +6b25 6b26 903 993 +6b64 6b25 903 904 +6b26 6b27 902 992 +6b65 6b26 902 903 +6b66 6b27 901 902 +6b28 6b29 8af 93f +6b67 6b28 8af 8b0 +6b29 6b2a 8ae 93e +6b68 6b29 8ae 8af +6b2a 6b2b 8ad 93d +6b69 6b2a 8ad 8ae +6b2b 6b2c 8ac 93c +6b6a 6b2b 8ac 8ad +6b2c 6b2d 8ab 93b +6b6b 6b2c 8ab 8ac +6b2d 6b2e 8aa 93a +6b6c 6b2d 8aa 8ab +6b2e 6b2f 8a9 939 +6b6d 6b2e 8a9 8aa +6b2f 6b30 8a8 938 +6b6e 6b2f 8a8 8a9 +6b30 6b31 8a7 937 +6b6f 6b30 8a7 8a8 +6b31 6b32 8a6 936 +6b70 6b31 8a6 8a7 +6b32 6b33 8a5 935 +6b71 6b32 8a5 8a6 +6b33 6b34 8a4 934 +6b72 6b33 8a4 8a5 +6b34 6b35 8a3 933 +6b73 6b34 8a3 8a4 +6b35 6b36 8a2 932 +6b74 6b35 8a2 8a3 +6b36 6b37 8a1 931 +6b75 6b36 8a1 8a2 +6b37 6b38 8a0 930 +6b76 6b37 8a0 8a1 +6b38 6b39 89f 92f +6b77 6b38 89f 8a0 +6b39 6b3a 89e 92e +6b78 6b39 89e 89f +6b3a 6b3b 89d 92d +6b79 6b3a 89d 89e +6b3b 6b3c 89c 92c +6b7a 6b3b 89c 89d +6b3c 6b3d 89b 92b +6b7b 6b3c 89b 89c +6b3d 6b3e 89a 92a +6b7c 6b3d 89a 89b +6b3e 6b3f 899 929 +6b7d 6b3e 899 89a +6b3f 6b40 898 928 +6b7e 6b3f 898 899 +6b40 6b41 897 927 +6b7f 6b40 897 898 +6b41 6b42 896 926 +6b80 6b41 896 897 +6b42 6b43 895 925 +6b81 6b42 895 896 +6b43 6b44 894 924 +6b82 6b43 894 895 +6b44 6b45 893 923 +6b83 6b44 893 894 +6b45 6b46 892 922 +6b84 6b45 892 893 +6b46 6b47 891 921 +6b85 6b46 891 892 +6b47 6b48 890 920 +6b86 6b47 890 891 +6b48 6b49 88f 91f +6b87 6b48 88f 890 +6b49 6b4a 88e 91e +6b88 6b49 88e 88f +6b4a 6b4b 88d 91d +6b89 6b4a 88d 88e +6b4b 6b4c 88c 91c +6b8a 6b4b 88c 88d +6b4c 6b4d 88b 91b +6b8b 6b4c 88b 88c +6b4d 6b4e 88a 91a +6b8c 6b4d 88a 88b +6b4e 6b4f 889 919 +6b8d 6b4e 889 88a +6b4f 6b50 888 918 +6b8e 6b4f 888 889 +6b50 6b51 887 917 +6b8f 6b50 887 888 +6b51 6b52 886 916 +6b90 6b51 886 887 +6b52 6b53 885 915 +6b91 6b52 885 886 +6b53 6b54 884 914 +6b92 6b53 884 885 +6b54 6b55 883 913 +6b93 6b54 883 884 +6b55 6b56 882 912 +6b94 6b55 882 883 +6b56 6b57 881 911 +6b95 6b56 881 882 +6b57 6b58 880 910 +6b96 6b57 880 881 +6b58 6b59 87f 90f +6b97 6b58 87f 880 +6b59 6b5a 87e 90e +6b98 6b59 87e 87f +6b5a 6b5b 87d 90d +6b99 6b5a 87d 87e +6b5b 6b5c 87c 90c +6b9a 6b5b 87c 87d +6b5c 6b5d 87b 90b +6b9b 6b5c 87b 87c +6b5d 6b5e 87a 90a +6b9c 6b5d 87a 87b +6b5e 6b5f 879 909 +6b9d 6b5e 879 87a +6b5f 6b60 878 908 +6b9e 6b5f 878 879 +6b60 6b61 877 907 +6b9f 6b60 877 878 +6b61 6b62 876 906 +6ba0 6b61 876 877 +6b62 6b63 875 905 +6ba1 6b62 875 876 +6b63 6b64 874 904 +6ba2 6b63 874 875 +6b64 6b65 873 903 +6ba3 6b64 873 874 +6b65 6b66 872 902 +6ba4 6b65 872 873 +6ba5 6b66 871 872 +6b67 6b68 81f 8af +6ba6 6b67 81f 820 +6b68 6b69 81e 8ae +6ba7 6b68 81e 81f +6b69 6b6a 81d 8ad +6ba8 6b69 81d 81e +6b6a 6b6b 81c 8ac +6ba9 6b6a 81c 81d +6b6b 6b6c 81b 8ab +6baa 6b6b 81b 81c +6b6c 6b6d 81a 8aa +6bab 6b6c 81a 81b +6b6d 6b6e 819 8a9 +6bac 6b6d 819 81a +6b6e 6b6f 818 8a8 +6bad 6b6e 818 819 +6b6f 6b70 817 8a7 +6bae 6b6f 817 818 +6b70 6b71 816 8a6 +6baf 6b70 816 817 +6b71 6b72 815 8a5 +6bb0 6b71 815 816 +6b72 6b73 814 8a4 +6bb1 6b72 814 815 +6b73 6b74 813 8a3 +6bb2 6b73 813 814 +6b74 6b75 812 8a2 +6bb3 6b74 812 813 +6b75 6b76 811 8a1 +6bb4 6b75 811 812 +6b76 6b77 810 8a0 +6bb5 6b76 810 811 +6b77 6b78 80f 89f +6bb6 6b77 80f 810 +6b78 6b79 80e 89e +6bb7 6b78 80e 80f +6b79 6b7a 80d 89d +6bb8 6b79 80d 80e +6b7a 6b7b 80c 89c +6bb9 6b7a 80c 80d +6b7b 6b7c 80b 89b +6bba 6b7b 80b 80c +6b7c 6b7d 80a 89a +6bbb 6b7c 80a 80b +6b7d 6b7e 809 899 +6bbc 6b7d 809 80a +6b7e 6b7f 808 898 +6bbd 6b7e 808 809 +6b7f 6b80 807 897 +6bbe 6b7f 807 808 +6b80 6b81 806 896 +6bbf 6b80 806 807 +6b81 6b82 805 895 +6bc0 6b81 805 806 +6b82 6b83 804 894 +6bc1 6b82 804 805 +6b83 6b84 803 893 +6bc2 6b83 803 804 +6b84 6b85 802 892 +6bc3 6b84 802 803 +6b85 6b86 801 891 +6bc4 6b85 801 802 +6b86 6b87 800 890 +6bc5 6b86 800 801 +6b87 6b88 7ff 88f +6bc6 6b87 7ff 800 +6b88 6b89 7fe 88e +6bc7 6b88 7fe 7ff +6b89 6b8a 7fd 88d +6bc8 6b89 7fd 7fe +6b8a 6b8b 7fc 88c +6bc9 6b8a 7fc 7fd +6b8b 6b8c 7fb 88b +6bca 6b8b 7fb 7fc +6b8c 6b8d 7fa 88a +6bcb 6b8c 7fa 7fb +6b8d 6b8e 7f9 889 +6bcc 6b8d 7f9 7fa +6b8e 6b8f 7f8 888 +6bcd 6b8e 7f8 7f9 +6b8f 6b90 7f7 887 +6bce 6b8f 7f7 7f8 +6b90 6b91 7f6 886 +6bcf 6b90 7f6 7f7 +6b91 6b92 7f5 885 +6bd0 6b91 7f5 7f6 +6b92 6b93 7f4 884 +6bd1 6b92 7f4 7f5 +6b93 6b94 7f3 883 +6bd2 6b93 7f3 7f4 +6b94 6b95 7f2 882 +6bd3 6b94 7f2 7f3 +6b95 6b96 7f1 881 +6bd4 6b95 7f1 7f2 +6b96 6b97 7f0 880 +6bd5 6b96 7f0 7f1 +6b97 6b98 7ef 87f +6bd6 6b97 7ef 7f0 +6b98 6b99 7ee 87e +6bd7 6b98 7ee 7ef +6b99 6b9a 7ed 87d +6bd8 6b99 7ed 7ee +6b9a 6b9b 7ec 87c +6bd9 6b9a 7ec 7ed +6b9b 6b9c 7eb 87b +6bda 6b9b 7eb 7ec +6b9c 6b9d 7ea 87a +6bdb 6b9c 7ea 7eb +6b9d 6b9e 7e9 879 +6bdc 6b9d 7e9 7ea +6b9e 6b9f 7e8 878 +6bdd 6b9e 7e8 7e9 +6b9f 6ba0 7e7 877 +6bde 6b9f 7e7 7e8 +6ba0 6ba1 7e6 876 +6bdf 6ba0 7e6 7e7 +6ba1 6ba2 7e5 875 +6be0 6ba1 7e5 7e6 +6ba2 6ba3 7e4 874 +6be1 6ba2 7e4 7e5 +6ba3 6ba4 7e3 873 +6be2 6ba3 7e3 7e4 +6ba4 6ba5 7e2 872 +6be3 6ba4 7e2 7e3 +6be4 6ba5 7e1 7e2 +6ba6 6ba7 78f 81f +6be5 6ba6 78f 790 +6ba7 6ba8 78e 81e +6be6 6ba7 78e 78f +6ba8 6ba9 78d 81d +6be7 6ba8 78d 78e +6ba9 6baa 78c 81c +6be8 6ba9 78c 78d +6baa 6bab 78b 81b +6be9 6baa 78b 78c +6bab 6bac 78a 81a +6bea 6bab 78a 78b +6bac 6bad 789 819 +6beb 6bac 789 78a +6bad 6bae 788 818 +6bec 6bad 788 789 +6bae 6baf 787 817 +6bed 6bae 787 788 +6baf 6bb0 786 816 +6bee 6baf 786 787 +6bb0 6bb1 785 815 +6bef 6bb0 785 786 +6bb1 6bb2 784 814 +6bf0 6bb1 784 785 +6bb2 6bb3 783 813 +6bf1 6bb2 783 784 +6bb3 6bb4 782 812 +6bf2 6bb3 782 783 +6bb4 6bb5 781 811 +6bf3 6bb4 781 782 +6bb5 6bb6 780 810 +6bf4 6bb5 780 781 +6bb6 6bb7 77f 80f +6bf5 6bb6 77f 780 +6bb7 6bb8 77e 80e +6bf6 6bb7 77e 77f +6bb8 6bb9 77d 80d +6bf7 6bb8 77d 77e +6bb9 6bba 77c 80c +6bf8 6bb9 77c 77d +6bba 6bbb 77b 80b +6bf9 6bba 77b 77c +6bbb 6bbc 77a 80a +6bfa 6bbb 77a 77b +6bbc 6bbd 779 809 +6bfb 6bbc 779 77a +6bbd 6bbe 778 808 +6bfc 6bbd 778 779 +6bbe 6bbf 777 807 +6bfd 6bbe 777 778 +6bbf 6bc0 776 806 +6bfe 6bbf 776 777 +6bc0 6bc1 775 805 +6bff 6bc0 775 776 +6bc1 6bc2 774 804 +6c00 6bc1 774 775 +6bc2 6bc3 773 803 +6c01 6bc2 773 774 +6bc3 6bc4 772 802 +6c02 6bc3 772 773 +6bc4 6bc5 771 801 +6c03 6bc4 771 772 +6bc5 6bc6 770 800 +6c04 6bc5 770 771 +6bc6 6bc7 76f 7ff +6c05 6bc6 76f 770 +6bc7 6bc8 76e 7fe +6c06 6bc7 76e 76f +6bc8 6bc9 76d 7fd +6c07 6bc8 76d 76e +6bc9 6bca 76c 7fc +6c08 6bc9 76c 76d +6bca 6bcb 76b 7fb +6c09 6bca 76b 76c +6bcb 6bcc 76a 7fa +6c0a 6bcb 76a 76b +6bcc 6bcd 769 7f9 +6c0b 6bcc 769 76a +6bcd 6bce 768 7f8 +6c0c 6bcd 768 769 +6bce 6bcf 767 7f7 +6c0d 6bce 767 768 +6bcf 6bd0 766 7f6 +6c0e 6bcf 766 767 +6bd0 6bd1 765 7f5 +6c0f 6bd0 765 766 +6bd1 6bd2 764 7f4 +6c10 6bd1 764 765 +6bd2 6bd3 763 7f3 +6c11 6bd2 763 764 +6bd3 6bd4 762 7f2 +6c12 6bd3 762 763 +6bd4 6bd5 761 7f1 +6c13 6bd4 761 762 +6bd5 6bd6 760 7f0 +6c14 6bd5 760 761 +6bd6 6bd7 75f 7ef +6c15 6bd6 75f 760 +6bd7 6bd8 75e 7ee +6c16 6bd7 75e 75f +6bd8 6bd9 75d 7ed +6c17 6bd8 75d 75e +6bd9 6bda 75c 7ec +6c18 6bd9 75c 75d +6bda 6bdb 75b 7eb +6c19 6bda 75b 75c +6bdb 6bdc 75a 7ea +6c1a 6bdb 75a 75b +6bdc 6bdd 759 7e9 +6c1b 6bdc 759 75a +6bdd 6bde 758 7e8 +6c1c 6bdd 758 759 +6bde 6bdf 757 7e7 +6c1d 6bde 757 758 +6bdf 6be0 756 7e6 +6c1e 6bdf 756 757 +6be0 6be1 755 7e5 +6c1f 6be0 755 756 +6be1 6be2 754 7e4 +6c20 6be1 754 755 +6be2 6be3 753 7e3 +6c21 6be2 753 754 +6be3 6be4 752 7e2 +6c22 6be3 752 753 +6c23 6be4 751 752 +6be5 6be6 6ff 78f +6c24 6be5 6ff 700 +6be6 6be7 6fe 78e +6c25 6be6 6fe 6ff +6be7 6be8 6fd 78d +6c26 6be7 6fd 6fe +6be8 6be9 6fc 78c +6c27 6be8 6fc 6fd +6be9 6bea 6fb 78b +6c28 6be9 6fb 6fc +6bea 6beb 6fa 78a +6c29 6bea 6fa 6fb +6beb 6bec 6f9 789 +6c2a 6beb 6f9 6fa +6bec 6bed 6f8 788 +6c2b 6bec 6f8 6f9 +6bed 6bee 6f7 787 +6c2c 6bed 6f7 6f8 +6bee 6bef 6f6 786 +6c2d 6bee 6f6 6f7 +6bef 6bf0 6f5 785 +6c2e 6bef 6f5 6f6 +6bf0 6bf1 6f4 784 +6c2f 6bf0 6f4 6f5 +6bf1 6bf2 6f3 783 +6c30 6bf1 6f3 6f4 +6bf2 6bf3 6f2 782 +6c31 6bf2 6f2 6f3 +6bf3 6bf4 6f1 781 +6c32 6bf3 6f1 6f2 +6bf4 6bf5 6f0 780 +6c33 6bf4 6f0 6f1 +6bf5 6bf6 6ef 77f +6c34 6bf5 6ef 6f0 +6bf6 6bf7 6ee 77e +6c35 6bf6 6ee 6ef +6bf7 6bf8 6ed 77d +6c36 6bf7 6ed 6ee +6bf8 6bf9 6ec 77c +6c37 6bf8 6ec 6ed +6bf9 6bfa 6eb 77b +6c38 6bf9 6eb 6ec +6bfa 6bfb 6ea 77a +6c39 6bfa 6ea 6eb +6bfb 6bfc 6e9 779 +6c3a 6bfb 6e9 6ea +6bfc 6bfd 6e8 778 +6c3b 6bfc 6e8 6e9 +6bfd 6bfe 6e7 777 +6c3c 6bfd 6e7 6e8 +6bfe 6bff 6e6 776 +6c3d 6bfe 6e6 6e7 +6bff 6c00 6e5 775 +6c3e 6bff 6e5 6e6 +6c00 6c01 6e4 774 +6c3f 6c00 6e4 6e5 +6c01 6c02 6e3 773 +6c40 6c01 6e3 6e4 +6c02 6c03 6e2 772 +6c41 6c02 6e2 6e3 +6c03 6c04 6e1 771 +6c42 6c03 6e1 6e2 +6c04 6c05 6e0 770 +6c43 6c04 6e0 6e1 +6c05 6c06 6df 76f +6c44 6c05 6df 6e0 +6c06 6c07 6de 76e +6c45 6c06 6de 6df +6c07 6c08 6dd 76d +6c46 6c07 6dd 6de +6c08 6c09 6dc 76c +6c47 6c08 6dc 6dd +6c09 6c0a 6db 76b +6c48 6c09 6db 6dc +6c0a 6c0b 6da 76a +6c49 6c0a 6da 6db +6c0b 6c0c 6d9 769 +6c4a 6c0b 6d9 6da +6c0c 6c0d 6d8 768 +6c4b 6c0c 6d8 6d9 +6c0d 6c0e 6d7 767 +6c4c 6c0d 6d7 6d8 +6c0e 6c0f 6d6 766 +6c4d 6c0e 6d6 6d7 +6c0f 6c10 6d5 765 +6c4e 6c0f 6d5 6d6 +6c10 6c11 6d4 764 +6c4f 6c10 6d4 6d5 +6c11 6c12 6d3 763 +6c50 6c11 6d3 6d4 +6c12 6c13 6d2 762 +6c51 6c12 6d2 6d3 +6c13 6c14 6d1 761 +6c52 6c13 6d1 6d2 +6c14 6c15 6d0 760 +6c53 6c14 6d0 6d1 +6c15 6c16 6cf 75f +6c54 6c15 6cf 6d0 +6c16 6c17 6ce 75e +6c55 6c16 6ce 6cf +6c17 6c18 6cd 75d +6c56 6c17 6cd 6ce +6c18 6c19 6cc 75c +6c57 6c18 6cc 6cd +6c19 6c1a 6cb 75b +6c58 6c19 6cb 6cc +6c1a 6c1b 6ca 75a +6c59 6c1a 6ca 6cb +6c1b 6c1c 6c9 759 +6c5a 6c1b 6c9 6ca +6c1c 6c1d 6c8 758 +6c5b 6c1c 6c8 6c9 +6c1d 6c1e 6c7 757 +6c5c 6c1d 6c7 6c8 +6c1e 6c1f 6c6 756 +6c5d 6c1e 6c6 6c7 +6c1f 6c20 6c5 755 +6c5e 6c1f 6c5 6c6 +6c20 6c21 6c4 754 +6c5f 6c20 6c4 6c5 +6c21 6c22 6c3 753 +6c60 6c21 6c3 6c4 +6c22 6c23 6c2 752 +6c61 6c22 6c2 6c3 +6c62 6c23 6c1 6c2 +6c24 6c25 66f 6ff +6c63 6c24 66f 670 +6c25 6c26 66e 6fe +6c64 6c25 66e 66f +6c26 6c27 66d 6fd +6c65 6c26 66d 66e +6c27 6c28 66c 6fc +6c66 6c27 66c 66d +6c28 6c29 66b 6fb +6c67 6c28 66b 66c +6c29 6c2a 66a 6fa +6c68 6c29 66a 66b +6c2a 6c2b 669 6f9 +6c69 6c2a 669 66a +6c2b 6c2c 668 6f8 +6c6a 6c2b 668 669 +6c2c 6c2d 667 6f7 +6c6b 6c2c 667 668 +6c2d 6c2e 666 6f6 +6c6c 6c2d 666 667 +6c2e 6c2f 665 6f5 +6c6d 6c2e 665 666 +6c2f 6c30 664 6f4 +6c6e 6c2f 664 665 +6c30 6c31 663 6f3 +6c6f 6c30 663 664 +6c31 6c32 662 6f2 +6c70 6c31 662 663 +6c32 6c33 661 6f1 +6c71 6c32 661 662 +6c33 6c34 660 6f0 +6c72 6c33 660 661 +6c34 6c35 65f 6ef +6c73 6c34 65f 660 +6c35 6c36 65e 6ee +6c74 6c35 65e 65f +6c36 6c37 65d 6ed +6c75 6c36 65d 65e +6c37 6c38 65c 6ec +6c76 6c37 65c 65d +6c38 6c39 65b 6eb +6c77 6c38 65b 65c +6c39 6c3a 65a 6ea +6c78 6c39 65a 65b +6c3a 6c3b 659 6e9 +6c79 6c3a 659 65a +6c3b 6c3c 658 6e8 +6c7a 6c3b 658 659 +6c3c 6c3d 657 6e7 +6c7b 6c3c 657 658 +6c3d 6c3e 656 6e6 +6c7c 6c3d 656 657 +6c3e 6c3f 655 6e5 +6c7d 6c3e 655 656 +6c3f 6c40 654 6e4 +6c7e 6c3f 654 655 +6c40 6c41 653 6e3 +6c7f 6c40 653 654 +6c41 6c42 652 6e2 +6c80 6c41 652 653 +6c42 6c43 651 6e1 +6c81 6c42 651 652 +6c43 6c44 650 6e0 +6c82 6c43 650 651 +6c44 6c45 64f 6df +6c83 6c44 64f 650 +6c45 6c46 64e 6de +6c84 6c45 64e 64f +6c46 6c47 64d 6dd +6c85 6c46 64d 64e +6c47 6c48 64c 6dc +6c86 6c47 64c 64d +6c48 6c49 64b 6db +6c87 6c48 64b 64c +6c49 6c4a 64a 6da +6c88 6c49 64a 64b +6c4a 6c4b 649 6d9 +6c89 6c4a 649 64a +6c4b 6c4c 648 6d8 +6c8a 6c4b 648 649 +6c4c 6c4d 647 6d7 +6c8b 6c4c 647 648 +6c4d 6c4e 646 6d6 +6c8c 6c4d 646 647 +6c4e 6c4f 645 6d5 +6c8d 6c4e 645 646 +6c4f 6c50 644 6d4 +6c8e 6c4f 644 645 +6c50 6c51 643 6d3 +6c8f 6c50 643 644 +6c51 6c52 642 6d2 +6c90 6c51 642 643 +6c52 6c53 641 6d1 +6c91 6c52 641 642 +6c53 6c54 640 6d0 +6c92 6c53 640 641 +6c54 6c55 63f 6cf +6c93 6c54 63f 640 +6c55 6c56 63e 6ce +6c94 6c55 63e 63f +6c56 6c57 63d 6cd +6c95 6c56 63d 63e +6c57 6c58 63c 6cc +6c96 6c57 63c 63d +6c58 6c59 63b 6cb +6c97 6c58 63b 63c +6c59 6c5a 63a 6ca +6c98 6c59 63a 63b +6c5a 6c5b 639 6c9 +6c99 6c5a 639 63a +6c5b 6c5c 638 6c8 +6c9a 6c5b 638 639 +6c5c 6c5d 637 6c7 +6c9b 6c5c 637 638 +6c5d 6c5e 636 6c6 +6c9c 6c5d 636 637 +6c5e 6c5f 635 6c5 +6c9d 6c5e 635 636 +6c5f 6c60 634 6c4 +6c9e 6c5f 634 635 +6c60 6c61 633 6c3 +6c9f 6c60 633 634 +6c61 6c62 632 6c2 +6ca0 6c61 632 633 +6ca1 6c62 631 632 +6c63 6c64 5df 66f +6ca2 6c63 5df 5e0 +6c64 6c65 5de 66e +6ca3 6c64 5de 5df +6c65 6c66 5dd 66d +6ca4 6c65 5dd 5de +6c66 6c67 5dc 66c +6ca5 6c66 5dc 5dd +6c67 6c68 5db 66b +6ca6 6c67 5db 5dc +6c68 6c69 5da 66a +6ca7 6c68 5da 5db +6c69 6c6a 5d9 669 +6ca8 6c69 5d9 5da +6c6a 6c6b 5d8 668 +6ca9 6c6a 5d8 5d9 +6c6b 6c6c 5d7 667 +6caa 6c6b 5d7 5d8 +6c6c 6c6d 5d6 666 +6cab 6c6c 5d6 5d7 +6c6d 6c6e 5d5 665 +6cac 6c6d 5d5 5d6 +6c6e 6c6f 5d4 664 +6cad 6c6e 5d4 5d5 +6c6f 6c70 5d3 663 +6cae 6c6f 5d3 5d4 +6c70 6c71 5d2 662 +6caf 6c70 5d2 5d3 +6c71 6c72 5d1 661 +6cb0 6c71 5d1 5d2 +6c72 6c73 5d0 660 +6cb1 6c72 5d0 5d1 +6c73 6c74 5cf 65f +6cb2 6c73 5cf 5d0 +6c74 6c75 5ce 65e +6cb3 6c74 5ce 5cf +6c75 6c76 5cd 65d +6cb4 6c75 5cd 5ce +6c76 6c77 5cc 65c +6cb5 6c76 5cc 5cd +6c77 6c78 5cb 65b +6cb6 6c77 5cb 5cc +6c78 6c79 5ca 65a +6cb7 6c78 5ca 5cb +6c79 6c7a 5c9 659 +6cb8 6c79 5c9 5ca +6c7a 6c7b 5c8 658 +6cb9 6c7a 5c8 5c9 +6c7b 6c7c 5c7 657 +6cba 6c7b 5c7 5c8 +6c7c 6c7d 5c6 656 +6cbb 6c7c 5c6 5c7 +6c7d 6c7e 5c5 655 +6cbc 6c7d 5c5 5c6 +6c7e 6c7f 5c4 654 +6cbd 6c7e 5c4 5c5 +6c7f 6c80 5c3 653 +6cbe 6c7f 5c3 5c4 +6c80 6c81 5c2 652 +6cbf 6c80 5c2 5c3 +6c81 6c82 5c1 651 +6cc0 6c81 5c1 5c2 +6c82 6c83 5c0 650 +6cc1 6c82 5c0 5c1 +6c83 6c84 5bf 64f +6cc2 6c83 5bf 5c0 +6c84 6c85 5be 64e +6cc3 6c84 5be 5bf +6c85 6c86 5bd 64d +6cc4 6c85 5bd 5be +6c86 6c87 5bc 64c +6cc5 6c86 5bc 5bd +6c87 6c88 5bb 64b +6cc6 6c87 5bb 5bc +6c88 6c89 5ba 64a +6cc7 6c88 5ba 5bb +6c89 6c8a 5b9 649 +6cc8 6c89 5b9 5ba +6c8a 6c8b 5b8 648 +6cc9 6c8a 5b8 5b9 +6c8b 6c8c 5b7 647 +6cca 6c8b 5b7 5b8 +6c8c 6c8d 5b6 646 +6ccb 6c8c 5b6 5b7 +6c8d 6c8e 5b5 645 +6ccc 6c8d 5b5 5b6 +6c8e 6c8f 5b4 644 +6ccd 6c8e 5b4 5b5 +6c8f 6c90 5b3 643 +6cce 6c8f 5b3 5b4 +6c90 6c91 5b2 642 +6ccf 6c90 5b2 5b3 +6c91 6c92 5b1 641 +6cd0 6c91 5b1 5b2 +6c92 6c93 5b0 640 +6cd1 6c92 5b0 5b1 +6c93 6c94 5af 63f +6cd2 6c93 5af 5b0 +6c94 6c95 5ae 63e +6cd3 6c94 5ae 5af +6c95 6c96 5ad 63d +6cd4 6c95 5ad 5ae +6c96 6c97 5ac 63c +6cd5 6c96 5ac 5ad +6c97 6c98 5ab 63b +6cd6 6c97 5ab 5ac +6c98 6c99 5aa 63a +6cd7 6c98 5aa 5ab +6c99 6c9a 5a9 639 +6cd8 6c99 5a9 5aa +6c9a 6c9b 5a8 638 +6cd9 6c9a 5a8 5a9 +6c9b 6c9c 5a7 637 +6cda 6c9b 5a7 5a8 +6c9c 6c9d 5a6 636 +6cdb 6c9c 5a6 5a7 +6c9d 6c9e 5a5 635 +6cdc 6c9d 5a5 5a6 +6c9e 6c9f 5a4 634 +6cdd 6c9e 5a4 5a5 +6c9f 6ca0 5a3 633 +6cde 6c9f 5a3 5a4 +6ca0 6ca1 5a2 632 +6cdf 6ca0 5a2 5a3 +6ce0 6ca1 5a1 5a2 +6ca2 6ca3 54f 5df +6ce1 6ca2 54f 550 +6ca3 6ca4 54e 5de +6ce2 6ca3 54e 54f +6ca4 6ca5 54d 5dd +6ce3 6ca4 54d 54e +6ca5 6ca6 54c 5dc +6ce4 6ca5 54c 54d +6ca6 6ca7 54b 5db +6ce5 6ca6 54b 54c +6ca7 6ca8 54a 5da +6ce6 6ca7 54a 54b +6ca8 6ca9 549 5d9 +6ce7 6ca8 549 54a +6ca9 6caa 548 5d8 +6ce8 6ca9 548 549 +6caa 6cab 547 5d7 +6ce9 6caa 547 548 +6cab 6cac 546 5d6 +6cea 6cab 546 547 +6cac 6cad 545 5d5 +6ceb 6cac 545 546 +6cad 6cae 544 5d4 +6cec 6cad 544 545 +6cae 6caf 543 5d3 +6ced 6cae 543 544 +6caf 6cb0 542 5d2 +6cee 6caf 542 543 +6cb0 6cb1 541 5d1 +6cef 6cb0 541 542 +6cb1 6cb2 540 5d0 +6cf0 6cb1 540 541 +6cb2 6cb3 53f 5cf +6cf1 6cb2 53f 540 +6cb3 6cb4 53e 5ce +6cf2 6cb3 53e 53f +6cb4 6cb5 53d 5cd +6cf3 6cb4 53d 53e +6cb5 6cb6 53c 5cc +6cf4 6cb5 53c 53d +6cb6 6cb7 53b 5cb +6cf5 6cb6 53b 53c +6cb7 6cb8 53a 5ca +6cf6 6cb7 53a 53b +6cb8 6cb9 539 5c9 +6cf7 6cb8 539 53a +6cb9 6cba 538 5c8 +6cf8 6cb9 538 539 +6cba 6cbb 537 5c7 +6cf9 6cba 537 538 +6cbb 6cbc 536 5c6 +6cfa 6cbb 536 537 +6cbc 6cbd 535 5c5 +6cfb 6cbc 535 536 +6cbd 6cbe 534 5c4 +6cfc 6cbd 534 535 +6cbe 6cbf 533 5c3 +6cfd 6cbe 533 534 +6cbf 6cc0 532 5c2 +6cfe 6cbf 532 533 +6cc0 6cc1 531 5c1 +6cff 6cc0 531 532 +6cc1 6cc2 530 5c0 +6d00 6cc1 530 531 +6cc2 6cc3 52f 5bf +6d01 6cc2 52f 530 +6cc3 6cc4 52e 5be +6d02 6cc3 52e 52f +6cc4 6cc5 52d 5bd +6d03 6cc4 52d 52e +6cc5 6cc6 52c 5bc +6d04 6cc5 52c 52d +6cc6 6cc7 52b 5bb +6d05 6cc6 52b 52c +6cc7 6cc8 52a 5ba +6d06 6cc7 52a 52b +6cc8 6cc9 529 5b9 +6d07 6cc8 529 52a +6cc9 6cca 528 5b8 +6d08 6cc9 528 529 +6cca 6ccb 527 5b7 +6d09 6cca 527 528 +6ccb 6ccc 526 5b6 +6d0a 6ccb 526 527 +6ccc 6ccd 525 5b5 +6d0b 6ccc 525 526 +6ccd 6cce 524 5b4 +6d0c 6ccd 524 525 +6cce 6ccf 523 5b3 +6d0d 6cce 523 524 +6ccf 6cd0 522 5b2 +6d0e 6ccf 522 523 +6cd0 6cd1 521 5b1 +6d0f 6cd0 521 522 +6cd1 6cd2 520 5b0 +6d10 6cd1 520 521 +6cd2 6cd3 51f 5af +6d11 6cd2 51f 520 +6cd3 6cd4 51e 5ae +6d12 6cd3 51e 51f +6cd4 6cd5 51d 5ad +6d13 6cd4 51d 51e +6cd5 6cd6 51c 5ac +6d14 6cd5 51c 51d +6cd6 6cd7 51b 5ab +6d15 6cd6 51b 51c +6cd7 6cd8 51a 5aa +6d16 6cd7 51a 51b +6cd8 6cd9 519 5a9 +6d17 6cd8 519 51a +6cd9 6cda 518 5a8 +6d18 6cd9 518 519 +6cda 6cdb 517 5a7 +6d19 6cda 517 518 +6cdb 6cdc 516 5a6 +6d1a 6cdb 516 517 +6cdc 6cdd 515 5a5 +6d1b 6cdc 515 516 +6cdd 6cde 514 5a4 +6d1c 6cdd 514 515 +6cde 6cdf 513 5a3 +6d1d 6cde 513 514 +6cdf 6ce0 512 5a2 +6d1e 6cdf 512 513 +6d1f 6ce0 511 512 +6ce1 6ce2 4bf 54f +6d20 6ce1 4bf 4c0 +6ce2 6ce3 4be 54e +6d21 6ce2 4be 4bf +6ce3 6ce4 4bd 54d +6d22 6ce3 4bd 4be +6ce4 6ce5 4bc 54c +6d23 6ce4 4bc 4bd +6ce5 6ce6 4bb 54b +6d24 6ce5 4bb 4bc +6ce6 6ce7 4ba 54a +6d25 6ce6 4ba 4bb +6ce7 6ce8 4b9 549 +6d26 6ce7 4b9 4ba +6ce8 6ce9 4b8 548 +6d27 6ce8 4b8 4b9 +6ce9 6cea 4b7 547 +6d28 6ce9 4b7 4b8 +6cea 6ceb 4b6 546 +6d29 6cea 4b6 4b7 +6ceb 6cec 4b5 545 +6d2a 6ceb 4b5 4b6 +6cec 6ced 4b4 544 +6d2b 6cec 4b4 4b5 +6ced 6cee 4b3 543 +6d2c 6ced 4b3 4b4 +6cee 6cef 4b2 542 +6d2d 6cee 4b2 4b3 +6cef 6cf0 4b1 541 +6d2e 6cef 4b1 4b2 +6cf0 6cf1 4b0 540 +6d2f 6cf0 4b0 4b1 +6cf1 6cf2 4af 53f +6d30 6cf1 4af 4b0 +6cf2 6cf3 4ae 53e +6d31 6cf2 4ae 4af +6cf3 6cf4 4ad 53d +6d32 6cf3 4ad 4ae +6cf4 6cf5 4ac 53c +6d33 6cf4 4ac 4ad +6cf5 6cf6 4ab 53b +6d34 6cf5 4ab 4ac +6cf6 6cf7 4aa 53a +6d35 6cf6 4aa 4ab +6cf7 6cf8 4a9 539 +6d36 6cf7 4a9 4aa +6cf8 6cf9 4a8 538 +6d37 6cf8 4a8 4a9 +6cf9 6cfa 4a7 537 +6d38 6cf9 4a7 4a8 +6cfa 6cfb 4a6 536 +6d39 6cfa 4a6 4a7 +6cfb 6cfc 4a5 535 +6d3a 6cfb 4a5 4a6 +6cfc 6cfd 4a4 534 +6d3b 6cfc 4a4 4a5 +6cfd 6cfe 4a3 533 +6d3c 6cfd 4a3 4a4 +6cfe 6cff 4a2 532 +6d3d 6cfe 4a2 4a3 +6cff 6d00 4a1 531 +6d3e 6cff 4a1 4a2 +6d00 6d01 4a0 530 +6d3f 6d00 4a0 4a1 +6d01 6d02 49f 52f +6d40 6d01 49f 4a0 +6d02 6d03 49e 52e +6d41 6d02 49e 49f +6d03 6d04 49d 52d +6d42 6d03 49d 49e +6d04 6d05 49c 52c +6d43 6d04 49c 49d +6d05 6d06 49b 52b +6d44 6d05 49b 49c +6d06 6d07 49a 52a +6d45 6d06 49a 49b +6d07 6d08 499 529 +6d46 6d07 499 49a +6d08 6d09 498 528 +6d47 6d08 498 499 +6d09 6d0a 497 527 +6d48 6d09 497 498 +6d0a 6d0b 496 526 +6d49 6d0a 496 497 +6d0b 6d0c 495 525 +6d4a 6d0b 495 496 +6d0c 6d0d 494 524 +6d4b 6d0c 494 495 +6d0d 6d0e 493 523 +6d4c 6d0d 493 494 +6d0e 6d0f 492 522 +6d4d 6d0e 492 493 +6d0f 6d10 491 521 +6d4e 6d0f 491 492 +6d10 6d11 490 520 +6d4f 6d10 490 491 +6d11 6d12 48f 51f +6d50 6d11 48f 490 +6d12 6d13 48e 51e +6d51 6d12 48e 48f +6d13 6d14 48d 51d +6d52 6d13 48d 48e +6d14 6d15 48c 51c +6d53 6d14 48c 48d +6d15 6d16 48b 51b +6d54 6d15 48b 48c +6d16 6d17 48a 51a +6d55 6d16 48a 48b +6d17 6d18 489 519 +6d56 6d17 489 48a +6d18 6d19 488 518 +6d57 6d18 488 489 +6d19 6d1a 487 517 +6d58 6d19 487 488 +6d1a 6d1b 486 516 +6d59 6d1a 486 487 +6d1b 6d1c 485 515 +6d5a 6d1b 485 486 +6d1c 6d1d 484 514 +6d5b 6d1c 484 485 +6d1d 6d1e 483 513 +6d5c 6d1d 483 484 +6d1e 6d1f 482 512 +6d5d 6d1e 482 483 +6d5e 6d1f 481 482 +6d20 6d21 42f 4bf +6d5f 6d20 42f 430 +6d21 6d22 42e 4be +6d60 6d21 42e 42f +6d22 6d23 42d 4bd +6d61 6d22 42d 42e +6d23 6d24 42c 4bc +6d62 6d23 42c 42d +6d24 6d25 42b 4bb +6d63 6d24 42b 42c +6d25 6d26 42a 4ba +6d64 6d25 42a 42b +6d26 6d27 429 4b9 +6d65 6d26 429 42a +6d27 6d28 428 4b8 +6d66 6d27 428 429 +6d28 6d29 427 4b7 +6d67 6d28 427 428 +6d29 6d2a 426 4b6 +6d68 6d29 426 427 +6d2a 6d2b 425 4b5 +6d69 6d2a 425 426 +6d2b 6d2c 424 4b4 +6d6a 6d2b 424 425 +6d2c 6d2d 423 4b3 +6d6b 6d2c 423 424 +6d2d 6d2e 422 4b2 +6d6c 6d2d 422 423 +6d2e 6d2f 421 4b1 +6d6d 6d2e 421 422 +6d2f 6d30 420 4b0 +6d6e 6d2f 420 421 +6d30 6d31 41f 4af +6d6f 6d30 41f 420 +6d31 6d32 41e 4ae +6d70 6d31 41e 41f +6d32 6d33 41d 4ad +6d71 6d32 41d 41e +6d33 6d34 41c 4ac +6d72 6d33 41c 41d +6d34 6d35 41b 4ab +6d73 6d34 41b 41c +6d35 6d36 41a 4aa +6d74 6d35 41a 41b +6d36 6d37 419 4a9 +6d75 6d36 419 41a +6d37 6d38 418 4a8 +6d76 6d37 418 419 +6d38 6d39 417 4a7 +6d77 6d38 417 418 +6d39 6d3a 416 4a6 +6d78 6d39 416 417 +6d3a 6d3b 415 4a5 +6d79 6d3a 415 416 +6d3b 6d3c 414 4a4 +6d7a 6d3b 414 415 +6d3c 6d3d 413 4a3 +6d7b 6d3c 413 414 +6d3d 6d3e 412 4a2 +6d7c 6d3d 412 413 +6d3e 6d3f 411 4a1 +6d7d 6d3e 411 412 +6d3f 6d40 410 4a0 +6d7e 6d3f 410 411 +6d40 6d41 40f 49f +6d7f 6d40 40f 410 +6d41 6d42 40e 49e +6d80 6d41 40e 40f +6d42 6d43 40d 49d +6d81 6d42 40d 40e +6d43 6d44 40c 49c +6d82 6d43 40c 40d +6d44 6d45 40b 49b +6d83 6d44 40b 40c +6d45 6d46 40a 49a +6d84 6d45 40a 40b +6d46 6d47 409 499 +6d85 6d46 409 40a +6d47 6d48 408 498 +6d86 6d47 408 409 +6d48 6d49 407 497 +6d87 6d48 407 408 +6d49 6d4a 406 496 +6d88 6d49 406 407 +6d4a 6d4b 405 495 +6d89 6d4a 405 406 +6d4b 6d4c 404 494 +6d8a 6d4b 404 405 +6d4c 6d4d 403 493 +6d8b 6d4c 403 404 +6d4d 6d4e 402 492 +6d8c 6d4d 402 403 +6d4e 6d4f 401 491 +6d8d 6d4e 401 402 +6d4f 6d50 400 490 +6d8e 6d4f 400 401 +6d50 6d51 3ff 48f +6d8f 6d50 3ff 400 +6d51 6d52 3fe 48e +6d90 6d51 3fe 3ff +6d52 6d53 3fd 48d +6d91 6d52 3fd 3fe +6d53 6d54 3fc 48c +6d92 6d53 3fc 3fd +6d54 6d55 3fb 48b +6d93 6d54 3fb 3fc +6d55 6d56 3fa 48a +6d94 6d55 3fa 3fb +6d56 6d57 3f9 489 +6d95 6d56 3f9 3fa +6d57 6d58 3f8 488 +6d96 6d57 3f8 3f9 +6d58 6d59 3f7 487 +6d97 6d58 3f7 3f8 +6d59 6d5a 3f6 486 +6d98 6d59 3f6 3f7 +6d5a 6d5b 3f5 485 +6d99 6d5a 3f5 3f6 +6d5b 6d5c 3f4 484 +6d9a 6d5b 3f4 3f5 +6d5c 6d5d 3f3 483 +6d9b 6d5c 3f3 3f4 +6d5d 6d5e 3f2 482 +6d9c 6d5d 3f2 3f3 +6d9d 6d5e 3f1 3f2 +6d5f 6d60 39f 42f +6d9e 6d5f 39f 3a0 +6d60 6d61 39e 42e +6d9f 6d60 39e 39f +6d61 6d62 39d 42d +6da0 6d61 39d 39e +6d62 6d63 39c 42c +6da1 6d62 39c 39d +6d63 6d64 39b 42b +6da2 6d63 39b 39c +6d64 6d65 39a 42a +6da3 6d64 39a 39b +6d65 6d66 399 429 +6da4 6d65 399 39a +6d66 6d67 398 428 +6da5 6d66 398 399 +6d67 6d68 397 427 +6da6 6d67 397 398 +6d68 6d69 396 426 +6da7 6d68 396 397 +6d69 6d6a 395 425 +6da8 6d69 395 396 +6d6a 6d6b 394 424 +6da9 6d6a 394 395 +6d6b 6d6c 393 423 +6daa 6d6b 393 394 +6d6c 6d6d 392 422 +6dab 6d6c 392 393 +6d6d 6d6e 391 421 +6dac 6d6d 391 392 +6d6e 6d6f 390 420 +6dad 6d6e 390 391 +6d6f 6d70 38f 41f +6dae 6d6f 38f 390 +6d70 6d71 38e 41e +6daf 6d70 38e 38f +6d71 6d72 38d 41d +6db0 6d71 38d 38e +6d72 6d73 38c 41c +6db1 6d72 38c 38d +6d73 6d74 38b 41b +6db2 6d73 38b 38c +6d74 6d75 38a 41a +6db3 6d74 38a 38b +6d75 6d76 389 419 +6db4 6d75 389 38a +6d76 6d77 388 418 +6db5 6d76 388 389 +6d77 6d78 387 417 +6db6 6d77 387 388 +6d78 6d79 386 416 +6db7 6d78 386 387 +6d79 6d7a 385 415 +6db8 6d79 385 386 +6d7a 6d7b 384 414 +6db9 6d7a 384 385 +6d7b 6d7c 383 413 +6dba 6d7b 383 384 +6d7c 6d7d 382 412 +6dbb 6d7c 382 383 +6d7d 6d7e 381 411 +6dbc 6d7d 381 382 +6d7e 6d7f 380 410 +6dbd 6d7e 380 381 +6d7f 6d80 37f 40f +6dbe 6d7f 37f 380 +6d80 6d81 37e 40e +6dbf 6d80 37e 37f +6d81 6d82 37d 40d +6dc0 6d81 37d 37e +6d82 6d83 37c 40c +6dc1 6d82 37c 37d +6d83 6d84 37b 40b +6dc2 6d83 37b 37c +6d84 6d85 37a 40a +6dc3 6d84 37a 37b +6d85 6d86 379 409 +6dc4 6d85 379 37a +6d86 6d87 378 408 +6dc5 6d86 378 379 +6d87 6d88 377 407 +6dc6 6d87 377 378 +6d88 6d89 376 406 +6dc7 6d88 376 377 +6d89 6d8a 375 405 +6dc8 6d89 375 376 +6d8a 6d8b 374 404 +6dc9 6d8a 374 375 +6d8b 6d8c 373 403 +6dca 6d8b 373 374 +6d8c 6d8d 372 402 +6dcb 6d8c 372 373 +6d8d 6d8e 371 401 +6dcc 6d8d 371 372 +6d8e 6d8f 370 400 +6dcd 6d8e 370 371 +6d8f 6d90 36f 3ff +6dce 6d8f 36f 370 +6d90 6d91 36e 3fe +6dcf 6d90 36e 36f +6d91 6d92 36d 3fd +6dd0 6d91 36d 36e +6d92 6d93 36c 3fc +6dd1 6d92 36c 36d +6d93 6d94 36b 3fb +6dd2 6d93 36b 36c +6d94 6d95 36a 3fa +6dd3 6d94 36a 36b +6d95 6d96 369 3f9 +6dd4 6d95 369 36a +6d96 6d97 368 3f8 +6dd5 6d96 368 369 +6d97 6d98 367 3f7 +6dd6 6d97 367 368 +6d98 6d99 366 3f6 +6dd7 6d98 366 367 +6d99 6d9a 365 3f5 +6dd8 6d99 365 366 +6d9a 6d9b 364 3f4 +6dd9 6d9a 364 365 +6d9b 6d9c 363 3f3 +6dda 6d9b 363 364 +6d9c 6d9d 362 3f2 +6ddb 6d9c 362 363 +6ddc 6d9d 361 362 +6d9e 6d9f 30f 39f +6ddd 6d9e 30f 310 +6d9f 6da0 30e 39e +6dde 6d9f 30e 30f +6da0 6da1 30d 39d +6ddf 6da0 30d 30e +6da1 6da2 30c 39c +6de0 6da1 30c 30d +6da2 6da3 30b 39b +6de1 6da2 30b 30c +6da3 6da4 30a 39a +6de2 6da3 30a 30b +6da4 6da5 309 399 +6de3 6da4 309 30a +6da5 6da6 308 398 +6de4 6da5 308 309 +6da6 6da7 307 397 +6de5 6da6 307 308 +6da7 6da8 306 396 +6de6 6da7 306 307 +6da8 6da9 305 395 +6de7 6da8 305 306 +6da9 6daa 304 394 +6de8 6da9 304 305 +6daa 6dab 303 393 +6de9 6daa 303 304 +6dab 6dac 302 392 +6dea 6dab 302 303 +6dac 6dad 301 391 +6deb 6dac 301 302 +6dad 6dae 300 390 +6dec 6dad 300 301 +6dae 6daf 2ff 38f +6ded 6dae 2ff 300 +6daf 6db0 2fe 38e +6dee 6daf 2fe 2ff +6db0 6db1 2fd 38d +6def 6db0 2fd 2fe +6db1 6db2 2fc 38c +6df0 6db1 2fc 2fd +6db2 6db3 2fb 38b +6df1 6db2 2fb 2fc +6db3 6db4 2fa 38a +6df2 6db3 2fa 2fb +6db4 6db5 2f9 389 +6df3 6db4 2f9 2fa +6db5 6db6 2f8 388 +6df4 6db5 2f8 2f9 +6db6 6db7 2f7 387 +6df5 6db6 2f7 2f8 +6db7 6db8 2f6 386 +6df6 6db7 2f6 2f7 +6db8 6db9 2f5 385 +6df7 6db8 2f5 2f6 +6db9 6dba 2f4 384 +6df8 6db9 2f4 2f5 +6dba 6dbb 2f3 383 +6df9 6dba 2f3 2f4 +6dbb 6dbc 2f2 382 +6dfa 6dbb 2f2 2f3 +6dbc 6dbd 2f1 381 +6dfb 6dbc 2f1 2f2 +6dbd 6dbe 2f0 380 +6dfc 6dbd 2f0 2f1 +6dbe 6dbf 2ef 37f +6dfd 6dbe 2ef 2f0 +6dbf 6dc0 2ee 37e +6dfe 6dbf 2ee 2ef +6dc0 6dc1 2ed 37d +6dff 6dc0 2ed 2ee +6dc1 6dc2 2ec 37c +6e00 6dc1 2ec 2ed +6dc2 6dc3 2eb 37b +6e01 6dc2 2eb 2ec +6dc3 6dc4 2ea 37a +6e02 6dc3 2ea 2eb +6dc4 6dc5 2e9 379 +6e03 6dc4 2e9 2ea +6dc5 6dc6 2e8 378 +6e04 6dc5 2e8 2e9 +6dc6 6dc7 2e7 377 +6e05 6dc6 2e7 2e8 +6dc7 6dc8 2e6 376 +6e06 6dc7 2e6 2e7 +6dc8 6dc9 2e5 375 +6e07 6dc8 2e5 2e6 +6dc9 6dca 2e4 374 +6e08 6dc9 2e4 2e5 +6dca 6dcb 2e3 373 +6e09 6dca 2e3 2e4 +6dcb 6dcc 2e2 372 +6e0a 6dcb 2e2 2e3 +6dcc 6dcd 2e1 371 +6e0b 6dcc 2e1 2e2 +6dcd 6dce 2e0 370 +6e0c 6dcd 2e0 2e1 +6dce 6dcf 2df 36f +6e0d 6dce 2df 2e0 +6dcf 6dd0 2de 36e +6e0e 6dcf 2de 2df +6dd0 6dd1 2dd 36d +6e0f 6dd0 2dd 2de +6dd1 6dd2 2dc 36c +6e10 6dd1 2dc 2dd +6dd2 6dd3 2db 36b +6e11 6dd2 2db 2dc +6dd3 6dd4 2da 36a +6e12 6dd3 2da 2db +6dd4 6dd5 2d9 369 +6e13 6dd4 2d9 2da +6dd5 6dd6 2d8 368 +6e14 6dd5 2d8 2d9 +6dd6 6dd7 2d7 367 +6e15 6dd6 2d7 2d8 +6dd7 6dd8 2d6 366 +6e16 6dd7 2d6 2d7 +6dd8 6dd9 2d5 365 +6e17 6dd8 2d5 2d6 +6dd9 6dda 2d4 364 +6e18 6dd9 2d4 2d5 +6dda 6ddb 2d3 363 +6e19 6dda 2d3 2d4 +6ddb 6ddc 2d2 362 +6e1a 6ddb 2d2 2d3 +6e1b 6ddc 2d1 2d2 +6ddd 6dde 27f 30f +6e1c 6ddd 27f 280 +6dde 6ddf 27e 30e +6e1d 6dde 27e 27f +6ddf 6de0 27d 30d +6e1e 6ddf 27d 27e +6de0 6de1 27c 30c +6e1f 6de0 27c 27d +6de1 6de2 27b 30b +6e20 6de1 27b 27c +6de2 6de3 27a 30a +6e21 6de2 27a 27b +6de3 6de4 279 309 +6e22 6de3 279 27a +6de4 6de5 278 308 +6e23 6de4 278 279 +6de5 6de6 277 307 +6e24 6de5 277 278 +6de6 6de7 276 306 +6e25 6de6 276 277 +6de7 6de8 275 305 +6e26 6de7 275 276 +6de8 6de9 274 304 +6e27 6de8 274 275 +6de9 6dea 273 303 +6e28 6de9 273 274 +6dea 6deb 272 302 +6e29 6dea 272 273 +6deb 6dec 271 301 +6e2a 6deb 271 272 +6dec 6ded 270 300 +6e2b 6dec 270 271 +6ded 6dee 26f 2ff +6e2c 6ded 26f 270 +6dee 6def 26e 2fe +6e2d 6dee 26e 26f +6def 6df0 26d 2fd +6e2e 6def 26d 26e +6df0 6df1 26c 2fc +6e2f 6df0 26c 26d +6df1 6df2 26b 2fb +6e30 6df1 26b 26c +6df2 6df3 26a 2fa +6e31 6df2 26a 26b +6df3 6df4 269 2f9 +6e32 6df3 269 26a +6df4 6df5 268 2f8 +6e33 6df4 268 269 +6df5 6df6 267 2f7 +6e34 6df5 267 268 +6df6 6df7 266 2f6 +6e35 6df6 266 267 +6df7 6df8 265 2f5 +6e36 6df7 265 266 +6df8 6df9 264 2f4 +6e37 6df8 264 265 +6df9 6dfa 263 2f3 +6e38 6df9 263 264 +6dfa 6dfb 262 2f2 +6e39 6dfa 262 263 +6dfb 6dfc 261 2f1 +6e3a 6dfb 261 262 +6dfc 6dfd 260 2f0 +6e3b 6dfc 260 261 +6dfd 6dfe 25f 2ef +6e3c 6dfd 25f 260 +6dfe 6dff 25e 2ee +6e3d 6dfe 25e 25f +6dff 6e00 25d 2ed +6e3e 6dff 25d 25e +6e00 6e01 25c 2ec +6e3f 6e00 25c 25d +6e01 6e02 25b 2eb +6e40 6e01 25b 25c +6e02 6e03 25a 2ea +6e41 6e02 25a 25b +6e03 6e04 259 2e9 +6e42 6e03 259 25a +6e04 6e05 258 2e8 +6e43 6e04 258 259 +6e05 6e06 257 2e7 +6e44 6e05 257 258 +6e06 6e07 256 2e6 +6e45 6e06 256 257 +6e07 6e08 255 2e5 +6e46 6e07 255 256 +6e08 6e09 254 2e4 +6e47 6e08 254 255 +6e09 6e0a 253 2e3 +6e48 6e09 253 254 +6e0a 6e0b 252 2e2 +6e49 6e0a 252 253 +6e0b 6e0c 251 2e1 +6e4a 6e0b 251 252 +6e0c 6e0d 250 2e0 +6e4b 6e0c 250 251 +6e0d 6e0e 24f 2df +6e4c 6e0d 24f 250 +6e0e 6e0f 24e 2de +6e4d 6e0e 24e 24f +6e0f 6e10 24d 2dd +6e4e 6e0f 24d 24e +6e10 6e11 24c 2dc +6e4f 6e10 24c 24d +6e11 6e12 24b 2db +6e50 6e11 24b 24c +6e12 6e13 24a 2da +6e51 6e12 24a 24b +6e13 6e14 249 2d9 +6e52 6e13 249 24a +6e14 6e15 248 2d8 +6e53 6e14 248 249 +6e15 6e16 247 2d7 +6e54 6e15 247 248 +6e16 6e17 246 2d6 +6e55 6e16 246 247 +6e17 6e18 245 2d5 +6e56 6e17 245 246 +6e18 6e19 244 2d4 +6e57 6e18 244 245 +6e19 6e1a 243 2d3 +6e58 6e19 243 244 +6e1a 6e1b 242 2d2 +6e59 6e1a 242 243 +6e5a 6e1b 241 242 +6e1c 6e1d 1ef 27f +6e5b 6e1c 1ef 1f0 +6e1d 6e1e 1ee 27e +6e5c 6e1d 1ee 1ef +6e1e 6e1f 1ed 27d +6e5d 6e1e 1ed 1ee +6e1f 6e20 1ec 27c +6e5e 6e1f 1ec 1ed +6e20 6e21 1eb 27b +6e5f 6e20 1eb 1ec +6e21 6e22 1ea 27a +6e60 6e21 1ea 1eb +6e22 6e23 1e9 279 +6e61 6e22 1e9 1ea +6e23 6e24 1e8 278 +6e62 6e23 1e8 1e9 +6e24 6e25 1e7 277 +6e63 6e24 1e7 1e8 +6e25 6e26 1e6 276 +6e64 6e25 1e6 1e7 +6e26 6e27 1e5 275 +6e65 6e26 1e5 1e6 +6e27 6e28 1e4 274 +6e66 6e27 1e4 1e5 +6e28 6e29 1e3 273 +6e67 6e28 1e3 1e4 +6e29 6e2a 1e2 272 +6e68 6e29 1e2 1e3 +6e2a 6e2b 1e1 271 +6e69 6e2a 1e1 1e2 +6e2b 6e2c 1e0 270 +6e6a 6e2b 1e0 1e1 +6e2c 6e2d 1df 26f +6e6b 6e2c 1df 1e0 +6e2d 6e2e 1de 26e +6e6c 6e2d 1de 1df +6e2e 6e2f 1dd 26d +6e6d 6e2e 1dd 1de +6e2f 6e30 1dc 26c +6e6e 6e2f 1dc 1dd +6e30 6e31 1db 26b +6e6f 6e30 1db 1dc +6e31 6e32 1da 26a +6e70 6e31 1da 1db +6e32 6e33 1d9 269 +6e71 6e32 1d9 1da +6e33 6e34 1d8 268 +6e72 6e33 1d8 1d9 +6e34 6e35 1d7 267 +6e73 6e34 1d7 1d8 +6e35 6e36 1d6 266 +6e74 6e35 1d6 1d7 +6e36 6e37 1d5 265 +6e75 6e36 1d5 1d6 +6e37 6e38 1d4 264 +6e76 6e37 1d4 1d5 +6e38 6e39 1d3 263 +6e77 6e38 1d3 1d4 +6e39 6e3a 1d2 262 +6e78 6e39 1d2 1d3 +6e3a 6e3b 1d1 261 +6e79 6e3a 1d1 1d2 +6e3b 6e3c 1d0 260 +6e7a 6e3b 1d0 1d1 +6e3c 6e3d 1cf 25f +6e7b 6e3c 1cf 1d0 +6e3d 6e3e 1ce 25e +6e7c 6e3d 1ce 1cf +6e3e 6e3f 1cd 25d +6e7d 6e3e 1cd 1ce +6e3f 6e40 1cc 25c +6e7e 6e3f 1cc 1cd +6e40 6e41 1cb 25b +6e7f 6e40 1cb 1cc +6e41 6e42 1ca 25a +6e80 6e41 1ca 1cb +6e42 6e43 1c9 259 +6e81 6e42 1c9 1ca +6e43 6e44 1c8 258 +6e82 6e43 1c8 1c9 +6e44 6e45 1c7 257 +6e83 6e44 1c7 1c8 +6e45 6e46 1c6 256 +6e84 6e45 1c6 1c7 +6e46 6e47 1c5 255 +6e85 6e46 1c5 1c6 +6e47 6e48 1c4 254 +6e86 6e47 1c4 1c5 +6e48 6e49 1c3 253 +6e87 6e48 1c3 1c4 +6e49 6e4a 1c2 252 +6e88 6e49 1c2 1c3 +6e4a 6e4b 1c1 251 +6e89 6e4a 1c1 1c2 +6e4b 6e4c 1c0 250 +6e8a 6e4b 1c0 1c1 +6e4c 6e4d 1bf 24f +6e8b 6e4c 1bf 1c0 +6e4d 6e4e 1be 24e +6e8c 6e4d 1be 1bf +6e4e 6e4f 1bd 24d +6e8d 6e4e 1bd 1be +6e4f 6e50 1bc 24c +6e8e 6e4f 1bc 1bd +6e50 6e51 1bb 24b +6e8f 6e50 1bb 1bc +6e51 6e52 1ba 24a +6e90 6e51 1ba 1bb +6e52 6e53 1b9 249 +6e91 6e52 1b9 1ba +6e53 6e54 1b8 248 +6e92 6e53 1b8 1b9 +6e54 6e55 1b7 247 +6e93 6e54 1b7 1b8 +6e55 6e56 1b6 246 +6e94 6e55 1b6 1b7 +6e56 6e57 1b5 245 +6e95 6e56 1b5 1b6 +6e57 6e58 1b4 244 +6e96 6e57 1b4 1b5 +6e58 6e59 1b3 243 +6e97 6e58 1b3 1b4 +6e59 6e5a 1b2 242 +6e98 6e59 1b2 1b3 +6e99 6e5a 1b1 1b2 +6e5b 6e5c 15f 1ef +6e9a 6e5b 15f 160 +6e5c 6e5d 15e 1ee +6e9b 6e5c 15e 15f +6e5d 6e5e 15d 1ed +6e9c 6e5d 15d 15e +6e5e 6e5f 15c 1ec +6e9d 6e5e 15c 15d +6e5f 6e60 15b 1eb +6e9e 6e5f 15b 15c +6e60 6e61 15a 1ea +6e9f 6e60 15a 15b +6e61 6e62 159 1e9 +6ea0 6e61 159 15a +6e62 6e63 158 1e8 +6ea1 6e62 158 159 +6e63 6e64 157 1e7 +6ea2 6e63 157 158 +6e64 6e65 156 1e6 +6ea3 6e64 156 157 +6e65 6e66 155 1e5 +6ea4 6e65 155 156 +6e66 6e67 154 1e4 +6ea5 6e66 154 155 +6e67 6e68 153 1e3 +6ea6 6e67 153 154 +6e68 6e69 152 1e2 +6ea7 6e68 152 153 +6e69 6e6a 151 1e1 +6ea8 6e69 151 152 +6e6a 6e6b 150 1e0 +6ea9 6e6a 150 151 +6e6b 6e6c 14f 1df +6eaa 6e6b 14f 150 +6e6c 6e6d 14e 1de +6eab 6e6c 14e 14f +6e6d 6e6e 14d 1dd +6eac 6e6d 14d 14e +6e6e 6e6f 14c 1dc +6ead 6e6e 14c 14d +6e6f 6e70 14b 1db +6eae 6e6f 14b 14c +6e70 6e71 14a 1da +6eaf 6e70 14a 14b +6e71 6e72 149 1d9 +6eb0 6e71 149 14a +6e72 6e73 148 1d8 +6eb1 6e72 148 149 +6e73 6e74 147 1d7 +6eb2 6e73 147 148 +6e74 6e75 146 1d6 +6eb3 6e74 146 147 +6e75 6e76 145 1d5 +6eb4 6e75 145 146 +6e76 6e77 144 1d4 +6eb5 6e76 144 145 +6e77 6e78 143 1d3 +6eb6 6e77 143 144 +6e78 6e79 142 1d2 +6eb7 6e78 142 143 +6e79 6e7a 141 1d1 +6eb8 6e79 141 142 +6e7a 6e7b 140 1d0 +6eb9 6e7a 140 141 +6e7b 6e7c 13f 1cf +6eba 6e7b 13f 140 +6e7c 6e7d 13e 1ce +6ebb 6e7c 13e 13f +6e7d 6e7e 13d 1cd +6ebc 6e7d 13d 13e +6e7e 6e7f 13c 1cc +6ebd 6e7e 13c 13d +6e7f 6e80 13b 1cb +6ebe 6e7f 13b 13c +6e80 6e81 13a 1ca +6ebf 6e80 13a 13b +6e81 6e82 139 1c9 +6ec0 6e81 139 13a +6e82 6e83 138 1c8 +6ec1 6e82 138 139 +6e83 6e84 137 1c7 +6ec2 6e83 137 138 +6e84 6e85 136 1c6 +6ec3 6e84 136 137 +6e85 6e86 135 1c5 +6ec4 6e85 135 136 +6e86 6e87 134 1c4 +6ec5 6e86 134 135 +6e87 6e88 133 1c3 +6ec6 6e87 133 134 +6e88 6e89 132 1c2 +6ec7 6e88 132 133 +6e89 6e8a 131 1c1 +6ec8 6e89 131 132 +6e8a 6e8b 130 1c0 +6ec9 6e8a 130 131 +6e8b 6e8c 12f 1bf +6eca 6e8b 12f 130 +6e8c 6e8d 12e 1be +6ecb 6e8c 12e 12f +6e8d 6e8e 12d 1bd +6ecc 6e8d 12d 12e +6e8e 6e8f 12c 1bc +6ecd 6e8e 12c 12d +6e8f 6e90 12b 1bb +6ece 6e8f 12b 12c +6e90 6e91 12a 1ba +6ecf 6e90 12a 12b +6e91 6e92 129 1b9 +6ed0 6e91 129 12a +6e92 6e93 128 1b8 +6ed1 6e92 128 129 +6e93 6e94 127 1b7 +6ed2 6e93 127 128 +6e94 6e95 126 1b6 +6ed3 6e94 126 127 +6e95 6e96 125 1b5 +6ed4 6e95 125 126 +6e96 6e97 124 1b4 +6ed5 6e96 124 125 +6e97 6e98 123 1b3 +6ed6 6e97 123 124 +6e98 6e99 122 1b2 +6ed7 6e98 122 123 +6ed8 6e99 121 122 +6e9a 6e9b cf 15f +6ed9 6e9a cf d0 +6e9b 6e9c ce 15e +6eda 6e9b ce cf +6e9c 6e9d cd 15d +6edb 6e9c cd ce +6e9d 6e9e cc 15c +6edc 6e9d cc cd +6e9e 6e9f cb 15b +6edd 6e9e cb cc +6e9f 6ea0 ca 15a +6ede 6e9f ca cb +6ea0 6ea1 c9 159 +6edf 6ea0 c9 ca +6ea1 6ea2 c8 158 +6ee0 6ea1 c8 c9 +6ea2 6ea3 c7 157 +6ee1 6ea2 c7 c8 +6ea3 6ea4 c6 156 +6ee2 6ea3 c6 c7 +6ea4 6ea5 c5 155 +6ee3 6ea4 c5 c6 +6ea5 6ea6 c4 154 +6ee4 6ea5 c4 c5 +6ea6 6ea7 c3 153 +6ee5 6ea6 c3 c4 +6ea7 6ea8 c2 152 +6ee6 6ea7 c2 c3 +6ea8 6ea9 c1 151 +6ee7 6ea8 c1 c2 +6ea9 6eaa c0 150 +6ee8 6ea9 c0 c1 +6eaa 6eab bf 14f +6ee9 6eaa bf c0 +6eab 6eac be 14e +6eea 6eab be bf +6eac 6ead bd 14d +6eeb 6eac bd be +6ead 6eae bc 14c +6eec 6ead bc bd +6eae 6eaf bb 14b +6eed 6eae bb bc +6eaf 6eb0 ba 14a +6eee 6eaf ba bb +6eb0 6eb1 b9 149 +6eef 6eb0 b9 ba +6eb1 6eb2 b8 148 +6ef0 6eb1 b8 b9 +6eb2 6eb3 b7 147 +6ef1 6eb2 b7 b8 +6eb3 6eb4 b6 146 +6ef2 6eb3 b6 b7 +6eb4 6eb5 b5 145 +6ef3 6eb4 b5 b6 +6eb5 6eb6 b4 144 +6ef4 6eb5 b4 b5 +6eb6 6eb7 b3 143 +6ef5 6eb6 b3 b4 +6eb7 6eb8 b2 142 +6ef6 6eb7 b2 b3 +6eb8 6eb9 b1 141 +6ef7 6eb8 b1 b2 +6eb9 6eba b0 140 +6ef8 6eb9 b0 b1 +6eba 6ebb af 13f +6ef9 6eba af b0 +6ebb 6ebc ae 13e +6efa 6ebb ae af +6ebc 6ebd ad 13d +6efb 6ebc ad ae +6ebd 6ebe ac 13c +6efc 6ebd ac ad +6ebe 6ebf ab 13b +6efd 6ebe ab ac +6ebf 6ec0 aa 13a +6efe 6ebf aa ab +6ec0 6ec1 a9 139 +6eff 6ec0 a9 aa +6ec1 6ec2 a8 138 +6f00 6ec1 a8 a9 +6ec2 6ec3 a7 137 +6f01 6ec2 a7 a8 +6ec3 6ec4 a6 136 +6f02 6ec3 a6 a7 +6ec4 6ec5 a5 135 +6f03 6ec4 a5 a6 +6ec5 6ec6 a4 134 +6f04 6ec5 a4 a5 +6ec6 6ec7 a3 133 +6f05 6ec6 a3 a4 +6ec7 6ec8 a2 132 +6f06 6ec7 a2 a3 +6ec8 6ec9 a1 131 +6f07 6ec8 a1 a2 +6ec9 6eca a0 130 +6f08 6ec9 a0 a1 +6eca 6ecb 9f 12f +6f09 6eca 9f a0 +6ecb 6ecc 9e 12e +6f0a 6ecb 9e 9f +6ecc 6ecd 9d 12d +6f0b 6ecc 9d 9e +6ecd 6ece 9c 12c +6f0c 6ecd 9c 9d +6ece 6ecf 9b 12b +6f0d 6ece 9b 9c +6ecf 6ed0 9a 12a +6f0e 6ecf 9a 9b +6ed0 6ed1 99 129 +6f0f 6ed0 99 9a +6ed1 6ed2 98 128 +6f10 6ed1 98 99 +6ed2 6ed3 97 127 +6f11 6ed2 97 98 +6ed3 6ed4 96 126 +6f12 6ed3 96 97 +6ed4 6ed5 95 125 +6f13 6ed4 95 96 +6ed5 6ed6 94 124 +6f14 6ed5 94 95 +6ed6 6ed7 93 123 +6f15 6ed6 93 94 +6ed7 6ed8 92 122 +6f16 6ed7 92 93 +6f17 6ed8 91 92 +6ed9 6eda 3f cf +6eda 6edb 3e ce +6edb 6edc 3d cd +6edc 6edd 3c cc +6edd 6ede 3b cb +6ede 6edf 3a ca +6edf 6ee0 39 c9 +6ee0 6ee1 38 c8 +6ee1 6ee2 37 c7 +6ee2 6ee3 36 c6 +6ee3 6ee4 35 c5 +6ee4 6ee5 34 c4 +6ee5 6ee6 33 c3 +6ee6 6ee7 32 c2 +6ee7 6ee8 31 c1 +6ee8 6ee9 30 c0 +6ee9 6eea 2f bf +6eea 6eeb 2e be +6eeb 6eec 2d bd +6eec 6eed 2c bc +6eed 6eee 2b bb +6eee 6eef 2a ba +6eef 6ef0 29 b9 +6ef0 6ef1 28 b8 +6ef1 6ef2 27 b7 +6ef2 6ef3 26 b6 +6ef3 6ef4 25 b5 +6ef4 6ef5 24 b4 +6ef5 6ef6 23 b3 +6ef6 6ef7 22 b2 +6ef7 6ef8 21 b1 +6ef8 6ef9 20 b0 +6ef9 6efa 1f af +6efa 6efb 1e ae +6efb 6efc 1d ad +6efc 6efd 1c ac +6efd 6efe 1b ab +6efe 6eff 1a aa +6eff 6f00 19 a9 +6f00 6f01 18 a8 +6f01 6f02 17 a7 +6f02 6f03 16 a6 +6f03 6f04 15 a5 +6f04 6f05 14 a4 +6f05 6f06 13 a3 +6f06 6f07 12 a2 +6f07 6f08 11 a1 +6f08 6f09 10 a0 +6f09 6f0a f 9f +6f0a 6f0b e 9e +6f0b 6f0c d 9d +6f0c 6f0d c 9c +6f0d 6f0e b 9b +6f0e 6f0f a 9a +6f0f 6f10 9 99 +6f10 6f11 8 98 +6f11 6f12 7 97 +6f12 6f13 6 96 +6f13 6f14 5 95 +6f14 6f15 4 94 +6f15 6f16 3 93 +6f16 6f17 2 92 +)) +(45 (3 interior interior-3) ()) + +(0 "Zone 4 (124 faces), BC : pressure-far-field") +(13 (4 fb64 fbdf 9 2)( +27 1 4c37 0 +1 9e 4c38 0 +2 3a 4c64 0 +3b 2 4c67 0 +3 62 4cc3 0 +63 3 4cc6 0 +4 76 4cf2 0 +77 4 4cf4 0 +28 27 4c39 0 +29 28 4c3b 0 +2a 29 4c3e 0 +2b 2a 4c40 0 +2c 2b 4c42 0 +2d 2c 4c44 0 +2e 2d 4c46 0 +2f 2e 4c48 0 +30 2f 4c4a 0 +31 30 4c4d 0 +32 31 4c50 0 +33 32 4c52 0 +34 33 4c54 0 +35 34 4c57 0 +36 35 4c59 0 +37 36 4c5c 0 +38 37 4c5e 0 +39 38 4c60 0 +3a 39 4c62 0 +3c 3b 4c68 0 +3d 3c 4c6a 0 +3e 3d 4c6d 0 +3f 3e 4c6f 0 +40 3f 4c71 0 +41 40 4c73 0 +42 41 4c75 0 +43 42 4c77 0 +44 43 4c7a 0 +45 44 4c7c 0 +46 45 4c7e 0 +47 46 4c80 0 +48 47 4c83 0 +49 48 4c84 0 +4a 49 4c87 0 +4b 4a 4c8a 0 +4c 4b 4c8c 0 +4d 4c 4c8f 0 +4e 4d 4c91 0 +4f 4e 4c93 0 +50 4f 4c96 0 +51 50 4c98 0 +52 51 4c9a 0 +53 52 4c9d 0 +54 53 4c9f 0 +55 54 4ca2 0 +56 55 4ca4 0 +57 56 4ca6 0 +58 57 4ca8 0 +59 58 4cab 0 +5a 59 4cad 0 +5b 5a 4caf 0 +5c 5b 4cb2 0 +5d 5c 4cb4 0 +5e 5d 4cb6 0 +5f 5e 4cb9 0 +60 5f 4cbb 0 +61 60 4cbe 0 +62 61 4cc0 0 +64 63 4cc7 0 +65 64 4cc9 0 +66 65 4ccb 0 +67 66 4ccd 0 +68 67 4cd0 0 +69 68 4cd3 0 +6a 69 4cd5 0 +6b 6a 4cd7 0 +6c 6b 4cd9 0 +6d 6c 4cdb 0 +6e 6d 4cde 0 +6f 6e 4ce0 0 +70 6f 4ce3 0 +71 70 4ce5 0 +72 71 4ce7 0 +73 72 4ce9 0 +74 73 4ceb 0 +75 74 4ced 0 +76 75 4cf0 0 +78 77 4cf5 0 +79 78 4cf7 0 +7a 79 4cf9 0 +7b 7a 4cfc 0 +7c 7b 4cff 0 +7d 7c 4d01 0 +7e 7d 4d03 0 +7f 7e 4d05 0 +80 7f 4d08 0 +81 80 4d0a 0 +82 81 4d0c 0 +83 82 4d0e 0 +84 83 4d11 0 +85 84 4d13 0 +86 85 4d15 0 +87 86 4d18 0 +88 87 4d1a 0 +89 88 4d1d 0 +8a 89 4d1f 0 +8b 8a 4d22 0 +8c 8b 4d24 0 +8d 8c 4d26 0 +8e 8d 4d28 0 +8f 8e 4d2b 0 +90 8f 4d2d 0 +91 90 4d30 0 +92 91 4d32 0 +93 92 4d34 0 +94 93 4d37 0 +95 94 4d39 0 +96 95 4d3b 0 +97 96 4d3d 0 +98 97 4d40 0 +99 98 4d42 0 +9a 99 4d45 0 +9b 9a 4d48 0 +9c 9b 4d4a 0 +9d 9c 4d4c 0 +9e 9d 4d4e 0 +)) +(45 (4 pressure-far-field pressure-far-field-4) ()) + +(0 "Zone 5 (605 faces), BC : wall") +(13 (5 fbe0 fe3c 3 2)( +5 9f 3664 0 +1bb 5 3663 0 +bd 6 3683 0 +6 156 3684 0 +194 a 36c3 0 +a 297 36c4 0 +b 1b2 3659 0 +229 b 3658 0 +d 1e3 3611 0 +29f d 36cd 0 +2d0 f 35b5 0 +f 425 35b4 0 +11 2c2 35c4 0 +310 11 35c5 0 +13 302 35d4 0 +350 13 35d5 0 +15 342 35e4 0 +3f9 15 35e5 0 +18 3cf 3610 0 +5c0 18 3501 0 +44f 1a 3589 0 +1a 472 3588 0 +490 1b 3569 0 +1b 523 3568 0 +551 1d 3539 0 +1d 58b 3538 0 +5a1 20 3521 0 +20 5a2 3520 0 +21 5e0 10b0 0 +686 21 10b1 0 +5fe 22 1091 0 +22 6d3 1090 0 +25 658 10e0 0 +711 25 1051 0 +9f a0 3665 0 +a0 a1 3666 0 +a1 a2 3667 0 +a2 a3 3668 0 +a3 a4 3669 0 +a4 a5 366a 0 +a5 a6 366b 0 +a6 a7 366c 0 +a7 a8 366d 0 +a8 a9 366e 0 +a9 aa 366f 0 +aa ab 3670 0 +ab ac 3671 0 +ac ad 3672 0 +ad ae 3673 0 +ae af 3674 0 +af b0 3675 0 +b0 b1 3676 0 +b1 b2 3677 0 +b2 b3 3678 0 +b3 b4 3679 0 +b4 b5 367a 0 +b5 b6 367b 0 +b6 b7 367c 0 +b7 b8 367d 0 +b8 b9 367e 0 +b9 ba 367f 0 +ba bb 3680 0 +bb bc 3681 0 +bc bd 3682 0 +156 157 3685 0 +157 158 3686 0 +158 159 3687 0 +159 15a 3688 0 +15a 15b 3689 0 +15b 15c 368a 0 +15c 15d 368b 0 +15d 15e 368c 0 +15e 15f 368d 0 +15f 160 368e 0 +160 161 368f 0 +161 162 3690 0 +162 163 3691 0 +163 164 3692 0 +164 165 3693 0 +165 166 3694 0 +166 167 3695 0 +167 168 3696 0 +168 169 3697 0 +169 16a 3698 0 +16a 16b 3699 0 +16b 16c 369a 0 +16c 16d 369b 0 +16d 16e 369c 0 +16e 16f 369d 0 +16f 170 369e 0 +170 171 369f 0 +171 172 36a0 0 +172 173 36a1 0 +173 174 36a2 0 +174 175 36a3 0 +175 176 36a4 0 +176 177 36a5 0 +177 178 36a6 0 +178 179 36a7 0 +179 17a 36a8 0 +17a 17b 36a9 0 +17b 17c 36aa 0 +17c 17d 36ab 0 +17d 17e 36ac 0 +17e 17f 36ad 0 +17f 180 36ae 0 +180 181 36af 0 +181 182 36b0 0 +182 183 36b1 0 +183 184 36b2 0 +184 185 36b3 0 +185 186 36b4 0 +186 187 36b5 0 +187 188 36b6 0 +188 189 36b7 0 +189 18a 36b8 0 +18a 18b 36b9 0 +18b 18c 36ba 0 +18c 18d 36bb 0 +18d 18e 36bc 0 +18e 18f 36bd 0 +18f 190 36be 0 +190 191 36bf 0 +191 192 36c0 0 +192 193 36c1 0 +193 194 36c2 0 +1b2 1b3 365a 0 +1b3 1b4 365b 0 +1b4 1b5 365c 0 +1b5 1b6 365d 0 +1b6 1b7 365e 0 +1b7 1b8 365f 0 +1b8 1b9 3660 0 +1b9 1ba 3661 0 +1ba 1bb 3662 0 +1e3 1e4 3612 0 +1e4 1e5 3613 0 +1e5 1e6 3614 0 +1e6 1e7 3615 0 +1e7 1e8 3616 0 +1e8 1e9 3617 0 +1e9 1ea 3618 0 +1ea 1eb 3619 0 +1eb 1ec 361a 0 +1ec 1ed 361b 0 +1ed 1ee 361c 0 +1ee 1ef 361d 0 +1ef 1f0 361e 0 +1f0 1f1 361f 0 +1f1 1f2 3620 0 +1f2 1f3 3621 0 +1f3 1f4 3622 0 +1f4 1f5 3623 0 +1f5 1f6 3624 0 +1f6 1f7 3625 0 +1f7 1f8 3626 0 +1f8 1f9 3627 0 +1f9 1fa 3628 0 +1fa 1fb 3629 0 +1fb 1fc 362a 0 +1fc 1fd 362b 0 +1fd 1fe 362c 0 +1fe 1ff 362d 0 +1ff 200 362e 0 +200 201 362f 0 +201 202 3630 0 +202 203 3631 0 +203 204 3632 0 +204 205 3633 0 +205 206 3634 0 +206 207 3635 0 +207 208 3636 0 +208 209 3637 0 +209 20a 3638 0 +20a 20b 3639 0 +20b 20c 363a 0 +20c 20d 363b 0 +20d 20e 363c 0 +20e 20f 363d 0 +20f 210 363e 0 +210 211 363f 0 +211 212 3640 0 +212 213 3641 0 +213 214 3642 0 +214 215 3643 0 +215 216 3644 0 +216 217 3645 0 +217 218 3646 0 +218 219 3647 0 +219 21a 3648 0 +21a 21b 3649 0 +21b 21c 364a 0 +21c 21d 364b 0 +21d 21e 364c 0 +21e 21f 364d 0 +21f 220 364e 0 +220 221 364f 0 +221 222 3650 0 +222 223 3651 0 +223 224 3652 0 +224 225 3653 0 +225 226 3654 0 +226 227 3655 0 +227 228 3656 0 +228 229 3657 0 +297 298 36c5 0 +298 299 36c6 0 +299 29a 36c7 0 +29a 29b 36c8 0 +29b 29c 36c9 0 +29c 29d 36ca 0 +29d 29e 36cb 0 +29e 29f 36cc 0 +2c2 2c3 35c3 0 +2c3 2c4 35c2 0 +2c4 2c5 35c1 0 +2c5 2c6 35c0 0 +2c6 2c7 35bf 0 +2c7 2c8 35be 0 +2c8 2c9 35bd 0 +2c9 2ca 35bc 0 +2ca 2cb 35bb 0 +2cb 2cc 35ba 0 +2cc 2cd 35b9 0 +2cd 2ce 35b8 0 +2ce 2cf 35b7 0 +2cf 2d0 35b6 0 +302 303 35d3 0 +303 304 35d2 0 +304 305 35d1 0 +305 306 35d0 0 +306 307 35cf 0 +307 308 35ce 0 +308 309 35cd 0 +309 30a 35cc 0 +30a 30b 35cb 0 +30b 30c 35ca 0 +30c 30d 35c9 0 +30d 30e 35c8 0 +30e 30f 35c7 0 +30f 310 35c6 0 +342 343 35e3 0 +343 344 35e2 0 +344 345 35e1 0 +345 346 35e0 0 +346 347 35df 0 +347 348 35de 0 +348 349 35dd 0 +349 34a 35dc 0 +34a 34b 35db 0 +34b 34c 35da 0 +34c 34d 35d9 0 +34d 34e 35d8 0 +34e 34f 35d7 0 +34f 350 35d6 0 +3cf 3d0 360f 0 +3d0 3d1 360e 0 +3d1 3d2 360d 0 +3d2 3d3 360c 0 +3d3 3d4 360b 0 +3d4 3d5 360a 0 +3d5 3d6 3609 0 +3d6 3d7 3608 0 +3d7 3d8 3607 0 +3d8 3d9 3606 0 +3d9 3da 3605 0 +3da 3db 3604 0 +3db 3dc 3603 0 +3dc 3dd 3602 0 +3dd 3de 3601 0 +3de 3df 3600 0 +3df 3e0 35ff 0 +3e0 3e1 35fe 0 +3e1 3e2 35fd 0 +3e2 3e3 35fc 0 +3e3 3e4 35fb 0 +3e4 3e5 35fa 0 +3e5 3e6 35f9 0 +3e6 3e7 35f8 0 +3e7 3e8 35f7 0 +3e8 3e9 35f6 0 +3e9 3ea 35f5 0 +3ea 3eb 35f4 0 +3eb 3ec 35f3 0 +3ec 3ed 35f2 0 +3ed 3ee 35f1 0 +3ee 3ef 35f0 0 +3ef 3f0 35ef 0 +3f0 3f1 35ee 0 +3f1 3f2 35ed 0 +3f2 3f3 35ec 0 +3f3 3f4 35eb 0 +3f4 3f5 35ea 0 +3f5 3f6 35e9 0 +3f6 3f7 35e8 0 +3f7 3f8 35e7 0 +3f8 3f9 35e6 0 +425 426 35b3 0 +426 427 35b2 0 +427 428 35b1 0 +428 429 35b0 0 +429 42a 35af 0 +42a 42b 35ae 0 +42b 42c 35ad 0 +42c 42d 35ac 0 +42d 42e 35ab 0 +42e 42f 35aa 0 +42f 430 35a9 0 +430 431 35a8 0 +431 432 35a7 0 +432 433 35a6 0 +433 434 35a5 0 +434 435 35a4 0 +435 436 35a3 0 +436 437 35a2 0 +437 438 35a1 0 +438 439 35a0 0 +439 43a 359f 0 +43a 43b 359e 0 +43b 43c 359d 0 +43c 43d 359c 0 +43d 43e 359b 0 +43e 43f 359a 0 +43f 440 3599 0 +440 441 3598 0 +441 442 3597 0 +442 443 3596 0 +443 444 3595 0 +444 445 3594 0 +445 446 3593 0 +446 447 3592 0 +447 448 3591 0 +448 449 3590 0 +449 44a 358f 0 +44a 44b 358e 0 +44b 44c 358d 0 +44c 44d 358c 0 +44d 44e 358b 0 +44e 44f 358a 0 +472 473 3587 0 +473 474 3586 0 +474 475 3585 0 +475 476 3584 0 +476 477 3583 0 +477 478 3582 0 +478 479 3581 0 +479 47a 3580 0 +47a 47b 357f 0 +47b 47c 357e 0 +47c 47d 357d 0 +47d 47e 357c 0 +47e 47f 357b 0 +47f 480 357a 0 +480 481 3579 0 +481 482 3578 0 +482 483 3577 0 +483 484 3576 0 +484 485 3575 0 +485 486 3574 0 +486 487 3573 0 +487 488 3572 0 +488 489 3571 0 +489 48a 3570 0 +48a 48b 356f 0 +48b 48c 356e 0 +48c 48d 356d 0 +48d 48e 356c 0 +48e 48f 356b 0 +48f 490 356a 0 +523 524 3567 0 +524 525 3566 0 +525 526 3565 0 +526 527 3564 0 +527 528 3563 0 +528 529 3562 0 +529 52a 3561 0 +52a 52b 3560 0 +52b 52c 355f 0 +52c 52d 355e 0 +52d 52e 355d 0 +52e 52f 355c 0 +52f 530 355b 0 +530 531 355a 0 +531 532 3559 0 +532 533 3558 0 +533 534 3557 0 +534 535 3556 0 +535 536 3555 0 +536 537 3554 0 +537 538 3553 0 +538 539 3552 0 +539 53a 3551 0 +53a 53b 3550 0 +53b 53c 354f 0 +53c 53d 354e 0 +53d 53e 354d 0 +53e 53f 354c 0 +53f 540 354b 0 +540 541 354a 0 +541 542 3549 0 +542 543 3548 0 +543 544 3547 0 +544 545 3546 0 +545 546 3545 0 +546 547 3544 0 +547 548 3543 0 +548 549 3542 0 +549 54a 3541 0 +54a 54b 3540 0 +54b 54c 353f 0 +54c 54d 353e 0 +54d 54e 353d 0 +54e 54f 353c 0 +54f 550 353b 0 +550 551 353a 0 +58b 58c 3537 0 +58c 58d 3536 0 +58d 58e 3535 0 +58e 58f 3534 0 +58f 590 3533 0 +590 591 3532 0 +591 592 3531 0 +592 593 3530 0 +593 594 352f 0 +594 595 352e 0 +595 596 352d 0 +596 597 352c 0 +597 598 352b 0 +598 599 352a 0 +599 59a 3529 0 +59a 59b 3528 0 +59b 59c 3527 0 +59c 59d 3526 0 +59d 59e 3525 0 +59e 59f 3524 0 +59f 5a0 3523 0 +5a0 5a1 3522 0 +5a2 5a3 351f 0 +5a3 5a4 351e 0 +5a4 5a5 351d 0 +5a5 5a6 351c 0 +5a6 5a7 351b 0 +5a7 5a8 351a 0 +5a8 5a9 3519 0 +5a9 5aa 3518 0 +5aa 5ab 3517 0 +5ab 5ac 3516 0 +5ac 5ad 3515 0 +5ad 5ae 3514 0 +5ae 5af 3513 0 +5af 5b0 3512 0 +5b0 5b1 3511 0 +5b1 5b2 3510 0 +5b2 5b3 350f 0 +5b3 5b4 350e 0 +5b4 5b5 350d 0 +5b5 5b6 350c 0 +5b6 5b7 350b 0 +5b7 5b8 350a 0 +5b8 5b9 3509 0 +5b9 5ba 3508 0 +5ba 5bb 3507 0 +5bb 5bc 3506 0 +5bc 5bd 3505 0 +5bd 5be 3504 0 +5be 5bf 3503 0 +5bf 5c0 3502 0 +5e0 5e1 10af 0 +5e1 5e2 10ae 0 +5e2 5e3 10ad 0 +5e3 5e4 10ac 0 +5e4 5e5 10ab 0 +5e5 5e6 10aa 0 +5e6 5e7 10a9 0 +5e7 5e8 10a8 0 +5e8 5e9 10a7 0 +5e9 5ea 10a6 0 +5ea 5eb 10a5 0 +5eb 5ec 10a4 0 +5ec 5ed 10a3 0 +5ed 5ee 10a2 0 +5ee 5ef 10a1 0 +5ef 5f0 10a0 0 +5f0 5f1 109f 0 +5f1 5f2 109e 0 +5f2 5f3 109d 0 +5f3 5f4 109c 0 +5f4 5f5 109b 0 +5f5 5f6 109a 0 +5f6 5f7 1099 0 +5f7 5f8 1098 0 +5f8 5f9 1097 0 +5f9 5fa 1096 0 +5fa 5fb 1095 0 +5fb 5fc 1094 0 +5fc 5fd 1093 0 +5fd 5fe 1092 0 +658 659 10df 0 +659 65a 10de 0 +65a 65b 10dd 0 +65b 65c 10dc 0 +65c 65d 10db 0 +65d 65e 10da 0 +65e 65f 10d9 0 +65f 660 10d8 0 +660 661 10d7 0 +661 662 10d6 0 +662 663 10d5 0 +663 664 10d4 0 +664 665 10d3 0 +665 666 10d2 0 +666 667 10d1 0 +667 668 10d0 0 +668 669 10cf 0 +669 66a 10ce 0 +66a 66b 10cd 0 +66b 66c 10cc 0 +66c 66d 10cb 0 +66d 66e 10ca 0 +66e 66f 10c9 0 +66f 670 10c8 0 +670 671 10c7 0 +671 672 10c6 0 +672 673 10c5 0 +673 674 10c4 0 +674 675 10c3 0 +675 676 10c2 0 +676 677 10c1 0 +677 678 10c0 0 +678 679 10bf 0 +679 67a 10be 0 +67a 67b 10bd 0 +67b 67c 10bc 0 +67c 67d 10bb 0 +67d 67e 10ba 0 +67e 67f 10b9 0 +67f 680 10b8 0 +680 681 10b7 0 +681 682 10b6 0 +682 683 10b5 0 +683 684 10b4 0 +684 685 10b3 0 +685 686 10b2 0 +6d3 6d4 108f 0 +6d4 6d5 108e 0 +6d5 6d6 108d 0 +6d6 6d7 108c 0 +6d7 6d8 108b 0 +6d8 6d9 108a 0 +6d9 6da 1089 0 +6da 6db 1088 0 +6db 6dc 1087 0 +6dc 6dd 1086 0 +6dd 6de 1085 0 +6de 6df 1084 0 +6df 6e0 1083 0 +6e0 6e1 1082 0 +6e1 6e2 1081 0 +6e2 6e3 1080 0 +6e3 6e4 107f 0 +6e4 6e5 107e 0 +6e5 6e6 107d 0 +6e6 6e7 107c 0 +6e7 6e8 107b 0 +6e8 6e9 107a 0 +6e9 6ea 1079 0 +6ea 6eb 1078 0 +6eb 6ec 1077 0 +6ec 6ed 1076 0 +6ed 6ee 1075 0 +6ee 6ef 1074 0 +6ef 6f0 1073 0 +6f0 6f1 1072 0 +6f1 6f2 1071 0 +6f2 6f3 1070 0 +6f3 6f4 106f 0 +6f4 6f5 106e 0 +6f5 6f6 106d 0 +6f6 6f7 106c 0 +6f7 6f8 106b 0 +6f8 6f9 106a 0 +6f9 6fa 1069 0 +6fa 6fb 1068 0 +6fb 6fc 1067 0 +6fc 6fd 1066 0 +6fd 6fe 1065 0 +6fe 6ff 1064 0 +6ff 700 1063 0 +700 701 1062 0 +701 702 1061 0 +702 703 1060 0 +703 704 105f 0 +704 705 105e 0 +705 706 105d 0 +706 707 105c 0 +707 708 105b 0 +708 709 105a 0 +709 70a 1059 0 +70a 70b 1058 0 +70b 70c 1057 0 +70c 70d 1056 0 +70d 70e 1055 0 +70e 70f 1054 0 +70f 710 1053 0 +710 711 1052 0 +)) +(45 (5 wall wall-5) ()) diff --git a/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/cfd_para.hypara b/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/cfd_para.hypara new file mode 100644 index 0000000..b17970c --- /dev/null +++ b/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/cfd_para.hypara @@ -0,0 +1,1220 @@ +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +// PPPPP H H EEEEE N N GGGGG L EEEEE III + +// P P H H E NN N G L E I + +// PPPPP HHHHH EEEEE N N N G GG L EEEEE I + +// P H H E N N N G G L E I + +// P H H EEEEE N N GGGGG LLLLL EEEEE III + +//------------------------------------------------------------------------+ +// Platform for Hybrid Engineering Simulation of Flows + +// China Aerodynamics Research and Development Center + +// (C) Copyright, Since 2010 + +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +########################################################################### +# Default parameters for Grid conversion # +########################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// 2 -- Hybrid grid, include both of unstructured and structured grid. +// gridobj: Task type of grid treatment. +// 0 -- Grid generation of typical case, such as cylinder, flat plate, etc. +// 1 -- Grid conversion, from other grid data to PHenglEI, such as Fluent, CGNS. +// 2 -- Grid refinement. +// 3 -- Grid merging, merge two blocks into one block. +// 4 -- Grid deformation, achieve unstructured grid deformation. +// 5 -- Grid repairing, repair the original grid in order to remove the negative volume cells. +// 6 -- Grid mirroring, mirror a symmetry grid to whole grid. +// multiblock: Multi-block grid or not, only for structured grid conversion. +// 0 -- Not. +// 1 -- Yes. +// iadapt: Adaptation number for unstructure grid. +// SymmetryFaceVector: The vector of symmetry face. +// 0 -- X axis. +// 1 -- Y axis. +// 2 -- Z axis. +int gridtype = 0; +int gridobj = 1; +int multiblock = 0; +int iadapt = 0; +int SymmetryFaceVector = 1; + +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +int axisup = 1; + +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +int omit_no_bound_bc = 0; + +//----------------------------------------------------------------------- +# Grid data type # +//----------------------------------------------------------------------- +// from_gtype/to_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +// dumpOldGrid: If dump out the old grid file. +// 0 -- Not. (default) +// 1 -- Yes. +int from_gtype = 2; +int to_gtype = 1; +int dumpOldGrid = 0; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +int numberOfGridFile = 1; +string from_gfile = "./grid/rae2822_hybrid2d.cas"; +string from_gfile1= ""; + +string out_gfile = "./grid/flat_laminr_133_85_2d.fts"; + +// ----------------- some advanced choices ------------------------------ +// iunsteady: The Grid is for unsteady simulation or not. +int iunsteady = 0; +int codeOfAleModel = 0; + +// fileformat: Ustar Grid file format. +// 0 -- BINARY. +// 1 -- ASCII. +int fileformat = 0; + +// Parameters for hybrid solver. +// mixgrid_uns: path of unstructure grid file for hybrid solver, *.fts type. +// mixgrid_str: path of structure grid file for hybrid solver, *.fts type. +string mixgrid_uns = "./grid/rae2822_uns2d_4.fts"; +string mixgrid_str = "./grid/flat_laminr_133_85_2d.fts"; + +// Some parameters for structured overlapping grid. +int codeOfDigHoles = 1; +string holeBasicFileName = "./oversetGridView/holeBasicFile.inp"; +string holeFullFileName = "./oversetGridView/holeFullFile.dat"; +string linkFileName = "./oversetGridView/topology.dat"; +string zoneInverseFileName = "./oversetGridView/zoneInverseMapping.inp"; + +// ----------------- Adaptive Mesh Refine ------------------------------- +// In this file, the original_grid_file is used of the partition part. +// If use it dependently, abstract it here. +string adapt_grid_file = "./grid/sphere_mixed_adapt1.fts"; +string geometryFileName = "./grid/jsm.igs"; + +// geometryUnit: Geometry unit. +// 1 -- meter. +// 2 -- millimeter. +// 3 -- inch. +// exclusiveCase: Parallel projection exclusive case. +// 0 -- NON case. +// 1 -- JSM-C2-NPOFF case. +// 2 -- CHNT. +// projectOrgPoint: If the original wall points need to be projected or not. +int geometryUnit = 1; +int anisoRefine = 0; +int isProject = 0; +int readDist = 0; +int isDeform = 0; +int exclusiveCase = 0; // 0: NON case; 1: JSM-C2-NPOFF case; 2: CHNT. +int projectOrgPoint = 0; // if project original wall points. + + +// ----------------- Grid Deform Parameters ----------------------------- +// deformationMethod: Grid Deform. +// 1 -- SPRING. +// 2 -- RBF. +// stationalGridFile: Original grid file. +// visualFileName : The visualization file path of deform grid. +// nDeformStep : The max deform step. +// flapAngle : The max flap angle. +// rotatePostionZ : Rotate postion. +// rotatePostionY : Rotate postion. +// gridSlice : If dump slice grid. +// sliceAxis : Grid slice axis. +// slicePosition : Grid slice position. +int nDeformStep = 40; +double flapAngle = 10.0; +double rotatePostionZ = 4.00003; +double rotatePostionY = 3.05; + +int deformationMethod = 2; +string stationalGridFile = "./grid/Segment2Brid.fts"; +string visualFileName = "./results/deformedGrid.dat" + +int gridSlice = 1; +int sliceAxis = 1; +double slicePosition = 13; + +// ----------------- RBF Parameters ------------------------------------- +// numberOfReferenceCP : Number of reference Control Points. +// influencePara : The RBF influence radius parameter. +int numberOfReferenceCP = 40; +double influencePara = 25.0; + +// ----------------- Periodic Parameters -------------------------------- +// Notice: Rotational periodicity only support rotation along the X axis! +// periodicType: Which periodic boundary is used. +// 0 -- without Periodic Boundary. +// 1 -- Translational periodicity. +// 2 -- Rotational periodicity. +// translationLength[]: The relative distance between two periodic face + which only support one direction. +// rotationAngle: The relative angle between two periodic face. + which is recorded in degrees. + +int periodicType = 0; +double translationLength[] = [0.0,0.0,0.0]; +double rotationAngle = 0.0; + +######################################################################### +# Default parameters for Partition # +######################################################################### +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// 2 -- refine structured grid. +// maxproc: The number of partition zones that want to be divided into. +int pgridtype = 0; +int maxproc = 4; + +// traceMark: Trace mark or not, only for structured grid partition. +// 0 -- Not. +// 1 -- Yes. +// blockIndexOfMark: the block index of mark, only for structured grid partition. +// cellIndexOfMark: the cell index of mark, only for structured grid partition. +int traceMark = 0; +int blockIndexOfMark = 0; +int cellIndexOfMark[] = [185,30,1]; + +// parallel Strategy: +//! -# 0 : each zone is assigned to the one that defined in grid partition procedure. +//! -# 1 : random assigned for each zone or by some else ways. +int parallelStrategy = 1; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). +string original_grid_file = "./grid/sphere_mixed.fts"; +string partition_grid_file = "./grid/sphere_mixed__4.fts"; + +// ------------------ Sompe advanced parameters ------------------------- +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +// npartmethod: Method of interface reconstruction, default is 1. +// parallelPartitionMethod: Method of parallel partition, this is set only when execute parallel partition. It would be skipped when serial partition. +// 1 -- Using ParMetis for homogeneous MPI. +// 2 -- Using Metis for homogeneous MPI. +// 3 -- using METIS partition for homogeneous OpenMP. +// parmetisBalance: Used to specify the imbalance tolerance. +// 1 -- perfect balance. +// maxproc -- perfect imbalance. +// 1.05 -- recommended. + +int omit_no_bound_bc = 0; +int npartmethod = 1; +int parallelPartitionMethod = 2; +double parmetisBalance = 1.05; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level, ..., et al. +int numberOfMultigrid = 1; + +######################################################################### +# Default parameters for CFD simulation # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepSample: The step intervals for monitored probes variables file 'sample.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual file 'res.dat' saved. +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) + +int maxSimuStep = 20000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepSample = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; +int ifLowSpeedPrecon = 0; + +// compressible: +// 0 -- incompressible flow. +// 1 -- compressible flow. (default) +int compressible = 1; + +//----------------------------------------------------------------------- +# CFD Control Parameter # +//----------------------------------------------------------------------- +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// 4 -- the condition that the velocity, temperature and density are given. +// 5 -- the condition that the velocity, temperature and pressure are given. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. +// radiationCoef: The radiation coefficient on wall, it is used to compute the radiation heat flux on wall when the boundary +// condition is radiation equilibrium temperature, and 0.8 is the default value. +// refMolecularWeight : the reference molecular weight of gas used for perfect gas. The unit is g/mol. +// Generally, the gas is air. Sometimes, it is experiment gas, such as Nitrogen, Argon, and so on. + +double refMachNumber = 0.73; +double attackd = 2.79; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 6.5e6; +double refDimensionalTemperature = 288.15; +double freestream_vibration_temperature = 300.00; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +//int inflowParaType = 3; +//int nsubsonicInlet = 1; +//int nsubsonicOutlet = 1; +//string inLetFileName = "./bin/subsonicInlet.hypara"; +//string outLetFileName = "./bin/subsonicOutlet.hypara"; +//double refDimensionalTemperature = 288.144; +//double refDimensionalPressure = 1.01313E05; + +//The velocity, temperature and density are fixed. +//int inflowParaType = 4; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalDensity = 1.0e3; + +//The velocity, temperature and pressure are fixed. +//int inflowParaType = 5; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalPressure = 1.0e5; + +//The MachNumber, temperature and pressure are fixed. +//int inflowParaType = 6; +//double refDimensionalTemperature = 293; +//double refDimensionalPressure = 8886.06; + +double wallTemperature = -1.0; + +double radiationCoef = 0.8; +double gridScaleFactor = 1.0; + +int numberOfAerodynamicForceComponents = 1; +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. +double refMolecularWeight = 28.9644; // unit of g/mol. + +//----------------------------------------------------------------------- +# Spatial Discretisation # +//----------------------------------------------------------------------- +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "hlle", "lax_f". +// -- "roe", "modified_roe". +// -- "ausm+", "ausm+w", "ausm+up", "ausmdv", "ausmpw", "ausmpw+". +// str_limiter_name: Limiter of struct grid. +// -- "vanalbada", "vanleer", "minmod", "smooth", "minvan", "3rdsmooth", "3rd_minmod_smooth". +// -- "nolim", no limiter. +// -- "vanalbada_clz", clz supersonic version. +string inviscidSchemeName = "roe"; +string str_limiter_name = "vanalbada"; + +#******************************************************************* +# UnStruct Solver or Common * +#******************************************************************* +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 2 -- Algebraic. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "0eq-bl". +// -- "1eq-sa". +// -- "2eq-kw-menter-sst". +// -- "2eq-kw-menter-bsl". +// -- "2eq-kw-wilcox-1988". +// -- "2eq-kw-wilcox-1998". +// -- "2eq-kw-kok-tnt". +// -- "2eq-kw-wilcox-2006". +// -- "easm-kw-2003". +// -- "easm-kw-2005". +// DESType: Type of DES. +// 0 -- RANS. (default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpw+". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "barth", "vencat", "vanleer", "minmod". +// -- "vanalbada", "smooth", "nnd", "lpz", "1st". +// -- "nolim", no limiter. +// uns_vis_name: Discretisation method of viscous term. +// -- "std", "test", "aver", "new1", "new2". +// gradientName: Gradient reconstruction method. +// -- "default", "ggcell", "ggnode", "lsq". +// ivencat: Variation of vencat limiter. +// 0 -- org method, it is independent of grid scale. +// 1 -- new method, it is dependent of grid scale. +// 4 -- Ustar limiter model, without grid size unitary. +// 7 -- default used. +// venkatCoeff: Cofficient of vencat, when using vencat limter. +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. +// skewnessAngle: The skewness angle of grid cells. +// roeEntropyFixMethod: Entropy fix (correction) method. +// 1 -- direct fix, which limits the minimum eigenvalue directly. +// 2 -- multi-dimensional fix, which is derived from structured solver and now is only valid for struct solver. +// 3 -- Harten type, which is default used. +// roeEntropyScale: Entropy fix (correction) coefficient scale, default is 1.0. +// It is used to scale the default Roe entropy fix coefficients. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +string uns_scheme_name = "roe"; +string uns_limiter_name = "vencat"; +string uns_vis_name = "test"; +string gradientName = "ggnode"; + +int ivencat = 7; +double venkatCoeff = 5.0; +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; +double skewnessAngle = 60.0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; + +//----------------------------------------------------------------------- +# Temporal Discretisation # +//----------------------------------------------------------------------- +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// physicalTimeStep: The nondimensional physical time step. +// ifStartFromSteadyResults: The unsteady simulation is start from steady flowfield or not, 0 is for no and else is for yes. +// ifStaticsFlowField: Statistical variables for unsteady simulation. +// ifStaticsReynoldsStress: Statistical Reynolds stress for unsteady simulation. +// startStatisticStep: Outer step when start statistics. +// when the value is larger than "maxSimuStep", it is useless. +// statisticalTimePeriod: Used as time period of statistic analysis. +// when the value is negative, time period is treated as infinite. +// statisticMethod: Statistic reynolds stress method. + 0 --tau = - ^2 + 1 --tau = +// min_sub_iter: The min sub iteration of unsteady simulation. +// max_sub_iter: The max sub iteration of unsteady simulation. +// tol_sub_iter: The tolerance of sub iteration of unsteady simulation. +// tscheme: Temporal Discretisation method. +// 1 -- Runge-Kutta Multi-State. +// 2 -- Point implicit. +// 3 -- Full implicit. +// 4 -- LU-SGS. +// 5 -- Block LU-SGS. +// 6 -- Jacobian iteration. +// 7 -- Lower G-S iteration. +// 8 -- Upper G-S iteration. +// 9 -- Lower/Upper G-S iteration. +// iSimplifyViscousTerm: Simplify the computation of viscous term in the Block LU-SGS method. The default value assigns 1 that could speed up the computation. +// Otherwise, the viscous Jacobian matrix Mv should be computed that will increase the memory and time in iteration of the BLUSGS method. +// CFLStart: Started cfl number. +// CFLEnd: End cfl number. +// CFLVaryStep: The number of step when cfl increase from CFLStart to CFLEnd. +// ktmax: Dtratio. dt[i] = MIN(dt[i], ktmax * dtmin / vol[i]) +// swapDq: Communication dq between forward/backward sweep of LUSGS or not, default is 0. +// nLUSGSSweeps: Sub iteration of LU-SGS or Block LU-SGS. +// LUSGSTolerance: Sub iter tolerance of LU-SGS or Block LU-SGS. +// ifLocalTimeStep: Time step method. +// 0 --Local. +// 1 --Global. +// visl_min: Minimum value of laminar viscosity coefficient. +// turbCFLScale: Turbulence model cfl number factor. +// codeOfAleModel: Arbitrary Lagrangian-Eulerian method. +// 0 -- no ALE method. +// 1 -- ALE method for non-moving grids. +// 2 -- ALE method for moving grids. +// 3 -- ALE method for deforming grids. +// wallFunctionType: The type of wall function to implement. +// 0 -- no wall function. (default) +// 1 -- standard wall function. +// 2 -- Pab3D wall function. +// RKStage: The number of Runge-Kutta step. +// lamda: Cofficient of Runge-Kutta step. + +int iunsteady = 0; +double physicalTimeStep = 0.01; +int ifStartFromSteadyResults = 0; +int ifStaticsFlowField = 0; +int ifStaticsReynoldsStress = 0; +int startStatisticStep = 800000; +double statisticalTimePeriod = -1.0; +int statisticMethod = 0; +int linearTwoStepMethods = 1; // 1--BDF1; 2--C-N; 3--BDF2; + +int methodOfDualTime = 3; +int min_sub_iter = 50; +int max_sub_iter = 50; +double tol_sub_iter = 0.01; + +int tscheme = 4; +int iSimplifyViscousTerm = 1; +int ifLocalTimeStep = 0; +double CFLStart = 0.01; +double CFLEnd = 10.0; +int CFLVaryStep = 500; + +double ktmax = 1.0e10; + +int swapDq = 1; + +int nLUSGSSweeps = 1; +double LUSGSTolerance = 0.01; +int order = 2; + +double visl_min = 0.01; +double turbCFLScale = 1.0; +double csrv = 2.0; +double timemax = 1.0e10; +double dtsave = -1.0; +int maxale = 10; +double dtau = 0.001; + +int wallFunctionType = 0; + +int RKStage = 2; +double lamda[] = 0.5, 1.0; + +//int RKStage = 1; +//double lamda[] = 1.0; + +//int RKStage = 4; +//double lamda[] = [0.25, 0.33333333333, 0.5, 1.0]; + +//----------------------------------------------------------------------- +# File In or Out # +//----------------------------------------------------------------------- +// numberOfGridGroups: The number of grid groups. +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the field results to visulization. +// walldistMethod: The method to compute wall distance. +// 0 -- accurate but not fast enough. +// 1 -- fast but not accurate enough. +// 2 -- super fast but more non-accurate! +// resSaveFile: The file path to save the residual convergence process, write data for every default (intervalStepRes) steps. +// turbresfile: The file path to save the residual convergence process of turbulence, write data for every default (intervalStepRes) steps. +// aircoeffile: The file path to save the aerodynamic force coefficients convergence process, write data for every default (intervalStepForce) steps. +// restartNSFile: The file path to write restart flowfield variables, write data for every default (intervalStepFlow) steps. +// turbfile: The file path to write restart flowfield variables of turbulence , write data for every default(intervalStepFlow) steps. +// visualfile: The visualization file path of flowfield , write data for every default (intervalStepPlot) steps. +// wall_aircoefile: The file path to save flowfield variables of wall, write data for every default steps. +// nDumpSurfaceInfo = 0 the "wall_varfile" write the informations including heat flux. +// nDumpSurfaceInfo = 1 the "wall_varfile" write the informations without heat flux. + +int numberOfGridGroups = 1; +string gridfile = "./grid/rae2822_hybrid2d__4.fts"; +string wallTemperaturefile= ""; + +int walldistMethod = 1; + +string resSaveFile = "results/res.dat"; +string turbresfile = "results/turbres.dat"; +string aircoeffile = "results/aircoef.dat"; + +string restartNSFile = "results/flow.dat"; +string turbfile = "results/turb.dat"; + +string visualfile = "results/tecflow.plt"; +string wall_aircoefile = "results/wall_aircoef.dat"; +string samplefile = "results/sample.dat"; + +int nDumpSurfaceInfo = 0; +string wall_varfile = ""; + +string jetDefineFile = "bin/jet.hypara"; + +string sixDofFileName = "results/sixDofInfo.dat"; +string derivativeFileName = "results/identify.dat"; +string hysteresisFileName = "results/force_beta.plt"; + +int plotFieldType = 0; + +// visualfileType: The file type of visualfile. +// 0 -- Tecplot binary. +// 1 -- Tecplot ASCII. + +int visualfileType = 1; + +// samplefileMode: The dump mode of sample file. +// 0 -- dump out every probe/line/surface data for all step intervals. +// 1 -- dump out all probe/line/surface data for every step intervals. +int samplefileMode = 0; + +// visualSlice: The slice of tecflow. +// 0 -- Do not save slice data. +// 1 -- comput and save it to sliceFile. +// sliceAxis: Normal vector of slice. +// 1 -- X_DIR. +// 2 -- Y_DIR. +// 3 -- Z_DIR. +// slicePostion: Coordinate of slice. + +int visualSlice = 0; +int sliceAxis = 1; +double slicePostion = -0.5; +string sliceFile = "results/Slice.plt"; +int dumpWallFaceCenter = 0; + +// min-max box of the visual block. +double lowerPlotFieldBox[] = [0.0 0.0 0.0]; +double upperPlotFieldBox[] = [1.0 1.0 1.0]; + +//-----------the optional parameters list for the flow field output---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40), +// -- gradientUx(41), gradientUy(42), gradientVx(43), gradientVy(44), iblank(81). +// -- specific heat ratio(gama, 56) +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. +//-----------the optional parameters list for the wall boundary condition---------------- +// nVisualWallVariables: The number of visual variables on wall. +// visualWallVariables : dumped variable types, listed as following: +// -coefficient of pressure(cp, 0), -coefficient of friction(cf, 1), yplus(2), -non-dimensional heat flux(Q_NonDim, 3), -dimensional heat flux(Q_Dim, 4), +// -pressure on wall(pw, 5), -temperature on wall(Tw, 6), -density on wall(rhow, 7), -heat flux of translational-rotational temperature term(Qtr, 8), +// -heat flux of species diffusion term(Qs, 9), -heat flux of vibrational temperature term(Qv, 10), -heat flux of electron temperature term(Qe, 11), +// -species mass fractions(Ns, 12), -x component of wall velocity(Vx, 13), -y component of wall velocity(Vy, 14), -z component of wall velocity(Vz, 15) +// -slip translational-rotational temperature(Tts, 16), -slip vibrational temperature(Tvs, 17), -slip electron temperature(Tes, 18), -absolute wall velocity(Vs, 19) +// -Stanton number(St, 20), -coefficient of heat rate(Ch, 21), -temperature jump(deltaT, 22), -transition gamaeff(gamaeff, 48), +// -transition intermittency(intermittency, 51), -transition momentum thickness reynolds(MomentumThicknessReynolds, 52), +// -overlap iblank(iblank, 81) + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +int nVisualWallVariables = 9; +int visualWallVariables[] = [0, 1, 2, 3, 4, 5, 9, 10, 11]; + +// dumpStandardModel: Dump many standard model data. +// 1 -- Turbulent flat plate. +int dumpStandardModel = 0; + +// ifSetDataMonitor: Whether to set the data monitor. +// 0 -- No. +// 1 -- Yes. +// dataMonitorType: The type of data Monitor. +// 0 -- Probes data monitor. +// 1 -- Lines data monitor. +// 2 -- Surfaces data monitor. +// probesDefineFile: Probes location information file. +// nLines: The number of lines need to be monitored. +// linesDefineFile: Lines location information file. +// nSurfaces: The number of surfaces need to be monitored. +// surfacesDefineFile: Surfaces location information file. +// searchCellsMethod: method to search the cell of each probe. +// 0 -- Nearest cell to the probe. +// 1 -- Real cell where the probe is located. +// nProbeVariables: Number of variables want to be dumped for probes monitered. +// probeVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5). +// Important Warning: Array size of probeVariables MUST be equal to nProbeVariables!!! +// probeVariables order must from small to big. +// probeVariablesInterpolationMethod: Interpolation method used to compute the probe variables. +// 0 -- Take the value of probe's cell as probe real value. +// 1 -- Interpolation from probe's and neighbouring cell to probe. +// 2 -- Interpolation from probe's cell nodes to probe. +int ifSetDataMonitor = 0; + +int dataMonitorType = 0; +string probesDefineFile = "bin/probes_XYZ.dat"; + +//int dataMonitorType = 1; +//int nLines = 1; +//string linesDefineFile = "bin/lines_XYZ.dat"; + +//int dataMonitorType = 2; +//int nSurfaces = 4; +//string surfacesDefineFile = "bin/surfaces_XYZ.dat"; + +int searchCellsMethod = 0; + +int nProbeVariables = 6; +int probeVariables[] = [0, 1, 2, 3, 4, 5]; +int probeVariablesInterpolationMethod = 0; +//----------------------------------------------------------------------- +# Turbulence Parameter # +//----------------------------------------------------------------------- +// turbInterval: Iteration number of turbulence. +// kindOfTurbSource: Kinds of turbulent source. +// 0 -- Original. +// 1 -- Edwards. +// 2 -- new. +// mod_turb_res: If modify the residuals for the cells next to the wall or not, default is 0. + +int turbInterval = 1; +int turbOrderStruct = 2; +int kindOfTurbSource = 0; +int mod_turb_res = 0; +double turb_relax = 1.0; +double freeStreamViscosity = 1.0e-3; +double muoo = 3.0; +double kwoo = 5.0; +int transitionType = 0; +double turbIntensity = -1.0; +int freeturbIntensitySRModify = 0; +double freeDecayXLocation = 0.0; +int compressibleCorrection = 0; +int transitionMaFix = 1; + +# maximum eddy viscosity (myt/my) max. +double eddyViscosityLimit = 1.0e10; +int monitor_vistmax = 0; + +//----------------------------------------------------------------------- +# LES Parameter # +//----------------------------------------------------------------------- +// iLES: Create LESSolver or not. +// == 1 - Create LESSolver; +// != 1 - not. +// amplitudeofDisturb: Amplitude of adding disturb. +// disturbstep: Unsteady time step or steady iteration of adding random disturb. +// iterdisturb: Add random disturb in every sub-iter or only first sub-iter. +// = 0 - in only first sub-iter; +// != 0 - in every sub-iter. +// ipraddisturb: Add density and pressure disturb or not. +// ibodyforce: Add body force in source flux of NS equations or not. +// = 0 - not; +// != 0 - Add body force. +// bodyforce: Body force in source flux of NS equations or not. +// utau: friction velocity, using in DNSDisturb. +// sgsmodel: subgrid scale model. +// = "smagorinsky"; +// = "dsmCom"; +// = "wale"; +// = "sigma". +// deltaFunctionType: = 1 - MAX(deltai, deltaj, deltak); +// = 2 - pow(deltai * deltaj *deltak, 1/3); +// = 3 - Devloped by Scotti. +// wallDampingFunctionType: = 0 - no wall function; +// = 1 - van Driest; +// = 2 - developed by Dr. Deng Xiaobing; +// = 3 - developed by Piomelli. +// turbViscousCutType: turbulent viscosity cut type. +// = 0 - mu_total = mut + mul; +// = 1 - mu_total = max(mut-mul,0)+ mul; +// = 2 - mu_total = max(mut ,0)+ mul. +// smagConstant: constant of smagorinsky model. +// waleConstant: constant of wale model. +// filterDirection[3]: filter variables in i, j, k direction or not. +// averageDirection[3]: average variables in i, j, k direction or not. +// isotropicConstant: constant of isotropic part of SGS stress. + +int iLES = 0; +string sgsmodel = "smagorinsky"; +int deltaFunctionType = 2; +int wallDampingFunctionType = 1; +int turbViscousCutType = 2; +double smagConstant = 0.1; +double isotropicConstant = 0.0; +double waleConstant = 0.6; +double sigmaConstant = 1.35; +int filterDirection[] = [1, 1, 0]; +int averageDirection[] = [0, 0, 0]; +double testFilterScale = 2.0; +int averageWidth = 1; +int monitorNegativeConstant = 0; + +//----------------------------------------------------------------------- +# Other Parameters for Hypersonic Non-equilibrium Gas # +//----------------------------------------------------------------------- +// dg_high_order: +// 0 -- generic order accuracy. +// 1 -- high order accuracy. +// iapplication: +// 0 -- gas model is fixed in the codes. +// 1 -- gas model is imported from library files. +// iCodeBranch: +// 0 -- The old code version is used for Navier-Stokes. +// 1 -- A new code version is active for Navier-Stokes solver. +// nm: Equation number of the physics, but is out of commision now. +// 4 -- for 2D. +// 5 -- for 3D. +// nGasModel: The type of gas. less than and equal to 1 represents the mixture gas. +// Otherwise, the pure gas with one component is used for perfect gas. +// 0 -- Earth gas. +// 1 -- Mars gas. +// 2 -- Argon. +// 3 -- Nitrogen. +// nEnergyRecycle: The type of EnergyModel Recycle. +// 0 -- not used . +// 1 -- used. +// nDensityModify: The type of densitymodify. + +// 0 -- not used. +// 1 -- used. +// nchem: +// 0 -- without chemical reaction flow. +// 1 -- the chemical reaction flow is considered. +// nEquilibriumGas: the variable is valid when the condition of nchem=0 is satisfied. +// 0 -- perfect gas. +// 5, 7, 11 -- equilibrium gas, meanwhile, its value denotes the number of gas component. +// nPCWCycleStep: the maximum step number of iteration in the module of computing species mass fractions with the partial catalytic wall(PCW) condition. +// the value equals to or is greater than 1, and 3 is for default value. +// nRETCycleStep: the maximum step number of iteration in the module of computing radiation equilibrium temperature on wall. +// the value equals to or is greater than 1, and 3 is for default value. +// nSLIPCycleStep:the maximum step number of iteration in the module of computing slip temperature, slip velocity and slip species mass fraction. +// the value equals to or is greater than 1, and 3 is for default value. +// nSlipBCModel : The computational model of slip boundary conditions. + +// 0 -- no slip. +// 1 -- the conventional Maxwell slip conditions. +// 2 -- the Gokcen slip conditions. +// 3 -- the Knudsen-layer correction of the standard slip conditions proposed by Lockerby, et al. +// 4 -- the Kogan simplified slip conditions. +// nMeanFreePathType : the method to the mean free-path for the slip conditions. For the mixture, 0 is suggested. +// 0 -- the equivalent mean free-path is calculated by the simple hard sphere model(HS). +// 1 -- calculated by the definition that includes the variables of the number density and the molecule diameter. +// 2 -- the equivalent mean free-path is calculated by the variable hard sphere model(VHS). +// nchemsrc: +// 0 -- the source terms are not computed. +// 1 -- the source terms are computed. +// nchemrad: +// 0 -- compute the spectrum radius without considering chemical reaction flow. +// 1 -- compute the spectrum radius that need to count the contribution from chemical reaction flow. +// ntmodel: The thermodynamic temperature model. +// 1 -- One-temperature model. +// 2 -- Two-temperature model. +// 3 -- Three-temperature model. +// nTEnergyModel: the method to computing temperature energy model. +// 0 -- the energy term is computed using the conventional method. +// 1 -- the energy term is computed using the curve fitting method. +// parkVDPower: the power of translational-rotational temperature in the Park V-D(vibration-dissociation) coupling model. +// The value is in range of [0.0, 1.0], DPLR suggests 0.5, LAURA suggests 0.7, while 0.6 is given as default value. +// catalyticCoef: +// 0.0 -- full non-catalytic wall boundary condition. +// 1.0 -- full catalytic wall boundary condition. +// in range of (0.0, 1.0) -- partial catalytic condition, the value indicates the catalytic coefficient. +// nIsSuperCatalytic : the super catalytic condition for the fully catalytic wall, and assigned with the value of 1. +// 0 -- equilibrium condition for the fully catalytic wall where the mass fractions are assigned with the values of the free stream. +// 1 -- super catalytic condition for the fully catalytic wall where all the atomic components combine into molecular components. +// nTemperatureJump : the method to calculate the temperature jump. +// 0 -- calculated by the variables of heat conductivity and constant volume specific heat for each energy mode. +// 1 -- the general method where the iteration is calculated with the translation-rotation temperature. +// sigmaVelocity: the coordination coefficient of tangential momentum for computation of slip velocity. The value is in range of (0.0, 2.0]. +// sigmaTemperature: the heat coordination coefficient for computation of slip temperature. The value is in range of (0.0, 2.0]. +// sigmaMassFraction: the species coordination coefficient for computation of slip mass fractions. The value is in range of (0.0, 2.0]. +// velocitySlipCorrectConstant: the correction constant to the velocity slip condition. For the diffuse reflection, 1.0 is used. +// 1.0 -- proposed by Maxwell. +// sqrt(2/PI)~0.8 -- used for "micro-slip", namely the actual velocity slip at the wall. +// 1.146 -- proposed for an additional "fictitious" velocity slip. + +// chemicalRelaxCorf: The value is in range of [0.001, 1.0]. +// chemicalSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// viscousSpectrumRadiusCoef : The value is in range of [1.0, 3.0]. +// inviscidSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// staticPressureRelaxCorf: The value is in range of [0.1, 1.0]. +// nIsChemicalFreeze : the flag to freeze the chemical reactions. +// 0 -- not freeze, the chemical reaction sources will be calculated. +// 1 -- freezes the chemical reactions, the chemical reaction sources will not be calculated.// veTemperatureMin: The minimum of Tv and Te +// nDebug: cout the Wrong place and abort +// 0 -- not used. +// 1 -- used. +// nSpeciesLimit: limitter of gas species +// 0 -- not used. +// 1 -- used. +// nTurblenceForChemical: the coupled mode of Turblence and Chemical reaction +// 0 -- method 0. +// 1 -- method 1. +// nViscosityFluxSublevelModified: Modified for ViscosityFlux on Sublevel grid +// 0 -- not used. +// 1 -- used. +// nChemcalSourceModified: Modified on ChemcalSource +// 0 -- not used. +// 1 -- used. +// nAblation: +// 0 -- The wall ablation is not computed. +// 1 -- The wall ablation is computed. +// isInjection: +// 0 -- The injection velocity of ablation wall is not computed. +// 1 -- The injection velocity of ablation wall is computed. +// nViscosityModel: + +// 0 -- Blottner fitting method. +// 1 -- Gupta fitting method. +// nSutherland: +// 0 -- stands for selecting the Blotter curve fits mode. +// 1 -- stands for Sutherland relation. +// gasfile: Indicates the gas model, 9 models are provided, namely "Gu5", "Gu7", "Gu11", "Pa5", "Pa7", "Pa11", "DK5", "DK7", "DK11". +// "Gu" -- indicates the Gupta Model, three-Type Models are embeded in the library, namely, the 5-species-6-reactions, the 7-species-9-reactions, the 11-species-20-reactions. +// "Pa" -- indicates the Park Model, three-Type Models are embeded in the library, namely, the 5-species-17-reactions, the 7-species-22-reactions, the 11-species-48-reactions. +// "DK" -- indicates the Dunn-Kang Model, three-Type Models are embeded in the library, namely, the 5-species-11-reactions, the 7-species-15-reactions, the 11-species-26-reactions. +// "Mars-Pa8" is for Park model of Mars gas, "Mars-Mc8" for McKenzie model of Mars gas. +// "Combustion-12" -- indicates the Combustion Chamber Gas Model which includes 12-species-20-reactions. +// "Gas-Mixture" -- indicates the process of mixing two species without reacting. +// For self-definition model, the gasfile is used to indicate the file path of the new gas model. +// speciesName: Used to list the names of each species, while each species name is separated by the symbol of comma. +// initMassFraction: Used to list the initial mass fractions of species in accordance with the sequence of names in the parameter speciesName. +// ifStartFromPerfectGasResults: The chemical reaction simulation is start from perfect gas flowfield or not, 0 is for no and else is for yes. + +int dg_high_order = 0; +int iapplication = 0; +int iCodeBranch = 0; +int nm = 5; +int nEquilibriumGas = 0; +int nPCWCycleStep = 3; +int nRETCycleStep = 3; +int nSLIPCycleStep= 3; + +double refGama = 1.4; +double prl = 0.72; +double prt = 0.90; +double sc_l = 0.5; +double sc_t = 0.5; + +int nGasModel = 0; +int nchem = 0; +int nchemsrc = 1; +int nchemrad = 1; +int ntmodel = 1; + +int nEnergyRecycle = 0; +int nSlipBCModel = 0; +int nDensityModify = 1; +int nTEnergyModel = 0; +int nMeanFreePathType = 0; +int nIsChemicalFreeze = 0; +int nIsSuperCatalytic = 1; +int nTemperatureJump = 0; + +double parkVDPower = 0.6; +double catalyticCoef = 0.0; +double sigmaVelocity = 1.0; +double sigmaTemperature = 1.0; +double sigmaMassFraction = 1.0; +double velocitySlipCorrectConstant = 1.0; + +double chemicalRelaxCorf = 1.0; +double chemicalSpectrumRadiusCoef = 1.0; +double viscousSpectrumRadiusCoef = 1.0; +double inviscidSpectrumRadiusCoef = 1.0; +double staticPressureRelaxCorf = 1.0; + +double veTemperatureMin = 30.0; +int nDebug = 0; +int nSpeciesLimit = 0; +int nTurblenceForChemical = 0; +int nViscosityFluxSublevelModified = 0 ; +int nChemcalSourceModified = 0; + +int nAblation = 0; +int isInjection = 0; +int nViscosityModel = 0; +int nMarsModel = 0; +string gasfile = "DK5"; +//string gasfile = "./chemical/Dunn-Kang_air5s11r.dat"; +string speciesName = "O, O2, NO, N, N2"; +string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.767"; + +//string speciesName = "O, O2, NO, N, NO+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string speciesName = "O, O2, NO, N, O+, O2+, NO+, N+, N2+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Mars-Pa8"; +//string speciesName = "O, O2, NO, N, N2, C, CO, CO2"; +//string initMassFraction = "0.0015, 0.0429, 0.0, 0.0, 0.0, 0.0, 0.0777, 0.8779"; + +//string gasfile = "DK7"; +//string speciesName = "O, O2, NO, N, NO+, C, C2, CO, CO2, CN, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Combustion-12"; +//string speciesName = "O, O2, NO, N, C, CO, CO2, H, H2, OH, H2O, N2"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767"; + +//string gasfile = "Gas-Mixture"; +//string speciesName ="SpeciesA, SpeciesB"; +//string initMassFraction = "1.0, 0.0"; +int nSutherland = 0; +double gamaSpeciesA = 1.4; +double gamaSpeciesB = 1.3; +double molecularWeightSpeciesA = 29.0; +double molecularWeightSpeciesB = 30.0; + +int nChemicalFlowStep = 0; +int ifStartFromPerfectGasResults = 0; + +######################################################################### +// Multi-Grid parameters. +// nMGLevel: The number of level of Multi-Grid. +// <= 1 -- Single-level. +// > 1 -- multi-level. +// MGPreIteration: For each grid, the number of pre-smoothing steps. +// n_post: For each grid, the number of post-smoothing steps. +// MGCoarsestIteration: For the coarest grid the number of smoothing steps. +// MGFasType: V-multi cycle or W-multi cycle. +// 1 -- V-multi cycle. +// 2 -- W-multi cycle. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. +// mgCFLScale: CFL number enlarge times for coarse grid. +// mprol: Multi-grid interpolation method, interpolation from coarse cell to fine grid. +// 1 -- zero order. +// 2 -- first-order. (default) +// mgCorrectionLimit: Multi-grid correction limit. + +int nMGLevel = 1; +int MGCoarsestIteration = 1; +int MGPreIteration = 1; +int MGFasType = 1; +int n_post = 0; +int flowInitStep = 100; +int mprol = 2; +double mgCFLScale = 1.0; +double mgCorrectionLimit = 0.01; + +//--------------- Some parameter for turbulent model -------------------- +// neasm: The variation of kw turbulent model. +// ismooth_turb: Residual smooth for turb or not. +// SSTProductType: The type of product term based on vorticity for SST. +// SAProductType: The type of product term based on vorticity for SA. +int neasm = -3; +int SSTProductType = 0; +int ismooth_turb = 0; +int SAProductType = 2; + +// ----------------- Overset Grid parameter ----------------------------- +int codeOfDigHoles = 1; +int codeOfTurbulentModel = 0; +string masterFileName = "./grid/searchFile.inp"; +string holeBasicFileName = "./grid/holeBasicFile.inp"; +string holeFullFileName = "./grid/holeFullFile.dat"; +string linkFileName = "./grid/topology.dat"; +string zoneInverseFileName = "./grid/zoneInverseMapping.inp"; + +######################################################################### +# High Order Struct Solver # +######################################################################### +// isFVMOrFDM: +// 0 -- NSSolverStruct using Finite Volume Method. +// 1 -- NSSolverStruct using Finite Differ Method. +// SolverStructOrder: Spatial discretisation order of NS equations with struct grid. +// <= 2 -- finite volume method. +// >= 3 -- finite difference order. (to be completed) +// 0 -- default. +// str_highorder_interpolation_epsilon: Epsilon in weighted interpolation, bigger epsilon, better convergence, +// smaller epsilon, robuster for shock-detecting. +// str_highorder_interpolation_type: +// -- "classical", "test". +// str_highorder_flux_name: +// -- "roe", "steger". +// structhighordergradient: +// -- "conservation", "chain_rule". +int isFVMOrFDM = 0; +string str_highorder_solver = "WCNS"; +int SolverStructOrder = 0; +double str_highorder_interpolation_epsilon = 1.0e-6; +string str_highorder_interpolation_type = "test"; +string str_highorder_flux_name = "steger"; +string structhighordergradient = "conservation"; +double coefofstrflux = 0.5; +double limitcoefofinterface = 0.0; + +// ----------------- Advanced choices ----------------------------------- +// outtimesc: Time stepping scheme for the outer loop. +// MUSCLCoefXk: The parameter of MUSCL interpolations, belongs to [-1, 1]. +// -1 -- seconde-order fully-upwind differencing. +// 0 -- seconde-order upwind-biased differencing. +// 0.333333 -- third-order upwind-biased differencing. +// 1 -- seconde-order central differencing. +// MUSCLCoefXb: The limiter parameter. +// 0 -- the effect of the limiter is cancelled, means the first-order interpolations. +// allReduceStep: Iteration intervals for MPI AllReduce operation, default is 1. +string outtimesc = "impbd2"; +double MUSCLCoefXk = -1; +double MUSCLCoefXb = 1.0; +int allReduceStep = 1; + +// ----------------- overlap configuration ------------------------------ +// codeOfOversetGrid: Overlapping(overset) grid or not. +// 0 -- NON-overlapping grid. +// 1 -- Overlapping grid. +// oversetInterpolationMethod: the method of overset interpolation while field simulation +// 0 -- set the acceptor cell value by donor cell value. +// 1 -- set the acceptor cell value by distance weight of donor cell value. + +int codeOfOversetGrid = 0; +int oversetInterpolationMethod = 0; +int readOversetFileOrNot = 0; +int symetryOrNot = 0; +int readInAuxiliaryInnerGrid = 1; +int readInAuxiliaryOuterGrid = 0; +int readInSklFileOrNot = 0; +string auxiliaryInnerGrid0 = "./grid/aux-upper.fts"; +string auxiliaryInnerGrid1 = "./grid/aux-lower.fts"; +string auxiliaryInnerGrid2 = ""; +string oversetGridFileName = "./grid/iblank.ovs"; +double walldistMainZone = 1.0 +double toleranceForOversetSearch = 1.0e-3; +double toleranceForOversetBox = 1.0e-3; +int twoOrderInterpolationOrNot = 0; +int keyEnlargeOfActiveNodes = 0; +int outTecplotOverset = 0; + +int numberOfMovingBodies = 2; + +// ----------------- ALE configuration ------------------------------ +int codeOfAleModel = 1; +int aleStartStrategy = -1; + +int strategyForFaceNormalVelocity = 0; //0-By Sweeping volume; 1-By face center 1st; 2-By face center 2nd; +int strategyForGCLSource = 0; //0-present; 1-Ahn; + +//0:1st-Admas-Bashforth; 1:2nd-Admas-Bashforth; 2:1st-Implicit-Euler; 3:2nd-Implicit Euler; 4:2nd-Adams-Moulton; 5:3rd-Adams-Moulton +int methodForKineticEquation = 0; +double relaxParameterOfKinetic = 1.0; + +######################################################################### +# motive information # +######################################################################### +int numberOfMovingBodies = 1; + +############################## body0 ############################## +//mass of parts +double mass_0 = 1.0; +//mass matrix of parts Ixx Iyy Izz Ixy Ixz Iyz +double massMatrix_0[] = 1e-7, 1e-6, 1e-6, 0.0, 0.0, 0.0; +//initial six DOF position information of parts. xc yc zc +double massCenter_0[] = 0.0 , 0.0, 0.0; +//initial six DOF position information of parts. angleX angleY angleZ +double attitudeAngle_0[] = 0.0 , 0.0, 0.0; +//initial six DOF move information of parts. vc vy vz +double massCenterVelocity_0[] = 0.0, 0.0, 0.0; +//initial six DOF move information of parts. omigX omigY omigZ +double angularVelocity_0[] = 0.0, 0.0, 0.0; +//the object that the parts belong to. +int fartherIndex_0 = -1; +//the assembly position of the parts. xc yc zc angleX angleY angleZ +double configPamameter_0[] = 0.0 ,0.0 ,0.0 ,0.0 ,0.0 ,0.0; +//the move pattern of the parts. +// -1 given motion partten. +// 0 still. +// 1 six DOF motion. +// 2 three DOF motion. +// 11 X-axis forced motion. +// 12 Y-axis forced motion. +// 13 Z-axis forced motion. +// 14 forced pitch motion. +// 15 forced yaw motion. +// 16 forced roll motion. +int RBDMethod_0 = 0; +double amplitude_0 = 0.0; +double reduceFrequency_0 = 0.0; +//string uDFSixDofFileName_0 = "./Bin/UDFSixDof.Parameter"; +//additional force (system axis) fX fY fZ +double addedForce_0[] = 0.0 ,0.0 ,0.0 ; +//additional moment of Force (system axis) mX mY mZ +double addedMoment_0[] = 0.0 ,0.0 ,0.0 ; +//the deformation method of the parts. +int morphing_0 = 0; + +// post indentify +int integralOrder = 4; + + +// ---------------- ATP read -------------------------------------------- +//@int inflowParaType = 0; +//@double refReNumber = 6.5e6; +//@double refDimensionalTemperature = 288.15; +//@double freestream_vibration_temperature = 300.00; +//@double refDimensionalPressure = 0; +//@double height = 0; +//@int nsubsonicInlet = 0; +//@int nsubsonicOutlet = 0; +//@string inLetFileName = "./bin/subsonicInlet.hypara"; +//@string outLetFileName = "./bin/subsonicOutlet.hypara"; +//@double refDimensionalVelocity = 0; +//@double refDimensionalDensity = 0; + +######################################################################### +# Old Parameter # +######################################################################### +int isPlotVolumeField = 0; + diff --git a/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/cfd_para_subsonic.hypara b/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/cfd_para_subsonic.hypara new file mode 100644 index 0000000..ec5cced --- /dev/null +++ b/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/cfd_para_subsonic.hypara @@ -0,0 +1,195 @@ +######################################################################### +# General Control Parameter # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual 'res.dat' saved. + +int maxSimuStep = 10000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; + +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) +int ifLowSpeedPrecon = 0; + +######################################################################### +# Inflow Parameter # +######################################################################### +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. + +double refMachNumber = 0.185; +double attackd = 6.00; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 2.51e6; +double refDimensionalTemperature = 288.15; + +//int inflowParaType = 1; +//double height = 0.001; + +double gridScaleFactor = 1.0; + +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. + +######################################################################### +# Physical models # +######################################################################### +// viscousType : Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "1eq-sa", when viscousType = 3. +// -- "2eq-kw-menter-sst", when viscousType = 4. +// DESType: Type of DES. +// 0 -- RANS.(default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; +######################################################################### +# Spatial Discretisation # +######################################################################### +#******************************************************************* +# Struct Solver * +#******************************************************************* +// str_limiter_name: Limiter of struct grid. +// -- "3rdsmooth", "smooth". +// -- "nolim", no limiter. + +string str_limiter_name = "smooth"; + +#******************************************************************* +# UnStruct Solver * +#******************************************************************* +// uns_limiter_name: Limiter of Unstruct grid. +// -- "vencat". +// -- "1st", meaning accuracy of first-order. +// -- "nolim", no limiter. +// venkatCoeff: Coefficient of vencat limiter, when uns_limiter_name = 'vencat'. +// The smaller the value, the more robust it is. + +string uns_limiter_name = "vencat"; +double venkatCoeff = 50.0; + +######################################################################### +# Temporal Discretisation # +######################################################################### +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// CFLEnd: The CFL number, [0.1, 100]. +// The bigger the value, the convergence faster but lower robustness. +// nLUSGSSweeps: Number of Sub-iteration of LU-SGS. +// 1 -- is recommended for structured solver. +// 1-3 -- is recommended for unstructured solver. + +int iunsteady = 0; + +double CFLEnd = 100.0; + +int nLUSGSSweeps = 1; + +######################################################################### +# Multi-Grid parameters # +######################################################################### +// nMGLevel: The number of Multi-Grid level. +// = 1 -- single-level. +// > 1 -- multi-level. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. + +int nMGLevel = 2; +int flowInitStep = 100; + +######################################################################### +# File In or Out # +######################################################################### +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// Please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the whole field results to tecplot or not, 0 / 1. + +string gridfile = "./grid/2D_NLR7301_Unstr.fts"; +int plotFieldType = 0; + +// ----------------- Advanced Parameters, DO NOT care it ---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables: Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21). +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. + +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; diff --git a/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/grid_para.hypara b/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/grid_para.hypara new file mode 100644 index 0000000..1d02bda --- /dev/null +++ b/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/grid_para.hypara @@ -0,0 +1,30 @@ +######################################################################### +# Grid data type # +######################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +// from_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +int gridtype = 0; +int axisup = 1; +int from_gtype = 2; + +######################################################################### +# File path # +######################################################################### +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +string from_gfile = "./grid/2D_NLR7301_Unstr.cgns"; +string out_gfile = "./grid/2D_NLR7301_Unstr.fts"; diff --git a/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/key.hypara b/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/key.hypara new file mode 100644 index 0000000..78c5988 --- /dev/null +++ b/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/key.hypara @@ -0,0 +1,59 @@ +string title = "PHengLEI Main Parameter Control File"; + +// IMPORTANT NOTICE: DON NOT MODIFY THE FOWLLOWING LINE. +string defaultParaFile = "./bin/cfd_para.hypara"; + +// ndim: Dimensional of the grid, 2 or 3. +// nparafile: the number of parameter files. +// nsimutask: simulation task type. +// 0 -- CFD Solver of NS or Turbulation. +// 1 -- Grid generation: for special typical cases, such as cylinder, flat plate, etc. +// Grid conversion: from other format to PHengLEI format (.fts). +// Grid reconstruction: such as grid adaptation. +// Grid merging: merge two blocks into one block. +// Grid repairing: repair the original grid in order to remove the negative volume cells. +// 2 -- Wall distance computation for turb-solver. +// 3 -- Grid partition. +// 4 -- Knowledge repository / examples of PHengLEI-API. +int ndim = 2; +int nparafile = 1; + +int nsimutask = 0; +string parafilename = "./bin/cfd_para_subsonic.hypara"; +//string parafilename = "./bin/cfd_para_transonic.hypara"; +//string parafilename = "./bin/cfd_para_supersonic.hypara"; +//string parafilename = "./bin/cfd_para_hypersonic.hypara"; +//string parafilename = "./bin/incompressible.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_para.hypara"; + +//int nsimutask = 2; +//string parafilename = "./bin/cfd_para.hypara"; + +//int nsimutask = 3; +//string parafilename = "./bin/partition.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_deform_para.hypara"; + +//int nsimutask = 4; +//string parafilename = "./bin/repository.hypara"; + +//int nsimutask = 5; +//string parafilename = "./bin/overset_grid_view.hypara"; + +//int nsimutask = 13; +//string parafilename = "./bin/lbm_para.hypara"; + +//int nsimutask = 14; +//string parafilename = "./bin/integrative_solver.hypara"; + +//int nsimutask = 99; +//string parafilename = "./bin/post_processing.hypara"; + +// ---------------- Advanced Parameters, DO NOT care it ---------------- +int numberOfGridProcessor = 0; +// ATP read +//@string parafilename1 = "" +//@string parafilename2 = ""; diff --git a/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/partition.hypara b/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/partition.hypara new file mode 100644 index 0000000..194744f --- /dev/null +++ b/B15-TwoD_NLR7301_SA_Unstruct_4CPU/bin/partition.hypara @@ -0,0 +1,21 @@ +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// maxproc: The number of partition zones that want to be divided into, +// which is equal to the number of CPU processors you want. +// Usually, 50~100 thousands structured cells per CPU-Core is suggested. +// 30~70 thousands unstructured cells per CPU-Core is suggested. +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). + +int pgridtype = 0; +int maxproc = 1; + +string original_grid_file = "./grid/2D_NLR7301_Unstr.fts"; +string partition_grid_file = "./grid/2D_NLR7301_Unstr.fts"; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level,..., et al. +int numberOfMultigrid = 1; diff --git a/B15-TwoD_NLR7301_SA_Unstruct_4CPU/grid/2D_NLR7301_Unstr.cgns b/B15-TwoD_NLR7301_SA_Unstruct_4CPU/grid/2D_NLR7301_Unstr.cgns new file mode 100644 index 0000000..55f80b5 Binary files /dev/null and b/B15-TwoD_NLR7301_SA_Unstruct_4CPU/grid/2D_NLR7301_Unstr.cgns differ diff --git a/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/boundary_condition.hypara b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/boundary_condition.hypara new file mode 100644 index 0000000..15112a8 --- /dev/null +++ b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/boundary_condition.hypara @@ -0,0 +1,49 @@ +# nBoundaryConditons : number of global boundary conditions. +# bcName : Boundary Condition Name. +# bcType(in PHengLEI): Boundary Condition Type. + +# Account of how to set boundaryconditon. +# string bcName = "Farfield"; +# { +# int bcType = 4; +# int inflowParaType = 1; +# double attackd = 0; +# double refReNumber = 6.5e6; +# double refMachNumber = 3.5; +# double angleSlide = 0; +# } + +int nBoundaryConditons = 4; +string bcName = "wall"; +{ + string bodyName = "body"; + int bcType = 2; +} +string bcName = "sym"; +{ + int bcType = 3; +} +string bcName = "in"; +{ + int bcType = 5; +} +string bcName = "out"; +{ + int bcType = 6; +} + +# 'bcType' is defined as following: +# 99: PERIODIC +# -2: WAKE +# -1: INTERFACE +# 0 : NO_BOUNDARY_CONDITION +# 1 : EXTRAPOLATION +# 2 : SOLID_SURFACE +# 3 : SYMMETRY +# 4 : FARFIELD +# 5 : INFLOW +# 6 : OUTFLOW +# 52: PRESSURE_INLET +# 62: PRESSURE_OUTLET +# 61: OUTFLOW_CONFINED +# 7 : POLE diff --git a/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/cfd_para.hypara b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/cfd_para.hypara new file mode 100644 index 0000000..b17970c --- /dev/null +++ b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/cfd_para.hypara @@ -0,0 +1,1220 @@ +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +// PPPPP H H EEEEE N N GGGGG L EEEEE III + +// P P H H E NN N G L E I + +// PPPPP HHHHH EEEEE N N N G GG L EEEEE I + +// P H H E N N N G G L E I + +// P H H EEEEE N N GGGGG LLLLL EEEEE III + +//------------------------------------------------------------------------+ +// Platform for Hybrid Engineering Simulation of Flows + +// China Aerodynamics Research and Development Center + +// (C) Copyright, Since 2010 + +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +########################################################################### +# Default parameters for Grid conversion # +########################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// 2 -- Hybrid grid, include both of unstructured and structured grid. +// gridobj: Task type of grid treatment. +// 0 -- Grid generation of typical case, such as cylinder, flat plate, etc. +// 1 -- Grid conversion, from other grid data to PHenglEI, such as Fluent, CGNS. +// 2 -- Grid refinement. +// 3 -- Grid merging, merge two blocks into one block. +// 4 -- Grid deformation, achieve unstructured grid deformation. +// 5 -- Grid repairing, repair the original grid in order to remove the negative volume cells. +// 6 -- Grid mirroring, mirror a symmetry grid to whole grid. +// multiblock: Multi-block grid or not, only for structured grid conversion. +// 0 -- Not. +// 1 -- Yes. +// iadapt: Adaptation number for unstructure grid. +// SymmetryFaceVector: The vector of symmetry face. +// 0 -- X axis. +// 1 -- Y axis. +// 2 -- Z axis. +int gridtype = 0; +int gridobj = 1; +int multiblock = 0; +int iadapt = 0; +int SymmetryFaceVector = 1; + +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +int axisup = 1; + +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +int omit_no_bound_bc = 0; + +//----------------------------------------------------------------------- +# Grid data type # +//----------------------------------------------------------------------- +// from_gtype/to_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +// dumpOldGrid: If dump out the old grid file. +// 0 -- Not. (default) +// 1 -- Yes. +int from_gtype = 2; +int to_gtype = 1; +int dumpOldGrid = 0; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +int numberOfGridFile = 1; +string from_gfile = "./grid/rae2822_hybrid2d.cas"; +string from_gfile1= ""; + +string out_gfile = "./grid/flat_laminr_133_85_2d.fts"; + +// ----------------- some advanced choices ------------------------------ +// iunsteady: The Grid is for unsteady simulation or not. +int iunsteady = 0; +int codeOfAleModel = 0; + +// fileformat: Ustar Grid file format. +// 0 -- BINARY. +// 1 -- ASCII. +int fileformat = 0; + +// Parameters for hybrid solver. +// mixgrid_uns: path of unstructure grid file for hybrid solver, *.fts type. +// mixgrid_str: path of structure grid file for hybrid solver, *.fts type. +string mixgrid_uns = "./grid/rae2822_uns2d_4.fts"; +string mixgrid_str = "./grid/flat_laminr_133_85_2d.fts"; + +// Some parameters for structured overlapping grid. +int codeOfDigHoles = 1; +string holeBasicFileName = "./oversetGridView/holeBasicFile.inp"; +string holeFullFileName = "./oversetGridView/holeFullFile.dat"; +string linkFileName = "./oversetGridView/topology.dat"; +string zoneInverseFileName = "./oversetGridView/zoneInverseMapping.inp"; + +// ----------------- Adaptive Mesh Refine ------------------------------- +// In this file, the original_grid_file is used of the partition part. +// If use it dependently, abstract it here. +string adapt_grid_file = "./grid/sphere_mixed_adapt1.fts"; +string geometryFileName = "./grid/jsm.igs"; + +// geometryUnit: Geometry unit. +// 1 -- meter. +// 2 -- millimeter. +// 3 -- inch. +// exclusiveCase: Parallel projection exclusive case. +// 0 -- NON case. +// 1 -- JSM-C2-NPOFF case. +// 2 -- CHNT. +// projectOrgPoint: If the original wall points need to be projected or not. +int geometryUnit = 1; +int anisoRefine = 0; +int isProject = 0; +int readDist = 0; +int isDeform = 0; +int exclusiveCase = 0; // 0: NON case; 1: JSM-C2-NPOFF case; 2: CHNT. +int projectOrgPoint = 0; // if project original wall points. + + +// ----------------- Grid Deform Parameters ----------------------------- +// deformationMethod: Grid Deform. +// 1 -- SPRING. +// 2 -- RBF. +// stationalGridFile: Original grid file. +// visualFileName : The visualization file path of deform grid. +// nDeformStep : The max deform step. +// flapAngle : The max flap angle. +// rotatePostionZ : Rotate postion. +// rotatePostionY : Rotate postion. +// gridSlice : If dump slice grid. +// sliceAxis : Grid slice axis. +// slicePosition : Grid slice position. +int nDeformStep = 40; +double flapAngle = 10.0; +double rotatePostionZ = 4.00003; +double rotatePostionY = 3.05; + +int deformationMethod = 2; +string stationalGridFile = "./grid/Segment2Brid.fts"; +string visualFileName = "./results/deformedGrid.dat" + +int gridSlice = 1; +int sliceAxis = 1; +double slicePosition = 13; + +// ----------------- RBF Parameters ------------------------------------- +// numberOfReferenceCP : Number of reference Control Points. +// influencePara : The RBF influence radius parameter. +int numberOfReferenceCP = 40; +double influencePara = 25.0; + +// ----------------- Periodic Parameters -------------------------------- +// Notice: Rotational periodicity only support rotation along the X axis! +// periodicType: Which periodic boundary is used. +// 0 -- without Periodic Boundary. +// 1 -- Translational periodicity. +// 2 -- Rotational periodicity. +// translationLength[]: The relative distance between two periodic face + which only support one direction. +// rotationAngle: The relative angle between two periodic face. + which is recorded in degrees. + +int periodicType = 0; +double translationLength[] = [0.0,0.0,0.0]; +double rotationAngle = 0.0; + +######################################################################### +# Default parameters for Partition # +######################################################################### +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// 2 -- refine structured grid. +// maxproc: The number of partition zones that want to be divided into. +int pgridtype = 0; +int maxproc = 4; + +// traceMark: Trace mark or not, only for structured grid partition. +// 0 -- Not. +// 1 -- Yes. +// blockIndexOfMark: the block index of mark, only for structured grid partition. +// cellIndexOfMark: the cell index of mark, only for structured grid partition. +int traceMark = 0; +int blockIndexOfMark = 0; +int cellIndexOfMark[] = [185,30,1]; + +// parallel Strategy: +//! -# 0 : each zone is assigned to the one that defined in grid partition procedure. +//! -# 1 : random assigned for each zone or by some else ways. +int parallelStrategy = 1; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). +string original_grid_file = "./grid/sphere_mixed.fts"; +string partition_grid_file = "./grid/sphere_mixed__4.fts"; + +// ------------------ Sompe advanced parameters ------------------------- +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +// npartmethod: Method of interface reconstruction, default is 1. +// parallelPartitionMethod: Method of parallel partition, this is set only when execute parallel partition. It would be skipped when serial partition. +// 1 -- Using ParMetis for homogeneous MPI. +// 2 -- Using Metis for homogeneous MPI. +// 3 -- using METIS partition for homogeneous OpenMP. +// parmetisBalance: Used to specify the imbalance tolerance. +// 1 -- perfect balance. +// maxproc -- perfect imbalance. +// 1.05 -- recommended. + +int omit_no_bound_bc = 0; +int npartmethod = 1; +int parallelPartitionMethod = 2; +double parmetisBalance = 1.05; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level, ..., et al. +int numberOfMultigrid = 1; + +######################################################################### +# Default parameters for CFD simulation # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepSample: The step intervals for monitored probes variables file 'sample.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual file 'res.dat' saved. +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) + +int maxSimuStep = 20000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepSample = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; +int ifLowSpeedPrecon = 0; + +// compressible: +// 0 -- incompressible flow. +// 1 -- compressible flow. (default) +int compressible = 1; + +//----------------------------------------------------------------------- +# CFD Control Parameter # +//----------------------------------------------------------------------- +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// 4 -- the condition that the velocity, temperature and density are given. +// 5 -- the condition that the velocity, temperature and pressure are given. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. +// radiationCoef: The radiation coefficient on wall, it is used to compute the radiation heat flux on wall when the boundary +// condition is radiation equilibrium temperature, and 0.8 is the default value. +// refMolecularWeight : the reference molecular weight of gas used for perfect gas. The unit is g/mol. +// Generally, the gas is air. Sometimes, it is experiment gas, such as Nitrogen, Argon, and so on. + +double refMachNumber = 0.73; +double attackd = 2.79; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 6.5e6; +double refDimensionalTemperature = 288.15; +double freestream_vibration_temperature = 300.00; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +//int inflowParaType = 3; +//int nsubsonicInlet = 1; +//int nsubsonicOutlet = 1; +//string inLetFileName = "./bin/subsonicInlet.hypara"; +//string outLetFileName = "./bin/subsonicOutlet.hypara"; +//double refDimensionalTemperature = 288.144; +//double refDimensionalPressure = 1.01313E05; + +//The velocity, temperature and density are fixed. +//int inflowParaType = 4; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalDensity = 1.0e3; + +//The velocity, temperature and pressure are fixed. +//int inflowParaType = 5; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalPressure = 1.0e5; + +//The MachNumber, temperature and pressure are fixed. +//int inflowParaType = 6; +//double refDimensionalTemperature = 293; +//double refDimensionalPressure = 8886.06; + +double wallTemperature = -1.0; + +double radiationCoef = 0.8; +double gridScaleFactor = 1.0; + +int numberOfAerodynamicForceComponents = 1; +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. +double refMolecularWeight = 28.9644; // unit of g/mol. + +//----------------------------------------------------------------------- +# Spatial Discretisation # +//----------------------------------------------------------------------- +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "hlle", "lax_f". +// -- "roe", "modified_roe". +// -- "ausm+", "ausm+w", "ausm+up", "ausmdv", "ausmpw", "ausmpw+". +// str_limiter_name: Limiter of struct grid. +// -- "vanalbada", "vanleer", "minmod", "smooth", "minvan", "3rdsmooth", "3rd_minmod_smooth". +// -- "nolim", no limiter. +// -- "vanalbada_clz", clz supersonic version. +string inviscidSchemeName = "roe"; +string str_limiter_name = "vanalbada"; + +#******************************************************************* +# UnStruct Solver or Common * +#******************************************************************* +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 2 -- Algebraic. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "0eq-bl". +// -- "1eq-sa". +// -- "2eq-kw-menter-sst". +// -- "2eq-kw-menter-bsl". +// -- "2eq-kw-wilcox-1988". +// -- "2eq-kw-wilcox-1998". +// -- "2eq-kw-kok-tnt". +// -- "2eq-kw-wilcox-2006". +// -- "easm-kw-2003". +// -- "easm-kw-2005". +// DESType: Type of DES. +// 0 -- RANS. (default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpw+". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "barth", "vencat", "vanleer", "minmod". +// -- "vanalbada", "smooth", "nnd", "lpz", "1st". +// -- "nolim", no limiter. +// uns_vis_name: Discretisation method of viscous term. +// -- "std", "test", "aver", "new1", "new2". +// gradientName: Gradient reconstruction method. +// -- "default", "ggcell", "ggnode", "lsq". +// ivencat: Variation of vencat limiter. +// 0 -- org method, it is independent of grid scale. +// 1 -- new method, it is dependent of grid scale. +// 4 -- Ustar limiter model, without grid size unitary. +// 7 -- default used. +// venkatCoeff: Cofficient of vencat, when using vencat limter. +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. +// skewnessAngle: The skewness angle of grid cells. +// roeEntropyFixMethod: Entropy fix (correction) method. +// 1 -- direct fix, which limits the minimum eigenvalue directly. +// 2 -- multi-dimensional fix, which is derived from structured solver and now is only valid for struct solver. +// 3 -- Harten type, which is default used. +// roeEntropyScale: Entropy fix (correction) coefficient scale, default is 1.0. +// It is used to scale the default Roe entropy fix coefficients. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +string uns_scheme_name = "roe"; +string uns_limiter_name = "vencat"; +string uns_vis_name = "test"; +string gradientName = "ggnode"; + +int ivencat = 7; +double venkatCoeff = 5.0; +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; +double skewnessAngle = 60.0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; + +//----------------------------------------------------------------------- +# Temporal Discretisation # +//----------------------------------------------------------------------- +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// physicalTimeStep: The nondimensional physical time step. +// ifStartFromSteadyResults: The unsteady simulation is start from steady flowfield or not, 0 is for no and else is for yes. +// ifStaticsFlowField: Statistical variables for unsteady simulation. +// ifStaticsReynoldsStress: Statistical Reynolds stress for unsteady simulation. +// startStatisticStep: Outer step when start statistics. +// when the value is larger than "maxSimuStep", it is useless. +// statisticalTimePeriod: Used as time period of statistic analysis. +// when the value is negative, time period is treated as infinite. +// statisticMethod: Statistic reynolds stress method. + 0 --tau = - ^2 + 1 --tau = +// min_sub_iter: The min sub iteration of unsteady simulation. +// max_sub_iter: The max sub iteration of unsteady simulation. +// tol_sub_iter: The tolerance of sub iteration of unsteady simulation. +// tscheme: Temporal Discretisation method. +// 1 -- Runge-Kutta Multi-State. +// 2 -- Point implicit. +// 3 -- Full implicit. +// 4 -- LU-SGS. +// 5 -- Block LU-SGS. +// 6 -- Jacobian iteration. +// 7 -- Lower G-S iteration. +// 8 -- Upper G-S iteration. +// 9 -- Lower/Upper G-S iteration. +// iSimplifyViscousTerm: Simplify the computation of viscous term in the Block LU-SGS method. The default value assigns 1 that could speed up the computation. +// Otherwise, the viscous Jacobian matrix Mv should be computed that will increase the memory and time in iteration of the BLUSGS method. +// CFLStart: Started cfl number. +// CFLEnd: End cfl number. +// CFLVaryStep: The number of step when cfl increase from CFLStart to CFLEnd. +// ktmax: Dtratio. dt[i] = MIN(dt[i], ktmax * dtmin / vol[i]) +// swapDq: Communication dq between forward/backward sweep of LUSGS or not, default is 0. +// nLUSGSSweeps: Sub iteration of LU-SGS or Block LU-SGS. +// LUSGSTolerance: Sub iter tolerance of LU-SGS or Block LU-SGS. +// ifLocalTimeStep: Time step method. +// 0 --Local. +// 1 --Global. +// visl_min: Minimum value of laminar viscosity coefficient. +// turbCFLScale: Turbulence model cfl number factor. +// codeOfAleModel: Arbitrary Lagrangian-Eulerian method. +// 0 -- no ALE method. +// 1 -- ALE method for non-moving grids. +// 2 -- ALE method for moving grids. +// 3 -- ALE method for deforming grids. +// wallFunctionType: The type of wall function to implement. +// 0 -- no wall function. (default) +// 1 -- standard wall function. +// 2 -- Pab3D wall function. +// RKStage: The number of Runge-Kutta step. +// lamda: Cofficient of Runge-Kutta step. + +int iunsteady = 0; +double physicalTimeStep = 0.01; +int ifStartFromSteadyResults = 0; +int ifStaticsFlowField = 0; +int ifStaticsReynoldsStress = 0; +int startStatisticStep = 800000; +double statisticalTimePeriod = -1.0; +int statisticMethod = 0; +int linearTwoStepMethods = 1; // 1--BDF1; 2--C-N; 3--BDF2; + +int methodOfDualTime = 3; +int min_sub_iter = 50; +int max_sub_iter = 50; +double tol_sub_iter = 0.01; + +int tscheme = 4; +int iSimplifyViscousTerm = 1; +int ifLocalTimeStep = 0; +double CFLStart = 0.01; +double CFLEnd = 10.0; +int CFLVaryStep = 500; + +double ktmax = 1.0e10; + +int swapDq = 1; + +int nLUSGSSweeps = 1; +double LUSGSTolerance = 0.01; +int order = 2; + +double visl_min = 0.01; +double turbCFLScale = 1.0; +double csrv = 2.0; +double timemax = 1.0e10; +double dtsave = -1.0; +int maxale = 10; +double dtau = 0.001; + +int wallFunctionType = 0; + +int RKStage = 2; +double lamda[] = 0.5, 1.0; + +//int RKStage = 1; +//double lamda[] = 1.0; + +//int RKStage = 4; +//double lamda[] = [0.25, 0.33333333333, 0.5, 1.0]; + +//----------------------------------------------------------------------- +# File In or Out # +//----------------------------------------------------------------------- +// numberOfGridGroups: The number of grid groups. +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the field results to visulization. +// walldistMethod: The method to compute wall distance. +// 0 -- accurate but not fast enough. +// 1 -- fast but not accurate enough. +// 2 -- super fast but more non-accurate! +// resSaveFile: The file path to save the residual convergence process, write data for every default (intervalStepRes) steps. +// turbresfile: The file path to save the residual convergence process of turbulence, write data for every default (intervalStepRes) steps. +// aircoeffile: The file path to save the aerodynamic force coefficients convergence process, write data for every default (intervalStepForce) steps. +// restartNSFile: The file path to write restart flowfield variables, write data for every default (intervalStepFlow) steps. +// turbfile: The file path to write restart flowfield variables of turbulence , write data for every default(intervalStepFlow) steps. +// visualfile: The visualization file path of flowfield , write data for every default (intervalStepPlot) steps. +// wall_aircoefile: The file path to save flowfield variables of wall, write data for every default steps. +// nDumpSurfaceInfo = 0 the "wall_varfile" write the informations including heat flux. +// nDumpSurfaceInfo = 1 the "wall_varfile" write the informations without heat flux. + +int numberOfGridGroups = 1; +string gridfile = "./grid/rae2822_hybrid2d__4.fts"; +string wallTemperaturefile= ""; + +int walldistMethod = 1; + +string resSaveFile = "results/res.dat"; +string turbresfile = "results/turbres.dat"; +string aircoeffile = "results/aircoef.dat"; + +string restartNSFile = "results/flow.dat"; +string turbfile = "results/turb.dat"; + +string visualfile = "results/tecflow.plt"; +string wall_aircoefile = "results/wall_aircoef.dat"; +string samplefile = "results/sample.dat"; + +int nDumpSurfaceInfo = 0; +string wall_varfile = ""; + +string jetDefineFile = "bin/jet.hypara"; + +string sixDofFileName = "results/sixDofInfo.dat"; +string derivativeFileName = "results/identify.dat"; +string hysteresisFileName = "results/force_beta.plt"; + +int plotFieldType = 0; + +// visualfileType: The file type of visualfile. +// 0 -- Tecplot binary. +// 1 -- Tecplot ASCII. + +int visualfileType = 1; + +// samplefileMode: The dump mode of sample file. +// 0 -- dump out every probe/line/surface data for all step intervals. +// 1 -- dump out all probe/line/surface data for every step intervals. +int samplefileMode = 0; + +// visualSlice: The slice of tecflow. +// 0 -- Do not save slice data. +// 1 -- comput and save it to sliceFile. +// sliceAxis: Normal vector of slice. +// 1 -- X_DIR. +// 2 -- Y_DIR. +// 3 -- Z_DIR. +// slicePostion: Coordinate of slice. + +int visualSlice = 0; +int sliceAxis = 1; +double slicePostion = -0.5; +string sliceFile = "results/Slice.plt"; +int dumpWallFaceCenter = 0; + +// min-max box of the visual block. +double lowerPlotFieldBox[] = [0.0 0.0 0.0]; +double upperPlotFieldBox[] = [1.0 1.0 1.0]; + +//-----------the optional parameters list for the flow field output---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40), +// -- gradientUx(41), gradientUy(42), gradientVx(43), gradientVy(44), iblank(81). +// -- specific heat ratio(gama, 56) +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. +//-----------the optional parameters list for the wall boundary condition---------------- +// nVisualWallVariables: The number of visual variables on wall. +// visualWallVariables : dumped variable types, listed as following: +// -coefficient of pressure(cp, 0), -coefficient of friction(cf, 1), yplus(2), -non-dimensional heat flux(Q_NonDim, 3), -dimensional heat flux(Q_Dim, 4), +// -pressure on wall(pw, 5), -temperature on wall(Tw, 6), -density on wall(rhow, 7), -heat flux of translational-rotational temperature term(Qtr, 8), +// -heat flux of species diffusion term(Qs, 9), -heat flux of vibrational temperature term(Qv, 10), -heat flux of electron temperature term(Qe, 11), +// -species mass fractions(Ns, 12), -x component of wall velocity(Vx, 13), -y component of wall velocity(Vy, 14), -z component of wall velocity(Vz, 15) +// -slip translational-rotational temperature(Tts, 16), -slip vibrational temperature(Tvs, 17), -slip electron temperature(Tes, 18), -absolute wall velocity(Vs, 19) +// -Stanton number(St, 20), -coefficient of heat rate(Ch, 21), -temperature jump(deltaT, 22), -transition gamaeff(gamaeff, 48), +// -transition intermittency(intermittency, 51), -transition momentum thickness reynolds(MomentumThicknessReynolds, 52), +// -overlap iblank(iblank, 81) + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +int nVisualWallVariables = 9; +int visualWallVariables[] = [0, 1, 2, 3, 4, 5, 9, 10, 11]; + +// dumpStandardModel: Dump many standard model data. +// 1 -- Turbulent flat plate. +int dumpStandardModel = 0; + +// ifSetDataMonitor: Whether to set the data monitor. +// 0 -- No. +// 1 -- Yes. +// dataMonitorType: The type of data Monitor. +// 0 -- Probes data monitor. +// 1 -- Lines data monitor. +// 2 -- Surfaces data monitor. +// probesDefineFile: Probes location information file. +// nLines: The number of lines need to be monitored. +// linesDefineFile: Lines location information file. +// nSurfaces: The number of surfaces need to be monitored. +// surfacesDefineFile: Surfaces location information file. +// searchCellsMethod: method to search the cell of each probe. +// 0 -- Nearest cell to the probe. +// 1 -- Real cell where the probe is located. +// nProbeVariables: Number of variables want to be dumped for probes monitered. +// probeVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5). +// Important Warning: Array size of probeVariables MUST be equal to nProbeVariables!!! +// probeVariables order must from small to big. +// probeVariablesInterpolationMethod: Interpolation method used to compute the probe variables. +// 0 -- Take the value of probe's cell as probe real value. +// 1 -- Interpolation from probe's and neighbouring cell to probe. +// 2 -- Interpolation from probe's cell nodes to probe. +int ifSetDataMonitor = 0; + +int dataMonitorType = 0; +string probesDefineFile = "bin/probes_XYZ.dat"; + +//int dataMonitorType = 1; +//int nLines = 1; +//string linesDefineFile = "bin/lines_XYZ.dat"; + +//int dataMonitorType = 2; +//int nSurfaces = 4; +//string surfacesDefineFile = "bin/surfaces_XYZ.dat"; + +int searchCellsMethod = 0; + +int nProbeVariables = 6; +int probeVariables[] = [0, 1, 2, 3, 4, 5]; +int probeVariablesInterpolationMethod = 0; +//----------------------------------------------------------------------- +# Turbulence Parameter # +//----------------------------------------------------------------------- +// turbInterval: Iteration number of turbulence. +// kindOfTurbSource: Kinds of turbulent source. +// 0 -- Original. +// 1 -- Edwards. +// 2 -- new. +// mod_turb_res: If modify the residuals for the cells next to the wall or not, default is 0. + +int turbInterval = 1; +int turbOrderStruct = 2; +int kindOfTurbSource = 0; +int mod_turb_res = 0; +double turb_relax = 1.0; +double freeStreamViscosity = 1.0e-3; +double muoo = 3.0; +double kwoo = 5.0; +int transitionType = 0; +double turbIntensity = -1.0; +int freeturbIntensitySRModify = 0; +double freeDecayXLocation = 0.0; +int compressibleCorrection = 0; +int transitionMaFix = 1; + +# maximum eddy viscosity (myt/my) max. +double eddyViscosityLimit = 1.0e10; +int monitor_vistmax = 0; + +//----------------------------------------------------------------------- +# LES Parameter # +//----------------------------------------------------------------------- +// iLES: Create LESSolver or not. +// == 1 - Create LESSolver; +// != 1 - not. +// amplitudeofDisturb: Amplitude of adding disturb. +// disturbstep: Unsteady time step or steady iteration of adding random disturb. +// iterdisturb: Add random disturb in every sub-iter or only first sub-iter. +// = 0 - in only first sub-iter; +// != 0 - in every sub-iter. +// ipraddisturb: Add density and pressure disturb or not. +// ibodyforce: Add body force in source flux of NS equations or not. +// = 0 - not; +// != 0 - Add body force. +// bodyforce: Body force in source flux of NS equations or not. +// utau: friction velocity, using in DNSDisturb. +// sgsmodel: subgrid scale model. +// = "smagorinsky"; +// = "dsmCom"; +// = "wale"; +// = "sigma". +// deltaFunctionType: = 1 - MAX(deltai, deltaj, deltak); +// = 2 - pow(deltai * deltaj *deltak, 1/3); +// = 3 - Devloped by Scotti. +// wallDampingFunctionType: = 0 - no wall function; +// = 1 - van Driest; +// = 2 - developed by Dr. Deng Xiaobing; +// = 3 - developed by Piomelli. +// turbViscousCutType: turbulent viscosity cut type. +// = 0 - mu_total = mut + mul; +// = 1 - mu_total = max(mut-mul,0)+ mul; +// = 2 - mu_total = max(mut ,0)+ mul. +// smagConstant: constant of smagorinsky model. +// waleConstant: constant of wale model. +// filterDirection[3]: filter variables in i, j, k direction or not. +// averageDirection[3]: average variables in i, j, k direction or not. +// isotropicConstant: constant of isotropic part of SGS stress. + +int iLES = 0; +string sgsmodel = "smagorinsky"; +int deltaFunctionType = 2; +int wallDampingFunctionType = 1; +int turbViscousCutType = 2; +double smagConstant = 0.1; +double isotropicConstant = 0.0; +double waleConstant = 0.6; +double sigmaConstant = 1.35; +int filterDirection[] = [1, 1, 0]; +int averageDirection[] = [0, 0, 0]; +double testFilterScale = 2.0; +int averageWidth = 1; +int monitorNegativeConstant = 0; + +//----------------------------------------------------------------------- +# Other Parameters for Hypersonic Non-equilibrium Gas # +//----------------------------------------------------------------------- +// dg_high_order: +// 0 -- generic order accuracy. +// 1 -- high order accuracy. +// iapplication: +// 0 -- gas model is fixed in the codes. +// 1 -- gas model is imported from library files. +// iCodeBranch: +// 0 -- The old code version is used for Navier-Stokes. +// 1 -- A new code version is active for Navier-Stokes solver. +// nm: Equation number of the physics, but is out of commision now. +// 4 -- for 2D. +// 5 -- for 3D. +// nGasModel: The type of gas. less than and equal to 1 represents the mixture gas. +// Otherwise, the pure gas with one component is used for perfect gas. +// 0 -- Earth gas. +// 1 -- Mars gas. +// 2 -- Argon. +// 3 -- Nitrogen. +// nEnergyRecycle: The type of EnergyModel Recycle. +// 0 -- not used . +// 1 -- used. +// nDensityModify: The type of densitymodify. + +// 0 -- not used. +// 1 -- used. +// nchem: +// 0 -- without chemical reaction flow. +// 1 -- the chemical reaction flow is considered. +// nEquilibriumGas: the variable is valid when the condition of nchem=0 is satisfied. +// 0 -- perfect gas. +// 5, 7, 11 -- equilibrium gas, meanwhile, its value denotes the number of gas component. +// nPCWCycleStep: the maximum step number of iteration in the module of computing species mass fractions with the partial catalytic wall(PCW) condition. +// the value equals to or is greater than 1, and 3 is for default value. +// nRETCycleStep: the maximum step number of iteration in the module of computing radiation equilibrium temperature on wall. +// the value equals to or is greater than 1, and 3 is for default value. +// nSLIPCycleStep:the maximum step number of iteration in the module of computing slip temperature, slip velocity and slip species mass fraction. +// the value equals to or is greater than 1, and 3 is for default value. +// nSlipBCModel : The computational model of slip boundary conditions. + +// 0 -- no slip. +// 1 -- the conventional Maxwell slip conditions. +// 2 -- the Gokcen slip conditions. +// 3 -- the Knudsen-layer correction of the standard slip conditions proposed by Lockerby, et al. +// 4 -- the Kogan simplified slip conditions. +// nMeanFreePathType : the method to the mean free-path for the slip conditions. For the mixture, 0 is suggested. +// 0 -- the equivalent mean free-path is calculated by the simple hard sphere model(HS). +// 1 -- calculated by the definition that includes the variables of the number density and the molecule diameter. +// 2 -- the equivalent mean free-path is calculated by the variable hard sphere model(VHS). +// nchemsrc: +// 0 -- the source terms are not computed. +// 1 -- the source terms are computed. +// nchemrad: +// 0 -- compute the spectrum radius without considering chemical reaction flow. +// 1 -- compute the spectrum radius that need to count the contribution from chemical reaction flow. +// ntmodel: The thermodynamic temperature model. +// 1 -- One-temperature model. +// 2 -- Two-temperature model. +// 3 -- Three-temperature model. +// nTEnergyModel: the method to computing temperature energy model. +// 0 -- the energy term is computed using the conventional method. +// 1 -- the energy term is computed using the curve fitting method. +// parkVDPower: the power of translational-rotational temperature in the Park V-D(vibration-dissociation) coupling model. +// The value is in range of [0.0, 1.0], DPLR suggests 0.5, LAURA suggests 0.7, while 0.6 is given as default value. +// catalyticCoef: +// 0.0 -- full non-catalytic wall boundary condition. +// 1.0 -- full catalytic wall boundary condition. +// in range of (0.0, 1.0) -- partial catalytic condition, the value indicates the catalytic coefficient. +// nIsSuperCatalytic : the super catalytic condition for the fully catalytic wall, and assigned with the value of 1. +// 0 -- equilibrium condition for the fully catalytic wall where the mass fractions are assigned with the values of the free stream. +// 1 -- super catalytic condition for the fully catalytic wall where all the atomic components combine into molecular components. +// nTemperatureJump : the method to calculate the temperature jump. +// 0 -- calculated by the variables of heat conductivity and constant volume specific heat for each energy mode. +// 1 -- the general method where the iteration is calculated with the translation-rotation temperature. +// sigmaVelocity: the coordination coefficient of tangential momentum for computation of slip velocity. The value is in range of (0.0, 2.0]. +// sigmaTemperature: the heat coordination coefficient for computation of slip temperature. The value is in range of (0.0, 2.0]. +// sigmaMassFraction: the species coordination coefficient for computation of slip mass fractions. The value is in range of (0.0, 2.0]. +// velocitySlipCorrectConstant: the correction constant to the velocity slip condition. For the diffuse reflection, 1.0 is used. +// 1.0 -- proposed by Maxwell. +// sqrt(2/PI)~0.8 -- used for "micro-slip", namely the actual velocity slip at the wall. +// 1.146 -- proposed for an additional "fictitious" velocity slip. + +// chemicalRelaxCorf: The value is in range of [0.001, 1.0]. +// chemicalSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// viscousSpectrumRadiusCoef : The value is in range of [1.0, 3.0]. +// inviscidSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// staticPressureRelaxCorf: The value is in range of [0.1, 1.0]. +// nIsChemicalFreeze : the flag to freeze the chemical reactions. +// 0 -- not freeze, the chemical reaction sources will be calculated. +// 1 -- freezes the chemical reactions, the chemical reaction sources will not be calculated.// veTemperatureMin: The minimum of Tv and Te +// nDebug: cout the Wrong place and abort +// 0 -- not used. +// 1 -- used. +// nSpeciesLimit: limitter of gas species +// 0 -- not used. +// 1 -- used. +// nTurblenceForChemical: the coupled mode of Turblence and Chemical reaction +// 0 -- method 0. +// 1 -- method 1. +// nViscosityFluxSublevelModified: Modified for ViscosityFlux on Sublevel grid +// 0 -- not used. +// 1 -- used. +// nChemcalSourceModified: Modified on ChemcalSource +// 0 -- not used. +// 1 -- used. +// nAblation: +// 0 -- The wall ablation is not computed. +// 1 -- The wall ablation is computed. +// isInjection: +// 0 -- The injection velocity of ablation wall is not computed. +// 1 -- The injection velocity of ablation wall is computed. +// nViscosityModel: + +// 0 -- Blottner fitting method. +// 1 -- Gupta fitting method. +// nSutherland: +// 0 -- stands for selecting the Blotter curve fits mode. +// 1 -- stands for Sutherland relation. +// gasfile: Indicates the gas model, 9 models are provided, namely "Gu5", "Gu7", "Gu11", "Pa5", "Pa7", "Pa11", "DK5", "DK7", "DK11". +// "Gu" -- indicates the Gupta Model, three-Type Models are embeded in the library, namely, the 5-species-6-reactions, the 7-species-9-reactions, the 11-species-20-reactions. +// "Pa" -- indicates the Park Model, three-Type Models are embeded in the library, namely, the 5-species-17-reactions, the 7-species-22-reactions, the 11-species-48-reactions. +// "DK" -- indicates the Dunn-Kang Model, three-Type Models are embeded in the library, namely, the 5-species-11-reactions, the 7-species-15-reactions, the 11-species-26-reactions. +// "Mars-Pa8" is for Park model of Mars gas, "Mars-Mc8" for McKenzie model of Mars gas. +// "Combustion-12" -- indicates the Combustion Chamber Gas Model which includes 12-species-20-reactions. +// "Gas-Mixture" -- indicates the process of mixing two species without reacting. +// For self-definition model, the gasfile is used to indicate the file path of the new gas model. +// speciesName: Used to list the names of each species, while each species name is separated by the symbol of comma. +// initMassFraction: Used to list the initial mass fractions of species in accordance with the sequence of names in the parameter speciesName. +// ifStartFromPerfectGasResults: The chemical reaction simulation is start from perfect gas flowfield or not, 0 is for no and else is for yes. + +int dg_high_order = 0; +int iapplication = 0; +int iCodeBranch = 0; +int nm = 5; +int nEquilibriumGas = 0; +int nPCWCycleStep = 3; +int nRETCycleStep = 3; +int nSLIPCycleStep= 3; + +double refGama = 1.4; +double prl = 0.72; +double prt = 0.90; +double sc_l = 0.5; +double sc_t = 0.5; + +int nGasModel = 0; +int nchem = 0; +int nchemsrc = 1; +int nchemrad = 1; +int ntmodel = 1; + +int nEnergyRecycle = 0; +int nSlipBCModel = 0; +int nDensityModify = 1; +int nTEnergyModel = 0; +int nMeanFreePathType = 0; +int nIsChemicalFreeze = 0; +int nIsSuperCatalytic = 1; +int nTemperatureJump = 0; + +double parkVDPower = 0.6; +double catalyticCoef = 0.0; +double sigmaVelocity = 1.0; +double sigmaTemperature = 1.0; +double sigmaMassFraction = 1.0; +double velocitySlipCorrectConstant = 1.0; + +double chemicalRelaxCorf = 1.0; +double chemicalSpectrumRadiusCoef = 1.0; +double viscousSpectrumRadiusCoef = 1.0; +double inviscidSpectrumRadiusCoef = 1.0; +double staticPressureRelaxCorf = 1.0; + +double veTemperatureMin = 30.0; +int nDebug = 0; +int nSpeciesLimit = 0; +int nTurblenceForChemical = 0; +int nViscosityFluxSublevelModified = 0 ; +int nChemcalSourceModified = 0; + +int nAblation = 0; +int isInjection = 0; +int nViscosityModel = 0; +int nMarsModel = 0; +string gasfile = "DK5"; +//string gasfile = "./chemical/Dunn-Kang_air5s11r.dat"; +string speciesName = "O, O2, NO, N, N2"; +string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.767"; + +//string speciesName = "O, O2, NO, N, NO+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string speciesName = "O, O2, NO, N, O+, O2+, NO+, N+, N2+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Mars-Pa8"; +//string speciesName = "O, O2, NO, N, N2, C, CO, CO2"; +//string initMassFraction = "0.0015, 0.0429, 0.0, 0.0, 0.0, 0.0, 0.0777, 0.8779"; + +//string gasfile = "DK7"; +//string speciesName = "O, O2, NO, N, NO+, C, C2, CO, CO2, CN, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Combustion-12"; +//string speciesName = "O, O2, NO, N, C, CO, CO2, H, H2, OH, H2O, N2"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767"; + +//string gasfile = "Gas-Mixture"; +//string speciesName ="SpeciesA, SpeciesB"; +//string initMassFraction = "1.0, 0.0"; +int nSutherland = 0; +double gamaSpeciesA = 1.4; +double gamaSpeciesB = 1.3; +double molecularWeightSpeciesA = 29.0; +double molecularWeightSpeciesB = 30.0; + +int nChemicalFlowStep = 0; +int ifStartFromPerfectGasResults = 0; + +######################################################################### +// Multi-Grid parameters. +// nMGLevel: The number of level of Multi-Grid. +// <= 1 -- Single-level. +// > 1 -- multi-level. +// MGPreIteration: For each grid, the number of pre-smoothing steps. +// n_post: For each grid, the number of post-smoothing steps. +// MGCoarsestIteration: For the coarest grid the number of smoothing steps. +// MGFasType: V-multi cycle or W-multi cycle. +// 1 -- V-multi cycle. +// 2 -- W-multi cycle. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. +// mgCFLScale: CFL number enlarge times for coarse grid. +// mprol: Multi-grid interpolation method, interpolation from coarse cell to fine grid. +// 1 -- zero order. +// 2 -- first-order. (default) +// mgCorrectionLimit: Multi-grid correction limit. + +int nMGLevel = 1; +int MGCoarsestIteration = 1; +int MGPreIteration = 1; +int MGFasType = 1; +int n_post = 0; +int flowInitStep = 100; +int mprol = 2; +double mgCFLScale = 1.0; +double mgCorrectionLimit = 0.01; + +//--------------- Some parameter for turbulent model -------------------- +// neasm: The variation of kw turbulent model. +// ismooth_turb: Residual smooth for turb or not. +// SSTProductType: The type of product term based on vorticity for SST. +// SAProductType: The type of product term based on vorticity for SA. +int neasm = -3; +int SSTProductType = 0; +int ismooth_turb = 0; +int SAProductType = 2; + +// ----------------- Overset Grid parameter ----------------------------- +int codeOfDigHoles = 1; +int codeOfTurbulentModel = 0; +string masterFileName = "./grid/searchFile.inp"; +string holeBasicFileName = "./grid/holeBasicFile.inp"; +string holeFullFileName = "./grid/holeFullFile.dat"; +string linkFileName = "./grid/topology.dat"; +string zoneInverseFileName = "./grid/zoneInverseMapping.inp"; + +######################################################################### +# High Order Struct Solver # +######################################################################### +// isFVMOrFDM: +// 0 -- NSSolverStruct using Finite Volume Method. +// 1 -- NSSolverStruct using Finite Differ Method. +// SolverStructOrder: Spatial discretisation order of NS equations with struct grid. +// <= 2 -- finite volume method. +// >= 3 -- finite difference order. (to be completed) +// 0 -- default. +// str_highorder_interpolation_epsilon: Epsilon in weighted interpolation, bigger epsilon, better convergence, +// smaller epsilon, robuster for shock-detecting. +// str_highorder_interpolation_type: +// -- "classical", "test". +// str_highorder_flux_name: +// -- "roe", "steger". +// structhighordergradient: +// -- "conservation", "chain_rule". +int isFVMOrFDM = 0; +string str_highorder_solver = "WCNS"; +int SolverStructOrder = 0; +double str_highorder_interpolation_epsilon = 1.0e-6; +string str_highorder_interpolation_type = "test"; +string str_highorder_flux_name = "steger"; +string structhighordergradient = "conservation"; +double coefofstrflux = 0.5; +double limitcoefofinterface = 0.0; + +// ----------------- Advanced choices ----------------------------------- +// outtimesc: Time stepping scheme for the outer loop. +// MUSCLCoefXk: The parameter of MUSCL interpolations, belongs to [-1, 1]. +// -1 -- seconde-order fully-upwind differencing. +// 0 -- seconde-order upwind-biased differencing. +// 0.333333 -- third-order upwind-biased differencing. +// 1 -- seconde-order central differencing. +// MUSCLCoefXb: The limiter parameter. +// 0 -- the effect of the limiter is cancelled, means the first-order interpolations. +// allReduceStep: Iteration intervals for MPI AllReduce operation, default is 1. +string outtimesc = "impbd2"; +double MUSCLCoefXk = -1; +double MUSCLCoefXb = 1.0; +int allReduceStep = 1; + +// ----------------- overlap configuration ------------------------------ +// codeOfOversetGrid: Overlapping(overset) grid or not. +// 0 -- NON-overlapping grid. +// 1 -- Overlapping grid. +// oversetInterpolationMethod: the method of overset interpolation while field simulation +// 0 -- set the acceptor cell value by donor cell value. +// 1 -- set the acceptor cell value by distance weight of donor cell value. + +int codeOfOversetGrid = 0; +int oversetInterpolationMethod = 0; +int readOversetFileOrNot = 0; +int symetryOrNot = 0; +int readInAuxiliaryInnerGrid = 1; +int readInAuxiliaryOuterGrid = 0; +int readInSklFileOrNot = 0; +string auxiliaryInnerGrid0 = "./grid/aux-upper.fts"; +string auxiliaryInnerGrid1 = "./grid/aux-lower.fts"; +string auxiliaryInnerGrid2 = ""; +string oversetGridFileName = "./grid/iblank.ovs"; +double walldistMainZone = 1.0 +double toleranceForOversetSearch = 1.0e-3; +double toleranceForOversetBox = 1.0e-3; +int twoOrderInterpolationOrNot = 0; +int keyEnlargeOfActiveNodes = 0; +int outTecplotOverset = 0; + +int numberOfMovingBodies = 2; + +// ----------------- ALE configuration ------------------------------ +int codeOfAleModel = 1; +int aleStartStrategy = -1; + +int strategyForFaceNormalVelocity = 0; //0-By Sweeping volume; 1-By face center 1st; 2-By face center 2nd; +int strategyForGCLSource = 0; //0-present; 1-Ahn; + +//0:1st-Admas-Bashforth; 1:2nd-Admas-Bashforth; 2:1st-Implicit-Euler; 3:2nd-Implicit Euler; 4:2nd-Adams-Moulton; 5:3rd-Adams-Moulton +int methodForKineticEquation = 0; +double relaxParameterOfKinetic = 1.0; + +######################################################################### +# motive information # +######################################################################### +int numberOfMovingBodies = 1; + +############################## body0 ############################## +//mass of parts +double mass_0 = 1.0; +//mass matrix of parts Ixx Iyy Izz Ixy Ixz Iyz +double massMatrix_0[] = 1e-7, 1e-6, 1e-6, 0.0, 0.0, 0.0; +//initial six DOF position information of parts. xc yc zc +double massCenter_0[] = 0.0 , 0.0, 0.0; +//initial six DOF position information of parts. angleX angleY angleZ +double attitudeAngle_0[] = 0.0 , 0.0, 0.0; +//initial six DOF move information of parts. vc vy vz +double massCenterVelocity_0[] = 0.0, 0.0, 0.0; +//initial six DOF move information of parts. omigX omigY omigZ +double angularVelocity_0[] = 0.0, 0.0, 0.0; +//the object that the parts belong to. +int fartherIndex_0 = -1; +//the assembly position of the parts. xc yc zc angleX angleY angleZ +double configPamameter_0[] = 0.0 ,0.0 ,0.0 ,0.0 ,0.0 ,0.0; +//the move pattern of the parts. +// -1 given motion partten. +// 0 still. +// 1 six DOF motion. +// 2 three DOF motion. +// 11 X-axis forced motion. +// 12 Y-axis forced motion. +// 13 Z-axis forced motion. +// 14 forced pitch motion. +// 15 forced yaw motion. +// 16 forced roll motion. +int RBDMethod_0 = 0; +double amplitude_0 = 0.0; +double reduceFrequency_0 = 0.0; +//string uDFSixDofFileName_0 = "./Bin/UDFSixDof.Parameter"; +//additional force (system axis) fX fY fZ +double addedForce_0[] = 0.0 ,0.0 ,0.0 ; +//additional moment of Force (system axis) mX mY mZ +double addedMoment_0[] = 0.0 ,0.0 ,0.0 ; +//the deformation method of the parts. +int morphing_0 = 0; + +// post indentify +int integralOrder = 4; + + +// ---------------- ATP read -------------------------------------------- +//@int inflowParaType = 0; +//@double refReNumber = 6.5e6; +//@double refDimensionalTemperature = 288.15; +//@double freestream_vibration_temperature = 300.00; +//@double refDimensionalPressure = 0; +//@double height = 0; +//@int nsubsonicInlet = 0; +//@int nsubsonicOutlet = 0; +//@string inLetFileName = "./bin/subsonicInlet.hypara"; +//@string outLetFileName = "./bin/subsonicOutlet.hypara"; +//@double refDimensionalVelocity = 0; +//@double refDimensionalDensity = 0; + +######################################################################### +# Old Parameter # +######################################################################### +int isPlotVolumeField = 0; + diff --git a/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/cfd_para_hypersonic.hypara b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/cfd_para_hypersonic.hypara new file mode 100644 index 0000000..de62bd2 --- /dev/null +++ b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/cfd_para_hypersonic.hypara @@ -0,0 +1,238 @@ +x######################################################################### +# General Control Parameter # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual 'res.dat' saved. + +int maxSimuStep = 30000; + +int intervalStepFlow = 2000; +int intervalStepPlot = 2000; +int intervalStepForce = 100; +int intervalStepRes = 10; + +######################################################################### +# Inflow Parameter # +######################################################################### +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. + +double refMachNumber = 9.91; +double attackd = 0.00; +double angleSlide = 0.00; + +double wallTemperature = 293; + +int inflowParaType = 0; +double refReNumber = 1.86e5; +double refDimensionalTemperature = 51; +double freestream_vibration_temperature = 10000.0; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +double gridScaleFactor = 0.001; + +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 0.1017; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. + +######################################################################### +# Physical models # +######################################################################### +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "1eq-sa", when viscousType = 3. +// -- "2eq-kw-menter-sst", when viscousType = 4. +// DESType: Type of DES. +// 0 -- RANS.(default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. + +//int viscousType = 0; +//string viscousName = "Euler"; + +int viscousType = 1; +string viscousName = "laminar"; + +//int viscousType = 3; +//string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; +######################################################################### +# Spatial Discretisation # +######################################################################### +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "ausmpw". +// str_limiter_name: Limiter of struct grid. +// -- "minmod", "3rd_minmod_smooth". + +string inviscidSchemeName = "steger"; +string str_limiter_name = "minmod"; + +#******************************************************************* +# UnStruct Solver * +#******************************************************************* +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpwplus". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "vencat", "barth". +// -- "1st", meaning accuracy of first-order. +// -- "nolim", no limiter. +// venkatCoeff: Coefficient of vencat limiter, when uns_limiter_name = 'vencat'. +// The smaller the value, the more robust it is. + +string uns_scheme_name = "steger"; +string uns_limiter_name = "vencat"; +double venkatCoeff = 0.5; + +######################################################################### +# Temporal Discretisation # +######################################################################### +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// CFLEnd: The CFL number, [0.1, 100]. +// The bigger the value, the convergence faster but lower robustness. +// ktmax: The lower the value, the more robustness, 1.0e5 - 1.0e10. + +int iunsteady = 0; + +double CFLEnd = 3.0; + +double ktmax = 1.0e10; + +######################################################################### +# File In or Out # +######################################################################### +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// Please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the whole field results to tecplot or not, 0 / 1. + +string gridfile = "./grid/3d_HCFlare_unstr__16.fts"; +int plotFieldType = 0; + +// ----------------- Advanced Parameters, DO NOT care it ---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables: Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40). +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. + +int reconmeth = 0; +int limitVariables = 0; +int limitVector = 1; + +######################################################################### +# Non-equilibrium gas # +######################################################################### +// nGasModel: The type of gas. +// 0 -- Earth gas. +// 1 -- Mars gas. +// nchem: +// 0 -- without chemical reaction flow. +// 1 -- the chemical reaction flow is considered. +// nchemsrc: +// 0 -- the source terms are not computed. +// 1 -- the source terms are computed. +// nchemrad: +// 0 -- compute the spectrum radius without considering chemical reaction flow. +// 1 -- compute the spectrum radius that need to count the contribution from chemical reaction flow. +// ntmodel: The thermodynamic temperature model. +// 1 -- One-temperature model. +// 2 -- Two-temperature model. +// 3 -- Three-temperature model. +// catalyticCoef: +// 0.0 -- full non-catalytic wall boundary condition. +// 1.0 -- full catalytic wall boundary condition. +// in range of (0.0, 1.0) -- partial catalytic condition, the value indicates the catalytic coefficient. +// gasfile: Indicates the gas model, 9 models are provided, namely "Gu5", "Gu7", "Gu11", "Pa5", "Pa7", "Pa11", "DK5", "DK7", "DK11". +// "Gu" -- indicates the Gupta Model, three-Type Models are embeded in the library, namely, the 5-species-6-reactions, the 7-species-9-reactions, the 11-species-20-reactions. +// "Pa" -- indicates the Park Model, three-Type Models are embeded in the library, namely, the 5-species-17-reactions, the 7-species-22-reactions, the 11-species-48-reactions. +// "DK" -- indicates the Dunn-Kang Model, three-Type Models are embeded in the library, namely, the 5-species-11-reactions, the 7-species-15-reactions, the 11-species-26-reactions. +// "Mars-Pa8" is for Park model of Mars gas, "Mars-Mc8" for McKenzie model of Mars gas. +// For self-definition model, the gasfile is used to indicate the file path of the new gas model. +// speciesName: Used to list the names of each species, while each species name is separated by the symbol of comma. +// initMassFraction: Used to list the initial mass fractions of species in accordance with the sequence of names in the parameter speciesName. +// ifStartFromPerfectGasResults: The chemical reaction simulation is start from perfect gas flowfield or not, 0 is for no and else is for yes. + +int nGasModel = 0; +int nchem = 0; +int ntmodel = 1; +int nchemsrc = 1; +int nchemrad = 1; +double catalyticCoef = 1.0; +string gasfile = "DK5"; +string speciesName = "O, O2, NO, N, N2"; +string initMassFraction = "0.07955, 0.134, 0.0509, 1.0e-9, 0.73555"; +int ifStartFromPerfectGasResults = 0; diff --git a/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/grid_para.hypara b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/grid_para.hypara new file mode 100644 index 0000000..ab69054 --- /dev/null +++ b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/grid_para.hypara @@ -0,0 +1,30 @@ +######################################################################### +# Grid data type # +######################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +// from_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +int gridtype = 0; +int axisup = 2; +int from_gtype = 2; + +######################################################################### +# File path # +######################################################################### +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +string from_gfile = "./grid/3d_HCFlare_unstr.cgns"; +string out_gfile = "./grid/3d_HCFlare_unstr.fts"; diff --git a/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/key.hypara b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/key.hypara new file mode 100644 index 0000000..a0b0913 --- /dev/null +++ b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/key.hypara @@ -0,0 +1,56 @@ +string title = "PHengLEI Main Parameter Control File"; + +// IMPORTANT NOTICE: DON NOT MODIFY THE FOWLLOWING LINE. +string defaultParaFile = "./bin/cfd_para.hypara"; + +// ndim: Dimensional of the grid, 2 or 3. +// nparafile: the number of parameter files. +// nsimutask: simulation task type. +// 0 -- CFD Solver of NS or Turbulation. +// 1 -- Grid generation: for special typical cases, such as cylinder, flat plate, etc. +// Grid conversion: from other format to PHengLEI format (.fts). +// Grid reconstruction: such as grid adaptation. +// Grid merging: merge two blocks into one block. +// Grid repairing: repair the original grid in order to remove the negative volume cells. +// 2 -- Wall distance computation for turb-solver. +// 3 -- Grid partition. +// 4 -- Knowledge repository / examples of PHengLEI-API. +int ndim = 3; +int nparafile = 1; + +int nsimutask = 0; +//string parafilename = "./bin/cfd_para_subsonic.hypara"; +//string parafilename = "./bin/cfd_para_transonic.hypara"; +//string parafilename = "./bin/cfd_para_supersonic.hypara"; +string parafilename = "./bin/cfd_para_hypersonic.hypara"; +//string parafilename = "./bin/incompressible.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_para.hypara"; + +//int nsimutask = 2; +//string parafilename = "./bin/cfd_para.hypara"; + +//int nsimutask = 3; +//string parafilename = "./bin/partition.hypara"; + +//int nsimutask = 4; +//string parafilename = "./bin/repository.hypara"; + +//int nsimutask = 5; +//string parafilename = "./bin/overset_grid_view.hypara"; + +//int nsimutask = 13; +//string parafilename = "./bin/lbm_para.hypara"; + +//int nsimutask = 14; +//string parafilename = "./bin/integrative_solver.hypara"; + +//int nsimutask = 99; +//string parafilename = "./bin/post_processing.hypara"; + +// ---------------- Advanced Parameters, DO NOT care it ---------------- +int numberOfGridProcessor = 0; +// ATP read +//@string parafilename1 = "" +//@string parafilename2 = ""; diff --git a/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/partition.hypara b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/partition.hypara new file mode 100644 index 0000000..4591179 --- /dev/null +++ b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/bin/partition.hypara @@ -0,0 +1,21 @@ +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// maxproc: The number of partition zones that want to be divided into, +// which is equal to the number of CPU processors you want. +// Usually, 50~100 thousands structured cells per CPU-Core is suggested. +// 30~70 thousands unstructured cells per CPU-Core is suggested. +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). + +int pgridtype = 0; +int maxproc = 16; + +string original_grid_file = "./grid/3d_HCFlare_unstr.fts"; +string partition_grid_file = "./grid/3d_HCFlare_unstr__16.fts"; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level,..., et al. +int numberOfMultigrid = 1; diff --git a/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/grid/3d_HCFlare_unstr.cgns b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/grid/3d_HCFlare_unstr.cgns new file mode 100644 index 0000000..bec82cb Binary files /dev/null and b/B16-ThreeD_Hollow_Cylinder_Flare_Laminar_Unstruct_16CPU/grid/3d_HCFlare_unstr.cgns differ diff --git a/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/boundary_condition.hypara b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/boundary_condition.hypara new file mode 100644 index 0000000..a5fa063 --- /dev/null +++ b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/boundary_condition.hypara @@ -0,0 +1,44 @@ +# nBoundaryConditons : number of global boundary conditions. +# bcName : Boundary Condition Name. +# bcType(in PHengLEI): Boundary Condition Type. + +# Account of how to set boundaryconditon. +# string bcName = "Farfield"; +# { +# int bcType = 4; +# int inflowParaType = 1; +# double attackd = 0; +# double refReNumber = 6.5e6; +# double refMachNumber = 3.5; +# double angleSlide = 0; +# } + +int nBoundaryConditons = 3; +string bcName = "BCWall"; +{ + int bcType = 2; +} +string bcName = "BCFarfield"; +{ + int bcType = 4; +} +string bcName = "BCOutflow"; +{ + int bcType = 6; +} + +# 'bcType' is defined as following: +# 99: PERIODIC +# -2: WAKE +# -1: INTERFACE +# 0 : NO_BOUNDARY_CONDITION +# 1 : EXTRAPOLATION +# 2 : SOLID_SURFACE +# 3 : SYMMETRY +# 4 : FARFIELD +# 5 : INFLOW +# 6 : OUTFLOW +# 52: PRESSURE_INLET +# 62: PRESSURE_OUTLET +# 61: OUTFLOW_CONFINED +# 7 : POLE diff --git a/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/cfd_para.hypara b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/cfd_para.hypara new file mode 100644 index 0000000..b17970c --- /dev/null +++ b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/cfd_para.hypara @@ -0,0 +1,1220 @@ +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +// PPPPP H H EEEEE N N GGGGG L EEEEE III + +// P P H H E NN N G L E I + +// PPPPP HHHHH EEEEE N N N G GG L EEEEE I + +// P H H E N N N G G L E I + +// P H H EEEEE N N GGGGG LLLLL EEEEE III + +//------------------------------------------------------------------------+ +// Platform for Hybrid Engineering Simulation of Flows + +// China Aerodynamics Research and Development Center + +// (C) Copyright, Since 2010 + +//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ +########################################################################### +# Default parameters for Grid conversion # +########################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// 2 -- Hybrid grid, include both of unstructured and structured grid. +// gridobj: Task type of grid treatment. +// 0 -- Grid generation of typical case, such as cylinder, flat plate, etc. +// 1 -- Grid conversion, from other grid data to PHenglEI, such as Fluent, CGNS. +// 2 -- Grid refinement. +// 3 -- Grid merging, merge two blocks into one block. +// 4 -- Grid deformation, achieve unstructured grid deformation. +// 5 -- Grid repairing, repair the original grid in order to remove the negative volume cells. +// 6 -- Grid mirroring, mirror a symmetry grid to whole grid. +// multiblock: Multi-block grid or not, only for structured grid conversion. +// 0 -- Not. +// 1 -- Yes. +// iadapt: Adaptation number for unstructure grid. +// SymmetryFaceVector: The vector of symmetry face. +// 0 -- X axis. +// 1 -- Y axis. +// 2 -- Z axis. +int gridtype = 0; +int gridobj = 1; +int multiblock = 0; +int iadapt = 0; +int SymmetryFaceVector = 1; + +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +int axisup = 1; + +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +int omit_no_bound_bc = 0; + +//----------------------------------------------------------------------- +# Grid data type # +//----------------------------------------------------------------------- +// from_gtype/to_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE. +// 1 -- PHengLEI, *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +// dumpOldGrid: If dump out the old grid file. +// 0 -- Not. (default) +// 1 -- Yes. +int from_gtype = 2; +int to_gtype = 1; +int dumpOldGrid = 0; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +int numberOfGridFile = 1; +string from_gfile = "./grid/rae2822_hybrid2d.cas"; +string from_gfile1= ""; + +string out_gfile = "./grid/flat_laminr_133_85_2d.fts"; + +// ----------------- some advanced choices ------------------------------ +// iunsteady: The Grid is for unsteady simulation or not. +int iunsteady = 0; +int codeOfAleModel = 0; + +// fileformat: Ustar Grid file format. +// 0 -- BINARY. +// 1 -- ASCII. +int fileformat = 0; + +// Parameters for hybrid solver. +// mixgrid_uns: path of unstructure grid file for hybrid solver, *.fts type. +// mixgrid_str: path of structure grid file for hybrid solver, *.fts type. +string mixgrid_uns = "./grid/rae2822_uns2d_4.fts"; +string mixgrid_str = "./grid/flat_laminr_133_85_2d.fts"; + +// Some parameters for structured overlapping grid. +int codeOfDigHoles = 1; +string holeBasicFileName = "./oversetGridView/holeBasicFile.inp"; +string holeFullFileName = "./oversetGridView/holeFullFile.dat"; +string linkFileName = "./oversetGridView/topology.dat"; +string zoneInverseFileName = "./oversetGridView/zoneInverseMapping.inp"; + +// ----------------- Adaptive Mesh Refine ------------------------------- +// In this file, the original_grid_file is used of the partition part. +// If use it dependently, abstract it here. +string adapt_grid_file = "./grid/sphere_mixed_adapt1.fts"; +string geometryFileName = "./grid/jsm.igs"; + +// geometryUnit: Geometry unit. +// 1 -- meter. +// 2 -- millimeter. +// 3 -- inch. +// exclusiveCase: Parallel projection exclusive case. +// 0 -- NON case. +// 1 -- JSM-C2-NPOFF case. +// 2 -- CHNT. +// projectOrgPoint: If the original wall points need to be projected or not. +int geometryUnit = 1; +int anisoRefine = 0; +int isProject = 0; +int readDist = 0; +int isDeform = 0; +int exclusiveCase = 0; // 0: NON case; 1: JSM-C2-NPOFF case; 2: CHNT. +int projectOrgPoint = 0; // if project original wall points. + + +// ----------------- Grid Deform Parameters ----------------------------- +// deformationMethod: Grid Deform. +// 1 -- SPRING. +// 2 -- RBF. +// stationalGridFile: Original grid file. +// visualFileName : The visualization file path of deform grid. +// nDeformStep : The max deform step. +// flapAngle : The max flap angle. +// rotatePostionZ : Rotate postion. +// rotatePostionY : Rotate postion. +// gridSlice : If dump slice grid. +// sliceAxis : Grid slice axis. +// slicePosition : Grid slice position. +int nDeformStep = 40; +double flapAngle = 10.0; +double rotatePostionZ = 4.00003; +double rotatePostionY = 3.05; + +int deformationMethod = 2; +string stationalGridFile = "./grid/Segment2Brid.fts"; +string visualFileName = "./results/deformedGrid.dat" + +int gridSlice = 1; +int sliceAxis = 1; +double slicePosition = 13; + +// ----------------- RBF Parameters ------------------------------------- +// numberOfReferenceCP : Number of reference Control Points. +// influencePara : The RBF influence radius parameter. +int numberOfReferenceCP = 40; +double influencePara = 25.0; + +// ----------------- Periodic Parameters -------------------------------- +// Notice: Rotational periodicity only support rotation along the X axis! +// periodicType: Which periodic boundary is used. +// 0 -- without Periodic Boundary. +// 1 -- Translational periodicity. +// 2 -- Rotational periodicity. +// translationLength[]: The relative distance between two periodic face + which only support one direction. +// rotationAngle: The relative angle between two periodic face. + which is recorded in degrees. + +int periodicType = 0; +double translationLength[] = [0.0,0.0,0.0]; +double rotationAngle = 0.0; + +######################################################################### +# Default parameters for Partition # +######################################################################### +// pgridtype: The grid type. +// 0 -- unstruct grid. +// 1 -- struct grid. +// 2 -- refine structured grid. +// maxproc: The number of partition zones that want to be divided into. +int pgridtype = 0; +int maxproc = 4; + +// traceMark: Trace mark or not, only for structured grid partition. +// 0 -- Not. +// 1 -- Yes. +// blockIndexOfMark: the block index of mark, only for structured grid partition. +// cellIndexOfMark: the cell index of mark, only for structured grid partition. +int traceMark = 0; +int blockIndexOfMark = 0; +int cellIndexOfMark[] = [185,30,1]; + +// parallel Strategy: +//! -# 0 : each zone is assigned to the one that defined in grid partition procedure. +//! -# 1 : random assigned for each zone or by some else ways. +int parallelStrategy = 1; + +//----------------------------------------------------------------------- +# File path # +//----------------------------------------------------------------------- +// original_grid_file: Original grid file that want to be divided(PHengLEI type, *.fts). +// partition_grid_file: Target partition grid file(PHengLEI type, *.fts). +string original_grid_file = "./grid/sphere_mixed.fts"; +string partition_grid_file = "./grid/sphere_mixed__4.fts"; + +// ------------------ Sompe advanced parameters ------------------------- +// omit_no_bound_bc: What's boundary condition for the type of "no_boundary_condition". +// 0 -- Interface. (default) +// 1 -- Physical boundary condition, used in Hybrid solver. +// npartmethod: Method of interface reconstruction, default is 1. +// parallelPartitionMethod: Method of parallel partition, this is set only when execute parallel partition. It would be skipped when serial partition. +// 1 -- Using ParMetis for homogeneous MPI. +// 2 -- Using Metis for homogeneous MPI. +// 3 -- using METIS partition for homogeneous OpenMP. +// parmetisBalance: Used to specify the imbalance tolerance. +// 1 -- perfect balance. +// maxproc -- perfect imbalance. +// 1.05 -- recommended. + +int omit_no_bound_bc = 0; +int npartmethod = 1; +int parallelPartitionMethod = 2; +double parmetisBalance = 1.05; + +// numberOfMultigrid: Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level. +// 2 -- 2 level. +// N -- N level, ..., et al. +int numberOfMultigrid = 1; + +######################################################################### +# Default parameters for CFD simulation # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepSample: The step intervals for monitored probes variables file 'sample.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual file 'res.dat' saved. +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) + +int maxSimuStep = 20000; + +int intervalStepFlow = 1000; +int intervalStepPlot = 1000; +int intervalStepSample = 1000; +int intervalStepForce = 100; +int intervalStepRes = 10; +int ifLowSpeedPrecon = 0; + +// compressible: +// 0 -- incompressible flow. +// 1 -- compressible flow. (default) +int compressible = 1; + +//----------------------------------------------------------------------- +# CFD Control Parameter # +//----------------------------------------------------------------------- +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// 4 -- the condition that the velocity, temperature and density are given. +// 5 -- the condition that the velocity, temperature and pressure are given. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// freestream_vibration_temperature: Dimensional freestream vibration temperature. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// wallTemperature: Temprature of the solid wall, minus value is for adiabatic boundary condition. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceReferenceLength, forceReferenceLengthSpanWise, forceReferenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. +// radiationCoef: The radiation coefficient on wall, it is used to compute the radiation heat flux on wall when the boundary +// condition is radiation equilibrium temperature, and 0.8 is the default value. +// refMolecularWeight : the reference molecular weight of gas used for perfect gas. The unit is g/mol. +// Generally, the gas is air. Sometimes, it is experiment gas, such as Nitrogen, Argon, and so on. + +double refMachNumber = 0.73; +double attackd = 2.79; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 6.5e6; +double refDimensionalTemperature = 288.15; +double freestream_vibration_temperature = 300.00; + +//int inflowParaType = 1; +//double height = 0.001; + +//int inflowParaType = 2; +//double refDimensionalTemperature = 6051.024; // The total temperature, T*(1+(refGama-1)*M*M/2). +//double refDimensionalPressure = 4.299696E09; // The total pressure, p*(T0/T)^(refGama/(refGama-1)). + +//int inflowParaType = 3; +//int nsubsonicInlet = 1; +//int nsubsonicOutlet = 1; +//string inLetFileName = "./bin/subsonicInlet.hypara"; +//string outLetFileName = "./bin/subsonicOutlet.hypara"; +//double refDimensionalTemperature = 288.144; +//double refDimensionalPressure = 1.01313E05; + +//The velocity, temperature and density are fixed. +//int inflowParaType = 4; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalDensity = 1.0e3; + +//The velocity, temperature and pressure are fixed. +//int inflowParaType = 5; +//double refDimensionalVelocity = 1000.0; +//double refDimensionalPressure = 1.0e5; + +//The MachNumber, temperature and pressure are fixed. +//int inflowParaType = 6; +//double refDimensionalTemperature = 293; +//double refDimensionalPressure = 8886.06; + +double wallTemperature = -1.0; + +double radiationCoef = 0.8; +double gridScaleFactor = 1.0; + +int numberOfAerodynamicForceComponents = 1; +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.0; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. +double refMolecularWeight = 28.9644; // unit of g/mol. + +//----------------------------------------------------------------------- +# Spatial Discretisation # +//----------------------------------------------------------------------- +#******************************************************************* +# Struct Solver * +#******************************************************************* +// inviscidSchemeName: Spatial discretisation scheme of struct grid. +// Using this when solve structered grid or hybrid. +// -- "vanleer", "steger", "hlle", "lax_f". +// -- "roe", "modified_roe". +// -- "ausm+", "ausm+w", "ausm+up", "ausmdv", "ausmpw", "ausmpw+". +// str_limiter_name: Limiter of struct grid. +// -- "vanalbada", "vanleer", "minmod", "smooth", "minvan", "3rdsmooth", "3rd_minmod_smooth". +// -- "nolim", no limiter. +// -- "vanalbada_clz", clz supersonic version. +string inviscidSchemeName = "roe"; +string str_limiter_name = "vanalbada"; + +#******************************************************************* +# UnStruct Solver or Common * +#******************************************************************* +// viscousType: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 2 -- Algebraic. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "0eq-bl". +// -- "1eq-sa". +// -- "2eq-kw-menter-sst". +// -- "2eq-kw-menter-bsl". +// -- "2eq-kw-wilcox-1988". +// -- "2eq-kw-wilcox-1998". +// -- "2eq-kw-kok-tnt". +// -- "2eq-kw-wilcox-2006". +// -- "easm-kw-2003". +// -- "easm-kw-2005". +// DESType: Type of DES. +// 0 -- RANS. (default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. +// uns_scheme_name: Spatial discretisation scheme of Unstruct grid. +// Using this when solve Unstructered grid or hybrid. +// -- "vanleer", "roe", "steger", "kfvs", "lax_f", "hlle". +// -- "ausm+", "ausmdv", "ausm+w", "ausmpw", "ausmpw+". +// uns_limiter_name: Limiter of Unstruct grid. +// -- "barth", "vencat", "vanleer", "minmod". +// -- "vanalbada", "smooth", "nnd", "lpz", "1st". +// -- "nolim", no limiter. +// uns_vis_name: Discretisation method of viscous term. +// -- "std", "test", "aver", "new1", "new2". +// gradientName: Gradient reconstruction method. +// -- "default", "ggcell", "ggnode", "lsq". +// ivencat: Variation of vencat limiter. +// 0 -- org method, it is independent of grid scale. +// 1 -- new method, it is dependent of grid scale. +// 4 -- Ustar limiter model, without grid size unitary. +// 7 -- default used. +// venkatCoeff: Cofficient of vencat, when using vencat limter. +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. +// skewnessAngle: The skewness angle of grid cells. +// roeEntropyFixMethod: Entropy fix (correction) method. +// 1 -- direct fix, which limits the minimum eigenvalue directly. +// 2 -- multi-dimensional fix, which is derived from structured solver and now is only valid for struct solver. +// 3 -- Harten type, which is default used. +// roeEntropyScale: Entropy fix (correction) coefficient scale, default is 1.0. +// It is used to scale the default Roe entropy fix coefficients. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +string uns_scheme_name = "roe"; +string uns_limiter_name = "vencat"; +string uns_vis_name = "test"; +string gradientName = "ggnode"; + +int ivencat = 7; +double venkatCoeff = 5.0; +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; +double skewnessAngle = 60.0; + +int roeEntropyFixMethod = 3; +double roeEntropyScale = 1.0; + +//----------------------------------------------------------------------- +# Temporal Discretisation # +//----------------------------------------------------------------------- +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// physicalTimeStep: The nondimensional physical time step. +// ifStartFromSteadyResults: The unsteady simulation is start from steady flowfield or not, 0 is for no and else is for yes. +// ifStaticsFlowField: Statistical variables for unsteady simulation. +// ifStaticsReynoldsStress: Statistical Reynolds stress for unsteady simulation. +// startStatisticStep: Outer step when start statistics. +// when the value is larger than "maxSimuStep", it is useless. +// statisticalTimePeriod: Used as time period of statistic analysis. +// when the value is negative, time period is treated as infinite. +// statisticMethod: Statistic reynolds stress method. + 0 --tau = - ^2 + 1 --tau = +// min_sub_iter: The min sub iteration of unsteady simulation. +// max_sub_iter: The max sub iteration of unsteady simulation. +// tol_sub_iter: The tolerance of sub iteration of unsteady simulation. +// tscheme: Temporal Discretisation method. +// 1 -- Runge-Kutta Multi-State. +// 2 -- Point implicit. +// 3 -- Full implicit. +// 4 -- LU-SGS. +// 5 -- Block LU-SGS. +// 6 -- Jacobian iteration. +// 7 -- Lower G-S iteration. +// 8 -- Upper G-S iteration. +// 9 -- Lower/Upper G-S iteration. +// iSimplifyViscousTerm: Simplify the computation of viscous term in the Block LU-SGS method. The default value assigns 1 that could speed up the computation. +// Otherwise, the viscous Jacobian matrix Mv should be computed that will increase the memory and time in iteration of the BLUSGS method. +// CFLStart: Started cfl number. +// CFLEnd: End cfl number. +// CFLVaryStep: The number of step when cfl increase from CFLStart to CFLEnd. +// ktmax: Dtratio. dt[i] = MIN(dt[i], ktmax * dtmin / vol[i]) +// swapDq: Communication dq between forward/backward sweep of LUSGS or not, default is 0. +// nLUSGSSweeps: Sub iteration of LU-SGS or Block LU-SGS. +// LUSGSTolerance: Sub iter tolerance of LU-SGS or Block LU-SGS. +// ifLocalTimeStep: Time step method. +// 0 --Local. +// 1 --Global. +// visl_min: Minimum value of laminar viscosity coefficient. +// turbCFLScale: Turbulence model cfl number factor. +// codeOfAleModel: Arbitrary Lagrangian-Eulerian method. +// 0 -- no ALE method. +// 1 -- ALE method for non-moving grids. +// 2 -- ALE method for moving grids. +// 3 -- ALE method for deforming grids. +// wallFunctionType: The type of wall function to implement. +// 0 -- no wall function. (default) +// 1 -- standard wall function. +// 2 -- Pab3D wall function. +// RKStage: The number of Runge-Kutta step. +// lamda: Cofficient of Runge-Kutta step. + +int iunsteady = 0; +double physicalTimeStep = 0.01; +int ifStartFromSteadyResults = 0; +int ifStaticsFlowField = 0; +int ifStaticsReynoldsStress = 0; +int startStatisticStep = 800000; +double statisticalTimePeriod = -1.0; +int statisticMethod = 0; +int linearTwoStepMethods = 1; // 1--BDF1; 2--C-N; 3--BDF2; + +int methodOfDualTime = 3; +int min_sub_iter = 50; +int max_sub_iter = 50; +double tol_sub_iter = 0.01; + +int tscheme = 4; +int iSimplifyViscousTerm = 1; +int ifLocalTimeStep = 0; +double CFLStart = 0.01; +double CFLEnd = 10.0; +int CFLVaryStep = 500; + +double ktmax = 1.0e10; + +int swapDq = 1; + +int nLUSGSSweeps = 1; +double LUSGSTolerance = 0.01; +int order = 2; + +double visl_min = 0.01; +double turbCFLScale = 1.0; +double csrv = 2.0; +double timemax = 1.0e10; +double dtsave = -1.0; +int maxale = 10; +double dtau = 0.001; + +int wallFunctionType = 0; + +int RKStage = 2; +double lamda[] = 0.5, 1.0; + +//int RKStage = 1; +//double lamda[] = 1.0; + +//int RKStage = 4; +//double lamda[] = [0.25, 0.33333333333, 0.5, 1.0]; + +//----------------------------------------------------------------------- +# File In or Out # +//----------------------------------------------------------------------- +// numberOfGridGroups: The number of grid groups. +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the field results to visulization. +// walldistMethod: The method to compute wall distance. +// 0 -- accurate but not fast enough. +// 1 -- fast but not accurate enough. +// 2 -- super fast but more non-accurate! +// resSaveFile: The file path to save the residual convergence process, write data for every default (intervalStepRes) steps. +// turbresfile: The file path to save the residual convergence process of turbulence, write data for every default (intervalStepRes) steps. +// aircoeffile: The file path to save the aerodynamic force coefficients convergence process, write data for every default (intervalStepForce) steps. +// restartNSFile: The file path to write restart flowfield variables, write data for every default (intervalStepFlow) steps. +// turbfile: The file path to write restart flowfield variables of turbulence , write data for every default(intervalStepFlow) steps. +// visualfile: The visualization file path of flowfield , write data for every default (intervalStepPlot) steps. +// wall_aircoefile: The file path to save flowfield variables of wall, write data for every default steps. +// nDumpSurfaceInfo = 0 the "wall_varfile" write the informations including heat flux. +// nDumpSurfaceInfo = 1 the "wall_varfile" write the informations without heat flux. + +int numberOfGridGroups = 1; +string gridfile = "./grid/rae2822_hybrid2d__4.fts"; +string wallTemperaturefile= ""; + +int walldistMethod = 1; + +string resSaveFile = "results/res.dat"; +string turbresfile = "results/turbres.dat"; +string aircoeffile = "results/aircoef.dat"; + +string restartNSFile = "results/flow.dat"; +string turbfile = "results/turb.dat"; + +string visualfile = "results/tecflow.plt"; +string wall_aircoefile = "results/wall_aircoef.dat"; +string samplefile = "results/sample.dat"; + +int nDumpSurfaceInfo = 0; +string wall_varfile = ""; + +string jetDefineFile = "bin/jet.hypara"; + +string sixDofFileName = "results/sixDofInfo.dat"; +string derivativeFileName = "results/identify.dat"; +string hysteresisFileName = "results/force_beta.plt"; + +int plotFieldType = 0; + +// visualfileType: The file type of visualfile. +// 0 -- Tecplot binary. +// 1 -- Tecplot ASCII. + +int visualfileType = 1; + +// samplefileMode: The dump mode of sample file. +// 0 -- dump out every probe/line/surface data for all step intervals. +// 1 -- dump out all probe/line/surface data for every step intervals. +int samplefileMode = 0; + +// visualSlice: The slice of tecflow. +// 0 -- Do not save slice data. +// 1 -- comput and save it to sliceFile. +// sliceAxis: Normal vector of slice. +// 1 -- X_DIR. +// 2 -- Y_DIR. +// 3 -- Z_DIR. +// slicePostion: Coordinate of slice. + +int visualSlice = 0; +int sliceAxis = 1; +double slicePostion = -0.5; +string sliceFile = "results/Slice.plt"; +int dumpWallFaceCenter = 0; + +// min-max box of the visual block. +double lowerPlotFieldBox[] = [0.0 0.0 0.0]; +double upperPlotFieldBox[] = [1.0 1.0 1.0]; + +//-----------the optional parameters list for the flow field output---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21), +// -- vibration temperature(Tv, 33), electron temperature(Te, 34), vibrational energy(Ev, 35), electric energy(Ee, 36), +// -- number density of electron(Ne, 37), dimensioanl density(rho, 38), dimensioanl pressure(p, 39), dimensioanl temperature(T, 40), +// -- gradientUx(41), gradientUy(42), gradientVx(43), gradientVy(44), iblank(81). +// -- specific heat ratio(gama, 56) +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. +//-----------the optional parameters list for the wall boundary condition---------------- +// nVisualWallVariables: The number of visual variables on wall. +// visualWallVariables : dumped variable types, listed as following: +// -coefficient of pressure(cp, 0), -coefficient of friction(cf, 1), yplus(2), -non-dimensional heat flux(Q_NonDim, 3), -dimensional heat flux(Q_Dim, 4), +// -pressure on wall(pw, 5), -temperature on wall(Tw, 6), -density on wall(rhow, 7), -heat flux of translational-rotational temperature term(Qtr, 8), +// -heat flux of species diffusion term(Qs, 9), -heat flux of vibrational temperature term(Qv, 10), -heat flux of electron temperature term(Qe, 11), +// -species mass fractions(Ns, 12), -x component of wall velocity(Vx, 13), -y component of wall velocity(Vy, 14), -z component of wall velocity(Vz, 15) +// -slip translational-rotational temperature(Tts, 16), -slip vibrational temperature(Tvs, 17), -slip electron temperature(Tes, 18), -absolute wall velocity(Vs, 19) +// -Stanton number(St, 20), -coefficient of heat rate(Ch, 21), -temperature jump(deltaT, 22), -transition gamaeff(gamaeff, 48), +// -transition intermittency(intermittency, 51), -transition momentum thickness reynolds(MomentumThicknessReynolds, 52), +// -overlap iblank(iblank, 81) + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +int nVisualWallVariables = 9; +int visualWallVariables[] = [0, 1, 2, 3, 4, 5, 9, 10, 11]; + +// dumpStandardModel: Dump many standard model data. +// 1 -- Turbulent flat plate. +int dumpStandardModel = 0; + +// ifSetDataMonitor: Whether to set the data monitor. +// 0 -- No. +// 1 -- Yes. +// dataMonitorType: The type of data Monitor. +// 0 -- Probes data monitor. +// 1 -- Lines data monitor. +// 2 -- Surfaces data monitor. +// probesDefineFile: Probes location information file. +// nLines: The number of lines need to be monitored. +// linesDefineFile: Lines location information file. +// nSurfaces: The number of surfaces need to be monitored. +// surfacesDefineFile: Surfaces location information file. +// searchCellsMethod: method to search the cell of each probe. +// 0 -- Nearest cell to the probe. +// 1 -- Real cell where the probe is located. +// nProbeVariables: Number of variables want to be dumped for probes monitered. +// probeVariables : Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5). +// Important Warning: Array size of probeVariables MUST be equal to nProbeVariables!!! +// probeVariables order must from small to big. +// probeVariablesInterpolationMethod: Interpolation method used to compute the probe variables. +// 0 -- Take the value of probe's cell as probe real value. +// 1 -- Interpolation from probe's and neighbouring cell to probe. +// 2 -- Interpolation from probe's cell nodes to probe. +int ifSetDataMonitor = 0; + +int dataMonitorType = 0; +string probesDefineFile = "bin/probes_XYZ.dat"; + +//int dataMonitorType = 1; +//int nLines = 1; +//string linesDefineFile = "bin/lines_XYZ.dat"; + +//int dataMonitorType = 2; +//int nSurfaces = 4; +//string surfacesDefineFile = "bin/surfaces_XYZ.dat"; + +int searchCellsMethod = 0; + +int nProbeVariables = 6; +int probeVariables[] = [0, 1, 2, 3, 4, 5]; +int probeVariablesInterpolationMethod = 0; +//----------------------------------------------------------------------- +# Turbulence Parameter # +//----------------------------------------------------------------------- +// turbInterval: Iteration number of turbulence. +// kindOfTurbSource: Kinds of turbulent source. +// 0 -- Original. +// 1 -- Edwards. +// 2 -- new. +// mod_turb_res: If modify the residuals for the cells next to the wall or not, default is 0. + +int turbInterval = 1; +int turbOrderStruct = 2; +int kindOfTurbSource = 0; +int mod_turb_res = 0; +double turb_relax = 1.0; +double freeStreamViscosity = 1.0e-3; +double muoo = 3.0; +double kwoo = 5.0; +int transitionType = 0; +double turbIntensity = -1.0; +int freeturbIntensitySRModify = 0; +double freeDecayXLocation = 0.0; +int compressibleCorrection = 0; +int transitionMaFix = 1; + +# maximum eddy viscosity (myt/my) max. +double eddyViscosityLimit = 1.0e10; +int monitor_vistmax = 0; + +//----------------------------------------------------------------------- +# LES Parameter # +//----------------------------------------------------------------------- +// iLES: Create LESSolver or not. +// == 1 - Create LESSolver; +// != 1 - not. +// amplitudeofDisturb: Amplitude of adding disturb. +// disturbstep: Unsteady time step or steady iteration of adding random disturb. +// iterdisturb: Add random disturb in every sub-iter or only first sub-iter. +// = 0 - in only first sub-iter; +// != 0 - in every sub-iter. +// ipraddisturb: Add density and pressure disturb or not. +// ibodyforce: Add body force in source flux of NS equations or not. +// = 0 - not; +// != 0 - Add body force. +// bodyforce: Body force in source flux of NS equations or not. +// utau: friction velocity, using in DNSDisturb. +// sgsmodel: subgrid scale model. +// = "smagorinsky"; +// = "dsmCom"; +// = "wale"; +// = "sigma". +// deltaFunctionType: = 1 - MAX(deltai, deltaj, deltak); +// = 2 - pow(deltai * deltaj *deltak, 1/3); +// = 3 - Devloped by Scotti. +// wallDampingFunctionType: = 0 - no wall function; +// = 1 - van Driest; +// = 2 - developed by Dr. Deng Xiaobing; +// = 3 - developed by Piomelli. +// turbViscousCutType: turbulent viscosity cut type. +// = 0 - mu_total = mut + mul; +// = 1 - mu_total = max(mut-mul,0)+ mul; +// = 2 - mu_total = max(mut ,0)+ mul. +// smagConstant: constant of smagorinsky model. +// waleConstant: constant of wale model. +// filterDirection[3]: filter variables in i, j, k direction or not. +// averageDirection[3]: average variables in i, j, k direction or not. +// isotropicConstant: constant of isotropic part of SGS stress. + +int iLES = 0; +string sgsmodel = "smagorinsky"; +int deltaFunctionType = 2; +int wallDampingFunctionType = 1; +int turbViscousCutType = 2; +double smagConstant = 0.1; +double isotropicConstant = 0.0; +double waleConstant = 0.6; +double sigmaConstant = 1.35; +int filterDirection[] = [1, 1, 0]; +int averageDirection[] = [0, 0, 0]; +double testFilterScale = 2.0; +int averageWidth = 1; +int monitorNegativeConstant = 0; + +//----------------------------------------------------------------------- +# Other Parameters for Hypersonic Non-equilibrium Gas # +//----------------------------------------------------------------------- +// dg_high_order: +// 0 -- generic order accuracy. +// 1 -- high order accuracy. +// iapplication: +// 0 -- gas model is fixed in the codes. +// 1 -- gas model is imported from library files. +// iCodeBranch: +// 0 -- The old code version is used for Navier-Stokes. +// 1 -- A new code version is active for Navier-Stokes solver. +// nm: Equation number of the physics, but is out of commision now. +// 4 -- for 2D. +// 5 -- for 3D. +// nGasModel: The type of gas. less than and equal to 1 represents the mixture gas. +// Otherwise, the pure gas with one component is used for perfect gas. +// 0 -- Earth gas. +// 1 -- Mars gas. +// 2 -- Argon. +// 3 -- Nitrogen. +// nEnergyRecycle: The type of EnergyModel Recycle. +// 0 -- not used . +// 1 -- used. +// nDensityModify: The type of densitymodify. + +// 0 -- not used. +// 1 -- used. +// nchem: +// 0 -- without chemical reaction flow. +// 1 -- the chemical reaction flow is considered. +// nEquilibriumGas: the variable is valid when the condition of nchem=0 is satisfied. +// 0 -- perfect gas. +// 5, 7, 11 -- equilibrium gas, meanwhile, its value denotes the number of gas component. +// nPCWCycleStep: the maximum step number of iteration in the module of computing species mass fractions with the partial catalytic wall(PCW) condition. +// the value equals to or is greater than 1, and 3 is for default value. +// nRETCycleStep: the maximum step number of iteration in the module of computing radiation equilibrium temperature on wall. +// the value equals to or is greater than 1, and 3 is for default value. +// nSLIPCycleStep:the maximum step number of iteration in the module of computing slip temperature, slip velocity and slip species mass fraction. +// the value equals to or is greater than 1, and 3 is for default value. +// nSlipBCModel : The computational model of slip boundary conditions. + +// 0 -- no slip. +// 1 -- the conventional Maxwell slip conditions. +// 2 -- the Gokcen slip conditions. +// 3 -- the Knudsen-layer correction of the standard slip conditions proposed by Lockerby, et al. +// 4 -- the Kogan simplified slip conditions. +// nMeanFreePathType : the method to the mean free-path for the slip conditions. For the mixture, 0 is suggested. +// 0 -- the equivalent mean free-path is calculated by the simple hard sphere model(HS). +// 1 -- calculated by the definition that includes the variables of the number density and the molecule diameter. +// 2 -- the equivalent mean free-path is calculated by the variable hard sphere model(VHS). +// nchemsrc: +// 0 -- the source terms are not computed. +// 1 -- the source terms are computed. +// nchemrad: +// 0 -- compute the spectrum radius without considering chemical reaction flow. +// 1 -- compute the spectrum radius that need to count the contribution from chemical reaction flow. +// ntmodel: The thermodynamic temperature model. +// 1 -- One-temperature model. +// 2 -- Two-temperature model. +// 3 -- Three-temperature model. +// nTEnergyModel: the method to computing temperature energy model. +// 0 -- the energy term is computed using the conventional method. +// 1 -- the energy term is computed using the curve fitting method. +// parkVDPower: the power of translational-rotational temperature in the Park V-D(vibration-dissociation) coupling model. +// The value is in range of [0.0, 1.0], DPLR suggests 0.5, LAURA suggests 0.7, while 0.6 is given as default value. +// catalyticCoef: +// 0.0 -- full non-catalytic wall boundary condition. +// 1.0 -- full catalytic wall boundary condition. +// in range of (0.0, 1.0) -- partial catalytic condition, the value indicates the catalytic coefficient. +// nIsSuperCatalytic : the super catalytic condition for the fully catalytic wall, and assigned with the value of 1. +// 0 -- equilibrium condition for the fully catalytic wall where the mass fractions are assigned with the values of the free stream. +// 1 -- super catalytic condition for the fully catalytic wall where all the atomic components combine into molecular components. +// nTemperatureJump : the method to calculate the temperature jump. +// 0 -- calculated by the variables of heat conductivity and constant volume specific heat for each energy mode. +// 1 -- the general method where the iteration is calculated with the translation-rotation temperature. +// sigmaVelocity: the coordination coefficient of tangential momentum for computation of slip velocity. The value is in range of (0.0, 2.0]. +// sigmaTemperature: the heat coordination coefficient for computation of slip temperature. The value is in range of (0.0, 2.0]. +// sigmaMassFraction: the species coordination coefficient for computation of slip mass fractions. The value is in range of (0.0, 2.0]. +// velocitySlipCorrectConstant: the correction constant to the velocity slip condition. For the diffuse reflection, 1.0 is used. +// 1.0 -- proposed by Maxwell. +// sqrt(2/PI)~0.8 -- used for "micro-slip", namely the actual velocity slip at the wall. +// 1.146 -- proposed for an additional "fictitious" velocity slip. + +// chemicalRelaxCorf: The value is in range of [0.001, 1.0]. +// chemicalSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// viscousSpectrumRadiusCoef : The value is in range of [1.0, 3.0]. +// inviscidSpectrumRadiusCoef: The value is in range of [1.0, 3.0]. +// staticPressureRelaxCorf: The value is in range of [0.1, 1.0]. +// nIsChemicalFreeze : the flag to freeze the chemical reactions. +// 0 -- not freeze, the chemical reaction sources will be calculated. +// 1 -- freezes the chemical reactions, the chemical reaction sources will not be calculated.// veTemperatureMin: The minimum of Tv and Te +// nDebug: cout the Wrong place and abort +// 0 -- not used. +// 1 -- used. +// nSpeciesLimit: limitter of gas species +// 0 -- not used. +// 1 -- used. +// nTurblenceForChemical: the coupled mode of Turblence and Chemical reaction +// 0 -- method 0. +// 1 -- method 1. +// nViscosityFluxSublevelModified: Modified for ViscosityFlux on Sublevel grid +// 0 -- not used. +// 1 -- used. +// nChemcalSourceModified: Modified on ChemcalSource +// 0 -- not used. +// 1 -- used. +// nAblation: +// 0 -- The wall ablation is not computed. +// 1 -- The wall ablation is computed. +// isInjection: +// 0 -- The injection velocity of ablation wall is not computed. +// 1 -- The injection velocity of ablation wall is computed. +// nViscosityModel: + +// 0 -- Blottner fitting method. +// 1 -- Gupta fitting method. +// nSutherland: +// 0 -- stands for selecting the Blotter curve fits mode. +// 1 -- stands for Sutherland relation. +// gasfile: Indicates the gas model, 9 models are provided, namely "Gu5", "Gu7", "Gu11", "Pa5", "Pa7", "Pa11", "DK5", "DK7", "DK11". +// "Gu" -- indicates the Gupta Model, three-Type Models are embeded in the library, namely, the 5-species-6-reactions, the 7-species-9-reactions, the 11-species-20-reactions. +// "Pa" -- indicates the Park Model, three-Type Models are embeded in the library, namely, the 5-species-17-reactions, the 7-species-22-reactions, the 11-species-48-reactions. +// "DK" -- indicates the Dunn-Kang Model, three-Type Models are embeded in the library, namely, the 5-species-11-reactions, the 7-species-15-reactions, the 11-species-26-reactions. +// "Mars-Pa8" is for Park model of Mars gas, "Mars-Mc8" for McKenzie model of Mars gas. +// "Combustion-12" -- indicates the Combustion Chamber Gas Model which includes 12-species-20-reactions. +// "Gas-Mixture" -- indicates the process of mixing two species without reacting. +// For self-definition model, the gasfile is used to indicate the file path of the new gas model. +// speciesName: Used to list the names of each species, while each species name is separated by the symbol of comma. +// initMassFraction: Used to list the initial mass fractions of species in accordance with the sequence of names in the parameter speciesName. +// ifStartFromPerfectGasResults: The chemical reaction simulation is start from perfect gas flowfield or not, 0 is for no and else is for yes. + +int dg_high_order = 0; +int iapplication = 0; +int iCodeBranch = 0; +int nm = 5; +int nEquilibriumGas = 0; +int nPCWCycleStep = 3; +int nRETCycleStep = 3; +int nSLIPCycleStep= 3; + +double refGama = 1.4; +double prl = 0.72; +double prt = 0.90; +double sc_l = 0.5; +double sc_t = 0.5; + +int nGasModel = 0; +int nchem = 0; +int nchemsrc = 1; +int nchemrad = 1; +int ntmodel = 1; + +int nEnergyRecycle = 0; +int nSlipBCModel = 0; +int nDensityModify = 1; +int nTEnergyModel = 0; +int nMeanFreePathType = 0; +int nIsChemicalFreeze = 0; +int nIsSuperCatalytic = 1; +int nTemperatureJump = 0; + +double parkVDPower = 0.6; +double catalyticCoef = 0.0; +double sigmaVelocity = 1.0; +double sigmaTemperature = 1.0; +double sigmaMassFraction = 1.0; +double velocitySlipCorrectConstant = 1.0; + +double chemicalRelaxCorf = 1.0; +double chemicalSpectrumRadiusCoef = 1.0; +double viscousSpectrumRadiusCoef = 1.0; +double inviscidSpectrumRadiusCoef = 1.0; +double staticPressureRelaxCorf = 1.0; + +double veTemperatureMin = 30.0; +int nDebug = 0; +int nSpeciesLimit = 0; +int nTurblenceForChemical = 0; +int nViscosityFluxSublevelModified = 0 ; +int nChemcalSourceModified = 0; + +int nAblation = 0; +int isInjection = 0; +int nViscosityModel = 0; +int nMarsModel = 0; +string gasfile = "DK5"; +//string gasfile = "./chemical/Dunn-Kang_air5s11r.dat"; +string speciesName = "O, O2, NO, N, N2"; +string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.767"; + +//string speciesName = "O, O2, NO, N, NO+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string speciesName = "O, O2, NO, N, O+, O2+, NO+, N+, N2+, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Mars-Pa8"; +//string speciesName = "O, O2, NO, N, N2, C, CO, CO2"; +//string initMassFraction = "0.0015, 0.0429, 0.0, 0.0, 0.0, 0.0, 0.0777, 0.8779"; + +//string gasfile = "DK7"; +//string speciesName = "O, O2, NO, N, NO+, C, C2, CO, CO2, CN, N2, e-"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767, 0.0"; + +//string gasfile = "Combustion-12"; +//string speciesName = "O, O2, NO, N, C, CO, CO2, H, H2, OH, H2O, N2"; +//string initMassFraction = "0.0, 0.233, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.767"; + +//string gasfile = "Gas-Mixture"; +//string speciesName ="SpeciesA, SpeciesB"; +//string initMassFraction = "1.0, 0.0"; +int nSutherland = 0; +double gamaSpeciesA = 1.4; +double gamaSpeciesB = 1.3; +double molecularWeightSpeciesA = 29.0; +double molecularWeightSpeciesB = 30.0; + +int nChemicalFlowStep = 0; +int ifStartFromPerfectGasResults = 0; + +######################################################################### +// Multi-Grid parameters. +// nMGLevel: The number of level of Multi-Grid. +// <= 1 -- Single-level. +// > 1 -- multi-level. +// MGPreIteration: For each grid, the number of pre-smoothing steps. +// n_post: For each grid, the number of post-smoothing steps. +// MGCoarsestIteration: For the coarest grid the number of smoothing steps. +// MGFasType: V-multi cycle or W-multi cycle. +// 1 -- V-multi cycle. +// 2 -- W-multi cycle. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. +// mgCFLScale: CFL number enlarge times for coarse grid. +// mprol: Multi-grid interpolation method, interpolation from coarse cell to fine grid. +// 1 -- zero order. +// 2 -- first-order. (default) +// mgCorrectionLimit: Multi-grid correction limit. + +int nMGLevel = 1; +int MGCoarsestIteration = 1; +int MGPreIteration = 1; +int MGFasType = 1; +int n_post = 0; +int flowInitStep = 100; +int mprol = 2; +double mgCFLScale = 1.0; +double mgCorrectionLimit = 0.01; + +//--------------- Some parameter for turbulent model -------------------- +// neasm: The variation of kw turbulent model. +// ismooth_turb: Residual smooth for turb or not. +// SSTProductType: The type of product term based on vorticity for SST. +// SAProductType: The type of product term based on vorticity for SA. +int neasm = -3; +int SSTProductType = 0; +int ismooth_turb = 0; +int SAProductType = 2; + +// ----------------- Overset Grid parameter ----------------------------- +int codeOfDigHoles = 1; +int codeOfTurbulentModel = 0; +string masterFileName = "./grid/searchFile.inp"; +string holeBasicFileName = "./grid/holeBasicFile.inp"; +string holeFullFileName = "./grid/holeFullFile.dat"; +string linkFileName = "./grid/topology.dat"; +string zoneInverseFileName = "./grid/zoneInverseMapping.inp"; + +######################################################################### +# High Order Struct Solver # +######################################################################### +// isFVMOrFDM: +// 0 -- NSSolverStruct using Finite Volume Method. +// 1 -- NSSolverStruct using Finite Differ Method. +// SolverStructOrder: Spatial discretisation order of NS equations with struct grid. +// <= 2 -- finite volume method. +// >= 3 -- finite difference order. (to be completed) +// 0 -- default. +// str_highorder_interpolation_epsilon: Epsilon in weighted interpolation, bigger epsilon, better convergence, +// smaller epsilon, robuster for shock-detecting. +// str_highorder_interpolation_type: +// -- "classical", "test". +// str_highorder_flux_name: +// -- "roe", "steger". +// structhighordergradient: +// -- "conservation", "chain_rule". +int isFVMOrFDM = 0; +string str_highorder_solver = "WCNS"; +int SolverStructOrder = 0; +double str_highorder_interpolation_epsilon = 1.0e-6; +string str_highorder_interpolation_type = "test"; +string str_highorder_flux_name = "steger"; +string structhighordergradient = "conservation"; +double coefofstrflux = 0.5; +double limitcoefofinterface = 0.0; + +// ----------------- Advanced choices ----------------------------------- +// outtimesc: Time stepping scheme for the outer loop. +// MUSCLCoefXk: The parameter of MUSCL interpolations, belongs to [-1, 1]. +// -1 -- seconde-order fully-upwind differencing. +// 0 -- seconde-order upwind-biased differencing. +// 0.333333 -- third-order upwind-biased differencing. +// 1 -- seconde-order central differencing. +// MUSCLCoefXb: The limiter parameter. +// 0 -- the effect of the limiter is cancelled, means the first-order interpolations. +// allReduceStep: Iteration intervals for MPI AllReduce operation, default is 1. +string outtimesc = "impbd2"; +double MUSCLCoefXk = -1; +double MUSCLCoefXb = 1.0; +int allReduceStep = 1; + +// ----------------- overlap configuration ------------------------------ +// codeOfOversetGrid: Overlapping(overset) grid or not. +// 0 -- NON-overlapping grid. +// 1 -- Overlapping grid. +// oversetInterpolationMethod: the method of overset interpolation while field simulation +// 0 -- set the acceptor cell value by donor cell value. +// 1 -- set the acceptor cell value by distance weight of donor cell value. + +int codeOfOversetGrid = 0; +int oversetInterpolationMethod = 0; +int readOversetFileOrNot = 0; +int symetryOrNot = 0; +int readInAuxiliaryInnerGrid = 1; +int readInAuxiliaryOuterGrid = 0; +int readInSklFileOrNot = 0; +string auxiliaryInnerGrid0 = "./grid/aux-upper.fts"; +string auxiliaryInnerGrid1 = "./grid/aux-lower.fts"; +string auxiliaryInnerGrid2 = ""; +string oversetGridFileName = "./grid/iblank.ovs"; +double walldistMainZone = 1.0 +double toleranceForOversetSearch = 1.0e-3; +double toleranceForOversetBox = 1.0e-3; +int twoOrderInterpolationOrNot = 0; +int keyEnlargeOfActiveNodes = 0; +int outTecplotOverset = 0; + +int numberOfMovingBodies = 2; + +// ----------------- ALE configuration ------------------------------ +int codeOfAleModel = 1; +int aleStartStrategy = -1; + +int strategyForFaceNormalVelocity = 0; //0-By Sweeping volume; 1-By face center 1st; 2-By face center 2nd; +int strategyForGCLSource = 0; //0-present; 1-Ahn; + +//0:1st-Admas-Bashforth; 1:2nd-Admas-Bashforth; 2:1st-Implicit-Euler; 3:2nd-Implicit Euler; 4:2nd-Adams-Moulton; 5:3rd-Adams-Moulton +int methodForKineticEquation = 0; +double relaxParameterOfKinetic = 1.0; + +######################################################################### +# motive information # +######################################################################### +int numberOfMovingBodies = 1; + +############################## body0 ############################## +//mass of parts +double mass_0 = 1.0; +//mass matrix of parts Ixx Iyy Izz Ixy Ixz Iyz +double massMatrix_0[] = 1e-7, 1e-6, 1e-6, 0.0, 0.0, 0.0; +//initial six DOF position information of parts. xc yc zc +double massCenter_0[] = 0.0 , 0.0, 0.0; +//initial six DOF position information of parts. angleX angleY angleZ +double attitudeAngle_0[] = 0.0 , 0.0, 0.0; +//initial six DOF move information of parts. vc vy vz +double massCenterVelocity_0[] = 0.0, 0.0, 0.0; +//initial six DOF move information of parts. omigX omigY omigZ +double angularVelocity_0[] = 0.0, 0.0, 0.0; +//the object that the parts belong to. +int fartherIndex_0 = -1; +//the assembly position of the parts. xc yc zc angleX angleY angleZ +double configPamameter_0[] = 0.0 ,0.0 ,0.0 ,0.0 ,0.0 ,0.0; +//the move pattern of the parts. +// -1 given motion partten. +// 0 still. +// 1 six DOF motion. +// 2 three DOF motion. +// 11 X-axis forced motion. +// 12 Y-axis forced motion. +// 13 Z-axis forced motion. +// 14 forced pitch motion. +// 15 forced yaw motion. +// 16 forced roll motion. +int RBDMethod_0 = 0; +double amplitude_0 = 0.0; +double reduceFrequency_0 = 0.0; +//string uDFSixDofFileName_0 = "./Bin/UDFSixDof.Parameter"; +//additional force (system axis) fX fY fZ +double addedForce_0[] = 0.0 ,0.0 ,0.0 ; +//additional moment of Force (system axis) mX mY mZ +double addedMoment_0[] = 0.0 ,0.0 ,0.0 ; +//the deformation method of the parts. +int morphing_0 = 0; + +// post indentify +int integralOrder = 4; + + +// ---------------- ATP read -------------------------------------------- +//@int inflowParaType = 0; +//@double refReNumber = 6.5e6; +//@double refDimensionalTemperature = 288.15; +//@double freestream_vibration_temperature = 300.00; +//@double refDimensionalPressure = 0; +//@double height = 0; +//@int nsubsonicInlet = 0; +//@int nsubsonicOutlet = 0; +//@string inLetFileName = "./bin/subsonicInlet.hypara"; +//@string outLetFileName = "./bin/subsonicOutlet.hypara"; +//@double refDimensionalVelocity = 0; +//@double refDimensionalDensity = 0; + +######################################################################### +# Old Parameter # +######################################################################### +int isPlotVolumeField = 0; + diff --git a/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/cfd_para_subsonic.hypara b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/cfd_para_subsonic.hypara new file mode 100644 index 0000000..6ba1f52 --- /dev/null +++ b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/cfd_para_subsonic.hypara @@ -0,0 +1,201 @@ +######################################################################### +# General Control Parameter # +######################################################################### +// maxSimuStep: The max simulation step, don't care simulation is restart or not. +// intervalStepFlow: The step intervals for flow variables file 'flow.dat' saved. +// intervalStepPlot: The step intervals for tecplot visual file 'tecflow.dat' saved. +// intervalStepForce: The step intervals for aerodynamics coefficients file 'aircoef.dat' saved. +// intervalStepRes: The step intervals for residual 'res.dat' saved. + +int maxSimuStep = 4000; + +int intervalStepFlow = 100; +int intervalStepPlot = 100; +int intervalStepForce = 1; +int intervalStepRes = 1; +// ifLowSpeedPrecon: Precondition process to accelerate convergence for low speed flow. +// 0 -- no precondition process. (default, mach > 0.3) +// 1 -- carry out precondition process. (mach number <= 0.3) +int ifLowSpeedPrecon = 0; + +######################################################################### +# Inflow Parameter # +######################################################################### +// refMachNumber: Mach number. +// attackd: Angle of attack. +// angleSlide: Angle of sideslip. +// inflowParaType: The type of inflow parameters. +// 0 -- the nondimensional conditions. +// 1 -- the flight conditions. +// 2 -- the experiment conditions. +// 3 -- the subsonic boundary conditions. +// refReNumber: Reynolds number, which is based unit length, unit of 1/m. +// refDimensionalTemperature: Dimensional reference temperature, or the total temperature only for the experiment condition. +// refDimensionalPressure: Dimensional reference pressure, or the total pressure only for the experiment condition. +// height: Fly height, unit of km. +// gridScaleFactor: The customizable unit of the grid, default value is 1.0 for meter.Common dimensions like: +// 1 dm = 0.1 m. +// 1 cm = 0.01 m. +// 1 mm = 0.001m. +// 1 inch = 0.0254m. +// 1 foot = 12 inches = 0.3048m. +// 1 yard = 3 feet = 0.9144m. +// forceRefenenceLength, forceRefenenceLengthSpanWise, forceRefenenceArea: Reference length, SpanWise length and area, independent of grid unit. +// TorqueRefX, TorqueRefY, TorqueRefZ: Reference point, independent of grid unit. + +double refMachNumber = 0.6; +double attackd = 2.89; +double angleSlide = 0.00; + +int inflowParaType = 0; +double refReNumber = 4.8e6; +double refDimensionalTemperature = 288.15; + +//int inflowParaType = 1; +//double height = 0.001; + +double gridScaleFactor = 1.0; + +double forceReferenceLengthSpanWise = 1.0; // unit of meter. +double forceReferenceLength = 1.0; // unit of meter. +double forceReferenceArea = 1.0; // unit of meter^2. +double TorqueRefX = 0.265; // unit of meter. +double TorqueRefY = 0.0; // unit of meter. +double TorqueRefZ = 0.0; // unit of meter. + +######################################################################### +# Physical models # +######################################################################### +// iviscous: Viscous model. +// 0 -- Euler. +// 1 -- Lamilar. +// 3 -- 1eq turbulent. +// 4 -- 2eq turbulent. +// viscousName: Laminar or tubulent model. +// -- "1eq-sa", when iviscous = 3. +// -- "2eq-kw-menter-sst", when iviscous = 4. +// DESType: Type of DES. +// 0 -- RANS.(default) +// 1 -- DES. +// 2 -- DDES. +// 3 -- IDDES. + +//int viscousType = 0; +//string viscousName = "Euler"; + +//int viscousType = 1; +//string viscousName = "laminar"; + +int viscousType = 3; +string viscousName = "1eq-sa"; + +//int viscousType = 4; +//string viscousName = "2eq-kw-menter-sst"; + +int DESType = 0; + +int roeEntropyFixMethod = 2; +double roeEntropyScale = 1.0; +######################################################################### +# Spatial Discretisation # +######################################################################### +#******************************************************************* +# Struct Solver * +#******************************************************************* +// str_limiter_name: Limiter of struct grid. +// -- "3rdsmooth", "smooth". +// -- "nolim", no limiter. + +string str_limiter_name = "smooth"; + +#******************************************************************* +# UnStruct Solver * +#******************************************************************* +// uns_limiter_name: Limiter of Unstruct grid. +// -- "vencat". +// -- "1st", meaning accuracy of first-order. +// -- "nolim", no limiter. +// venkatCoeff: Coefficient of vencat limiter, when uns_limiter_name = 'vencat'. +// The smaller the value, the more robust it is. + +string uns_limiter_name = "vencat"; +double venkatCoeff = 5.0; + +######################################################################### +# Temporal Discretisation # +######################################################################### +// iunsteady: Steady or unsteady. +// 0 -- steady. +// 1 -- unsteay. +// CFLEnd: The CFL number, [0.1, 100]. +// The bigger the value, the convergence faster but lower robustness. +// nLUSGSSweeps: Number of Sub-iteration of LU-SGS. +// 0 -- is recommended for structured solver. +// 1-3 -- is recommended for unstructured solver. + +int iunsteady = 1; +double physicalTimeStep = 0.05; +int min_sub_iter = 20; +int max_sub_iter = 200; +double tol_sub_iter = 0.001; +int aleStartStrategy = 1; + +int ifLocalTimeStep = 1; +double dtau = 0.05; + +double ktmax = 1.0e10; + +######################################################################### +# Multi-Grid parameters # +######################################################################### +// nMGLevel: The number of Multi-Grid level. +// = 1 -- single-level. +// > 1 -- multi-level. +// flowInitStep: Flow initialization step, 0 - 500 is suggested. +// Multi-Grid : Number of steps computing on coarse grid, during flow initialization. +// Single-Grid: Number of steps computing using first-order with vanleer, during flow initialization. + +int nMGLevel = 1; +int flowInitStep = 0; + +######################################################################### +# File In or Out # +######################################################################### +// gridfile: The partitioned Grid file path, using relative path, +// which is relative to the working directory. +// IMPORTANT WARNING: The file index should be ignored, +// e.g. if the partitioned grid is rae2822_hybrid2d__4_0.fts, +// Please use 'rae2822_hybrid2d__4.fts' here! +// plotFieldType: If dump out the whole field results to tecplot or not, 0 / 1. + +string gridfile = "./grid/2D_NACA0012_PM_Str__4.fts"; +int plotFieldType = 1; + +// ----------------- Advanced Parameters, DO NOT care it ---------------- +// nVisualVariables: Number of variables want to be dumped for tecplot visualization. +// visualVariables: Variable types dumped, listed as following: +// -- density(0), u(1), v(2), w(3), pressure(4), temperature(5), mach(6), +// -- viscosityLaminar(7), viscosityTurbulent(8), +// -- vorticity_x(9), vorticity_y(10), vorticity_z(11), vorticityMagnitude(12), +// -- strain_rate(13), Q_criteria(14), Cp(15), timeStep(16), volume(17), +// -- modeledTKE(18), modeleddissipationrate(19), SSTF1(20), SSTF2(21). +// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!! +// Variables order must from small to big. + +int nVisualVariables = 8; +int visualVariables[] = [0, 1, 2, 3, 4, 5, 6, 15]; + +// limitVariables: Limit model (It is useful only if limitVector is 0). +// 0 -- limit only for pressure and denstiny, then get the min value. +// 1 -- limit for every variables, then get the min value. +// limitVector: +// 0 -- Each variable use the same limiter coefficient. +// 1 -- Each variable use the respective limiter coefficients. +// reconmeth: +// 0 -- When reconstruct face value, Q+, Q- use respective limiter coefficients. +// 1 -- Q+, Q- use the min limiter coefficients of left and right cell. + +int reconmeth = 1; +int limitVariables = 0; +int limitVector = 0; +int SSTProductType = 1; \ No newline at end of file diff --git a/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/grid_para.hypara b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/grid_para.hypara new file mode 100644 index 0000000..56b0f40 --- /dev/null +++ b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/grid_para.hypara @@ -0,0 +1,34 @@ +######################################################################### +# Grid data type # +######################################################################### +// gridtype: Grid type for generation, conversion, reconstruction, merging. +// 0 -- Unstructured grid. +// 1 -- Structured grid. +// axisup: Type of Cartisien coordinates system, used in grid conversion. +// 1 -- Y upward. (default) +// 2 -- Z upward. +// from_gtype: Type of grid data type in grid conversion process. +// -1 -- MULTI_TYPE +// 1 -- HyperFLOW( PHengLEI ), *.fts. +// 2 -- CGNS, *.cgns. +// 3 -- Plot3D type of structured grid, *.dat/*.grd. +// 4 -- Fieldview type of unstructured grid, *.dat/*.inp. +// 5 -- Fluent, *.cas/*.msh. +// 6 -- Ustar, mgrid.in. +// 7 -- Hybrid, include both of unstructured and structured grid, *.fts. +// 8 -- GMSH, *.msh. +int gridtype = 1; +int axisup = 1; +int from_gtype = 2; + +######################################################################### +# File path # +######################################################################### +// from_gfile: path of original data file for unstructure grid convert from. +// out_gfile: path of target file for grid convert to, *.fts type of file usually. +string from_gfile = "./grid/2D_NACA0012_PM_Str.cgns"; +string out_gfile = "./grid/2D_NACA0012_PM_Str.fts"; + + + + diff --git a/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/key.hypara b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/key.hypara new file mode 100644 index 0000000..a103cbc --- /dev/null +++ b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/key.hypara @@ -0,0 +1,49 @@ +string title = "PHengLEI Main Parameter Control File"; +// IMPORTANT NOTICE锛欴ON NOT MODIFY THE FOWLLOWING LINE +string defaultParaFile = "./bin/cfd_para.hypara"; +// ndim: Dimensional of the grid: 2 or 3. +// nparafile: the number of the parameter file. +// nsimutask: simulation task type. +// 0 -- CFD Solver of NS or Turbulation. +// 1 -- Grid generation: for special typical cases, such as cylinder, flat plate, etc. +// Grid conversion: from other format to HyperFLOW format (.fts). +// Grid reconstruction: such as grid adaptation. +// Grid merging: merge two blocks into one block. +// Grid repairing: repair the original grid in order to remove the negative volume cells. +// 2 -- Wall distance computation for turb-solver. +// 3 -- Grid partition. +// 4 -- Knowledge repository / examples of PHengLEI-API. +int ndim = 2; +int nparafile = 2; + +int nsimutask = 0; +string parafilename = "./bin/cfd_para_subsonic.hypara"; +//string parafilename = "./bin/cfd_para_transonic.hypara"; +//string parafilename = "./bin/cfd_para_supersonic.hypara"; +//string parafilename = "./bin/cfd_para_hypersonic.hypara"; +//string parafilename = "./bin/incompressible.hypara"; + +//int nsimutask = 1; +//string parafilename = "./bin/grid_para.hypara"; + +//int nsimutask = 2; +//string parafilename = "./bin/cfd_para.hypara"; + +//int nsimutask = 3; +//string parafilename = "./bin/partition.hypara"; + +//int nsimutask = 4; +//string parafilename = "./bin/repository.hypara"; + +//int nsimutask = 5; +//string parafilename = "./bin/overset_grid_view.hypara"; + +//int nsimutask = 99; +//string parafilename = "./bin/post_processing.hypara"; +// ---------------- advanced Parameters, DO NOT care it ----------- +int iovrlap = 0; +int numberOfGridProcessor = 0; +// ATP read +string parafilename1 = "./bin/kinetic_para.hypara" +//string parafilename2 = "./bin/overset_config.hypara"; + diff --git a/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/kinetic_para.hypara b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/kinetic_para.hypara new file mode 100644 index 0000000..761e7bd --- /dev/null +++ b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/kinetic_para.hypara @@ -0,0 +1,56 @@ +######################################################################### +# Parameter for RBD # +# *动力学基于有量纲的形式 # +######################################################################### +int codeOfAleModel = 1; + +######################################################################### +# 必要的无量纲信息(NS方程无量纲化相关) # +######################################################################### +double referenceLength = 1.0; +double referenceVelocity = 1.0; +double referenceDensity = 1.0; + +int strategyForFaceNormalVelocity = 0; //0-By Sweeping volume; 1-By face center 1st; 2-By face center 2nd; +int strategyForGCLSource = 0; //0-present; 1-Ahn; + +######################################################################### +# 动力学方程计算相关参数 # +######################################################################### +//0:1st-Admas-Bashforth; 1:2nd-Admas-Bashforth; 2:1st-Implicit-Euler; 3:2nd-Implicit Euler; 4:2nd-Adams-Moulton; 5:3rd-Adams-Moulton +int methodForKineticEquation = 0; +double relaxParameterOfKinetic = 0.1; + +######################################################################### +# 物体刚体运动信息 # +######################################################################### +int numberOfMovingBodies = 1; + +############################## body0 ############################## +//部件的质量 +double mass_0 = 1.0; +//部件的质量矩阵 Ixx Iyy Izz Ixy Ixz Iyz +double massMatrix_0[] = 1e-7, 1e-6, 1e-6, 0.0, 0.0, 0.0; +//部件的初始六自由度位置信息 xc yc zc +double massCenter_0[] = 0.265 , 0.0, 0.0; +//部件的初始六自由度位置信息 angleX angleY angleZ +double attitudeAngle_0[] = 0.0 , 0.0, 0.0; +//部件的初始六自由度运动信息 vc vy vz +double massCenterVelocity_0[] = 0.0, 0.0, 0.0; +//部件的初始六自由度运动信息 omigX omigY omigZ +double angularVelocity_0[] = 0.0, 0.0, 0.0; +//部件所属的物体 +int fartherIndex_0 = -1; +//部件的装配位置 xc yc zc angleX angleY angleZ +double configPamameter_0[] = 0.0 ,0.0 ,0.0 ,0.0 ,0.0 ,0.0; +//部件运动方式 +int RBDMethod_0 = 14; +double amplitude_0 = 2.41; +double reduceFrequency_0 = 0.0808; +//string uDFSixDofFileName_0 = "./Bin/UDFSixDof.Parameter"; +//附加力 (体轴系) fX fY fZ +double addedForce_0[] = 0.0 ,0.0 ,0.0 ; +//附加力矩(体轴系) mX mY mZ +double addedMoment_0[] = 0.0 ,0.0 ,0.0 ; +//部件变形方式 +int morphing_0 = 0; \ No newline at end of file diff --git a/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/partition.hypara b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/partition.hypara new file mode 100644 index 0000000..2135996 --- /dev/null +++ b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/bin/partition.hypara @@ -0,0 +1,23 @@ +// pgridtype: The grid type. +// 0 -- unstruct grid +// 1 -- struct grid +// maxproc: The number of partition zones that want to be divided into, +// which is equal to the number of CPU processors you want. +// Usually, 50~100 thousands structured cells per CPU-Core is suggested. +// 30~70 thousands unstructured cells per CPU-Core is suggested. +// original_grid_file : original grid file that want to be divided(HyperFLOW/PHengLEI type, *.fts). +// partition_grid_file : target partition grid file(HyperFLOW/PHengLEI type, *.fts). + +int pgridtype = 1; +int maxproc = 4; + +string original_grid_file = "./grid/2D_NACA0012_PM_Str.fts"; +string partition_grid_file = "./grid/2D_NACA0012_PM_Str__4.fts"; + + +// Number of multi-grid levels, ONLY used for structured grid. +// 1 -- single level, 2 -- 2 level, N -- N level, ..., et al. +int numberOfMultigrid = 1; + + + diff --git a/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/grid/2D_NACA0012_PM_Str.cgns b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/grid/2D_NACA0012_PM_Str.cgns new file mode 100644 index 0000000..4ab926d Binary files /dev/null and b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/grid/2D_NACA0012_PM_Str.cgns differ diff --git a/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/浜岀淮缁撴瀯NACA0012缈煎瀷淇话鎸崱_绠椾緥璇存槑鏂囨。.pdf b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/浜岀淮缁撴瀯NACA0012缈煎瀷淇话鎸崱_绠椾緥璇存槑鏂囨。.pdf new file mode 100644 index 0000000..3ace59b Binary files /dev/null and b/F07-TwoD_NACA0012_PitchingMovement_SA_Struct_4CPU/浜岀淮缁撴瀯NACA0012缈煎瀷淇话鎸崱_绠椾緥璇存槑鏂囨。.pdf differ