Compare commits

...

6 Commits

Author SHA1 Message Date
JokerRayL 3cc319f0a0 Merge branch 'Branch_LeiYinghaonan_TestCase' of https://git.osredm.com/p15932078/PHengLEI-TestCases into Branch_LeiYinghaonan_TestCase
# Conflicts:
#	P01_Flate_Plate_1_Part/bin/GenerateGrid.hypara
#	P01_Flate_Plate_1_Part/grid/test_grid_0.fts
2021-10-18 00:07:27 +08:00
JokerRayL 6ff039a174 把UDF参数和BC参数独立出来 2021-10-18 00:04:06 +08:00
JokerRayL 65f7881348 优化参数表 2021-10-18 00:03:34 +08:00
JokerRayL 1a503d2c79 Merge branch 'Branch_LeiYinghaonan_TestCase' of https://git.osredm.com/p15932078/PHengLEI-TestCases into Branch_LeiYinghaonan_TestCase 2021-09-30 10:22:19 +08:00
JokerRayL afb05a1574 Merge branch 'master' of https://git.osredm.com/p15932078/PHengLEI-TestCases into Branch_LeiYinghaonan_TestCase 2021-09-30 09:40:01 +08:00
JokerRayL 82aa9d6caa 添加了自定义的网格库 2021-08-26 19:54:00 +08:00
49 changed files with 59769 additions and 19 deletions

View File

@ -0,0 +1,25 @@
//! #########################################################################
//! # grid Contorl #
//! #########################################################################
//! gridDatabaseIndex: Controls the type of geometry to generate.
//! 1 -- Square for Taylor-Green Vortex with periodic boundary condition.
//! 2 -- Flat plate boundary layer with 1 part.
//! 3 -- Flat plate boundart later with 2 parts.
//! 4 -- Poiseuille flow.
//int gridDataBaseIndex = 1;
//string gridDataBaseFileName = "./bin/GridDataBase_TaylorGreenVortex.hypara";
int gridDataBaseIndex = 2;
string gridDataBaseFileName = "./bin/GridDataBase_Flat_Plate_Boundary_Layer_1_part.hypara";
//! gridOutputFile: The name of output grid.
string gridOutputFile = "./grid/test_grid.fts";
//! gridType: The type of grid, which will genetrate.
//! 1 -- Struct grid.
//! 2 -- Unstruct grid.
int gridType = 1;
//! gridOutputType: The type of grid output model.
//! 0 -- No grid output.
//! 1 -- fts file.
int gridOutputType = 1;

View File

@ -0,0 +1,14 @@
//! Generate Supsonic Flat Plate Grid
int nBlocks = 1;
int nNodeX = 101;
int nNodeY = 69;
int nNodeZ = 1;
double lengthX = 1.2;
double lengthY = 0.8;
double lengthZ = 0;
double xCoefDelta = 0.012;
double yCoefDelta = 1e-5;

View File

@ -0,0 +1,923 @@
//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++
// 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.
// 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.
string from_gfile = "./grid/rae2822_hybrid2d.cas";
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 iale = 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.
// ----------------- RBF Parameters -------------------------------------
// symmetryPlane: Which symmetry plane is used in the mesh.
// 0 -- without symmetry.
// 1 -- plane of x=0.
// 2 -- plane of y=0.
// 3 -- plane of z=0.
int numberOfReferenceCP = 10;
double influenceRadius = 20;
int symmetryPlane = 3; // 1: plane of x=0; 2: plane of y=0; 3: plane of z=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.
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.
// parallelPartMethod: 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.
// 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.
// forceRefenenceLength, forceRefenenceLengthSpanWise, forceRefenenceArea: 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.
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 = 10000.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;
double wallTemperature = -1.0;
double radiationCoef = 0.8;
double gridScaleFactor = 1.0;
int numberOfAerodynamicForceComponents = 1;
double forceRefenenceLengthSpanWise = 1.0; // unit of meter.
double forceRefenenceLength = 1.0; // unit of meter.
double forceRefenenceArea = 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.
//-----------------------------------------------------------------------
# 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".
// 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", "ausmpwplus".
// 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".
// uns_gradient: 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 DES simulation.
// startStatisticStep: Outer step when start statistics.
// when the value is larger than "maxSimuStep", it is useless.
// 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 startStatisticStep = 800000;
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 codeOfAleModel = 0;
int aleStartStrategy = -1;
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";
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 probesflowfile = "results/sample.dat";
int nDumpSurfaceInfo = 0;
string wall_varfile = "";
string jetDefineFile = "bin/jet.hypara";
string overset_gridfile = "results/iblank.ovs";
string sixDofFileName = "results/sixDofInfo.dat";
int plotFieldType = 0;
// visualfileType: The file type of visualfile.
// 0 -- Tecplot binary.
// 1 -- Tecplot ASCII.
int visualfileType = 1;
// 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";
// min-max box of the visual block.
double lowerPlotFieldBox[] = [0.0 0.0 0.0];
double upperPlotFieldBox[] = [1.0 1.0 1.0];
// 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).
// 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];
// 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 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;
# 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";
// = "dsm";
// = "wale".
// 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.135;
double isotropicConstant = 0.0;
double waleConstant = 0.6;
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.
// 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 dg_high_order = 0;
int iapplication = 0;
int iCodeBranch = 0;
int nm = 5;
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 nChemicalFlowStep = 0;
double catalyticCoef = 0.0;
string gasfile = "DK5";
//string gasfile = "./chemical/Dunn-Kang_air5s11r.dat";
string speciesName = "O, O2, NO, N, N2";
string initMassFraction = "0.0, 0.23, 0.0, 0.0, 0.77";
//string speciesName = "O, O2, NO, N, NO+, N2, e-";
//string initMassFraction = "0.0, 0.23, 0.0, 0.0, 0.0, 0.77, 0.0";
//string speciesName = "O, O2, NO, N, O+, O2+, NO+, N+, N2+, N2, e-";
//string initMassFraction = "0.0, 0.23, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.77, 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";
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 #
#########################################################################
// ifvfd:
// 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 ifvfd = 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.
int codeOfOversetGrid = 0;
int codeOfOversetSlipGrid = 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/overlap.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;
// ---------------- ATP read --------------------------------------------
//@int inflowParaType = 0;
//@double refReNumber = 2.329418E08;
//@double refDimensionalTemperature = 288.144;
//@double refDimensionalPressure = 1.01313E05;
//@double height = -0.001;
//@int nsubsonicInlet = 0;
//@int nsubsonicOutlet = 0;
//@string inLetFileName = "./bin/subsonicInlet.hypara";
//@string outLetFileName = "./bin/subsonicOutlet.hypara";
#########################################################################
# Old Parameter #
#########################################################################
int isPlotVolumeField = 0;

View File

@ -0,0 +1,197 @@
#########################################################################
# 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 = 15000;
int intervalStepFlow = 100;
int intervalStepPlot = 100;
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.
// 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.1;
double attackd = 0.00;
double angleSlide = 0.00;
int inflowParaType = 0;
double refReNumber = 2.0e5;
double refDimensionalTemperature = 288.15;
//int inflowParaType = 1;
//double height = 0.001;
double gridScaleFactor = 1.0;
double forceRefenenceLengthSpanWise = 1.0; // unit of meter.
double forceRefenenceLength = 1.0; // unit of meter.
double forceRefenenceArea = 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 = "nolim";
#*******************************************************************
# 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 = 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/test_grid.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;
double MUSCLCoefXk = 0.333333;

View File

@ -0,0 +1,39 @@
#########################################################################
# 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/rae2822_hybrid2d.cgns";
string out_gfile = "./grid/rae2822_hybrid2d.fts";
// 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.
// 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.
int gridobj = 0;

View File

@ -0,0 +1,53 @@
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 = 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 numberOfGridProcessor = 0;
// ATP read
//@string parafilename1 = ""
//@string parafilename2 = "";

View File

@ -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/flat_laminar_73_81.fts";
string partition_grid_file = "./grid/flat_laminar_73_81.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;

Binary file not shown.

Binary file not shown.

View File

@ -0,0 +1,172 @@
Title="THE AIRCOEF"
Variables=
iter
<i>C<sub>L</sub></i>
<i>C<sub>D</sub></i>
<i>C<sub>Z</sub></i>
<i>C<sub>D_p</sub></i>
<i>C<sub>D_f</sub></i>
<i>C<sub>D</sub></i>-<i>C<sub>L</sub></i><sup>2</sup>/(<greek>p</greek><math>4</math>A<sub>r</sub>)</i>
<i>X<sub>cp</sub></i>
<i>C<sub>A</sub></i>
<i>C<sub>N</sub></i>
<i>C<sub>Z1</sub></i>
<i>C<sub>ml</sub></i>
<i>C<sub>mn</sub></i>
<i>C<sub>m</sub></i>
"Walltime"
1 -1.3866263996e-02 2.3648666870e+00 0.0000000000e+00 0.0000000000e+00 2.3648666870e+00 2.3648602446e+00 5.9998175277e-01 2.3648666870e+00 -1.3866263996e-02 0.0000000000e+00 -nan(ind) -nan(ind) -8.3195053768e-03 3.3700000000e-01
1 -1.3866263996e-02 2.3648666870e+00 0.0000000000e+00 0.0000000000e+00 2.3648666870e+00 2.3648602446e+00 5.9998175277e-01 2.3648666870e+00 -1.3866263996e-02 0.0000000000e+00 -nan(ind) -nan(ind) -8.3195053768e-03 7.2800000000e-01
2 -3.5159403257e-02 2.3065475675e+00 0.0000000000e+00 0.0000000000e+00 2.3065475675e+00 2.3065061475e+00 5.9996981819e-01 2.3065475675e+00 -3.5159403257e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.1094580780e-02 1.2200000000e-01
2 -3.5159403257e-02 2.3065475675e+00 0.0000000000e+00 0.0000000000e+00 2.3065475675e+00 2.3065061475e+00 5.9996981819e-01 2.3065475675e+00 -3.5159403257e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.1094580780e-02 4.7900000000e-01
100 -3.2733236638e-03 1.6887637116e-01 0.0000000000e+00 0.0000000000e+00 1.6887637116e-01 1.6887601216e-01 6.7396076715e-01 1.6887637116e-01 -3.2733236638e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.2060917276e-03 5.4680000000e+00
200 -2.5265257279e-03 9.9693931991e-02 0.0000000000e+00 0.0000000000e+00 9.9693931991e-02 9.9693718109e-02 5.7232540439e-01 9.9693931991e-02 -2.5265257279e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.4459948589e-03 1.1282000000e+01
300 -2.3137827169e-03 7.3333250819e-02 0.0000000000e+00 0.0000000000e+00 7.3333250819e-02 7.3333071440e-02 5.7017404583e-01 7.3333250819e-02 -2.3137827169e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.3192588529e-03 1.7053000000e+01
400 -2.1213452433e-03 5.8942930827e-02 0.0000000000e+00 0.0000000000e+00 5.8942930827e-02 5.8942780045e-02 5.7548881237e-01 5.8942930827e-02 -2.1213452433e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.2208104547e-03 2.2788000000e+01
500 -1.9348147209e-03 4.9720194778e-02 0.0000000000e+00 0.0000000000e+00 4.9720194778e-02 4.9720069347e-02 5.6433511547e-01 4.9720194778e-02 -1.9348147209e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.0918838890e-03 2.8547000000e+01
600 -1.7818837842e-03 4.3257552970e-02 0.0000000000e+00 0.0000000000e+00 4.3257552970e-02 4.3257446584e-02 5.6167514583e-01 4.3257552970e-02 -1.7818837842e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.0008398343e-03 3.4463000000e+01
700 -1.6449921264e-03 3.8450173456e-02 0.0000000000e+00 0.0000000000e+00 3.8450173456e-02 3.8450082788e-02 5.5543518111e-01 3.8450173456e-02 -1.6449921264e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -9.1368649967e-04 4.0224000000e+01
800 -1.5281488153e-03 3.4714372404e-02 0.0000000000e+00 0.0000000000e+00 3.4714372404e-02 3.4714294158e-02 5.4705664290e-01 3.4714372404e-02 -1.5281488153e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -8.3598396074e-04 4.5984000000e+01
900 -1.4299801617e-03 3.1716640925e-02 0.0000000000e+00 0.0000000000e+00 3.1716640925e-02 3.1716572410e-02 5.3803646785e-01 3.1716640925e-02 -1.4299801617e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -7.6938147530e-04 5.1693000000e+01
1000 -1.3475924790e-03 2.9251175662e-02 0.0000000000e+00 0.0000000000e+00 2.9251175662e-02 2.9251114815e-02 5.2846608064e-01 2.9251175662e-02 -1.3475924790e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -7.1215691569e-04 5.7438000000e+01
1100 -1.2787513238e-03 2.7183487697e-02 0.0000000000e+00 0.0000000000e+00 2.7183487697e-02 2.7183432907e-02 5.1846818236e-01 2.7183487697e-02 -1.2787513238e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -6.6299187454e-04 6.3147000000e+01
1200 -1.2214454896e-03 2.5421660410e-02 0.0000000000e+00 0.0000000000e+00 2.5421660410e-02 2.5421610421e-02 5.0821357085e-01 2.5421660410e-02 -1.2214454896e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -6.2075517385e-04 6.8868000000e+01
1300 -1.1738158496e-03 2.3900563775e-02 0.0000000000e+00 0.0000000000e+00 2.3900563775e-02 2.3900517608e-02 4.9781549647e-01 2.3900563775e-02 -1.1738158496e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -5.8434371993e-04 7.5395000000e+01
1400 -1.1342865382e-03 2.2572655773e-02 0.0000000000e+00 0.0000000000e+00 2.2572655773e-02 2.2572612663e-02 4.8737236282e-01 2.2572655773e-02 -1.1342865382e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -5.5281991026e-04 8.1107000000e+01
1500 -1.1015157352e-03 2.1402357298e-02 0.0000000000e+00 0.0000000000e+00 2.1402357298e-02 2.1402316644e-02 4.7695817442e-01 2.1402357298e-02 -1.1015157352e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -5.2537693418e-04 8.6816000000e+01
1600 -1.0743709034e-03 2.0362471521e-02 0.0000000000e+00 0.0000000000e+00 2.0362471521e-02 2.0362432846e-02 4.6662498690e-01 2.0362471521e-02 -1.0743709034e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -5.0132830870e-04 9.2560000000e+01
1700 -1.0519021298e-03 1.9431825977e-02 0.0000000000e+00 0.0000000000e+00 1.9431825977e-02 1.9431788902e-02 4.5640296473e-01 1.9431825977e-02 -1.0519021298e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -4.8009125066e-04 9.8275000000e+01
1800 -1.0333174591e-03 1.8593673992e-02 0.0000000000e+00 0.0000000000e+00 1.8593673992e-02 1.8593638216e-02 4.4630475135e-01 1.8593673992e-02 -1.0333174591e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -4.6117449163e-04 1.0400100000e+02
1900 -1.0179592446e-03 1.7834583211e-02 0.0000000000e+00 0.0000000000e+00 1.7834583211e-02 1.7834548490e-02 4.3632894112e-01 1.7834583211e-02 -1.0179592446e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -4.4416507931e-04 1.0971700000e+02
2000 -1.0052834688e-03 1.7143645514e-02 0.0000000000e+00 0.0000000000e+00 1.7143645514e-02 1.7143611653e-02 4.2646384462e-01 1.7143645514e-02 -1.0052834688e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -4.2871705305e-04 1.1541800000e+02
2100 -9.9484167398e-04 1.6511904373e-02 0.0000000000e+00 0.0000000000e+00 1.6511904373e-02 1.6511871211e-02 4.1669083147e-01 1.6511904373e-02 -9.9484167398e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -4.1454140431e-04 1.2114200000e+02
2200 -9.8626541740e-04 1.5931932412e-02 0.0000000000e+00 0.0000000000e+00 1.5931932412e-02 1.5931899820e-02 4.0698719645e-01 1.5931932412e-02 -9.8626541740e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -4.0139739718e-04 1.2714400000e+02
2300 -9.7925302578e-04 1.5397514995e-02 0.0000000000e+00 0.0000000000e+00 1.5397514995e-02 1.5397482864e-02 3.9732846878e-01 1.5397514995e-02 -9.7925302578e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -3.8908510528e-04 1.3285500000e+02
2400 -9.7355837249e-04 1.4903409837e-02 0.0000000000e+00 0.0000000000e+00 1.4903409837e-02 1.4903378079e-02 3.8769019429e-01 1.4903409837e-02 -9.7355837249e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -3.7743903459e-04 1.3855700000e+02
2500 -9.6898141129e-04 1.4445162002e-02 0.0000000000e+00 0.0000000000e+00 1.4445162002e-02 1.4445130542e-02 3.7804925260e-01 1.4445162002e-02 -9.6898141129e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -3.6632269832e-04 1.4426800000e+02
2600 -9.6536023819e-04 1.4018959924e-02 0.0000000000e+00 0.0000000000e+00 1.4018959924e-02 1.4018928699e-02 3.6838478522e-01 1.4018959924e-02 -9.6536023819e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -3.5562402400e-04 1.4998700000e+02
2700 -9.6256445063e-04 1.3621522126e-02 0.0000000000e+00 0.0000000000e+00 1.3621522126e-02 1.3621491081e-02 3.5867881240e-01 1.3621522126e-02 -9.6256445063e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -3.4525147401e-04 1.5570000000e+02
2800 -9.6048962078e-04 1.3250007236e-02 0.0000000000e+00 0.0000000000e+00 1.3250007236e-02 1.3249976325e-02 3.4891661131e-01 1.3250007236e-02 -9.6048962078e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -3.3513078368e-04 1.6144500000e+02
2900 -9.5905270288e-04 1.2901941865e-02 0.0000000000e+00 0.0000000000e+00 1.2901941865e-02 1.2901911046e-02 3.3908691453e-01 1.2901941865e-02 -9.5905270288e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -3.2520222189e-04 1.6716900000e+02
3000 -9.5818823536e-04 1.2575162308e-02 0.0000000000e+00 0.0000000000e+00 1.2575162308e-02 1.2575131545e-02 3.2918197726e-01 1.2575162308e-02 -9.5818823536e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -3.1541829790e-04 1.7321500000e+02
3100 -9.5784519887e-04 1.2267767078e-02 0.0000000000e+00 0.0000000000e+00 1.2267767078e-02 1.2267736337e-02 3.1919754940e-01 1.2267767078e-02 -9.5784519887e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -3.0574184018e-04 1.7894800000e+02
3200 -9.5798442552e-04 1.1978077961e-02 0.0000000000e+00 0.0000000000e+00 1.1978077961e-02 1.1978047211e-02 3.0913278164e-01 1.1978077961e-02 -9.5798442552e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.9614439023e-04 1.8468000000e+02
3300 -9.5857647462e-04 1.1704607867e-02 0.0000000000e+00 0.0000000000e+00 1.1704607867e-02 1.1704577079e-02 2.9899008742e-01 1.1704607867e-02 -9.5857647462e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.8660486394e-04 1.9041500000e+02
3400 -9.5959988414e-04 1.1446034118e-02 0.0000000000e+00 0.0000000000e+00 1.1446034118e-02 1.1446003265e-02 2.8877497188e-01 1.1446034118e-02 -9.5959988414e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.7710842956e-04 1.9615800000e+02
3500 -9.6103973003e-04 1.1201176120e-02 0.0000000000e+00 0.0000000000e+00 1.1201176120e-02 1.1201145174e-02 2.7849583555e-01 1.1201176120e-02 -9.6103973003e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.6764556261e-04 2.0189300000e+02
3600 -9.6288642985e-04 1.0968976602e-02 0.0000000000e+00 0.0000000000e+00 1.0968976602e-02 1.0968945537e-02 2.6816375724e-01 1.0968976602e-02 -9.6288642985e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.5821124283e-04 2.0762900000e+02
3700 -9.6513475005e-04 1.0748485777e-02 0.0000000000e+00 0.0000000000e+00 1.0748485777e-02 1.0748454566e-02 2.5779226228e-01 1.0748485777e-02 -9.6513475005e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.4880427062e-04 2.1337700000e+02
3800 -9.6778299083e-04 1.0538847889e-02 0.0000000000e+00 0.0000000000e+00 1.0538847889e-02 1.0538816507e-02 2.4739708234e-01 1.0538847889e-02 -9.6778299083e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.3942668827e-04 2.1911600000e+02
3900 -9.7083230471e-04 1.0339289761e-02 0.0000000000e+00 0.0000000000e+00 1.0339289761e-02 1.0339258181e-02 2.3699590290e-01 1.0339289761e-02 -9.7083230471e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.3008327862e-04 2.2483500000e+02
4000 -9.7428611075e-04 1.0149110965e-02 0.0000000000e+00 0.0000000000e+00 1.0149110965e-02 1.0149079159e-02 2.2660809529e-01 1.0149110965e-02 -9.7428611075e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.2078111982e-04 2.3066200000e+02
4100 -9.7814958234e-04 9.9676753899e-03 0.0000000000e+00 0.0000000000e+00 9.9676753899e-03 9.9676433318e-03 2.1625443357e-01 9.9676753899e-03 -9.7814958234e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.1152918387e-04 2.3640300000e+02
4200 -9.8242919268e-04 9.7944039578e-03 0.0000000000e+00 0.0000000000e+00 9.7944039578e-03 9.7943716186e-03 2.0595679782e-01 9.7944039578e-03 -9.8242919268e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.0233797061e-04 2.4212500000e+02
4300 -9.8713232003e-04 9.6287683108e-03 0.0000000000e+00 0.0000000000e+00 9.6287683108e-03 9.6287356613e-03 1.9573787213e-01 9.6287683108e-03 -9.8713232003e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.9321917983e-04 2.4783000000e+02
4400 -9.9226689691e-04 9.4702853275e-03 0.0000000000e+00 0.0000000000e+00 9.4702853275e-03 9.4702523374e-03 1.8562083647e-01 9.4702853275e-03 -9.9226689691e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.8418541140e-04 2.5353600000e+02
4500 -9.9784110265e-04 9.3185123381e-03 0.0000000000e+00 0.0000000000e+00 9.3185123381e-03 9.3184789763e-03 1.7562905888e-01 9.3185123381e-03 -9.9784110265e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.7524989377e-04 2.5924400000e+02
4600 -1.0038630675e-03 9.1730429390e-03 0.0000000000e+00 0.0000000000e+00 9.1730429390e-03 9.1730091733e-03 1.6578577830e-01 9.1730429390e-03 -1.0038630675e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.6642621996e-04 2.6494500000e+02
4700 -1.0103405997e-03 9.0335033186e-03 0.0000000000e+00 0.0000000000e+00 9.0335033186e-03 9.0334691158e-03 1.5611379248e-01 9.0335033186e-03 -1.0103405997e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.5772810271e-04 2.7067200000e+02
4800 -1.0172809305e-03 8.8995490234e-03 0.0000000000e+00 0.0000000000e+00 8.8995490234e-03 8.8995143491e-03 1.4663515249e-01 8.8995490234e-03 -1.0172809305e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.4916914437e-04 2.7636900000e+02
4900 -1.0246904875e-03 8.7708621047e-03 0.0000000000e+00 0.0000000000e+00 8.7708621047e-03 8.7708269233e-03 1.3737087468e-01 8.7708621047e-03 -1.0246904875e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.4076262855e-04 2.8207500000e+02
5000 -1.0325747005e-03 8.6471485926e-03 0.0000000000e+00 0.0000000000e+00 8.6471485926e-03 8.6471128679e-03 1.2834067772e-01 8.6471485926e-03 -1.0325747005e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.3252133686e-04 2.8778100000e+02
5100 -1.0409378344e-03 8.5281362568e-03 0.0000000000e+00 0.0000000000e+00 8.5281362568e-03 8.5280999510e-03 1.1956274628e-01 8.5281362568e-03 -1.0409378344e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.2445738619e-04 2.9370300000e+02
5200 -1.0497828441e-03 8.4135726131e-03 0.0000000000e+00 0.0000000000e+00 8.4135726131e-03 8.4135356877e-03 1.1105352501e-01 8.4135726131e-03 -1.0497828441e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.1658208534e-04 2.9942500000e+02
5300 -1.0591112697e-03 8.3032231475e-03 0.0000000000e+00 0.0000000000e+00 8.3032231475e-03 8.3031855629e-03 1.0282755398e-01 8.3032231475e-03 -1.0591112697e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.0890582126e-04 3.0513600000e+02
5400 -1.0689231456e-03 8.1968697300e-03 0.0000000000e+00 0.0000000000e+00 8.1968697300e-03 8.1968314458e-03 9.4897335336e-02 8.1968697300e-03 -1.0689231456e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.0143795820e-04 3.1084000000e+02
5500 -1.0792169409e-03 8.0943091935e-03 0.0000000000e+00 0.0000000000e+00 8.0943091935e-03 8.0942701684e-03 8.7273242838e-02 8.0943091935e-03 -1.0792169409e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -9.4186762160e-05 3.1654000000e+02
5600 -1.0899895250e-03 7.9953520601e-03 0.0000000000e+00 0.0000000000e+00 7.9953520601e-03 7.9953122520e-03 7.9963470574e-02 7.9953520601e-03 -1.0899895250e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -8.7159345310e-05 3.2224900000e+02
5700 -1.1012361616e-03 7.8998213950e-03 0.0000000000e+00 0.0000000000e+00 7.8998213950e-03 7.8997807612e-03 7.2974023412e-02 7.8998213950e-03 -1.1012361616e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -8.0361633439e-05 3.2793800000e+02
5800 -1.1129505342e-03 7.8075517745e-03 0.0000000000e+00 0.0000000000e+00 7.8075517745e-03 7.8075102716e-03 6.6308748594e-02 7.8075517745e-03 -1.1129505342e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -7.3798357170e-05 3.3366200000e+02
5900 -1.1251247963e-03 7.7183883554e-03 0.0000000000e+00 0.0000000000e+00 7.7183883554e-03 7.7183459396e-03 5.9969402778e-02 7.7183883554e-03 -1.1251247963e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -6.7473062085e-05 3.3938900000e+02
6000 -1.1377496365e-03 7.6321860333e-03 0.0000000000e+00 0.0000000000e+00 7.6321860333e-03 7.6321426603e-03 5.3955747546e-02 7.6321860333e-03 -1.1377496365e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -6.1388132160e-05 3.4511600000e+02
6100 -1.1508143670e-03 7.5488086806e-03 0.0000000000e+00 0.0000000000e+00 7.5488086806e-03 7.5487643057e-03 4.8265674212e-02 7.5488086806e-03 -1.1508143670e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -5.5544831316e-05 3.5083000000e+02
6200 -1.1643070260e-03 7.4681284548e-03 0.0000000000e+00 0.0000000000e+00 7.4681284548e-03 7.4680830333e-03 4.2895349689e-02 7.4681284548e-03 -1.1643070260e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -4.9943357025e-05 3.5655700000e+02
6300 -1.1782144919e-03 7.3900251712e-03 0.0000000000e+00 0.0000000000e+00 7.3900251712e-03 7.3899786581e-03 3.7839377806e-02 7.3900251712e-03 -1.1782144919e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -4.4582903295e-05 3.6226700000e+02
6400 -1.1925226032e-03 7.3143857316e-03 0.0000000000e+00 0.0000000000e+00 7.3143857316e-03 7.3143380819e-03 3.3090970455e-02 7.3143857316e-03 -1.1925226032e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -3.9461730229e-05 3.6797500000e+02
6500 -1.2072162831e-03 7.2411036030e-03 0.0000000000e+00 0.0000000000e+00 7.2411036030e-03 7.2410547718e-03 2.8642124346e-02 7.2411036030e-03 -1.2072162831e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -3.4577238894e-05 3.7369200000e+02
6600 -1.2222796670e-03 7.1700783431e-03 0.0000000000e+00 0.0000000000e+00 7.1700783431e-03 7.1700282858e-03 2.4483798878e-02 7.1700783431e-03 -1.2222796670e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.9926049540e-05 3.7939200000e+02
6700 -1.2376962344e-03 7.1012151660e-03 0.0000000000e+00 0.0000000000e+00 7.1012151660e-03 7.1011638380e-03 2.0606094572e-02 7.1012151660e-03 -1.2376962344e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.5504085657e-05 3.8511400000e+02
6800 -1.2534489289e-03 7.0344245448e-03 0.0000000000e+00 0.0000000000e+00 7.0344245448e-03 7.0343719019e-03 1.6998418433e-02 7.0344245448e-03 -1.2534489289e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.1306649378e-05 3.9080200000e+02
6900 -1.2695202855e-03 6.9696218475e-03 0.0000000000e+00 0.0000000000e+00 6.9696218475e-03 6.9695678460e-03 1.3649648970e-02 6.9696218475e-03 -1.2695202855e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.7328506257e-05 3.9650400000e+02
7000 -1.2858925483e-03 6.9067270028e-03 0.0000000000e+00 0.0000000000e+00 6.9067270028e-03 6.9066715995e-03 1.0548286124e-02 6.9067270028e-03 -1.2858925483e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.3563962524e-05 4.0222400000e+02
7100 -1.3025477854e-03 6.8456641936e-03 0.0000000000e+00 0.0000000000e+00 6.8456641936e-03 6.8456073458e-03 7.6825916121e-03 6.8456641936e-03 -1.3025477854e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.0006942690e-05 4.0793700000e+02
7200 -1.3194679938e-03 6.7863615741e-03 0.0000000000e+00 0.0000000000e+00 6.7863615741e-03 6.7863032398e-03 5.0407142600e-03 6.7863615741e-03 -1.3194679938e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -6.6510611317e-06 4.1364100000e+02
7300 -1.3366351960e-03 6.7287510106e-03 0.0000000000e+00 0.0000000000e+00 6.7287510106e-03 6.7286911484e-03 2.6108016217e-03 6.7287510106e-03 -1.3366351960e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -3.4896893374e-06 4.1936400000e+02
7400 -1.3540315276e-03 6.6727678410e-03 0.0000000000e+00 0.0000000000e+00 6.6727678410e-03 6.6727064105e-03 3.8109749887e-04 6.6727678410e-03 -1.3540315276e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -5.1601802857e-07 4.2507800000e+02
7500 -1.3716393216e-03 6.6183506544e-03 0.0000000000e+00 0.0000000000e+00 6.6183506544e-03 6.6182876159e-03 -1.6599713293e-03 6.6183506544e-03 -1.3716393216e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.2768819480e-06 4.3080000000e+02
7600 -1.3894411780e-03 6.5654410862e-03 0.0000000000e+00 0.0000000000e+00 6.5654410862e-03 6.5653764007e-03 -3.5237256022e-03 6.5654410862e-03 -1.3894411780e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 4.8960094515e-06 4.3651000000e+02
7700 -1.4074200166e-03 6.5139836290e-03 0.0000000000e+00 0.0000000000e+00 6.5139836290e-03 6.5139172587e-03 -5.2211782547e-03 6.5139836290e-03 -1.4074200166e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 7.3483907857e-06 4.4222700000e+02
7800 -1.4255591353e-03 6.4639254580e-03 0.0000000000e+00 0.0000000000e+00 6.4639254580e-03 6.4638573658e-03 -6.7629851783e-03 6.4639254580e-03 -1.4255591353e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 9.6410353027e-06 4.4793000000e+02
7900 -1.4438422527e-03 6.4152162682e-03 0.0000000000e+00 0.0000000000e+00 6.4152162682e-03 6.4151464182e-03 -8.1594095683e-03 6.4152162682e-03 -1.4438422527e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.1780900292e-05 4.5364600000e+02
8000 -1.4622535459e-03 6.3678081243e-03 0.0000000000e+00 0.0000000000e+00 6.3678081243e-03 6.3677364817e-03 -9.4202945844e-03 6.3678081243e-03 -1.4622535459e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.3774859160e-05 4.5934900000e+02
8100 -1.4807776798e-03 6.3216553209e-03 0.0000000000e+00 0.0000000000e+00 6.3216553209e-03 6.3215818515e-03 -1.0555044643e-02 6.3216553209e-03 -1.4807776798e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.5629674516e-05 4.6507300000e+02
8200 -1.4993998299e-03 6.2767142521e-03 0.0000000000e+00 0.0000000000e+00 6.2767142521e-03 6.2766389232e-03 -1.1572614073e-02 6.2767142521e-03 -1.4993998299e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.7351975573e-05 4.7080300000e+02
8300 -1.5181057096e-03 6.2329432912e-03 0.0000000000e+00 0.0000000000e+00 6.2329432912e-03 6.2328660711e-03 -1.2481497641e-02 6.2329432912e-03 -1.5181057096e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.8948232834e-05 4.7652900000e+02
8400 -1.5368815803e-03 6.1903026778e-03 0.0000000000e+00 0.0000000000e+00 6.1903026778e-03 6.1902235357e-03 -1.3289731960e-02 6.1903026778e-03 -1.5368815803e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.0424744256e-05 4.8235000000e+02
8500 -1.5557142651e-03 6.1487544130e-03 0.0000000000e+00 0.0000000000e+00 6.1487544130e-03 6.1486733195e-03 -1.4004897197e-02 6.1487544130e-03 -1.5557142651e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.1787618351e-05 4.8810400000e+02
8600 -1.5745911434e-03 6.1082621617e-03 0.0000000000e+00 0.0000000000e+00 6.1082621617e-03 6.1081790882e-03 -1.4634130063e-02 6.1082621617e-03 -1.5745911434e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.3042771589e-05 4.9381900000e+02
8700 -1.5935001563e-03 6.0687911608e-03 0.0000000000e+00 0.0000000000e+00 6.0687911608e-03 6.0687060802e-03 -1.5184131181e-02 6.0687911608e-03 -1.5935001563e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.4195915411e-05 4.9954100000e+02
8800 -1.6124298064e-03 6.0303081345e-03 0.0000000000e+00 0.0000000000e+00 6.0303081345e-03 6.0302210205e-03 -1.5661178229e-02 6.0303081345e-03 -1.6124298064e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.5252550580e-05 5.0524200000e+02
8900 -1.6313691505e-03 5.9927812141e-03 0.0000000000e+00 0.0000000000e+00 5.9927812141e-03 5.9926920415e-03 -1.6071141620e-02 5.9927812141e-03 -1.6313691505e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.6217964652e-05 5.1094900000e+02
9000 -1.6503077891e-03 5.9561798633e-03 0.0000000000e+00 0.0000000000e+00 5.9561798633e-03 5.9560886083e-03 -1.6419502061e-02 5.9561798633e-03 -1.6503077891e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.7097232145e-05 5.1665900000e+02
9100 -1.6692358607e-03 5.9204748086e-03 0.0000000000e+00 0.0000000000e+00 5.9204748086e-03 5.9203814484e-03 -1.6711365555e-02 5.9204748086e-03 -1.6692358607e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.7895210666e-05 5.2237800000e+02
9200 -1.6881440290e-03 5.8856379737e-03 0.0000000000e+00 0.0000000000e+00 5.8856379737e-03 5.8855424864e-03 -1.6951482540e-02 5.8856379737e-03 -1.6881440290e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.8616544032e-05 5.2810200000e+02
9300 -1.7070234662e-03 5.8516424177e-03 0.0000000000e+00 0.0000000000e+00 5.8516424177e-03 5.8515447827e-03 -1.7144267189e-02 5.8516424177e-03 -1.7070234662e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.9265666403e-05 5.3381000000e+02
9400 -1.7258658376e-03 5.8184622782e-03 0.0000000000e+00 0.0000000000e+00 5.8184622782e-03 5.8183624759e-03 -1.7293816051e-02 5.8184622782e-03 -1.7258658376e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.9846806324e-05 5.3951100000e+02
9500 -1.7446632897e-03 5.7860727165e-03 0.0000000000e+00 0.0000000000e+00 5.7860727165e-03 5.7859707284e-03 -1.7403924267e-02 5.7860727165e-03 -1.7446632897e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.0363987765e-05 5.4522000000e+02
9600 -1.7634084304e-03 5.7544498670e-03 0.0000000000e+00 0.0000000000e+00 5.7544498670e-03 5.7543456755e-03 -1.7478105987e-02 5.7544498670e-03 -1.7634084304e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.0821039445e-05 5.5094700000e+02
9700 -1.7820943115e-03 5.7235707893e-03 0.0000000000e+00 0.0000000000e+00 5.7235707893e-03 5.7234643779e-03 -1.7519610680e-02 5.7235707893e-03 -1.7820943115e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1221598532e-05 5.5664500000e+02
9800 -1.8007144144e-03 5.6934134234e-03 0.0000000000e+00 0.0000000000e+00 5.6934134234e-03 5.6933047768e-03 -1.7531439727e-02 5.6934134234e-03 -1.8007144144e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1569116223e-05 5.6234500000e+02
9900 -1.8192626343e-03 5.6639565472e-03 0.0000000000e+00 0.0000000000e+00 5.6639565472e-03 5.6638456508e-03 -1.7516361642e-02 5.6639565472e-03 -1.8192626343e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1866862225e-05 5.6806400000e+02
10000 -1.8377332664e-03 5.6351797365e-03 0.0000000000e+00 0.0000000000e+00 5.6351797365e-03 5.6350665769e-03 -1.7476926839e-02 5.6351797365e-03 -1.8377332664e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2117929846e-05 5.7376800000e+02
10100 -1.8561209856e-03 5.6070633276e-03 0.0000000000e+00 0.0000000000e+00 5.6070633276e-03 5.6069478922e-03 -1.7415483461e-02 5.6070633276e-03 -1.8561209856e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2325244326e-05 5.7948400000e+02
10200 -1.8744208313e-03 5.5795883817e-03 0.0000000000e+00 0.0000000000e+00 5.5795883817e-03 5.5794706588e-03 -1.7334190995e-02 5.5795883817e-03 -1.8744208313e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2491568696e-05 5.8519300000e+02
10300 -1.8926281894e-03 5.5527366514e-03 0.0000000000e+00 0.0000000000e+00 5.5527366514e-03 5.5526166304e-03 -1.7235033917e-02 5.5527366514e-03 -1.8926281894e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2619511037e-05 5.9089700000e+02
10400 -1.9107387771e-03 5.5264905491e-03 0.0000000000e+00 0.0000000000e+00 5.5264905491e-03 5.5263682202e-03 -1.7119833957e-02 5.5264905491e-03 -1.9107387771e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2711530599e-05 5.9661300000e+02
10500 -1.9287486269e-03 5.5008331173e-03 0.0000000000e+00 0.0000000000e+00 5.5008331173e-03 5.5007084715e-03 -1.6990262060e-02 5.5008331173e-03 -1.9287486269e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2769944619e-05 6.0232900000e+02
10600 -1.9466540709e-03 5.4757480002e-03 0.0000000000e+00 0.0000000000e+00 5.4757480002e-03 5.4756210293e-03 -1.6847849431e-02 5.4757480002e-03 -1.9466540709e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2796934681e-05 6.0804900000e+02
10700 -1.9644517272e-03 5.4512194168e-03 0.0000000000e+00 0.0000000000e+00 5.4512194168e-03 5.4510901137e-03 -1.6693997721e-02 5.4512194168e-03 -1.9644517272e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2794552657e-05 6.1376900000e+02
10800 -1.9821384809e-03 5.4272321362e-03 0.0000000000e+00 0.0000000000e+00 5.4272321362e-03 5.4271004942e-03 -1.6529990115e-02 5.4272321362e-03 -1.9821384809e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2764729496e-05 6.1948500000e+02
10900 -1.9997114736e-03 5.4037714532e-03 0.0000000000e+00 0.0000000000e+00 5.4037714532e-03 5.4036374666e-03 -1.6356999239e-02 5.4037714532e-03 -1.9997114736e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2709279053e-05 6.2519300000e+02
11000 -2.0171680894e-03 5.3808231655e-03 0.0000000000e+00 0.0000000000e+00 5.3808231655e-03 5.3806868295e-03 -1.6176095794e-02 5.3808231655e-03 -2.0171680894e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2629904247e-05 6.3093300000e+02
11100 -2.0345059424e-03 5.3583735529e-03 0.0000000000e+00 0.0000000000e+00 5.3583735529e-03 5.3582348632e-03 -1.5988256408e-02 5.3583735529e-03 -2.0345059424e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2528202669e-05 6.3664000000e+02
11200 -2.0517228627e-03 5.3364093564e-03 0.0000000000e+00 0.0000000000e+00 5.3364093564e-03 5.3362683094e-03 -1.5794371431e-02 5.3364093564e-03 -2.0517228627e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2405672967e-05 6.4235800000e+02
11300 -2.0688168855e-03 5.3149177587e-03 0.0000000000e+00 0.0000000000e+00 5.3149177587e-03 5.3147743517e-03 -1.5595251533e-02 5.3149177587e-03 -2.0688168855e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2263719705e-05 6.4811100000e+02
11400 -2.0857862372e-03 5.2938863666e-03 0.0000000000e+00 0.0000000000e+00 5.2938863666e-03 5.2937405973e-03 -1.5391634475e-02 5.2938863666e-03 -2.0857862372e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2103659356e-05 6.5381300000e+02
11500 -2.1026293290e-03 5.2733031927e-03 0.0000000000e+00 0.0000000000e+00 5.2733031927e-03 5.2731550597e-03 -1.5184189971e-02 5.2733031927e-03 -2.1026293290e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1926723169e-05 6.5954500000e+02
11600 -2.1193447434e-03 5.2531566396e-03 0.0000000000e+00 0.0000000000e+00 5.2531566396e-03 5.2530061419e-03 -1.4973525738e-02 5.2531566396e-03 -2.1193447434e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1734063062e-05 6.6526900000e+02
11700 -2.1359312258e-03 5.2334354835e-03 0.0000000000e+00 0.0000000000e+00 5.2334354835e-03 5.2332826210e-03 -1.4760192366e-02 5.2334354835e-03 -2.1359312258e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1526755774e-05 6.7101000000e+02
11800 -2.1523876743e-03 5.2141288599e-03 0.0000000000e+00 0.0000000000e+00 5.2141288599e-03 5.2139736329e-03 -1.4544687955e-02 5.2141288599e-03 -2.1523876743e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1305807081e-05 6.7672500000e+02
11900 -2.1687131320e-03 5.1952262489e-03 0.0000000000e+00 0.0000000000e+00 5.1952262489e-03 5.1950686581e-03 -1.4327462308e-02 5.1952262489e-03 -2.1687131320e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1072155656e-05 6.8242100000e+02
12000 -2.1849067733e-03 5.1767174616e-03 0.0000000000e+00 0.0000000000e+00 5.1767174616e-03 5.1765575086e-03 -1.4108922145e-02 5.1767174616e-03 -2.1849067733e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.0826679559e-05 6.8814600000e+02
12100 -2.2009679009e-03 5.1585926276e-03 0.0000000000e+00 0.0000000000e+00 5.1585926276e-03 5.1584303144e-03 -1.3889433358e-02 5.1585926276e-03 -2.2009679009e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.0570196982e-05 6.9386800000e+02
12200 -2.2168959370e-03 5.1408421824e-03 0.0000000000e+00 0.0000000000e+00 5.1408421824e-03 5.1406775114e-03 -1.3669324725e-02 5.1408421824e-03 -2.2168959370e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.0303470443e-05 6.9956800000e+02
12300 -2.2326904158e-03 5.1234568557e-03 0.0000000000e+00 0.0000000000e+00 5.1234568557e-03 5.1232898300e-03 -1.3448891095e-02 5.1234568557e-03 -2.2326904158e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.0027210252e-05 7.0527300000e+02
12400 -2.2483509757e-03 5.1064276605e-03 0.0000000000e+00 0.0000000000e+00 5.1064276605e-03 5.1062582834e-03 -1.3228396522e-02 5.1064276605e-03 -2.2483509757e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.9742078227e-05 7.1098700000e+02
12500 -2.2638773536e-03 5.0897458818e-03 0.0000000000e+00 0.0000000000e+00 5.0897458818e-03 5.0895741573e-03 -1.3008076577e-02 5.0897458818e-03 -2.2638773536e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.9448689977e-05 7.1669300000e+02
12600 -2.2792693789e-03 5.0734030673e-03 0.0000000000e+00 0.0000000000e+00 5.0734030673e-03 5.0732289998e-03 -1.2788140897e-02 5.0734030673e-03 -2.2792693789e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.9147617960e-05 7.2241800000e+02
12700 -2.2945269663e-03 5.0573910170e-03 0.0000000000e+00 0.0000000000e+00 5.0573910170e-03 5.0572146112e-03 -1.2568775600e-02 5.0573910170e-03 -2.2945269663e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.8839394548e-05 7.2815200000e+02
12800 -2.3096501118e-03 5.0417017741e-03 0.0000000000e+00 0.0000000000e+00 5.0417017741e-03 5.0415230352e-03 -1.2350145080e-02 5.0417017741e-03 -2.3096501118e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.8524513964e-05 7.3386300000e+02
12900 -2.3246388862e-03 5.0263276163e-03 0.0000000000e+00 0.0000000000e+00 5.0263276163e-03 5.0261465500e-03 -1.2132394216e-02 5.0263276163e-03 -2.3246388862e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.8203435377e-05 7.3957200000e+02
13000 -2.3394934303e-03 5.0112610472e-03 0.0000000000e+00 0.0000000000e+00 5.0112610472e-03 5.0110776596e-03 -1.1915649942e-02 5.0112610472e-03 -2.3394934303e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.7876584758e-05 7.4528900000e+02
13100 -2.3542139519e-03 4.9964947884e-03 0.0000000000e+00 0.0000000000e+00 4.9964947884e-03 4.9963090856e-03 -1.1700022614e-02 4.9964947884e-03 -2.3542139519e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.7544356476e-05 7.5102200000e+02
13200 -2.3688007177e-03 4.9820217711e-03 0.0000000000e+00 0.0000000000e+00 4.9820217711e-03 4.9818337600e-03 -1.1485608396e-02 4.9820217711e-03 -2.3688007177e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.7207117413e-05 7.5673900000e+02
13300 -2.3832540507e-03 4.9678351297e-03 0.0000000000e+00 0.0000000000e+00 4.9678351297e-03 4.9676448172e-03 -1.1272490078e-02 4.9678351297e-03 -2.3832540507e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.6865207640e-05 7.6246300000e+02
13400 -2.3975743271e-03 4.9539281937e-03 0.0000000000e+00 0.0000000000e+00 4.9539281937e-03 4.9537355873e-03 -1.1060738168e-02 4.9539281937e-03 -2.3975743271e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.6518941870e-05 7.6817200000e+02
13500 -2.4117619722e-03 4.9402944817e-03 0.0000000000e+00 0.0000000000e+00 4.9402944817e-03 4.9400995890e-03 -1.0850412211e-02 4.9402944817e-03 -2.4117619722e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.6168611554e-05 7.7387700000e+02
13600 -2.4258174566e-03 4.9269276942e-03 0.0000000000e+00 0.0000000000e+00 4.9269276942e-03 4.9267305234e-03 -1.0641561755e-02 4.9269276942e-03 -2.4258174566e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.5814486270e-05 7.7959000000e+02
13700 -2.4397412933e-03 4.9138217081e-03 0.0000000000e+00 0.0000000000e+00 4.9138217081e-03 4.9136222673e-03 -1.0434227394e-02 4.9138217081e-03 -2.4397412933e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.5456815436e-05 7.8531000000e+02
13800 -2.4535340340e-03 4.9009705700e-03 0.0000000000e+00 0.0000000000e+00 4.9009705700e-03 4.9007688678e-03 -1.0228441625e-02 4.9009705700e-03 -2.4535340340e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.5095829641e-05 7.9102600000e+02
13900 -2.4671962668e-03 4.8883684909e-03 0.0000000000e+00 0.0000000000e+00 4.8883684909e-03 4.8881645361e-03 -1.0024229684e-02 4.8883684909e-03 -2.4671962668e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.4731742054e-05 7.9673600000e+02
14000 -2.4807286124e-03 4.8760098404e-03 0.0000000000e+00 0.0000000000e+00 4.8760098404e-03 4.8758036421e-03 -9.8216103117e-03 4.8760098404e-03 -2.4807286124e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.4364749720e-05 8.0245600000e+02
14100 -2.4941317227e-03 4.8638891419e-03 0.0000000000e+00 0.0000000000e+00 4.8638891419e-03 4.8636807095e-03 -9.6205963662e-03 4.8638891419e-03 -2.4941317227e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.3995034589e-05 8.0815800000e+02
14200 -2.5074062782e-03 4.8520010669e-03 0.0000000000e+00 0.0000000000e+00 4.8520010669e-03 4.8517904099e-03 -9.4211953413e-03 4.8520010669e-03 -2.5074062782e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.3622764347e-05 8.1386000000e+02
14300 -2.5205529852e-03 4.8403404307e-03 0.0000000000e+00 0.0000000000e+00 4.8403404307e-03 4.8401275588e-03 -9.2234100622e-03 4.8403404307e-03 -2.5205529852e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.3248093766e-05 8.1956000000e+02
14400 -2.5335725731e-03 4.8289021872e-03 0.0000000000e+00 0.0000000000e+00 4.8289021872e-03 4.8286871105e-03 -9.0272395086e-03 4.8289021872e-03 -2.5335725731e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.2871166430e-05 8.2528200000e+02
14500 -2.5464657933e-03 4.8176814248e-03 0.0000000000e+00 0.0000000000e+00 4.8176814248e-03 4.8174641536e-03 -8.8326787591e-03 4.8176814248e-03 -2.5464657933e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.2492114323e-05 8.3100400000e+02
14600 -2.5592334170e-03 4.8066733621e-03 0.0000000000e+00 0.0000000000e+00 4.8066733621e-03 4.8064539067e-03 -8.6397197762e-03 4.8066733621e-03 -2.5592334170e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.2111059564e-05 8.3670000000e+02
14700 -2.5718762338e-03 4.7958733434e-03 0.0000000000e+00 0.0000000000e+00 4.7958733434e-03 4.7956517143e-03 -8.4483514954e-03 4.7958733434e-03 -2.5718762338e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.1728114426e-05 8.4240300000e+02
14800 -2.5843950498e-03 4.7852768348e-03 0.0000000000e+00 0.0000000000e+00 4.7852768348e-03 4.7850530429e-03 -8.2585604527e-03 4.7852768348e-03 -2.5843950498e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.1343382752e-05 8.4810500000e+02
14900 -2.5967906859e-03 4.7748794206e-03 0.0000000000e+00 0.0000000000e+00 4.7748794206e-03 4.7746534769e-03 -8.0703309067e-03 4.7748794206e-03 -2.5967906859e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.0956960131e-05 8.5382600000e+02
15000 -2.6090639762e-03 4.7646767996e-03 0.0000000000e+00 0.0000000000e+00 4.7646767996e-03 4.7644487150e-03 -7.8836453689e-03 4.7646767996e-03 -2.6090639762e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.0568935134e-05 8.5951300000e+02
15000 -2.6090639762e-03 4.7646767996e-03 0.0000000000e+00 0.0000000000e+00 4.7646767996e-03 4.7644487150e-03 -7.8836453689e-03 4.7646767996e-03 -2.6090639762e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.0568935134e-05 8.5988300000e+02

Binary file not shown.

View File

@ -0,0 +1,23 @@
# MeshFile : ./grid/test_grid.fts
# Reynolds : 2.000000e+05 1/m
# Mach : 0.1
# Alpha : 0 degree
# Beta : 0 degree
# Wall Temperature : Adiabatic Wall
# gridScaleFactor : 1
# forceRefenenceLength : 1 m
# forceRefenenceLengthSpanWise : 1 m
# forceRefenenceArea : 1 m^2
# TorqueRefX : 0
# TorqueRefY : 0
# TorqueRefZ : 0
# iter : 15000
# CA CN CZ1 Cml Cmn Cm
# CA_p CN_p CZ1_p Cml_p Cmn_p Cm_p
# CA_f CN_f CZ1_f Cml_f Cmn_f Cm_f
*whole
4.7646767996e-03 -2.6090639762e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.0568935134e-05
0.0000000000e+00 -2.6136228742e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.0528411267e-05
4.7646767996e-03 4.5588979508e-06 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 4.0523866064e-08

View File

@ -0,0 +1,13 @@
# MeshFile : ./grid/test_grid.fts
# Reynolds : 2.000000e+05 1/m
# Mach : 0.1
# Alpha : 0 degree
# Beta : 0 degree
# Wall Temperature : Adiabatic Wall
# gridScaleFactor : 1
# iter : 15000
# CA CN CZ1 Cml Cmn Cm
# CA_p CN_p CZ1_p Cml_p Cmn_p Cm_p
# CA_f CN_f CZ1_f Cml_f Cmn_f Cm_f
# CMh

View File

@ -0,0 +1,35 @@
This grid file is new HDF5 version!
Global grid files number: 1
Max processor ID : 1 of total zone 1, Zones' distribution is specified by partition ...
Zone index in current processor : 0
0.007 seconds: Grid Reading
Start Swapping Zone Neighbors Information!
Start broadcasting neighbor information to neighbor zones using new method...
End broadcasting neighbor information to neighbor zones by new method...
0.001 seconds: Neighbor zone information BCast
Start SwapNeighborsSendContent ...
End SwapNeighborsSendContent ...
0.000 seconds: Swap Neighbor Send Content
End Swapping Zone Neighbors Information!
The most valid multi-grid level is: 3
Change boundary condition ...
Monitoring probes ...
Swap geommetry sucessfully ...
Creating and initialization solvers start
Creating and initialization solvers over
Multi-Grid Init Flow ...
Start iterating ...
----- Time statistics -----
Wall time = 860.250
----- End time statistics -----
Job Done.

File diff suppressed because it is too large Load Diff

View File

Binary file not shown.

File diff suppressed because it is too large Load Diff

View File

@ -0,0 +1,196 @@
title="Wall Aircoef Data of PHengLEI"
variables="x", "y", "z", "cp", "cf", "yplus", "Q_NonDim", "Q_Dim(kW/m2)", "pw(Pa)"
zone T = "Zone0"
I = 101
J = 1
K = 1
f = BLOCK
0.0000000000e+00 1.1998839555e-02 2.3997702552e-02 3.5996588990e-02 4.7995498871e-02
5.9994432195e-02 7.1993388959e-02 8.3992369166e-02 9.5991372815e-02 1.0799039991e-01
1.1998945044e-01 1.3198852441e-01 1.4398762183e-01 1.5598674269e-01 1.6798588699e-01
1.7998505474e-01 1.9198424593e-01 2.0398346056e-01 2.1598269863e-01 2.2798196014e-01
2.3998124510e-01 2.5198055350e-01 2.6397988535e-01 2.7597924063e-01 2.8797861936e-01
2.9997802153e-01 3.1197744715e-01 3.2397689620e-01 3.3597636871e-01 3.4797586465e-01
3.5997538404e-01 3.7197492687e-01 3.8397449314e-01 3.9597408286e-01 4.0797369602e-01
4.1997333262e-01 4.3197299267e-01 4.4397267616e-01 4.5597238309e-01 4.6797211347e-01
4.7997186729e-01 4.9197164455e-01 5.0397144526e-01 5.1597126941e-01 5.2797111701e-01
5.3997098805e-01 5.5197088253e-01 5.6397080045e-01 5.7597074183e-01 5.8797070664e-01
5.9997069490e-01 6.1197070660e-01 6.2397074175e-01 6.3597080034e-01 6.4797088238e-01
6.5997098786e-01 6.7197111678e-01 6.8397126915e-01 6.9597144496e-01 7.0797164422e-01
7.1997186692e-01 7.3197211307e-01 7.4397238266e-01 7.5597267569e-01 7.6797299217e-01
7.7997333210e-01 7.9197369547e-01 8.0397408228e-01 8.1597449254e-01 8.2797492625e-01
8.3997538340e-01 8.5197586399e-01 8.6397636803e-01 8.7597689551e-01 8.8797744644e-01
8.9997802082e-01 9.1197861864e-01 9.2397923990e-01 9.3597988461e-01 9.4798055277e-01
9.5998124437e-01 9.7198195942e-01 9.8398269791e-01 9.9598345985e-01 1.0079842452e+00
1.0199850541e+00 1.0319858863e+00 1.0439867421e+00 1.0559876212e+00 1.0679885238e+00
1.0799894499e+00 1.0919903994e+00 1.1039913723e+00 1.1159923687e+00 1.1279933886e+00
1.1399944319e+00 1.1519954986e+00 1.1639965888e+00 1.1759977024e+00 1.1879988395e+00
1.2000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00
6.8138215682e-02 4.8032711779e-02 2.2750559539e-02 1.4911903621e-02 1.1004617830e-02
8.9426966948e-03 7.6407922062e-03 6.7944407357e-03 6.1535346230e-03 5.6343389215e-03
5.1843121215e-03 4.7835771358e-03 4.4208503901e-03 4.0908496543e-03 3.7900543639e-03
3.5159414391e-03 3.2662917806e-03 3.0390561013e-03 2.8322691273e-03 2.6440491742e-03
2.4726060816e-03 2.3162579952e-03 2.1734448489e-03 2.0427377753e-03 1.9228428271e-03
1.8125995043e-03 1.7109748694e-03 1.6170544869e-03 1.5300314312e-03 1.4491944862e-03
1.3739164427e-03 1.3036431096e-03 1.2378834098e-03 1.1762007151e-03 1.1182054148e-03
1.0635486321e-03 1.0119169333e-03 9.6302787500e-04 9.1662624028e-04 8.7248082794e-04
8.3038169134e-04 7.9013774491e-04 7.5157466561e-04 7.1453304687e-04 6.7886676655e-04
6.4444153352e-04 6.1113359254e-04 5.7882856723e-04 5.4742042327e-04 5.1681053444e-04
4.8690684075e-04 4.5762308291e-04 4.2887811152e-04 4.0059524666e-04 3.7270169213e-04
3.4512799256e-04 3.1780752036e-04 2.9067599726e-04 2.6367103277e-04 2.3673167999e-04
2.0979800493e-04 1.8281065415e-04 1.5571042707e-04 1.2843783743e-04 1.0093266295e-04
7.3133475112e-05 4.4977138117e-05 1.6398271470e-05 -1.2671341523e-05 -4.2303411348e-05
-7.2573880459e-05 -1.0356374678e-04 -1.3535998029e-04 -1.6805652855e-04 -2.0175544554e-04
-2.3656823370e-04 -2.7261758279e-04 -3.1003978958e-04 -3.4898810162e-04 -3.8963693709e-04
-4.3218628998e-04 -4.7686480104e-04 -5.2392967477e-04 -5.7366314229e-04 -6.2637006988e-04
-6.8238960773e-04 -7.4214229015e-04 -8.0623100665e-04 -8.7558862245e-04 -9.5159324789e-04
-1.0360096370e-03 -1.1305318354e-03 -1.2360582211e-03 -1.3518254455e-03 -1.4768646422e-03
-1.6118021833e-03 -1.7727808502e-03 -1.9760179209e-03 -2.3015335555e-03 -2.6597778952e-03
-2.8048762197e-03
7.9129364792e-02 4.9086239867e-02 1.5332386118e-02 1.0165296846e-02 7.9854749000e-03
6.8308584348e-03 6.1042679911e-03 5.5880305119e-03 5.1926774687e-03 4.8752986765e-03
4.6128349242e-03 4.3913490200e-03 4.2017309399e-03 4.0376142484e-03 3.8943415106e-03
3.7683768588e-03 3.6569607148e-03 3.5578910196e-03 3.4693801766e-03 3.3899573618e-03
3.3183998183e-03 3.2536828979e-03 3.1949426498e-03 3.1414469880e-03 3.0925729207e-03
3.0477882104e-03 3.0066363967e-03 2.9687244607e-03 2.9337126219e-03 2.9013058874e-03
2.8712470543e-03 2.8433109187e-03 2.8172994829e-03 2.7930379852e-03 2.7703716029e-03
2.7491627037e-03 2.7292885448e-03 2.7106393344e-03 2.6931165919e-03 2.6766317505e-03
2.6611049628e-03 2.6464640727e-03 2.6326437294e-03 2.6195846186e-03 2.6072327953e-03
2.5955391016e-03 2.5844586579e-03 2.5739504177e-03 2.5639767753e-03 2.5545032213e-03
2.5454980383e-03 2.5369320311e-03 2.5287782888e-03 2.5210119718e-03 2.5136101236e-03
2.5065515024e-03 2.4998164302e-03 2.4933866589e-03 2.4872452493e-03 2.4813764631e-03
2.4757656660e-03 2.4703992399e-03 2.4652645053e-03 2.4603496501e-03 2.4556436669e-03
2.4511362957e-03 2.4468179741e-03 2.4426797915e-03 2.4387134495e-03 2.4349112272e-03
2.4312659504e-03 2.4277709654e-03 2.4244201179e-03 2.4212077358e-03 2.4181286209e-03
2.4151780468e-03 2.4123517681e-03 2.4096460344e-03 2.4070576047e-03 2.4045837527e-03
2.4022222617e-03 2.3999714323e-03 2.3978301641e-03 2.3957982080e-03 2.3938766656e-03
2.3920686684e-03 2.3903798617e-03 2.3888179800e-03 2.3873907923e-03 2.3861028619e-03
2.3849541698e-03 2.3839482809e-03 2.3831178926e-03 2.3825740589e-03 2.3825447362e-03
2.3833794295e-03 2.3852959743e-03 2.3882285411e-03 2.3906066955e-03 2.3902945634e-03
2.3893047836e-03
3.9534005408e+24 2.9469371949e+24 1.7287401199e+24 1.4154572226e+24 1.2571171113e+24
1.1637634041e+24 1.1006944620e+24 1.0534706229e+24 1.0157505794e+24 9.8438056412e+23
9.5763360346e+23 9.3444782374e+23 9.1411757537e+23 8.9613979422e+23 8.8013832394e+23
8.6582062268e+23 8.5295251897e+23 8.4134221528e+23 8.3082990143e+23 8.2128069047e+23
8.1257967283e+23 8.0462831528e+23 7.9734174115e+23 7.9064659596e+23 7.8447931628e+23
7.7878468959e+23 7.7351463638e+23 7.6862717205e+23 7.6408552078e+23 7.5985736062e+23
7.5591418333e+23 7.5223075357e+23 7.4878465373e+23 7.4555590119e+23 7.4252662641e+23
7.3968080149e+23 7.3700401032e+23 7.3448325302e+23 7.3210677863e+23 7.2986394115e+23
7.2774507515e+23 7.2574138767e+23 7.2384486405e+23 7.2204818553e+23 7.2034465696e+23
7.1872814331e+23 7.1719301356e+23 7.1573409129e+23 7.1434661080e+23 7.1302617828e+23
7.1176873722e+23 7.1057053766e+23 7.0942810870e+23 7.0833823396e+23 7.0729792958e+23
7.0630442451e+23 7.0535514277e+23 7.0444768755e+23 7.0357982686e+23 7.0274948055e+23
7.0195470874e+23 7.0119370121e+23 7.0046476798e+23 6.9976633072e+23 6.9909691505e+23
6.9845514365e+23 6.9783973003e+23 6.9724947306e+23 6.9668325211e+23 6.9614002277e+23
6.9561881318e+23 6.9511872089e+23 6.9463891030e+23 6.9417861081e+23 6.9373711595e+23
6.9331378360e+23 6.9290803762e+23 6.9251937023e+23 6.9214734441e+23 6.9179159499e+23
6.9145182815e+23 6.9112782281e+23 6.9081944262e+23 6.9052667255e+23 6.9024969115e+23
6.8998896888e+23 6.8974533833e+23 6.8951993335e+23 6.8931389260e+23 6.8912789135e+23
6.8896194188e+23 6.8881657265e+23 6.8869651999e+23 6.8861784506e+23 6.8861349753e+23
6.8873397222e+23 6.8901062905e+23 6.8943380596e+23 6.8977663478e+23 6.8973122301e+23
6.8958833171e+23
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00
8.7030492192e+03 8.7018249488e+03 8.7002854604e+03 8.6998081466e+03 8.6995702229e+03
8.6994446678e+03 8.6993653919e+03 8.6993138556e+03 8.6992748293e+03 8.6992432143e+03
8.6992158111e+03 8.6991914095e+03 8.6991693222e+03 8.6991492277e+03 8.6991309116e+03
8.6991142202e+03 8.6990990185e+03 8.6990851816e+03 8.6990725898e+03 8.6990611287e+03
8.6990506891e+03 8.6990411687e+03 8.6990324725e+03 8.6990245134e+03 8.6990172128e+03
8.6990104998e+03 8.6990043116e+03 8.6989985926e+03 8.6989932936e+03 8.6989883712e+03
8.6989837874e+03 8.6989795083e+03 8.6989755040e+03 8.6989717480e+03 8.6989682165e+03
8.6989648884e+03 8.6989617444e+03 8.6989587674e+03 8.6989559419e+03 8.6989532538e+03
8.6989506903e+03 8.6989482398e+03 8.6989458916e+03 8.6989436360e+03 8.6989414642e+03
8.6989393680e+03 8.6989373398e+03 8.6989353726e+03 8.6989334601e+03 8.6989315962e+03
8.6989297753e+03 8.6989279922e+03 8.6989262418e+03 8.6989245196e+03 8.6989228211e+03
8.6989211421e+03 8.6989194785e+03 8.6989178264e+03 8.6989161820e+03 8.6989145416e+03
8.6989129015e+03 8.6989112582e+03 8.6989096080e+03 8.6989079473e+03 8.6989062725e+03
8.6989045797e+03 8.6989028652e+03 8.6989011250e+03 8.6988993549e+03 8.6988975505e+03
8.6988957073e+03 8.6988938202e+03 8.6988918841e+03 8.6988898931e+03 8.6988878411e+03
8.6988857213e+03 8.6988835261e+03 8.6988812474e+03 8.6988788758e+03 8.6988764006e+03
8.6988738096e+03 8.6988710891e+03 8.6988682232e+03 8.6988651948e+03 8.6988619853e+03
8.6988585742e+03 8.6988549357e+03 8.6988510332e+03 8.6988468098e+03 8.6988421817e+03
8.6988370414e+03 8.6988312858e+03 8.6988248600e+03 8.6988178107e+03 8.6988101968e+03
8.6988019801e+03 8.6987921777e+03 8.6987798022e+03 8.6987599808e+03 8.6987381665e+03
8.6987293311e+03

View File

@ -0,0 +1,27 @@
//! #########################################################################
//! # grid Contorl #
//! #########################################################################
//! gridDatabaseIndex: Controls the type of geometry to generate.
//! 1 -- Square for Taylor-Green Vortex with periodic boundary condition.
//! 2 -- Flat plate boundary layer with 1 part.
//! 3 -- Flat plate boundart later with 2 parts.
//! 4 -- Poiseuille flow.
//int gridDataBaseIndex = 1;
//string gridDataBaseFileName = "./bin/GridDataBase_TaylorGreenVortex.hypara";
//int gridDataBaseIndex = 2;
//string gridDataBaseFileName = "./bin/GridDataBase_Flat_Plate_Boundary_Layer_1_part.hypara";
int gridDataBaseIndex = 3;
string gridDataBaseFileName = "./bin/GridDataBase_Flat_Plate_Boundary_Layer_2_part.hypara";
//! gridOutputFile: The name of output grid.
string gridOutputFile = "./grid/test_grid.fts";
//! gridType: The type of grid, which will genetrate.
//! 1 -- Struct grid.
//! 2 -- Unstruct grid.
int gridType = 1;
//! gridOutputType: The type of grid output model.
//! 0 -- No grid output.
//! 1 -- fts file.
int gridOutputType = 1;

View File

@ -0,0 +1,14 @@
//! Generate Supsonic Flat Plate Grid
int nBlocks = 1;
int nNodeX = 101;
int nNodeY = 69;
int nNodeZ = 1;
double lengthX = 1.2;
double lengthY = 0.8;
double lengthZ = 0;
double xCoefDelta = 0.012;
double yCoefDelta = 1e-5;

View File

@ -0,0 +1,21 @@
//! Generate Supsonic Flat Plate Grid
int nBlocks = 1;
int nNodeX = 200;
int nNodeY = 81;
int nNodeZ = 1;
int nNodePart1X = 33;
int nNodePart1Y = 40;
double lengthX = 8;
double lengthY = 4;
double lengthZ = 0;
double lengthPart1X = 2;
double lengthPart1Y = 1;
double xCoefDelta1 = 0.0606;
double xCoefDelta2 = 0.05;
double yCoefDelta2 = 0.025;

View File

@ -0,0 +1,923 @@
//+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++
// 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.
// 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.
string from_gfile = "./grid/rae2822_hybrid2d.cas";
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 iale = 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.
// ----------------- RBF Parameters -------------------------------------
// symmetryPlane: Which symmetry plane is used in the mesh.
// 0 -- without symmetry.
// 1 -- plane of x=0.
// 2 -- plane of y=0.
// 3 -- plane of z=0.
int numberOfReferenceCP = 10;
double influenceRadius = 20;
int symmetryPlane = 3; // 1: plane of x=0; 2: plane of y=0; 3: plane of z=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.
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.
// parallelPartMethod: 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.
// 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.
// forceRefenenceLength, forceRefenenceLengthSpanWise, forceRefenenceArea: 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.
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 = 10000.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;
double wallTemperature = -1.0;
double radiationCoef = 0.8;
double gridScaleFactor = 1.0;
int numberOfAerodynamicForceComponents = 1;
double forceRefenenceLengthSpanWise = 1.0; // unit of meter.
double forceRefenenceLength = 1.0; // unit of meter.
double forceRefenenceArea = 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.
//-----------------------------------------------------------------------
# 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".
// 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", "ausmpwplus".
// 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".
// uns_gradient: 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 DES simulation.
// startStatisticStep: Outer step when start statistics.
// when the value is larger than "maxSimuStep", it is useless.
// 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 startStatisticStep = 800000;
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 codeOfAleModel = 0;
int aleStartStrategy = -1;
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";
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 probesflowfile = "results/sample.dat";
int nDumpSurfaceInfo = 0;
string wall_varfile = "";
string jetDefineFile = "bin/jet.hypara";
string overset_gridfile = "results/iblank.ovs";
string sixDofFileName = "results/sixDofInfo.dat";
int plotFieldType = 0;
// visualfileType: The file type of visualfile.
// 0 -- Tecplot binary.
// 1 -- Tecplot ASCII.
int visualfileType = 1;
// 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";
// min-max box of the visual block.
double lowerPlotFieldBox[] = [0.0 0.0 0.0];
double upperPlotFieldBox[] = [1.0 1.0 1.0];
// 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).
// 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];
// 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 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;
# 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";
// = "dsm";
// = "wale".
// 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.135;
double isotropicConstant = 0.0;
double waleConstant = 0.6;
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.
// 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 dg_high_order = 0;
int iapplication = 0;
int iCodeBranch = 0;
int nm = 5;
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 nChemicalFlowStep = 0;
double catalyticCoef = 0.0;
string gasfile = "DK5";
//string gasfile = "./chemical/Dunn-Kang_air5s11r.dat";
string speciesName = "O, O2, NO, N, N2";
string initMassFraction = "0.0, 0.23, 0.0, 0.0, 0.77";
//string speciesName = "O, O2, NO, N, NO+, N2, e-";
//string initMassFraction = "0.0, 0.23, 0.0, 0.0, 0.0, 0.77, 0.0";
//string speciesName = "O, O2, NO, N, O+, O2+, NO+, N+, N2+, N2, e-";
//string initMassFraction = "0.0, 0.23, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.77, 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";
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 #
#########################################################################
// ifvfd:
// 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 ifvfd = 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.
int codeOfOversetGrid = 0;
int codeOfOversetSlipGrid = 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/overlap.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;
// ---------------- ATP read --------------------------------------------
//@int inflowParaType = 0;
//@double refReNumber = 2.329418E08;
//@double refDimensionalTemperature = 288.144;
//@double refDimensionalPressure = 1.01313E05;
//@double height = -0.001;
//@int nsubsonicInlet = 0;
//@int nsubsonicOutlet = 0;
//@string inLetFileName = "./bin/subsonicInlet.hypara";
//@string outLetFileName = "./bin/subsonicOutlet.hypara";
#########################################################################
# Old Parameter #
#########################################################################
int isPlotVolumeField = 0;

View File

@ -0,0 +1,197 @@
#########################################################################
# 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 = 15000;
int intervalStepFlow = 100;
int intervalStepPlot = 100;
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.
// 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.1;
double attackd = 0.00;
double angleSlide = 0.00;
int inflowParaType = 0;
double refReNumber = 2.0e5;
double refDimensionalTemperature = 288.15;
//int inflowParaType = 1;
//double height = 0.001;
double gridScaleFactor = 1.0;
double forceRefenenceLengthSpanWise = 1.0; // unit of meter.
double forceRefenenceLength = 1.0; // unit of meter.
double forceRefenenceArea = 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 = "nolim";
#*******************************************************************
# 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 = 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/test_grid.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;
double MUSCLCoefXk = 0.333333;

View File

@ -0,0 +1,39 @@
#########################################################################
# 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/rae2822_hybrid2d.cgns";
string out_gfile = "./grid/rae2822_hybrid2d.fts";
// 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.
// 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.
int gridobj = 0;

View File

@ -0,0 +1,53 @@
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 = 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 numberOfGridProcessor = 0;
// ATP read
//@string parafilename1 = ""
//@string parafilename2 = "";

View File

@ -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/flat_laminar_73_81.fts";
string partition_grid_file = "./grid/flat_laminar_73_81.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;

Binary file not shown.

Binary file not shown.

View File

@ -0,0 +1,168 @@
Title="THE AIRCOEF"
Variables=
iter
<i>C<sub>L</sub></i>
<i>C<sub>D</sub></i>
<i>C<sub>Z</sub></i>
<i>C<sub>D_p</sub></i>
<i>C<sub>D_f</sub></i>
<i>C<sub>D</sub></i>-<i>C<sub>L</sub></i><sup>2</sup>/(<greek>p</greek><math>4</math>A<sub>r</sub>)</i>
<i>X<sub>cp</sub></i>
<i>C<sub>A</sub></i>
<i>C<sub>N</sub></i>
<i>C<sub>Z1</sub></i>
<i>C<sub>ml</sub></i>
<i>C<sub>mn</sub></i>
<i>C<sub>m</sub></i>
"Walltime"
100 -9.6403655117e-04 4.6646143768e-03 0.0000000000e+00 0.0000000000e+00 4.6646143768e-03 4.6645832371e-03 9.1269324080e-01 4.6646143768e-03 -9.6403655117e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -8.7986964414e-04 1.2655000000e+01
200 -9.6553069570e-04 4.6463541056e-03 0.0000000000e+00 0.0000000000e+00 4.6463541056e-03 4.6463228693e-03 1.3339750769e+00 4.6463541056e-03 -9.6553069570e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.2879938840e-03 2.6007000000e+01
300 -8.7377538314e-04 4.6284967556e-03 0.0000000000e+00 0.0000000000e+00 4.6284967556e-03 4.6284711741e-03 1.2571815861e+00 4.6284967556e-03 -8.7377538314e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -1.0984943221e-03 3.9271000000e+01
400 -6.4657122685e-04 4.6114116887e-03 0.0000000000e+00 0.0000000000e+00 4.6114116887e-03 4.6113976812e-03 4.3712245428e-01 4.6114116887e-03 -6.4657122685e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 -2.8263080155e-04 5.2379000000e+01
500 -3.3198066995e-04 4.5952180791e-03 0.0000000000e+00 0.0000000000e+00 4.5952180791e-03 4.5952143863e-03 -2.8054940672e+00 4.5952180791e-03 -3.3198066995e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 9.3136979998e-04 6.5502000000e+01
600 5.0447272323e-05 4.5799920086e-03 0.0000000000e+00 0.0000000000e+00 4.5799920086e-03 4.5799919233e-03 4.8457798250e+01 4.5799920086e-03 5.0447272323e-05 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.4445637445e-03 7.8641000000e+01
700 5.2345968273e-04 4.5657650387e-03 0.0000000000e+00 0.0000000000e+00 4.5657650387e-03 4.5657558577e-03 8.3015738417e+00 4.5657650387e-03 5.2345968273e-04 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 4.3455392094e-03 9.1761000000e+01
800 1.0762350938e-03 4.5525251499e-03 0.0000000000e+00 0.0000000000e+00 4.5525251499e-03 4.5524863402e-03 6.0213230207e+00 4.5525251499e-03 1.0762350938e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 6.4803591457e-03 1.0491500000e+02
900 1.6525328911e-03 4.5402498516e-03 0.0000000000e+00 0.0000000000e+00 4.5402498516e-03 4.5401583504e-03 5.2088343711e+00 4.5402498516e-03 1.6525328911e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 8.6077701226e-03 1.1812100000e+02
1000 2.1913187214e-03 4.5288952443e-03 0.0000000000e+00 0.0000000000e+00 4.5288952443e-03 4.5287343511e-03 4.7927017177e+00 4.5288952443e-03 2.1913187214e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.0502337000e-02 1.3127200000e+02
1100 2.7141062768e-03 4.5184039595e-03 0.0000000000e+00 0.0000000000e+00 4.5184039595e-03 4.5181571396e-03 4.5430115683e+00 4.5184039595e-03 2.7141062768e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.2330216213e-02 1.4439400000e+02
1200 3.2351267176e-03 4.5086966148e-03 0.0000000000e+00 0.0000000000e+00 4.5086966148e-03 4.5083459364e-03 4.3625149484e+00 4.5086966148e-03 3.2351267176e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.4113288666e-02 1.5756700000e+02
1300 3.7650692151e-03 4.4996798984e-03 0.0000000000e+00 0.0000000000e+00 4.4996798984e-03 4.4992049215e-03 4.2215727789e+00 4.4996798984e-03 3.7650692151e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.5894513709e-02 1.7078000000e+02
1400 4.3062798649e-03 4.4912648724e-03 0.0000000000e+00 0.0000000000e+00 4.4912648724e-03 4.4906435299e-03 4.1041118019e+00 4.4912648724e-03 4.3062798649e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.7673454016e-02 1.8396000000e+02
1500 4.8565996644e-03 4.4833800941e-03 0.0000000000e+00 0.0000000000e+00 4.4833800941e-03 4.4825897957e-03 4.0045602728e+00 4.4833800941e-03 4.8565996644e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.9448546077e-02 1.9712400000e+02
1600 5.4142723232e-03 4.4759684956e-03 0.0000000000e+00 0.0000000000e+00 4.4759684956e-03 4.4749862802e-03 3.9202703061e+00 4.4759684956e-03 5.4142723232e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.1225411018e-02 2.1022400000e+02
1700 5.9801805987e-03 4.4689826936e-03 0.0000000000e+00 0.0000000000e+00 4.4689826936e-03 4.4677844224e-03 3.8486792281e+00 4.4689826936e-03 5.9801805987e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.3015796850e-02 2.2338200000e+02
1800 6.5546002417e-03 4.4623830621e-03 0.0000000000e+00 0.0000000000e+00 4.4623830621e-03 4.4609435380e-03 3.7872154794e+00 4.4623830621e-03 6.5546002417e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.4823683496e-02 2.3647000000e+02
1900 7.1363971998e-03 4.4561361415e-03 0.0000000000e+00 0.0000000000e+00 4.4561361415e-03 4.4544297269e-03 3.7338366753e+00 4.4561361415e-03 7.1363971998e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.6646141594e-02 2.4969800000e+02
2000 7.7241542455e-03 4.4502133614e-03 0.0000000000e+00 0.0000000000e+00 4.4502133614e-03 4.4482142896e-03 3.6871164940e+00 4.4502133614e-03 7.7241542455e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.8479856521e-02 2.6282300000e+02
2100 8.3174960301e-03 4.4445902713e-03 0.0000000000e+00 0.0000000000e+00 4.4445902713e-03 4.4422722804e-03 3.6459838245e+00 4.4445902713e-03 8.3174960301e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.0325455986e-02 2.7654900000e+02
2200 8.9165081662e-03 4.4392458315e-03 0.0000000000e+00 0.0000000000e+00 4.4392458315e-03 4.4365819423e-03 3.6095715872e+00 4.4392458315e-03 8.9165081662e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.2184774534e-02 2.8986600000e+02
2300 9.5214591026e-03 4.4341618409e-03 0.0000000000e+00 0.0000000000e+00 4.4341618409e-03 4.4311242202e-03 3.5771702942e+00 4.4341618409e-03 9.5214591026e-03 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.4059880660e-02 3.0326700000e+02
2400 1.0132407229e-02 4.4293223897e-03 0.0000000000e+00 0.0000000000e+00 4.4293223897e-03 4.4258824423e-03 3.5481796135e+00 4.4293223897e-03 1.0132407229e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.5951600764e-02 3.1646700000e+02
2500 1.0749177850e-02 4.4247134829e-03 0.0000000000e+00 0.0000000000e+00 4.4247134829e-03 4.4208420029e-03 3.5221015716e+00 4.4247134829e-03 1.0749177850e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.7859696200e-02 3.2981300000e+02
2600 1.1371586866e-02 4.4203229050e-03 0.0000000000e+00 0.0000000000e+00 4.4203229050e-03 4.4159901047e-03 3.4985321136e+00 4.4203229050e-03 1.1371586866e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.9783861832e-02 3.4318900000e+02
2700 1.1999561611e-02 4.4161400446e-03 0.0000000000e+00 0.0000000000e+00 4.4161400446e-03 4.4113154893e-03 3.4771380938e+00 4.4161400446e-03 1.1999561611e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 4.1724132786e-02 3.5639600000e+02
2800 1.2633110563e-02 4.4121557134e-03 0.0000000000e+00 0.0000000000e+00 4.4121557134e-03 4.4068082587e-03 3.4576391759e+00 4.4121557134e-03 1.2633110563e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 4.3680737998e-02 3.6958200000e+02
2900 1.3272285151e-02 4.4083619710e-03 0.0000000000e+00 0.0000000000e+00 4.4083619710e-03 4.4024597165e-03 3.4397970403e+00 4.4083619710e-03 1.3272285151e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 4.5653967182e-02 3.8278900000e+02
3000 1.3917176403e-02 4.4047519820e-03 0.0000000000e+00 0.0000000000e+00 4.4047519820e-03 4.3982622197e-03 3.4234101215e+00 4.4047519820e-03 1.3917176403e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 4.7644202561e-02 3.9591000000e+02
3100 1.4567924280e-02 4.4013199004e-03 0.0000000000e+00 0.0000000000e+00 4.4013199004e-03 4.3942090446e-03 3.4083073434e+00 4.4013199004e-03 1.4567924280e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 4.9651963303e-02 4.0908600000e+02
3200 1.5224721568e-02 4.3980607993e-03 0.0000000000e+00 0.0000000000e+00 4.3980607993e-03 4.3902943012e-03 3.3943426449e+00 4.3980607993e-03 1.5224721568e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 5.1677921675e-02 4.2216200000e+02
3300 1.5887792316e-02 4.3949706609e-03 0.0000000000e+00 0.0000000000e+00 4.3949706609e-03 4.3865129345e-03 3.3813889958e+00 4.3949706609e-03 1.5887792316e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 5.3722806104e-02 4.3527300000e+02
3400 1.6557315591e-02 4.3920463841e-03 0.0000000000e+00 0.0000000000e+00 4.3920463841e-03 4.3828608085e-03 3.3693327330e+00 4.3920463841e-03 1.6557315591e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 5.5787105390e-02 4.4833800000e+02
3500 1.7233317182e-02 4.3892857081e-03 0.0000000000e+00 0.0000000000e+00 4.3892857081e-03 4.3793347640e-03 3.3580706771e+00 4.3892857081e-03 1.7233317182e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 5.7870697100e-02 4.6142500000e+02
3600 1.7915603545e-02 4.3866869348e-03 0.0000000000e+00 0.0000000000e+00 4.3866869348e-03 4.3759324550e-03 3.3475104767e+00 4.3866869348e-03 1.7915603545e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 5.9972670562e-02 4.7447700000e+02
3700 1.8603803063e-02 4.3842484732e-03 0.0000000000e+00 0.0000000000e+00 4.3842484732e-03 4.3726518916e-03 3.3375725038e+00 4.3842484732e-03 1.8603803063e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 6.2091541567e-02 4.8756700000e+02
3800 1.9297486692e-02 4.3819683515e-03 0.0000000000e+00 0.0000000000e+00 4.3819683515e-03 4.3694908388e-03 3.3281902063e+00 4.3819683515e-03 1.9297486692e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 6.4225706213e-02 5.0062500000e+02
3900 1.9996290749e-02 4.3798438798e-03 0.0000000000e+00 0.0000000000e+00 4.3798438798e-03 4.3664463292e-03 3.3193082572e+00 4.3798438798e-03 1.9996290749e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 6.6373852998e-02 5.1375300000e+02
4000 2.0699971932e-02 4.3778715523e-03 0.0000000000e+00 0.0000000000e+00 4.3778715523e-03 4.3635144751e-03 3.3108794766e+00 4.3778715523e-03 2.0699971932e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 6.8535112235e-02 5.2681000000e+02
4100 2.1408393731e-02 4.3760471501e-03 0.0000000000e+00 0.0000000000e+00 4.3760471501e-03 4.3606905636e-03 3.3028624836e+00 4.3760471501e-03 2.1408393731e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 7.0708980489e-02 5.3982500000e+02
4200 2.2121477116e-02 4.3743659496e-03 0.0000000000e+00 0.0000000000e+00 4.3743659496e-03 4.3579693132e-03 3.2952202465e+00 4.3743659496e-03 2.2121477116e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 7.2895139274e-02 5.5278400000e+02
4300 2.2839142713e-02 4.3728229487e-03 0.0000000000e+00 0.0000000000e+00 4.3728229487e-03 4.3553451748e-03 3.2879191961e+00 4.3728229487e-03 2.2839142713e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 7.5093255748e-02 5.6591400000e+02
4400 2.3561261146e-02 4.3714130451e-03 0.0000000000e+00 0.0000000000e+00 4.3714130451e-03 4.3528125893e-03 3.2809286548e+00 4.3714130451e-03 2.3561261146e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 7.7302816835e-02 5.7892800000e+02
4500 2.4287616231e-02 4.3701311354e-03 0.0000000000e+00 0.0000000000e+00 4.3701311354e-03 4.3503661587e-03 3.2742203702e+00 4.3701311354e-03 2.4287616231e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 7.9523007807e-02 5.9189300000e+02
4600 2.5017879819e-02 4.3689721254e-03 0.0000000000e+00 0.0000000000e+00 4.3689721254e-03 4.3480007205e-03 3.2677682297e+00 4.3689721254e-03 2.5017879819e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 8.1752632845e-02 6.0482100000e+02
4700 2.5751599730e-02 4.3679308581e-03 0.0000000000e+00 0.0000000000e+00 4.3679308581e-03 4.3457113240e-03 3.2615482432e+00 4.3679308581e-03 2.5751599730e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 8.3990084860e-02 6.1792000000e+02
4800 2.6488199161e-02 4.3670019784e-03 0.0000000000e+00 0.0000000000e+00 4.3670019784e-03 4.3434931282e-03 3.2555387149e+00 4.3670019784e-03 2.6488199161e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 8.6233357857e-02 6.3103500000e+02
4900 2.7227003512e-02 4.3661797167e-03 0.0000000000e+00 0.0000000000e+00 4.3661797167e-03 4.3413411680e-03 3.2497216598e+00 4.3661797167e-03 2.7227003512e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 8.8480183043e-02 6.4407400000e+02
5000 2.7967426875e-02 4.3654575985e-03 0.0000000000e+00 0.0000000000e+00 4.3654575985e-03 4.3392497395e-03 3.2440874543e+00 4.3654575985e-03 2.7967426875e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 9.0728778655e-02 6.5721100000e+02
5100 2.8709161864e-02 4.3648283890e-03 0.0000000000e+00 0.0000000000e+00 4.3648283890e-03 4.3372119581e-03 3.2386311483e+00 4.3648283890e-03 2.8709161864e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 9.2978385855e-02 6.7030600000e+02
5200 2.9452074761e-02 4.3642843459e-03 0.0000000000e+00 0.0000000000e+00 4.3642843459e-03 4.3352201501e-03 3.2333472108e+00 4.3642843459e-03 2.9452074761e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 9.5228783782e-02 6.8348800000e+02
5300 3.0196093742e-02 4.3638175090e-03 0.0000000000e+00 0.0000000000e+00 4.3638175090e-03 4.3332663246e-03 3.2282308263e+00 4.3638175090e-03 3.0196093742e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 9.7479960652e-02 6.9671600000e+02
5400 3.0941227037e-02 4.3634199143e-03 0.0000000000e+00 0.0000000000e+00 4.3634199143e-03 4.3313423350e-03 3.2232776103e+00 4.3634199143e-03 3.0941227037e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 9.9732164345e-02 7.0968500000e+02
5500 3.1687478196e-02 4.3630838114e-03 0.0000000000e+00 0.0000000000e+00 4.3630838114e-03 4.3294402566e-03 3.2184828952e+00 4.3630838114e-03 3.1687478196e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.0198560657e-01 7.2289200000e+02
5600 3.2434836279e-02 4.3628018276e-03 0.0000000000e+00 0.0000000000e+00 4.3628018276e-03 4.3275525727e-03 3.2138421982e+00 4.3628018276e-03 3.2434836279e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.0424044552e-01 7.3601100000e+02
5700 3.3183265164e-02 4.3625670919e-03 0.0000000000e+00 0.0000000000e+00 4.3625670919e-03 4.3256723262e-03 3.2093517824e+00 4.3625670919e-03 3.3183265164e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.0649677120e-01 7.4911000000e+02
5800 3.3932737631e-02 4.3623732911e-03 0.0000000000e+00 0.0000000000e+00 4.3623732911e-03 4.3237931048e-03 3.2050079699e+00 4.3623732911e-03 3.3932737631e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.0875469455e-01 7.6237500000e+02
5900 3.4683206979e-02 4.3622147101e-03 0.0000000000e+00 0.0000000000e+00 4.3622147101e-03 4.3219091447e-03 3.2008067403e+00 4.3622147101e-03 3.4683206979e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.1101424268e-01 7.7554900000e+02
6000 3.5434615749e-02 4.3620862444e-03 0.0000000000e+00 0.0000000000e+00 4.3620862444e-03 4.3200153275e-03 3.1967442759e+00 4.3620862444e-03 3.5434615749e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.1327540507e-01 7.8869200000e+02
6100 3.6186901022e-02 4.3619833873e-03 0.0000000000e+00 0.0000000000e+00 4.3619833873e-03 4.3181071571e-03 3.1928168408e+00 4.3619833873e-03 3.6186901022e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.1553814700e-01 8.0182100000e+02
6200 3.6939995116e-02 4.3619022005e-03 0.0000000000e+00 0.0000000000e+00 4.3619022005e-03 4.3161807301e-03 3.1890206536e+00 4.3619022005e-03 3.6939995116e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.1780240737e-01 8.1487500000e+02
6300 3.7693826949e-02 4.3618392729e-03 0.0000000000e+00 0.0000000000e+00 4.3618392729e-03 4.3142326925e-03 3.1853518627e+00 4.3618392729e-03 3.7693826949e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.2006810188e-01 8.2805400000e+02
6400 3.8448323233e-02 4.3617916731e-03 0.0000000000e+00 0.0000000000e+00 4.3617916731e-03 4.3122601901e-03 3.1818065014e+00 4.3617916731e-03 3.8448323233e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.2233512483e-01 8.4131900000e+02
6500 3.9203409686e-02 4.3617568992e-03 0.0000000000e+00 0.0000000000e+00 4.3617568992e-03 4.3102608152e-03 3.1783804965e+00 4.3617568992e-03 3.9203409686e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.2460335274e-01 8.5449700000e+02
6600 3.9959012903e-02 4.3617328284e-03 0.0000000000e+00 0.0000000000e+00 4.3617328284e-03 4.3082325522e-03 3.1750697036e+00 4.3617328284e-03 3.9959012903e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.2687265125e-01 8.6786500000e+02
6700 4.0715062763e-02 4.3617176690e-03 0.0000000000e+00 0.0000000000e+00 4.3617176690e-03 4.3061737218e-03 3.1718699632e+00 4.3617176690e-03 4.0715062763e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.2914288463e-01 8.8110400000e+02
6800 4.1471493929e-02 4.3617099152e-03 0.0000000000e+00 0.0000000000e+00 4.3617099152e-03 4.3040829322e-03 3.1687771143e+00 4.3617099152e-03 4.1471493929e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.3141392086e-01 8.9427500000e+02
6900 4.2228246579e-02 4.3617083065e-03 0.0000000000e+00 0.0000000000e+00 4.3617083065e-03 4.3019590343e-03 3.1657870231e+00 4.3617083065e-03 4.2228246579e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.3368563503e-01 9.0743600000e+02
7000 4.2985267013e-02 4.3617117914e-03 0.0000000000e+00 0.0000000000e+00 4.3617117914e-03 4.2998010822e-03 3.1628956130e+00 4.3617117914e-03 4.2985267013e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.3595791246e-01 9.2057800000e+02
7100 4.3742507955e-02 4.3617194948e-03 0.0000000000e+00 0.0000000000e+00 4.3617194948e-03 4.2976082985e-03 3.1600988877e+00 4.3617194948e-03 4.3742507955e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.3823065073e-01 9.3372700000e+02
7200 4.4499928488e-02 4.3617306903e-03 0.0000000000e+00 0.0000000000e+00 4.3617306903e-03 4.2953800454e-03 3.1573929498e+00 4.3617306903e-03 4.4499928488e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.4050376048e-01 9.4673400000e+02
7300 4.5257493766e-02 4.3617447759e-03 0.0000000000e+00 0.0000000000e+00 4.3617447759e-03 4.2931157993e-03 3.1547740145e+00 4.3617447759e-03 4.5257493766e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.4277716529e-01 9.5985600000e+02
7400 4.6015174523e-02 4.3617612537e-03 0.0000000000e+00 0.0000000000e+00 4.3617612537e-03 4.2908151304e-03 3.1522384204e+00 4.3617612537e-03 4.6015174523e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.4505080105e-01 9.7292700000e+02
7500 4.6772946517e-02 4.3617797122e-03 0.0000000000e+00 0.0000000000e+00 4.3617797122e-03 4.2884776856e-03 3.1497826369e+00 4.3617797122e-03 4.6772946517e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.4732461482e-01 9.8603900000e+02
7600 4.7530789936e-02 4.3617998116e-03 0.0000000000e+00 0.0000000000e+00 4.3617998116e-03 4.2861031745e-03 3.1474032698e+00 4.3617998116e-03 4.7530789936e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.4959856366e-01 9.9905000000e+02
7700 4.8288688823e-02 4.3618212717e-03 0.0000000000e+00 0.0000000000e+00 4.3618212717e-03 4.2836913573e-03 3.1450970644e+00 4.3618212717e-03 4.8288688823e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.5187261346e-01 1.0121450000e+03
7800 4.9046630505e-02 4.3618438611e-03 0.0000000000e+00 0.0000000000e+00 4.3618438611e-03 4.2812420361e-03 3.1428609065e+00 4.3618438611e-03 4.9046630505e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.5414673761e-01 1.0252470000e+03
7900 4.9804605065e-02 4.3618673892e-03 0.0000000000e+00 0.0000000000e+00 4.3618673892e-03 4.2787550467e-03 3.1406918216e+00 4.3618673892e-03 4.9804605065e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.5642091581e-01 1.0383350000e+03
8000 5.0562604862e-02 4.3618916986e-03 0.0000000000e+00 0.0000000000e+00 4.3618916986e-03 4.2762302526e-03 3.1385869732e+00 4.3618916986e-03 5.0562604862e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.5869513295e-01 1.0514580000e+03
8100 5.1320624099e-02 4.3619166594e-03 0.0000000000e+00 0.0000000000e+00 4.3619166594e-03 4.2736675401e-03 3.1365436591e+00 4.3619166594e-03 5.1320624099e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.6096937810e-01 1.0646930000e+03
8200 5.2078658457e-02 4.3619421643e-03 0.0000000000e+00 0.0000000000e+00 4.3619421643e-03 4.2710668139e-03 3.1345593079e+00 4.3619421643e-03 5.2078658457e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.6324364361e-01 1.0780200000e+03
8300 5.2836704771e-02 4.3619681247e-03 0.0000000000e+00 0.0000000000e+00 4.3619681247e-03 4.2684279943e-03 3.1326314744e+00 4.3619681247e-03 5.2836704771e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.6551792437e-01 1.0911730000e+03
8400 5.3594760766e-02 4.3619944672e-03 0.0000000000e+00 0.0000000000e+00 4.3619944672e-03 4.2657510143e-03 3.1307578341e+00 4.3619944672e-03 5.3594760766e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.6779221713e-01 1.1043210000e+03
8500 5.4352824838e-02 4.3620211309e-03 0.0000000000e+00 0.0000000000e+00 4.3620211309e-03 4.2630358175e-03 3.1289361787e+00 4.3620211309e-03 5.4352824838e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.7006652005e-01 1.1174730000e+03
8600 5.5110895879e-02 4.3620480655e-03 0.0000000000e+00 0.0000000000e+00 4.3620480655e-03 4.2602823562e-03 3.1271644101e+00 4.3620480655e-03 5.5110895879e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.7234083220e-01 1.1305830000e+03
8700 5.5868973135e-02 4.3620752289e-03 0.0000000000e+00 0.0000000000e+00 4.3620752289e-03 4.2574905902e-03 3.1254405355e+00 4.3620752289e-03 5.5868973135e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.7461515331e-01 1.1437930000e+03
8800 5.6627056106e-02 4.3621025864e-03 0.0000000000e+00 0.0000000000e+00 4.3621025864e-03 4.2546604857e-03 3.1237626616e+00 4.3621025864e-03 5.6627056106e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.7688948350e-01 1.1570130000e+03
8900 5.7385144459e-02 4.3621301086e-03 0.0000000000e+00 0.0000000000e+00 4.3621301086e-03 4.2517920139e-03 3.1221289896e+00 4.3621301086e-03 5.7385144459e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.7916382309e-01 1.1701640000e+03
9000 5.8143237972e-02 4.3621577714e-03 0.0000000000e+00 0.0000000000e+00 4.3621577714e-03 4.2488851504e-03 3.1205378103e+00 4.3621577714e-03 5.8143237972e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.8143817250e-01 1.1833670000e+03
9100 5.8901336489e-02 4.3621855541e-03 0.0000000000e+00 0.0000000000e+00 4.3621855541e-03 4.2459398746e-03 3.1189874989e+00 4.3621855541e-03 5.8901336489e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.8371253218e-01 1.1964400000e+03
9200 5.9659439896e-02 4.3622134397e-03 0.0000000000e+00 0.0000000000e+00 4.3622134397e-03 4.2429561691e-03 3.1174765104e+00 4.3622134397e-03 5.9659439896e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.8598690250e-01 1.2095360000e+03
9300 6.0417548096e-02 4.3622414136e-03 0.0000000000e+00 0.0000000000e+00 4.3622414136e-03 4.2399340189e-03 3.1160033752e+00 4.3622414136e-03 6.0417548096e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.8826128379e-01 1.2226960000e+03
9400 6.1175660998e-02 4.3622694635e-03 0.0000000000e+00 0.0000000000e+00 4.3622694635e-03 4.2368734116e-03 3.1145666949e+00 4.3622694635e-03 6.1175660998e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.9053567628e-01 1.2357850000e+03
9500 6.1933778512e-02 4.3622975792e-03 0.0000000000e+00 0.0000000000e+00 4.3622975792e-03 4.2337743363e-03 3.1131651378e+00 4.3622975792e-03 6.1933778512e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.9281008012e-01 1.2488620000e+03
9600 6.2691900545e-02 4.3623257518e-03 0.0000000000e+00 0.0000000000e+00 4.3623257518e-03 4.2306367839e-03 3.1117974360e+00 4.3623257518e-03 6.2691900545e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.9508449537e-01 1.2619700000e+03
9700 6.3450026999e-02 4.3623539737e-03 0.0000000000e+00 0.0000000000e+00 4.3623539737e-03 4.2274607466e-03 3.1104623808e+00 4.3623539737e-03 6.3450026999e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.9735892204e-01 1.2750990000e+03
9800 6.4208157776e-02 4.3623822385e-03 0.0000000000e+00 0.0000000000e+00 4.3623822385e-03 4.2242462178e-03 3.1091588204e+00 4.3623822385e-03 6.4208157776e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 1.9963336009e-01 1.2881660000e+03
9900 6.4966292775e-02 4.3624105406e-03 0.0000000000e+00 0.0000000000e+00 4.3624105406e-03 4.2209931916e-03 3.1078856556e+00 4.3624105406e-03 6.4966292775e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.0190780941e-01 1.3012630000e+03
10000 6.5724431896e-02 4.3624388754e-03 0.0000000000e+00 0.0000000000e+00 4.3624388754e-03 4.2177016630e-03 3.1066418378e+00 4.3624388754e-03 6.5724431896e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.0418226989e-01 1.3143550000e+03
10100 6.6482575036e-02 4.3624672386e-03 0.0000000000e+00 0.0000000000e+00 4.3624672386e-03 4.2143716279e-03 3.1054263657e+00 4.3624672386e-03 6.6482575036e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.0645674138e-01 1.3274340000e+03
10200 6.7240722103e-02 4.3624956267e-03 0.0000000000e+00 0.0000000000e+00 4.3624956267e-03 4.2110030824e-03 3.1042382829e+00 4.3624956267e-03 6.7240722103e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.0873122372e-01 1.3405050000e+03
10300 6.7998873005e-02 4.3625240366e-03 0.0000000000e+00 0.0000000000e+00 4.3625240366e-03 4.2075960233e-03 3.1030766752e+00 4.3625240366e-03 6.7998873005e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.1100571676e-01 1.3535820000e+03
10400 6.8757027658e-02 4.3625524656e-03 0.0000000000e+00 0.0000000000e+00 4.3625524656e-03 4.2041504476e-03 3.1019406686e+00 4.3625524656e-03 6.8757027658e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.1328022034e-01 1.3666590000e+03
10500 6.9515185986e-02 4.3625809114e-03 0.0000000000e+00 0.0000000000e+00 4.3625809114e-03 4.2006663529e-03 3.1008294270e+00 4.3625809114e-03 6.9515185986e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.1555473433e-01 1.3797260000e+03
10600 7.0273347916e-02 4.3626093720e-03 0.0000000000e+00 0.0000000000e+00 4.3626093720e-03 4.1971437368e-03 3.0997421502e+00 4.3626093720e-03 7.0273347916e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.1782925857e-01 1.3928040000e+03
10700 7.1031513384e-02 4.3626378455e-03 0.0000000000e+00 0.0000000000e+00 4.3626378455e-03 4.1935825974e-03 3.0986780720e+00 4.3626378455e-03 7.1031513384e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.2010379295e-01 1.4058980000e+03
10800 7.1789682333e-02 4.3626663304e-03 0.0000000000e+00 0.0000000000e+00 4.3626663304e-03 4.1899829327e-03 3.0976364585e+00 4.3626663304e-03 7.1789682333e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.2237833734e-01 1.4190010000e+03
10900 7.2547854711e-02 4.3626948253e-03 0.0000000000e+00 0.0000000000e+00 4.3626948253e-03 4.1863447412e-03 3.0966166063e+00 4.3626948253e-03 7.2547854711e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.2465289165e-01 1.4324160000e+03
11000 7.3306030474e-02 4.3627233290e-03 0.0000000000e+00 0.0000000000e+00 4.3627233290e-03 4.1826680213e-03 3.0956178409e+00 4.3627233290e-03 7.3306030474e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.2692745578e-01 1.4454990000e+03
11100 7.4064209580e-02 4.3627518405e-03 0.0000000000e+00 0.0000000000e+00 4.3627518405e-03 4.1789527717e-03 3.0946395156e+00 4.3627518405e-03 7.4064209580e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.2920202966e-01 1.4585840000e+03
11200 7.4822391997e-02 4.3627803588e-03 0.0000000000e+00 0.0000000000e+00 4.3627803588e-03 4.1751989911e-03 3.0936810095e+00 4.3627803588e-03 7.4822391997e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.3147661321e-01 1.4716870000e+03
11300 7.5580577695e-02 4.3628088831e-03 0.0000000000e+00 0.0000000000e+00 4.3628088831e-03 4.1714066783e-03 3.0927417269e+00 4.3628088831e-03 7.5580577695e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.3375120638e-01 1.4847970000e+03
11400 7.6338766644e-02 4.3628374127e-03 0.0000000000e+00 0.0000000000e+00 4.3628374127e-03 4.1675758323e-03 3.0918210955e+00 4.3628374127e-03 7.6338766644e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.3602580911e-01 1.4978570000e+03
11500 7.7096958826e-02 4.3628659470e-03 0.0000000000e+00 0.0000000000e+00 4.3628659470e-03 4.1637064520e-03 3.0909185653e+00 4.3628659470e-03 7.7096958826e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.3830042137e-01 1.5108710000e+03
11600 7.7855154221e-02 4.3628944853e-03 0.0000000000e+00 0.0000000000e+00 4.3628944853e-03 4.1597985365e-03 3.0900336081e+00 4.3628944853e-03 7.7855154221e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.4057504311e-01 1.5240480000e+03
11700 7.8613352811e-02 4.3629230273e-03 0.0000000000e+00 0.0000000000e+00 4.3629230273e-03 4.1558520848e-03 3.0891657157e+00 4.3629230273e-03 7.8613352811e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.4284967430e-01 1.5370520000e+03
11800 7.9371554581e-02 4.3629515725e-03 0.0000000000e+00 0.0000000000e+00 4.3629515725e-03 4.1518670963e-03 3.0883143994e+00 4.3629515725e-03 7.9371554581e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.4512431492e-01 1.5501290000e+03
11900 8.0129759521e-02 4.3629801204e-03 0.0000000000e+00 0.0000000000e+00 4.3629801204e-03 4.1478435700e-03 3.0874791890e+00 4.3629801204e-03 8.0129759521e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.4739896494e-01 1.5631590000e+03
12000 8.0887967617e-02 4.3630086709e-03 0.0000000000e+00 0.0000000000e+00 4.3630086709e-03 4.1437815052e-03 3.0866596318e+00 4.3630086709e-03 8.0887967617e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.4967362434e-01 1.5762280000e+03
12100 8.1646178862e-02 4.3630372235e-03 0.0000000000e+00 0.0000000000e+00 4.3630372235e-03 4.1396809012e-03 3.0858552919e+00 4.3630372235e-03 8.1646178862e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.5194829311e-01 1.5892370000e+03
12200 8.2404393247e-02 4.3630657781e-03 0.0000000000e+00 0.0000000000e+00 4.3630657781e-03 4.1355417573e-03 3.0850657496e+00 4.3630657781e-03 8.2404393247e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.5422297122e-01 1.6023060000e+03
12300 8.3162610762e-02 4.3630943343e-03 0.0000000000e+00 0.0000000000e+00 4.3630943343e-03 4.1313640728e-03 3.0842906003e+00 4.3630943343e-03 8.3162610762e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.5649765867e-01 1.6153780000e+03
12400 8.3920831405e-02 4.3631228921e-03 0.0000000000e+00 0.0000000000e+00 4.3631228921e-03 4.1271478471e-03 3.0835294540e+00 4.3631228921e-03 8.3920831405e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.5877235544e-01 1.6284450000e+03
12500 8.4679055171e-02 4.3631514511e-03 0.0000000000e+00 0.0000000000e+00 4.3631514511e-03 4.1228930795e-03 3.0827819348e+00 4.3631514511e-03 8.4679055171e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.6104706154e-01 1.6415150000e+03
12600 8.5437282053e-02 4.3631800114e-03 0.0000000000e+00 0.0000000000e+00 4.3631800114e-03 4.1185997695e-03 3.0820476801e+00 4.3631800114e-03 8.5437282053e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.6332177694e-01 1.6545170000e+03
12700 8.6195512048e-02 4.3632085727e-03 0.0000000000e+00 0.0000000000e+00 4.3632085727e-03 4.1142679165e-03 3.0813263399e+00 4.3632085727e-03 8.6195512048e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.6559650165e-01 1.6675980000e+03
12800 8.6953745152e-02 4.3632371349e-03 0.0000000000e+00 0.0000000000e+00 4.3632371349e-03 4.1098975199e-03 3.0806175765e+00 4.3632371349e-03 8.6953745152e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.6787123565e-01 1.6805910000e+03
12900 8.7711981360e-02 4.3632656979e-03 0.0000000000e+00 0.0000000000e+00 4.3632656979e-03 4.1054885791e-03 3.0799210638e+00 4.3632656979e-03 8.7711981360e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.7014597894e-01 1.6936820000e+03
13000 8.8470220672e-02 4.3632942616e-03 0.0000000000e+00 0.0000000000e+00 4.3632942616e-03 4.1010410937e-03 3.0792364871e+00 4.3632942616e-03 8.8470220672e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.7242073152e-01 1.7067500000e+03
13100 8.9228463086e-02 4.3633228260e-03 0.0000000000e+00 0.0000000000e+00 4.3633228260e-03 4.0965550629e-03 3.0785635422e+00 4.3633228260e-03 8.9228463086e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.7469549338e-01 1.7198470000e+03
13200 8.9986708599e-02 4.3633513910e-03 0.0000000000e+00 0.0000000000e+00 4.3633513910e-03 4.0920304864e-03 3.0779019350e+00 4.3633513910e-03 8.9986708599e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.7697026452e-01 1.7329450000e+03
13300 9.0744957210e-02 4.3633799564e-03 0.0000000000e+00 0.0000000000e+00 4.3633799564e-03 4.0874673636e-03 3.0772513815e+00 4.3633799564e-03 9.0744957210e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.7924504494e-01 1.7460430000e+03
13400 9.1503208917e-02 4.3634085224e-03 0.0000000000e+00 0.0000000000e+00 4.3634085224e-03 4.0828656940e-03 3.0766116070e+00 4.3634085224e-03 9.1503208917e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.8151983463e-01 1.7591860000e+03
13500 9.2261463718e-02 4.3634370887e-03 0.0000000000e+00 0.0000000000e+00 4.3634370887e-03 4.0782254771e-03 3.0759823458e+00 4.3634370887e-03 9.2261463718e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.8379463359e-01 1.7721650000e+03
13600 9.3019721611e-02 4.3634656555e-03 0.0000000000e+00 0.0000000000e+00 4.3634656555e-03 4.0735467123e-03 3.0753633409e+00 4.3634656555e-03 9.3019721611e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.8606944182e-01 1.7852350000e+03
13700 9.3777982596e-02 4.3634942225e-03 0.0000000000e+00 0.0000000000e+00 4.3634942225e-03 4.0688293992e-03 3.0747543436e+00 4.3634942225e-03 9.3777982596e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.8834425932e-01 1.7982310000e+03
13800 9.4536246672e-02 4.3635227899e-03 0.0000000000e+00 0.0000000000e+00 4.3635227899e-03 4.0640735373e-03 3.0741551131e+00 4.3635227899e-03 9.4536246672e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.9061908608e-01 1.8111290000e+03
13900 9.5294513839e-02 4.3635513576e-03 0.0000000000e+00 0.0000000000e+00 4.3635513576e-03 4.0592791261e-03 3.0735654164e+00 4.3635513576e-03 9.5294513839e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.9289392211e-01 1.8240640000e+03
14000 9.6052784097e-02 4.3635799255e-03 0.0000000000e+00 0.0000000000e+00 4.3635799255e-03 4.0544461650e-03 3.0729850278e+00 4.3635799255e-03 9.6052784097e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.9516876740e-01 1.8371390000e+03
14100 9.6811057443e-02 4.3636084937e-03 0.0000000000e+00 0.0000000000e+00 4.3636084937e-03 4.0495746537e-03 3.0724137285e+00 4.3636084937e-03 9.6811057443e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.9744362196e-01 1.8502380000e+03
14200 9.7569333878e-02 4.3636370621e-03 0.0000000000e+00 0.0000000000e+00 4.3636370621e-03 4.0446645916e-03 3.0718513068e+00 4.3636370621e-03 9.7569333878e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 2.9971848578e-01 1.8633220000e+03
14300 9.8327613401e-02 4.3636656307e-03 0.0000000000e+00 0.0000000000e+00 4.3636656307e-03 4.0397159783e-03 3.0712975573e+00 4.3636656307e-03 9.8327613401e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.0199335885e-01 1.8764150000e+03
14400 9.9085896010e-02 4.3636941995e-03 0.0000000000e+00 0.0000000000e+00 4.3636941995e-03 4.0347288132e-03 3.0707522810e+00 4.3636941995e-03 9.9085896010e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.0426824119e-01 1.8894930000e+03
14500 9.9844181706e-02 4.3637227685e-03 0.0000000000e+00 0.0000000000e+00 4.3637227685e-03 4.0297030959e-03 3.0702152849e+00 4.3637227685e-03 9.9844181706e-02 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.0654313278e-01 1.9025800000e+03
14600 1.0060247049e-01 4.3637513377e-03 0.0000000000e+00 0.0000000000e+00 4.3637513377e-03 4.0246388259e-03 3.0696863818e+00 4.3637513377e-03 1.0060247049e-01 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.0881803363e-01 1.9156890000e+03
14700 1.0136076236e-01 4.3637799070e-03 0.0000000000e+00 0.0000000000e+00 4.3637799070e-03 4.0195360028e-03 3.0691653901e+00 4.3637799070e-03 1.0136076236e-01 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1109294374e-01 1.9287640000e+03
14800 1.0211905732e-01 4.3638084765e-03 0.0000000000e+00 0.0000000000e+00 4.3638084765e-03 4.0143946260e-03 3.0686521336e+00 4.3638084765e-03 1.0211905732e-01 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1336786311e-01 1.9418300000e+03
14900 1.0287735536e-01 4.3638370462e-03 0.0000000000e+00 0.0000000000e+00 4.3638370462e-03 4.0092146950e-03 3.0681464413e+00 4.3638370462e-03 1.0287735536e-01 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1564279173e-01 1.9549160000e+03
15000 1.0363565649e-01 4.3638656160e-03 0.0000000000e+00 0.0000000000e+00 4.3638656160e-03 4.0039962095e-03 3.0676481473e+00 4.3638656160e-03 1.0363565649e-01 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1791772961e-01 1.9680210000e+03
15000 1.0363565649e-01 4.3638656160e-03 0.0000000000e+00 0.0000000000e+00 4.3638656160e-03 4.0039962095e-03 3.0676481473e+00 4.3638656160e-03 1.0363565649e-01 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1791772961e-01 1.9688430000e+03

Binary file not shown.

View File

@ -0,0 +1,23 @@
# MeshFile : ./grid/test_grid.fts
# Reynolds : 2.000000e+05 1/m
# Mach : 0.1
# Alpha : 0 degree
# Beta : 0 degree
# Wall Temperature : Adiabatic Wall
# gridScaleFactor : 1
# forceRefenenceLength : 1 m
# forceRefenenceLengthSpanWise : 1 m
# forceRefenenceArea : 1 m^2
# TorqueRefX : 0
# TorqueRefY : 0
# TorqueRefZ : 0
# iter : 15000
# CA CN CZ1 Cml Cmn Cm
# CA_p CN_p CZ1_p Cml_p Cmn_p Cm_p
# CA_f CN_f CZ1_f Cml_f Cmn_f Cm_f
*whole
4.3638656160e-03 1.0363565649e-01 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1791772961e-01
0.0000000000e+00 1.0363301115e-01 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 3.1791000791e-01
4.3638656160e-03 2.6453330541e-06 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 7.7217071003e-06

View File

@ -0,0 +1,13 @@
# MeshFile : ./grid/test_grid.fts
# Reynolds : 2.000000e+05 1/m
# Mach : 0.1
# Alpha : 0 degree
# Beta : 0 degree
# Wall Temperature : Adiabatic Wall
# gridScaleFactor : 1
# iter : 15000
# CA CN CZ1 Cml Cmn Cm
# CA_p CN_p CZ1_p Cml_p Cmn_p Cm_p
# CA_f CN_f CZ1_f Cml_f Cmn_f Cm_f
# CMh

View File

@ -0,0 +1,35 @@
This grid file is new HDF5 version!
Global grid files number: 1
Max processor ID : 1 of total zone 1, Zones' distribution is specified by partition ...
Zone index in current processor : 0
0.009 seconds: Grid Reading
Start Swapping Zone Neighbors Information!
Start broadcasting neighbor information to neighbor zones using new method...
End broadcasting neighbor information to neighbor zones by new method...
0.001 seconds: Neighbor zone information BCast
Start SwapNeighborsSendContent ...
End SwapNeighborsSendContent ...
0.001 seconds: Swap Neighbor Send Content
End Swapping Zone Neighbors Information!
The most valid multi-grid level is: 1
Change boundary condition ...
Monitoring probes ...
Swap geommetry sucessfully ...
Creating and initialization solvers start
Creating and initialization solvers over
Multi-Grid Init Flow ...
Start iterating ...
----- Time statistics -----
Wall time = 1969.728
----- End time statistics -----
Job Done.

File diff suppressed because it is too large Load Diff

View File

Binary file not shown.

File diff suppressed because it is too large Load Diff

View File

@ -0,0 +1,313 @@
title="Wall Aircoef Data of PHengLEI"
variables="x", "y", "z", "cp", "cf", "yplus", "Q_NonDim", "Q_Dim(kW/m2)", "pw(Pa)"
zone T = "Zone0"
I = 168
J = 1
K = 1
f = BLOCK
0.0000000000e+00 3.5926358087e-02 7.1852737702e-02 1.0777913882e-01 1.4370556144e-01
1.7963200559e-01 2.1555847125e-01 2.5148495841e-01 2.8741146709e-01 3.2333799729e-01
3.5926454899e-01 3.9519112222e-01 4.3111771694e-01 4.6704433320e-01 5.0297097095e-01
5.3889763023e-01 5.7482431101e-01 6.1075101331e-01 6.4667773712e-01 6.8260448245e-01
7.1853124928e-01 7.5445803763e-01 7.9038484749e-01 8.2631167887e-01 8.6223853176e-01
8.9816540616e-01 9.3409230208e-01 9.7001921951e-01 1.0059461584e+00 1.0418731189e+00
1.0778001009e+00 1.1137271044e+00 1.1496541293e+00 1.1855811759e+00 1.2215082439e+00
1.2574353334e+00 1.2933624445e+00 1.3292895770e+00 1.3652167311e+00 1.4011439067e+00
1.4370711038e+00 1.4729983224e+00 1.5089255625e+00 1.5448528242e+00 1.5807801073e+00
1.6167074120e+00 1.6526347382e+00 1.6885620858e+00 1.7244894551e+00 1.7604168458e+00
1.7963442580e+00 1.8322716918e+00 1.8681991470e+00 1.9041266238e+00 1.9400541221e+00
1.9759816419e+00 2.0119091832e+00 2.0478367460e+00 2.0837643304e+00 2.1196919362e+00
2.1556195636e+00 2.1915472125e+00 2.2274748829e+00 2.2634025748e+00 2.2993302882e+00
2.3352580231e+00 2.3711857796e+00 2.4071135576e+00 2.4430413570e+00 2.4789691780e+00
2.5148970205e+00 2.5508248845e+00 2.5867527701e+00 2.6226806771e+00 2.6586086057e+00
2.6945365558e+00 2.7304645273e+00 2.7663925204e+00 2.8023205351e+00 2.8382485712e+00
2.8741766288e+00 2.9101047080e+00 2.9460328087e+00 2.9819609308e+00 3.0178890745e+00
3.0538172397e+00 3.0897454265e+00 3.1256736347e+00 3.1616018645e+00 3.1975301157e+00
3.2334583885e+00 3.2693866828e+00 3.3053149986e+00 3.3412433359e+00 3.3771716948e+00
3.4131000751e+00 3.4490284770e+00 3.4849569004e+00 3.5208853453e+00 3.5568138117e+00
3.5927422996e+00 3.6286708090e+00 3.6645993400e+00 3.7005278924e+00 3.7364564664e+00
3.7723850619e+00 3.8083136789e+00 3.8442423174e+00 3.8801709775e+00 3.9160996590e+00
3.9520283621e+00 3.9879570867e+00 4.0238858327e+00 4.0598146004e+00 4.0957433895e+00
4.1316722001e+00 4.1676010323e+00 4.2035298859e+00 4.2394587611e+00 4.2753876578e+00
4.3113165760e+00 4.3472455157e+00 4.3831744769e+00 4.4191034597e+00 4.4550324639e+00
4.4909614897e+00 4.5268905370e+00 4.5628196058e+00 4.5987486961e+00 4.6346778080e+00
4.6706069413e+00 4.7065360962e+00 4.7424652726e+00 4.7783944705e+00 4.8143236899e+00
4.8502529308e+00 4.8861821932e+00 4.9221114772e+00 4.9580407826e+00 4.9939701096e+00
5.0298994581e+00 5.0658288281e+00 5.1017582196e+00 5.1376876327e+00 5.1736170672e+00
5.2095465233e+00 5.2454760009e+00 5.2814055000e+00 5.3173350206e+00 5.3532645627e+00
5.3891941264e+00 5.4251237115e+00 5.4610533182e+00 5.4969829464e+00 5.5329125961e+00
5.5688422673e+00 5.6047719600e+00 5.6407016742e+00 5.6766314100e+00 5.7125611673e+00
5.7484909461e+00 5.7844207464e+00 5.8203505682e+00 5.8562804115e+00 5.8922102764e+00
5.9281401627e+00 5.9640700706e+00 6.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
-1.5383352858e-02 -1.5585143715e-02 -1.5831664425e-02 -1.5938518854e-02 -1.6038818657e-02
-1.6110636357e-02 -1.6170802241e-02 -1.6220173512e-02 -1.6262659599e-02 -1.6299678625e-02
-1.6332614131e-02 -1.6362289153e-02 -1.6389352651e-02 -1.6414266556e-02 -1.6437388965e-02
-1.6458994959e-02 -1.6479302356e-02 -1.6498485326e-02 -1.6516685888e-02 -1.6534021301e-02
-1.6550589515e-02 -1.6566473179e-02 -1.6581742682e-02 -1.6596458478e-02 -1.6610672876e-02
-1.6624431461e-02 -1.6637774204e-02 -1.6650736364e-02 -1.6663349211e-02 -1.6675640615e-02
-1.6687635535e-02 -1.6699356421e-02 -1.6710823548e-02 -1.6722055300e-02 -1.6733068404e-02
-1.6743878140e-02 -1.6754498502e-02 -1.6764942357e-02 -1.6775221564e-02 -1.6785347091e-02
-1.6795329104e-02 -1.6805177056e-02 -1.6814899761e-02 -1.6824505451e-02 -1.6834001843e-02
-1.6843396184e-02 -1.6852695294e-02 -1.6861905613e-02 -1.6871033225e-02 -1.6880083900e-02
-1.6889063118e-02 -1.6897976093e-02 -1.6906827802e-02 -1.6915623001e-02 -1.6924366248e-02
-1.6933061914e-02 -1.6941714209e-02 -1.6950327187e-02 -1.6958904764e-02 -1.6967450732e-02
-1.6975968764e-02 -1.6984462431e-02 -1.6992935209e-02 -1.7001390487e-02 -1.7009831576e-02
-1.7018261716e-02 -1.7026684087e-02 -1.7035101810e-02 -1.7043517955e-02 -1.7051935553e-02
-1.7060357601e-02 -1.7068787068e-02 -1.7077226898e-02 -1.7085680017e-02 -1.7094149334e-02
-1.7102637752e-02 -1.7111148169e-02 -1.7119683483e-02 -1.7128246597e-02 -1.7136840427e-02
-1.7145467900e-02 -1.7154131967e-02 -1.7162835599e-02 -1.7171581800e-02 -1.7180373606e-02
-1.7189214091e-02 -1.7198106377e-02 -1.7207053629e-02 -1.7216059072e-02 -1.7225125988e-02
-1.7234257725e-02 -1.7243457702e-02 -1.7252729418e-02 -1.7262076452e-02 -1.7271502477e-02
-1.7281011261e-02 -1.7290606681e-02 -1.7300292723e-02 -1.7310073497e-02 -1.7319953244e-02
-1.7329936340e-02 -1.7340027317e-02 -1.7350230864e-02 -1.7360551841e-02 -1.7370995294e-02
-1.7381566466e-02 -1.7392270812e-02 -1.7403114013e-02 -1.7414101993e-02 -1.7425240936e-02
-1.7436537310e-02 -1.7447997881e-02 -1.7459629740e-02 -1.7471440327e-02 -1.7483437457e-02
-1.7495629351e-02 -1.7508024667e-02 -1.7520632537e-02 -1.7533462603e-02 -1.7546525062e-02
-1.7559830714e-02 -1.7573391012e-02 -1.7587218120e-02 -1.7601324980e-02 -1.7615725380e-02
-1.7630434035e-02 -1.7645466677e-02 -1.7660840155e-02 -1.7676572544e-02 -1.7692683278e-02
-1.7709193287e-02 -1.7726125165e-02 -1.7743503353e-02 -1.7761354350e-02 -1.7779706958e-02
-1.7798592559e-02 -1.7818045444e-02 -1.7838103183e-02 -1.7858807063e-02 -1.7880202608e-02
-1.7902340182e-02 -1.7925275704e-02 -1.7949071510e-02 -1.7973797377e-02 -1.7999531770e-02
-1.8026363353e-02 -1.8054392855e-02 -1.8083735398e-02 -1.8114523440e-02 -1.8146910556e-02
-1.8181076337e-02 -1.8217232727e-02 -1.8255632004e-02 -1.8296576433e-02 -1.8340428740e-02
-1.8387623512e-02 -1.8438678111e-02 -1.8494221127e-02 -1.8555050769e-02 -1.8622385786e-02
-1.8698281318e-02 -1.8787193554e-02 -1.8896832160e-02 -1.9045321019e-02 -1.9247615785e-02
-1.9567977034e-02 -1.9891038840e-02 -2.0008681210e-02
7.7982771397e-04 7.7959563640e-04 7.7909378535e-04 7.7853785178e-04 7.7795472330e-04
7.7735458881e-04 7.7674410980e-04 7.7612672826e-04 7.7550462074e-04 7.7487909827e-04
7.7425102730e-04 7.7362098715e-04 7.7298938544e-04 7.7235651633e-04 7.7172259923e-04
7.7108780201e-04 7.7045225627e-04 7.6981606714e-04 7.6917931992e-04 7.6854208478e-04
7.6790442011e-04 7.6726637510e-04 7.6662799150e-04 7.6598930514e-04 7.6535034698e-04
7.6471114395e-04 7.6407171966e-04 7.6343209490e-04 7.6279228812e-04 7.6215231575e-04
7.6151219249e-04 7.6087193157e-04 7.6023154492e-04 7.5959104337e-04 7.5895043678e-04
7.5830973414e-04 7.5766894369e-04 7.5702807301e-04 7.5638712911e-04 7.5574611843e-04
7.5510504698e-04 7.5446392035e-04 7.5382274373e-04 7.5318152200e-04 7.5254025972e-04
7.5189896119e-04 7.5125763046e-04 7.5061627134e-04 7.4997488745e-04 7.4933348225e-04
7.4869205899e-04 7.4805062079e-04 7.4740917065e-04 7.4676771140e-04 7.4612624581e-04
7.4548477650e-04 7.4484330602e-04 7.4420183684e-04 7.4356037134e-04 7.4291891183e-04
7.4227746056e-04 7.4163601974e-04 7.4099459149e-04 7.4035317793e-04 7.3971178110e-04
7.3907040303e-04 7.3842904571e-04 7.3778771110e-04 7.3714640114e-04 7.3650511774e-04
7.3586386282e-04 7.3522263827e-04 7.3458144598e-04 7.3394028784e-04 7.3329916573e-04
7.3265808154e-04 7.3201703716e-04 7.3137603450e-04 7.3073507548e-04 7.3009416201e-04
7.2945329606e-04 7.2881247959e-04 7.2817171460e-04 7.2753100312e-04 7.2689034719e-04
7.2624974891e-04 7.2560921041e-04 7.2496873387e-04 7.2432832149e-04 7.2368797555e-04
7.2304769837e-04 7.2240749233e-04 7.2176735987e-04 7.2112730350e-04 7.2048732580e-04
7.1984742943e-04 7.1920761713e-04 7.1856789174e-04 7.1792825617e-04 7.1728871345e-04
7.1664926673e-04 7.1600991924e-04 7.1537067436e-04 7.1473153559e-04 7.1409250659e-04
7.1345359114e-04 7.1281479321e-04 7.1217611692e-04 7.1153756660e-04 7.1089914675e-04
7.1026086211e-04 7.0962271762e-04 7.0898471850e-04 7.0834687019e-04 7.0770917846e-04
7.0707164935e-04 7.0643428925e-04 7.0579710490e-04 7.0516010343e-04 7.0452329237e-04
7.0388667974e-04 7.0325027401e-04 7.0261408421e-04 7.0197811995e-04 7.0134239148e-04
7.0070690973e-04 7.0007168641e-04 6.9943673407e-04 6.9880206616e-04 6.9816769718e-04
6.9753364272e-04 6.9689991965e-04 6.9626654619e-04 6.9563354214e-04 6.9500092899e-04
6.9436873020e-04 6.9373697137e-04 6.9310568058e-04 6.9247488868e-04 6.9184462971e-04
6.9121494130e-04 6.9058586525e-04 6.8995744815e-04 6.8932974214e-04 6.8870280586e-04
6.8807670551e-04 6.8745151631e-04 6.8682732409e-04 6.8620422753e-04 6.8558234078e-04
6.8496179705e-04 6.8434275330e-04 6.8372539660e-04 6.8310995245e-04 6.8249669528e-04
6.8188595990e-04 6.8127815124e-04 6.8067374710e-04 6.8007329346e-04 6.7947740632e-04
6.7888687097e-04 6.7830302636e-04 6.7772902500e-04 6.7717242257e-04 6.7665123244e-04
6.7619865946e-04 6.7587850654e-04 6.7576236705e-04
2.1939911496e+02 2.1936614858e+02 2.1929492485e+02 2.1921608586e+02 2.1913339114e+02
2.1904827755e+02 2.1896167754e+02 2.1887407429e+02 2.1878577265e+02 2.1869695638e+02
2.1860774683e+02 2.1851822512e+02 2.1842844829e+02 2.1833845747e+02 2.1824828335e+02
2.1815794936e+02 2.1806747388e+02 2.1797687158e+02 2.1788615434e+02 2.1779533191e+02
2.1770441244e+02 2.1761340274e+02 2.1752230861e+02 2.1743113501e+02 2.1733988622e+02
2.1724856596e+02 2.1715717748e+02 2.1706572364e+02 2.1697420697e+02 2.1688262973e+02
2.1679099391e+02 2.1669930133e+02 2.1660755360e+02 2.1651575219e+02 2.1642389843e+02
2.1633199353e+02 2.1624003859e+02 2.1614803464e+02 2.1605598260e+02 2.1596388333e+02
3.9439219206e+03 7.5457568959e+03 7.2938028020e+03 7.0426194930e+03 6.7922123876e+03
6.5425879087e+03 6.2937536756e+03 6.0457187394e+03 5.7984938773e+03 5.5520919618e+03
5.3065284288e+03 5.0618218751e+03 4.8179948320e+03 4.5750747758e+03 4.3330954644e+03
4.0920987302e+03 3.8521369193e+03 3.6132762645e+03 3.3756016335e+03 3.1392233457e+03
2.9042871775e+03 2.6709894124e+03 2.4396001101e+03 2.2105002160e+03 1.9842428190e+03
1.7616582197e+03 1.5440417147e+03 1.3335033134e+03 1.1336403050e+03 9.5082693112e+02
7.9640790425e+02 6.8871281622e+02 6.4393998378e+02 6.3842411288e+02 6.3814370594e+02
6.3786319660e+02 6.3758258555e+02 6.3730187347e+02 6.3702106105e+02 6.3674014900e+02
6.3645913803e+02 6.3617802885e+02 6.3589682220e+02 6.3561551883e+02 6.3533411949e+02
6.3505262498e+02 6.3477103607e+02 6.3448935359e+02 6.3420757839e+02 6.3392571130e+02
6.3364375324e+02 6.3336170510e+02 6.3307956783e+02 6.3279734240e+02 6.3251502982e+02
6.3223263113e+02 6.3195014741e+02 6.3166757978e+02 6.3138492940e+02 6.3110219750e+02
6.3081938532e+02 6.3053649418e+02 6.3025352544e+02 6.2997048055e+02 6.2968736100e+02
6.2940416834e+02 6.2912090421e+02 6.2883757035e+02 6.2855416853e+02 6.2827070066e+02
6.2798716873e+02 6.2770357482e+02 4.0535307322e+03 7.3579476126e+03 7.1152731429e+03
6.8734656357e+03 6.6325413518e+03 6.3925191035e+03 6.1534207260e+03 5.9152716558e+03
5.6781016459e+03 5.4419456577e+03 5.2068449802e+03 4.9728486472e+03 4.7400152491e+03
4.5084152687e+03 4.2781341260e+03 4.0492761908e+03 3.8219701308e+03 3.5963761325e+03
3.3726957793e+03 3.1511857577e+03 2.9321771561e+03 2.7161030533e+03 2.5035385558e+03
2.2952597177e+03 2.0923312249e+03 1.8962375433e+03 1.7090775690e+03 1.5338438156e+03
1.3747869864e+03 1.2377819536e+03 1.1303936383e+03 1.0610296632e+03 1.0336180287e+03
1.0300901757e+03 1.0296198454e+03 1.0291500522e+03 1.0286808707e+03 1.0282123872e+03
1.0277447022e+03 1.0272779345e+03 1.0268122253e+03 1.0263477453e+03 1.0258847017e+03
1.0254233479e+03 1.0249639900e+03 1.0245069894e+03 1.0240527594e+03 1.0236017667e+03
1.0231546036e+03 1.0227122836e+03 1.0222771724e+03 1.0218549873e+03 1.0214592500e+03
1.0211151831e+03 1.0208705981e+03 1.0207811987e+03
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
0.0000000000e+00 0.0000000000e+00 0.0000000000e+00
8.6979633987e+03 8.6979511112e+03 8.6979361000e+03 8.6979295934e+03 8.6979234859e+03
8.6979191127e+03 8.6979154491e+03 8.6979124428e+03 8.6979098557e+03 8.6979076015e+03
8.6979055960e+03 8.6979037890e+03 8.6979021411e+03 8.6979006240e+03 8.6978992160e+03
8.6978979004e+03 8.6978966638e+03 8.6978954957e+03 8.6978943874e+03 8.6978933318e+03
8.6978923230e+03 8.6978913558e+03 8.6978904260e+03 8.6978895299e+03 8.6978886644e+03
8.6978878266e+03 8.6978870141e+03 8.6978862248e+03 8.6978854568e+03 8.6978847083e+03
8.6978839779e+03 8.6978832642e+03 8.6978825660e+03 8.6978818820e+03 8.6978812114e+03
8.6978805532e+03 8.6978799065e+03 8.6978792705e+03 8.6978786446e+03 8.6978780280e+03
8.6978774202e+03 8.6978768205e+03 8.6978762285e+03 8.6978756436e+03 8.6978750653e+03
8.6978744933e+03 8.6978739271e+03 8.6978733662e+03 8.6978728104e+03 8.6978722593e+03
8.6978717125e+03 8.6978711698e+03 8.6978706308e+03 8.6978700952e+03 8.6978695628e+03
8.6978690333e+03 8.6978685065e+03 8.6978679820e+03 8.6978674597e+03 8.6978669393e+03
8.6978664206e+03 8.6978659034e+03 8.6978653875e+03 8.6978648727e+03 8.6978643587e+03
8.6978638453e+03 8.6978633325e+03 8.6978628199e+03 8.6978623074e+03 8.6978617949e+03
8.6978612820e+03 8.6978607687e+03 8.6978602548e+03 8.6978597401e+03 8.6978592244e+03
8.6978587075e+03 8.6978581893e+03 8.6978576695e+03 8.6978571481e+03 8.6978566248e+03
8.6978560995e+03 8.6978555719e+03 8.6978550419e+03 8.6978545093e+03 8.6978539740e+03
8.6978534356e+03 8.6978528942e+03 8.6978523494e+03 8.6978518010e+03 8.6978512489e+03
8.6978506928e+03 8.6978501326e+03 8.6978495681e+03 8.6978489989e+03 8.6978484249e+03
8.6978478459e+03 8.6978472616e+03 8.6978466718e+03 8.6978460762e+03 8.6978454746e+03
8.6978448667e+03 8.6978442523e+03 8.6978436310e+03 8.6978430025e+03 8.6978423666e+03
8.6978417229e+03 8.6978410711e+03 8.6978404108e+03 8.6978397417e+03 8.6978390634e+03
8.6978383756e+03 8.6978376777e+03 8.6978369694e+03 8.6978362502e+03 8.6978355197e+03
8.6978347773e+03 8.6978340225e+03 8.6978332548e+03 8.6978324736e+03 8.6978316782e+03
8.6978308680e+03 8.6978300422e+03 8.6978292003e+03 8.6978283413e+03 8.6978274644e+03
8.6978265688e+03 8.6978256534e+03 8.6978247173e+03 8.6978237593e+03 8.6978227783e+03
8.6978217729e+03 8.6978207419e+03 8.6978196837e+03 8.6978185967e+03 8.6978174792e+03
8.6978163292e+03 8.6978151447e+03 8.6978139233e+03 8.6978126626e+03 8.6978113598e+03
8.6978100118e+03 8.6978086152e+03 8.6978071662e+03 8.6978056606e+03 8.6978040935e+03
8.6978024597e+03 8.6978007529e+03 8.6977989662e+03 8.6977970914e+03 8.6977951193e+03
8.6977930389e+03 8.6977908372e+03 8.6977884990e+03 8.6977860058e+03 8.6977833355e+03
8.6977804617e+03 8.6977773529e+03 8.6977739708e+03 8.6977702667e+03 8.6977661665e+03
8.6977615451e+03 8.6977561310e+03 8.6977494549e+03 8.6977404130e+03 8.6977280948e+03
8.6977085873e+03 8.6976889153e+03 8.6976817518e+03

View File

@ -1,16 +1,26 @@
//! @file GenerateGrid.hypara
//! @brief This hypara file is for GenerateGrid.h,
//! which controls the scheme of GenerateGrid.
//! @author Lei Yinghaonan.
//! #########################################################################
//! # grid Contorl #
//! # grid scheme #
//! #########################################################################
//! gridDatabaseIndex: Controls the type of geometry to generate.
//! 1 -- Square for Taylor-Green Vortex with periodic boundary condition.
//! 2 -- Flat plate boundary layer with 1 part.
//! 3 -- Flat plate boundart later with 2 parts.
//! 4 -- Poiseuille flow.
int gridDataBaseIndex = 1;
string gridDataBaseFileName = "./bin/GridDataBase_TaylorGreenVortex.hypara";
//int gridDataBaseIndex = 2;
//string gridDataBaseFileName = "./bin/GridDataBase_Flat_Plate_Boundary_Layer_1_part.hypara";
// int gridDataBaseIndex = 1;
// string gridDataBaseFileName = "./bin/GridDataBase_TaylorGreenVortex.hypara";
int gridDataBaseIndex = 2;
string gridDataBaseFileName = "./bin/GridDataBase_Flat_Plate_Boundary_Layer_1_part.hypara";
//! #########################################################################
//! # grid IO #
//! #########################################################################
//! gridOutputFile: The name of output grid.
string gridOutputFile = "./grid/test_grid.fts";

View File

@ -1,4 +1,7 @@
//! Generate Supsonic Flat Plate Grid
//! @file GridDataBase_Flat_Plate_Boundary_Layer_1_part.hypara
//! @brief This hypara file controls the scheme of Grid Data base,
//! Which is a one part grid for 2-D Flat Plate boundary layer.
//! @author Lei Yinghaonan.
int nBlocks = 1;

View File

@ -1,3 +1,8 @@
//! @file GridDataBase_TaylorGreenVortex.hypara
//! @brief This hypara file controls the scheme of Grid Data base,
//! Which is a two dimensional uniform grid for Taylor-Green-Vortex.
//! @author Lei Yinghaonan.
int nBlocks = 1;
int nNodeX = 64;

View File

@ -0,0 +1,9 @@
//! @file UserDefineInterface_para.hypara
//! @brief This hypara file is controls UDF of flow.
//! @author Lei Yinghaonan.
#########################################################################
# user define parameter #
#########################################################################
int UDFInitFluid = 1;
string UDFInitFluidType = "TGV";

View File

@ -0,0 +1,30 @@
//! @file boundary_condition.hypara
//! @brief This hypara file controls Global boundary condition in "Simulation::InitGlobalBoundaryCondition()".
//! Here controls the boundary condition for particle.
//! @author Lei Yinghaonan.
int nBoundaryConditons = 4;
string bcName = "TGV_up1";
{
int bcType = 1009;
int bcParticleType = 1;
string periodicBC = "TGV_down1";
}
string bcName = "TGV_down1";
{
int bcType = 1009;
int bcParticleType = 1;
string periodicBC = "TGV_up1";
}
string bcName = "TGV_up2";
{
int bcType = 1009;
int bcParticleType = 1;
string periodicBC = "TGV_down2";
}
string bcName = "TGV_down2";
{
int bcType = 1009;
int bcParticleType = 1;
string periodicBC = "TGV_up2";
}

View File

@ -53,3 +53,4 @@ int numberOfGridProcessor = 0;
//@string parafilename2 = "";
string parafilename1 = "./bin/particle_para.hypara";
string parafilename2 = "./bin/UserDefineInterface_para.hypara";

View File

@ -1,16 +1,55 @@
#########################################################################
# Particle #
#########################################################################
//! @file particle_para.hypara
//! @brief This hypara file is for Param_ParticleSolver,
//! which controls the IO of particle files.
//! @author Lei Yinghaonan.
//! #########################################################################
//! # Particle Solver module #
//! #########################################################################
//! iParticleModel : The Solver for particle.
//! 0 -- Do not use particle solver.
//! 1 -- Particle Point Solver.
//! 2 -- Particle Resolved Solver.
int iParticleModel = 1;
//! #########################################################################
//! # Particle Interpolation #
//! #########################################################################
//! UseNewGhostPointPlan : If use a new plan for generating Ghost point of particle solver.
//! 0 -- Do not use new plan ,which use the default fluid solver scheme of ghost point.
//! 1 -- Use a new plan for particle solver ,which creat a new ghost point of grid.
//! GhostGrid_struct/unstruct : The scheme of particle interpolation for struct/unstruct grid.
//! OneLayerWithCorner -- One layer , ghost with corner point.
//! UDF -- The interface of user define function.
int UseNewGhostPointPlan = 1;
string GhostGrid_struct = "OneLayerWithCorner";
string GhostGrid_unstruct = "";
//! particleInterpolation_struct/unstruct : The scheme of particle interpolation for struct/unstruct grid.
//! TrilinearInterpolation -- Trilinear Interpolation,which only for orthogonal structural grid.
//! UDF -- The interface of user define function.
string particleInterpolation_struct = "TrilinearInterpolation";
string particleInterpolation_unstruct = "";
//! #########################################################################
//! # File in and out #
//! #########################################################################
//! ifInitParticle : If init particle field.
//! 0 -- do not init particle field.
//! 1 -- Init particle field by "initParticleFile".
//! initParticleFile : If init particle field, the file path for init ,
//! which is created by Matlab program.
int ifInitParticle = 1;
int ifReadRestartParticle = 0;
int ifWirteRestartParticle = 1;
string initParticleFile = "./grid/particle_init.h5";
//! ifReadRestartParticle : If read restart particle field.
//! 0 -- Do not read restart particle field.
//! 1 -- Read particle field by "restartParticleFile".
int ifReadRestartParticle = 0;
string restartParticleFile = "./grid/particle_restart.h5";
//! ifWirteRestartParticle : If write restart particle file.
//! 0 -- Do not write restart particle file.
//! 1 -- Write restart particle file.
int ifWirteRestartParticle = 1;
int intervalStepRestartParticle = 100;

Binary file not shown.