新增LBM算例6个

This commit is contained in:
hechao 2023-06-19 11:06:28 +08:00
parent 9a0ac605d8
commit 6eff6a7e02
46 changed files with 7765 additions and 4878 deletions

View File

@ -1,60 +0,0 @@
# nBoundaryConditons : number of global boundary conditions.
# bcName : Boundary Condition Name.
# bcType(in PHengLEI): Boundary Condition Type.
# Account of how to set boundaryconditon.
# string bcName = "Farfield";
# {
# int bcType = 4;
# int inflowParaType = 1;
# double attackd = 0;
# double refReNumber = 6.5e6;
# double refMachNumber = 3.5;
# double angleSlide = 0;
# }
int nBoundaryConditons = 7;
string bcName = "SOLID_SURFACE";
{
int bcType = 2;
}
string bcName = "Wall_16";
{
int bcType = 16;
}
string bcName = "Wall_17";
{
int bcType = 17;
}
string bcName = "Wall_18";
{
int bcType = 18;
}
string bcName = "SYMMETRY";
{
int bcType = 3;
}
string bcName = "FARFIELD";
{
int bcType = 4;
}
string bcName = "POLE1";
{
int bcType = 71;
}
# 'bcType' is defined as following:
# 99: PERIODIC
# -2: WAKE
# -1: INTERFACE
# 0 : NO_BOUNDARY_CONDITION
# 1 : EXTRAPOLATION
# 2 : SOLID_SURFACE
# 3 : SYMMETRY
# 4 : FARFIELD
# 5 : INFLOW
# 6 : OUTFLOW
# 52: PRESSURE_INLET
# 62: PRESSURE_OUTLET
# 61: OUTFLOW_CONFINED
# 7 : POLE

View File

@ -1,17 +0,0 @@
int taskSelector = 1;
int codeOfLargeScale = 0;
int numberOfMultigrid = 1;
int numberOfProcessors = 4;
string originalGridFile = "./grid/30p30n_str_3D.grd";
string originalBoundaryFile = "./grid/30p30n_str_3D.inp";
int numberOfGridGroups = 4;
int zoneSpan[numberOfGridGroups] = 3,4,4,5;
int solidBcSize = 2;
int solidColorList[solidBcSize] = 2,4;
int outerBcSize = 3;
int outerColorList[outerBcSize] = 16,17,18;

View File

@ -1,2 +0,0 @@
针对本算例风雷代码cmake构建的时候需要勾选USE_OVERSET选项
该算例当前只支持2171版本

View File

@ -1,61 +0,0 @@
# nBoundaryConditions: Number of global boundary conditions.
# bcName : Boundary condition name.
# bcType(in PHengLEI): Boundary condition type.
# How to set boundary condition, for example:
# string bcName = "Wall";
# {
# int bcType = 2;
# int viscousType = 1;
# double wallTemperature = -1.0;
# double uWall = 0.0;
# double vWall = 0.0;
# double wWall = 0.0;
# }
# string bcName = "Inflow";
# {
# int bcType = 5;
# int inflowParaType = 0;
# double refMachNumber = 0.73;
# double attackd = 2.79;
# double angleSlide = 0.0;
# double refReNumber = 6.5e6;
# double refDimensionalTemperature = 288.15;
# }
# For more information, see examples/bin/boundary_condition.hypara file!!!
int nBoundaryConditions = 3;
string bcName = "wall";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
}
string bcName = "inlet";
{
int bcType = 5;
string flowType = "FLOW_VELOCITY_INLET";
double flowU =0.9191874;
}
string bcName = "outlet";
{
int bcType = 6;
string flowType = "FLOW_PRESSURE_OUTLET";
double flowP =0;
}
# 'bcType' is defined as following:
# -2: WAKE
# -1: INTERFACE
# 0 : NO_BOUNDARY_CONDITION
# 1 : EXTRAPOLATION
# 2 : SOLID_SURFACE
# 3 : SYMMETRY
# 4 : FARFIELD
# 5 : INFLOW
# 6 : OUTFLOW
# 52: PRESSURE_INLET
# 62: PRESSURE_OUTLET
# 61: OUTFLOW_CONFINED
# 7 : POLE

View File

@ -1,215 +0,0 @@
#########################################################################
# General Control Parameter #
#########################################################################
// nIsComputeWallDist: Whether to compute the wall distance.
// 0 -- Compute wall distance.
// 1 -- Not compute.
// gridfile: The partitioned Grid file path, using relative path,
// which is relative to the working directory.
// 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.
// intervalStepRes: The step intervals for residual 'res.dat' saved.
// 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.
// compressible: An indicator that distinguishes density base from pressure base. 0-incompressible, 1-compressible
// isUnsteady: An indicator that distinguishes unsteady problem from steady problem. 0-steady, 1-unsteady
// startTime: The initial time of the unsteady simulation.
// endTime: The end time of the unsteady simulation.
// dt: The time interval of the unsteady simulation.
// innerIter: The number of step for current time.
// OutputTimeStep: The interval step of output for unsteady simulation.
int nIsComputeWallDist = 1;
string gridfile = "./grid/back.fts";
int maxSimuStep = 2000;
int intervalStepFlow = 2000;
int intervalStepPlot = 1000;
int intervalStepRes = 10;
double gridScaleFactor = 1.0;
int compressible = 0;
int iunsteady = 0;
double startTime = 0.0;
double endTime = 30;
double dt = 0.1;
int innerIter = 10;
int OutputTimeStep = 5;
#########################################################################
# Post-Processing #
#########################################################################
// nVisualVariables: Number of variables want to be dumped for tecplot visualization.
// visualVariables : Variable types dumped, listed as following:
// -- U(22), V(23), W(24), P(25), CP(26), T(27), DEN(28), VIS(29), TE(31), ED(32), enthalpy(70)
// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!!
// Variables order must from small to big.
int nVisualVariables = 4;
int visualVariables[] = [22, 23, 24, 25];
#########################################################################
# Flow Parameter #
#########################################################################
string FLOW[] = "FLOW";
// Initial value of variables or constant
double initRho = 1.0;
double initMu = 0.0001;
double initU = 0.9191874;
double initV = 0;
double initW = 0;
double initP = 0;
// Relaxing factor
double urfU = 0.4;
double urfV = 0.4;
double urfW = 0.4;
double urfP = 0.3;
double urfFlux = 0.4;
// Tolerance for governing equations
double resU = 1e-6;
double resV = 1e-6;
double resW = 1e-5;
double resP = 1e-5;
// Solver for solving linear system
// : CGS/GMRES/BiCGSTAB/AMG
string iterSolvU = "BiCGSTAB";
string iterSolvV = "BiCGSTAB";
string iterSolvW = "BiCGSTAB";
string iterSolvP = "AMG";
// Max Iter for solving linear system
int maxSweepU = 30;
int maxSweepV = 30;
int maxSweepW = 30;
int maxSweepP = 30;
// Tolerance for solving linear system
double iterSolvTolU = 1e-3;
double iterSolvTolV = 1e-3;
double iterSolvTolW = 1e-3;
double iterSolvTolP = 1e-2;
// Gradient Calculation
// : GAUSS/LSQ
string UGradCalc = "GAUSS";
string VGradCalc = "GAUSS";
string WGradCalc = "GAUSS";
string PGradCalc = "GAUSS";
// Convection scheme
// : UPWIND/CDS/QUICK/SUDS
string flowConvCalc = "UPWIND";
// Diffusion scheme(central difference)
// : NON_ORTHOGONAL
string flowDiffCalc = "NON_ORTHOGONAL";
// Transient scheme
// : CRANK_NICOLSON/IMPLICIT_2ND_ORDER/IMPLICIT_EULER
string flowTranCalc = "IMPLICIT_EULER";
// Source for flow
// : FLOW_DEFAULT/FLOW_GRAVITY
string flowSourceCalc[] = "FLOW_DEFAULT";
//string flowSourceCalc[] = "FLOW_DEFAULT FLOW_GRAVITY";
int bodyForceFlag = 0;
//double gravityX = 0.0;
//double gravityY = -9.81;
//double gravityZ = 0.0;
int isBoussinesq = 0;
#########################################################################
# Turbulence Parameter #
#########################################################################
// turb SA
//int viscousType = 11; //SPALART_ALLMARAS = 11, KEPSILON = 13
string TURB_SA[] = ["TURB_SA"];
string TURB_SA_SCALAR_NAME[] = ["kinetic"];
double urfMu = 1.0;
double kineticInitValue = 1.0;
string kineticConvCalc = "UPWIND";
string kineticDiffCalc = "NON_ORTHOGONAL";
string kineticSourceCalc[] = "TURB_SA_DEFAULT";
double kineticUrf = 1.0;
double kineticRes = 1e-6;
string turbIterSolv = "BiCGSTAB";
int turbMaxSweep = 30;
double turbIterSolvTol = 1e-12;
// turb K-EPSILON
//int viscousType = 13; //SPALART_ALLMARAS = 11, KEPSILON = 13
string TURB_K_EPSILON[] = ["TURB_K","TURB_EPSILON"];
string TURB_K_EPSILON_SCALAR_NAME[] = ["kinetic", "epsilon
string turbIterSolv = "BiCGSTAB";
int turbMaxSweep = 30;
double turbIterSolvTol = 1e-12;
string TURB_K[] = ["TURB_K"];
string TURB_K_SCALAR_NAME[] = ["kinetic"];
string TURB_EPSILON[] = ["TURB_EPSILON"];
string TURB_EPSILON_SCALAR_NAME[] = ["epsilon"];
double urfMu = 1.0;
// turb k
double kineticInitValue = 15.48;
string kineticConvCalc = "UPWIND";
string kineticDiffCalc = "NON_ORTHOGONAL";
string kineticSourceCalc[] = "TURB_K_DEFAULT";
double kineticUrf = 0.6;
double kineticRes = 1e-6;
// turb epsilon
double epsilonInitValue = 200.3;
string epsilonConvCalc = "UPWIND";
string epsilonDiffCalc = "NON_ORTHOGONAL";
string epsilonSourceCalc[] = "TURB_EPSILON_DEFAULT";
double epsilonUrf = 0.6;
double epsilonRes = 1e-6;
#########################################################################
# Energy Parameter #
#########################################################################
// energyType: The energy solver switch. 0-off, 1-on
// ENERGY[]: Solver binding for factory mode.
// ENERGY_SCALAR_NAME[]: The name of variable to be solved in energy equation.
// energyPrintName[]: The output on the screen during the solution.
int energyType = 0;
string ENERGY[] = ["ENERGY"];
string ENERGY_SCALAR_NAME[] = "enthalpy";
string energyPrintName[] = ["H"];
// Initial value of variables or constant
double initT = 273.0;
double initK = 0.026;
double initCPg = 1007.0;
double urfT = 0.8;
double urfH = 0.7;
double enthalpyInitValue = 0.21;
// Discrete schemes
string energyConvCalc = "UPWIND";
string energyDiffCalc = "NON_ORTHOGONAL";
string energySourceCalc[] = ["EMPTY"];
string energyGradCalc = "GAUSS";
string energyTranCalc = "IMPLICIT_EULER";
// Set for solving linear equations
string enthalpyIterSolv = "BiCGSTAB";
int enthalpyMaxSweep = 30;
double enthalpyIterSolvTol = 1e-12;
double enthalpyRes = 1e-6;

View File

@ -1,30 +0,0 @@
#########################################################################
# Grid data type #
#########################################################################
// gridtype: Grid type for generation, conversion, reconstruction, merging.
// 0 -- Unstructured grid.
// 1 -- Structured grid.
// axisup: Type of Cartisien coordinates system, used in grid conversion.
// 1 -- Y upward. (default)
// 2 -- Z upward.
// from_gtype: Type of grid data type in grid conversion process.
// -1 -- MULTI_TYPE.
// 1 -- PHengLEI, *.fts.
// 2 -- CGNS, *.cgns.
// 3 -- Plot3D type of structured grid, *.dat/*.grd.
// 4 -- Fieldview type of unstructured grid, *.dat/*.inp.
// 5 -- Fluent, *.cas/*.msh.
// 6 -- Ustar, mgrid.in.
// 7 -- Hybrid, include both of unstructured and structured grid, *.fts.
// 8 -- GMSH, *.msh.
int gridtype = 0;
int axisup = 1;
int from_gtype = 5;
#########################################################################
# File path #
#########################################################################
// from_gfile: path of original data file for unstructure grid convert from.
// out_gfile: path of target file for grid convert to, *.fts type of file usually.
string from_gfile = "./grid/back.cas";
string out_gfile = "./grid/back.fts";

View File

@ -1,52 +0,0 @@
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.
int ndim = 2;
int nparafile = 1;
int nsimutask = 0;
string parafilename = "./bin/cfd_para_incompressible.hypara"
//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";
//int nsimutask = 1;
//string parafilename = "./bin/grid_para.hypara";
//int nsimutask = 2;
//string parafilename = "./bin/cfd_para.hypara";
//int nsimutask = 3;
//string parafilename = "./bin/partition.hypara";
//int nsimutask = 1;
//string parafilename = "./bin/grid_deform_para.hypara";
//int nsimutask = 1;
//string parafilename = "./bin/grid_refine_para.hypara";
//int nsimutask = 14;
//string parafilename = "./bin/integrative_solver.hypara";
//int nsimutask = 99;
//string parafilename = "./bin/post_processing.hypara";
// ---------------- Advanced Parameters, DO NOT care it ----------------
int numberOfGridProcessor = 0;
// ATP read
//@string parafilename1 = ""
//@string parafilename2 = "";

View File

@ -1,5 +0,0 @@
红山开源风雷算例库原始网格获取百度网盘链接:
链接http://pan.baidu.com/s/1aZ9cdkp6CkT9il4fEpnTcA
提取码w47m
plot3D格式网格需同时下载.grd和.inp文件

View File

@ -1,73 +0,0 @@
# nBoundaryConditions: Number of global boundary conditions.
# bcName : Boundary condition name.
# bcType(in PHengLEI): Boundary condition type.
# How to set boundary condition, for example:
# string bcName = "Wall";
# {
# int bcType = 2;
# int viscousType = 1;
# double wallTemperature = -1.0;
# double uWall = 0.0;
# double vWall = 0.0;
# double wWall = 0.0;
# }
# string bcName = "Inflow";
# {
# int bcType = 5;
# int inflowParaType = 0;
# double refMachNumber = 0.73;
# double attackd = 2.79;
# double angleSlide = 0.0;
# double refReNumber = 6.5e6;
# double refDimensionalTemperature = 288.15;
# }
# For more information, see examples/bin/boundary_condition.hypara file!!!
int nBoundaryConditions = 4;
string bcName = "bottomwall";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
string energyBoundaryType = "ENERGY_WALL";
}
string bcName = "coldwall";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
string energyBoundaryType = "ENERGY_WALL";
double T = 290.0;
}
string bcName = "hotwall";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
string energyBoundaryType = "ENERGY_WALL";
double T = 305.0;
}
string bcName = "topwall";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
string energyBoundaryType = "ENERGY_WALL";
}
# 'bcType' is defined as following:
# -2: WAKE
# -1: INTERFACE
# 0 : NO_BOUNDARY_CONDITION
# 1 : EXTRAPOLATION
# 2 : SOLID_SURFACE
# 3 : SYMMETRY
# 4 : FARFIELD
# 5 : INFLOW
# 6 : OUTFLOW
# 52: PRESSURE_INLET
# 62: PRESSURE_OUTLET
# 61: OUTFLOW_CONFINED
# 7 : POLE

View File

@ -1,214 +0,0 @@
#########################################################################
# General Control Parameter #
#########################################################################
// nIsComputeWallDist: Whether to compute the wall distance.
// 0 -- Compute wall distance.
// 1 -- Not compute.
// gridfile: The partitioned Grid file path, using relative path,
// which is relative to the working directory.
// 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.
// intervalStepRes: The step intervals for residual 'res.dat' saved.
// 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.
// compressible: An indicator that distinguishes density base from pressure base. 0-incompressible, 1-compressible
// isUnsteady: An indicator that distinguishes unsteady problem from steady problem. 0-steady, 1-unsteady
// startTime: The initial time of the unsteady simulation.
// endTime: The end time of the unsteady simulation.
// dt: The time interval of the unsteady simulation.
// innerIter: The number of step for current time.
// OutputTimeStep: The interval step of output for unsteady simulation.
int nIsComputeWallDist = 1;
string gridfile = "./grid/run.fts";
int maxSimuStep = 10000;
int intervalStepFlow = 2000;
int intervalStepPlot = 1000;
int intervalStepRes = 10;
double gridScaleFactor = 1.0;
int compressible = 0;
int iunsteady = 0;
double startTime = 0.0;
double endTime = 20.0;
double dt = 0.1;
int innerIter = 10;
int OutputTimeStep = 5;
#########################################################################
# Post-Processing #
#########################################################################
// nVisualVariables: Number of variables want to be dumped for tecplot visualization.
// visualVariables : Variable types dumped, listed as following:
// -- U(22), V(23), W(24), P(25), CP(26), T(27), DEN(28), VIS(29), TE(31), ED(32), enthalpy(70)
// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!!
// Variables order must from small to big.
int nVisualVariables = 6;
int visualVariables[] = [22, 23, 24, 25, 27, 70];
#########################################################################
# Flow Parameter #
#########################################################################
string FLOW[] = "FLOW";
// Initial value of variables or constant
double initRho = 1.1405;
double initMu = 1.7894e-5;
double initU = 0;
double initV = 0;
double initW = 0;
double initP = 0;
// Relaxing factor
double urfU = 0.7;
double urfV = 0.7;
double urfW = 0.7;
double urfP = 0.3;
double urfFlux = 0.0;
// Tolerance for governing equations
double resU = 1e-6;
double resV = 1e-6;
double resW = 1e-5;
double resP = 1e-5;
// Solver for solving linear system
// : CGS/GMRES/BiCGSTAB/AMG
string iterSolvU = "BiCGSTAB";
string iterSolvV = "BiCGSTAB";
string iterSolvW = "BiCGSTAB";
string iterSolvP = "GMRES";
// Max Iter for solving linear system
int maxSweepU = 30;
int maxSweepV = 30;
int maxSweepW = 30;
int maxSweepP = 30;
// Tolerance for solving linear system
double iterSolvTolU = 1e-3;
double iterSolvTolV = 1e-3;
double iterSolvTolW = 1e-3;
double iterSolvTolP = 1e-2;
// Gradient Calculation
// : GAUSS/LSQ
string UGradCalc = "GAUSS";
string VGradCalc = "GAUSS";
string WGradCalc = "GAUSS";
string PGradCalc = "GAUSS";
// Convection scheme
// : UPWIND/CDS/QUICK/SUDS
string flowConvCalc = "UPWIND";
// Diffusion scheme(central difference)
// : NON_ORTHOGONAL
string flowDiffCalc = "NON_ORTHOGONAL";
// Transient scheme
// : CRANK_NICOLSON/IMPLICIT_2ND_ORDER/IMPLICIT_EULER
string flowTranCalc = "IMPLICIT_EULER";
// Source for flow
// : FLOW_DEFAULT/FLOW_GRAVITY
//string flowSourceCalc[] = "FLOW_DEFAULT";
string flowSourceCalc[] = "FLOW_DEFAULT FLOW_GRAVITY";
int bodyForceFlag = 1;
double gravityX = 0.0;
double gravityY = -9.81;
double gravityZ = 0.0;
int isBoussinesq = 1;
double thermalExpansion = 3.44827e-3;
double refT = 290;
#########################################################################
# Turbulence Parameter #
#########################################################################
//int viscousType = 13; //SPALART_ALLMARAS = 11, KEPSILON = 13
//turb SA
string TURB_SA[] = ["TURB_SA"];
string TURB_SA_SCALAR_NAME[] = ["kinetic"];
double urfMu = 1.0;
double kineticInitValue = 1.0;
string kineticConvCalc = "UPWIND";
string kineticDiffCalc = "NON_ORTHOGONAL";
string kineticSourceCalc[] = "TURB_SA_DEFAULT";
double kineticUrf = 1.0;
double kineticRes = 1e-6;
string turbIterSolv = "BiCGSTAB";
int turbMaxSweep = 30;
double turbIterSolvTol = 1e-12;
//turb KEPSILON
string TURB_K_EPSILON[] = ["TURB_K","TURB_EPSILON"];
string TURB_K_EPSILON_SCALAR_NAME[] = ["kinetic", "epsilon"];
string TURB_K[] = ["TURB_K"];
string TURB_K_SCALAR_NAME[] = ["kinetic"];
string TURB_EPSILON[] = ["TURB_EPSILON"];
string TURB_EPSILON_SCALAR_NAME[] = ["epsilon"];
double urfMu = 1.0;
// turb k
double kineticInitValue = 1.0;
string kineticConvCalc = "UPWIND";
string kineticDiffCalc = "NON_ORTHOGONAL";
string kineticSourceCalc[] = "TURB_K_DEFAULT";
double kineticUrf = 1.0;
double kineticRes = 1e-6;
// turb epsilon
double epsilonInitValue = 1.0;
string epsilonConvCalc = "UPWIND";
string epsilonDiffCalc = "NON_ORTHOGONAL";
string epsilonSourceCalc[] = "TURB_EPSILON_DEFAULT";
double epsilonUrf = 1.0;
double epsilonRes = 1e-6;
#########################################################################
# Energy Parameter #
#########################################################################
// energyType: The energy solver switch. 0-off, 1-on
// ENERGY[]: Solver binding for factory mode.
// ENERGY_SCALAR_NAME[]: The name of variable to be solved in energy equation.
// energyPrintName[]: The output on the screen during the solution.
int energyType = 1;
string ENERGY[] = ["ENERGY"];
string ENERGY_SCALAR_NAME[] = "enthalpy";
string energyPrintName[] = ["H"];
// Initial value of variables or constant
double initT = 295;
double initK = 0.0242;
double initCPg = 1006.43;
double urfT = 0.2;
double urfH = 0.2;
double enthalpyInitValue = 0.21;
// Discrete schemes
string energyConvCalc = "UPWIND";
string energyDiffCalc = "NON_ORTHOGONAL";
string energySourceCalc[] = ["EMPTY"];
string energyGradCalc = "GAUSS";
string energyTranCalc = "IMPLICIT_EULER";
// Set for solving linear equations
string enthalpyIterSolv = "BiCGSTAB";
int enthalpyMaxSweep = 30;
double enthalpyIterSolvTol = 1e-12;
double enthalpyRes = 1e-6;

View File

@ -1,30 +0,0 @@
#########################################################################
# Grid data type #
#########################################################################
// gridtype: Grid type for generation, conversion, reconstruction, merging.
// 0 -- Unstructured grid.
// 1 -- Structured grid.
// axisup: Type of Cartisien coordinates system, used in grid conversion.
// 1 -- Y upward. (default)
// 2 -- Z upward.
// from_gtype: Type of grid data type in grid conversion process.
// -1 -- MULTI_TYPE.
// 1 -- PHengLEI, *.fts.
// 2 -- CGNS, *.cgns.
// 3 -- Plot3D type of structured grid, *.dat/*.grd.
// 4 -- Fieldview type of unstructured grid, *.dat/*.inp.
// 5 -- Fluent, *.cas/*.msh.
// 6 -- Ustar, mgrid.in.
// 7 -- Hybrid, include both of unstructured and structured grid, *.fts.
// 8 -- GMSH, *.msh.
int gridtype = 0;
int axisup = 1;
int from_gtype = 5;
#########################################################################
# File path #
#########################################################################
// from_gfile: path of original data file for unstructure grid convert from.
// out_gfile: path of target file for grid convert to, *.fts type of file usually.
string from_gfile = "./grid/run.cas";
string out_gfile = "./grid/run.fts";

View File

@ -1,5 +0,0 @@
红山开源风雷算例库原始网格获取百度网盘链接:
链接http://pan.baidu.com/s/1aZ9cdkp6CkT9il4fEpnTcA
提取码w47m
plot3D格式网格需同时下载.grd和.inp文件

View File

@ -1,68 +0,0 @@
# nBoundaryConditions: Number of global boundary conditions.
# bcName : Boundary condition name.
# bcType(in PHengLEI): Boundary condition type.
# How to set boundary condition, for example:
# string bcName = "Wall";
# {
# int bcType = 2;
# int viscousType = 1;
# double wallTemperature = -1.0;
# double uWall = 0.0;
# double vWall = 0.0;
# double wWall = 0.0;
# }
# string bcName = "Inflow";
# {
# int bcType = 5;
# int inflowParaType = 0;
# double refMachNumber = 0.73;
# double attackd = 2.79;
# double angleSlide = 0.0;
# double refReNumber = 6.5e6;
# double refDimensionalTemperature = 288.15;
# }
# For more information, see examples/bin/boundary_condition.hypara file!!!
int nBoundaryConditions = 4;
string bcName = "bottom";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
}
string bcName = "left";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
}
string bcName = "right";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
}
string bcName = "top";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
double flowU = 1.0;
}
# 'bcType' is defined as following:
# -2: WAKE
# -1: INTERFACE
# 0 : NO_BOUNDARY_CONDITION
# 1 : EXTRAPOLATION
# 2 : SOLID_SURFACE
# 3 : SYMMETRY
# 4 : FARFIELD
# 5 : INFLOW
# 6 : OUTFLOW
# 52: PRESSURE_INLET
# 62: PRESSURE_OUTLET
# 61: OUTFLOW_CONFINED
# 7 : POLE

View File

@ -1,197 +0,0 @@
#########################################################################
# General Control Parameter #
#########################################################################
// nIsComputeWallDist: Whether to compute the wall distance.
// 0 -- Compute wall distance.
// 1 -- Not compute.
// gridfile: The partitioned Grid file path, using relative path,
// which is relative to the working directory.
// 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.
// intervalStepRes: The step intervals for residual 'res.dat' saved.
// 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.
// compressible: An indicator that distinguishes density base from pressure base. 0-incompressible, 1-compressible
// isUnsteady: An indicator that distinguishes unsteady problem from steady problem. 0-steady, 1-unsteady
// startTime: The initial time of the unsteady simulation.
// endTime: The end time of the unsteady simulation.
// dt: The time interval of the unsteady simulation.
// innerIter: The number of step for current time.
// OutputTimeStep: The interval step of output for unsteady simulation.
int nIsComputeWallDist = 1;
string gridfile = "./grid/cavity.fts";
int maxSimuStep = 10000;
int intervalStepFlow = 2000;
int intervalStepPlot = 2000;
int intervalStepRes = 10;
double gridScaleFactor = 1.0;
int compressible = 0;
int iunsteady = 0;
double startTime = 0.0;
double endTime = 30;
double dt = 0.1;
int innerIter = 10;
int OutputTimeStep = 5;
#########################################################################
# Post-Processing #
#########################################################################
// nVisualVariables: Number of variables want to be dumped for tecplot visualization.
// visualVariables : Variable types dumped, listed as following:
// -- U(22), V(23), W(24), P(25), CP(26), T(27), DEN(28), VIS(29), TE(31), ED(32), enthalpy(70)
// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!!
// Variables order must from small to big.
int nVisualVariables = 4;
int visualVariables[] = [22, 23, 24, 25];
#########################################################################
# Flow Parameter #
#########################################################################
string FLOW[] = "FLOW";
// Initial value of variables or constant
double initRho = 1.0;
double initMu = 0.001;
double initU = 0;
double initV = 0;
double initW = 0;
double initP = 0;
// Relaxing factor
double urfU = 0.4;
double urfV = 0.4;
double urfW = 0.4;
double urfP = 0.7;
double urfFlux = 0.4;
// Tolerance for governing equations
double resU = 1e-6;
double resV = 1e-6;
double resW = 1e-5;
double resP = 1e-5;
// Solver for solving linear system
// : CGS/GMRES/BiCGSTAB/AMG
string iterSolvU = "BiCGSTAB";
string iterSolvV = "BiCGSTAB";
string iterSolvW = "BiCGSTAB";
string iterSolvP = "GMRES";
// Max Iter for solving linear system
int maxSweepU = 30;
int maxSweepV = 30;
int maxSweepW = 30;
int maxSweepP = 30;
// Tolerance for solving linear system
double iterSolvTolU = 1e-3;
double iterSolvTolV = 1e-3;
double iterSolvTolW = 1e-3;
double iterSolvTolP = 1e-2;
// Gradient Calculation
// : GAUSS/LSQ
string UGradCalc = "GAUSS";
string VGradCalc = "GAUSS";
string WGradCalc = "GAUSS";
string PGradCalc = "GAUSS";
// Convection scheme
// : UPWIND/CDS/QUICK/SUDS
string flowConvCalc = "UPWIND";
// Diffusion scheme(central difference)
// : NON_ORTHOGONAL
string flowDiffCalc = "NON_ORTHOGONAL";
// Transient scheme
// : CRANK_NICOLSON/IMPLICIT_2ND_ORDER/IMPLICIT_EULER
string flowTranCalc = "IMPLICIT_EULER";
// Source for flow
// : FLOW_DEFAULT/FLOW_GRAVITY
string flowSourceCalc[] = "FLOW_DEFAULT";
// string flowSourceCalc[] = "FLOW_DEFAULT FLOW_GRAVITY";
int bodyForceFlag = 0;
int isBoussinesq = 0;
//double gravityX = 0.0;
//double gravityY = -9.81;
//double gravityZ = 0.0;
#########################################################################
# Turbulence Parameter #
#########################################################################
// turb K-EPSILON
//int viscousType = 13; //SPALART_ALLMARAS = 11, KEPSILON = 13
string TURB_K_EPSILON[] = ["TURB_K","TURB_EPSILON"];
string TURB_K_EPSILON_SCALAR_NAME[] = ["kinetic", "epsilon"];
string turbIterSolv = "BiCGSTAB";
int turbMaxSweep = 30;
double turbIterSolvTol = 1e-12;
string TURB_K[] = ["TURB_K"];
string TURB_K_SCALAR_NAME[] = ["kinetic"];
string TURB_EPSILON[] = ["TURB_EPSILON"];
string TURB_EPSILON_SCALAR_NAME[] = ["epsilon"];
double urfMu = 1.0;
// turb k
double kineticInitValue = 1.0;
string kineticConvCalc = "UPWIND";
string kineticDiffCalc = "NON_ORTHOGONAL";
string kineticSourceCalc[] = "TURB_K_DEFAULT";
double kineticUrf = 1.0;
double kineticRes = 1e-6;
// turb epsilon
double epsilonInitValue = 1.0;
string epsilonConvCalc = "UPWIND";
string epsilonDiffCalc = "NON_ORTHOGONAL";
string epsilonSourceCalc[] = "TURB_EPSILON_DEFAULT";
double epsilonUrf = 1.0;
double epsilonRes = 1e-6;
#########################################################################
# Energy Parameter #
#########################################################################
// energyType: The energy solver switch. 0-off, 1-on
// ENERGY[]: Solver binding for factory mode.
// ENERGY_SCALAR_NAME[]: The name of variable to be solved in energy equation.
// energyPrintName[]: The output on the screen during the solution.
int energyType = 0;
string ENERGY[] = ["ENERGY"];
string ENERGY_SCALAR_NAME[] = "enthalpy";
string energyPrintName[] = ["H"];
// Initial value of variables or constant
double initT = 273.0;
double initK = 0.026;
double initCPg = 1007.0;
double urfT = 0.8;
double urfH = 0.7;
double enthalpyInitValue = 0.21;
// Discrete schemes
string energyConvCalc = "UPWIND";
string energyDiffCalc = "NON_ORTHOGONAL";
string energySourceCalc[] = ["EMPTY"];
string energyGradCalc = "GAUSS";
string energyTranCalc = "IMPLICIT_EULER";
// Set for solving linear equations
string enthalpyIterSolv = "BiCGSTAB";
int enthalpyMaxSweep = 30;
double enthalpyIterSolvTol = 1e-12;
double enthalpyRes = 1e-6;

View File

@ -1,30 +0,0 @@
#########################################################################
# Grid data type #
#########################################################################
// gridtype: Grid type for generation, conversion, reconstruction, merging.
// 0 -- Unstructured grid.
// 1 -- Structured grid.
// axisup: Type of Cartisien coordinates system, used in grid conversion.
// 1 -- Y upward. (default)
// 2 -- Z upward.
// from_gtype: Type of grid data type in grid conversion process.
// -1 -- MULTI_TYPE.
// 1 -- PHengLEI, *.fts.
// 2 -- CGNS, *.cgns.
// 3 -- Plot3D type of structured grid, *.dat/*.grd.
// 4 -- Fieldview type of unstructured grid, *.dat/*.inp.
// 5 -- Fluent, *.cas/*.msh.
// 6 -- Ustar, mgrid.in.
// 7 -- Hybrid, include both of unstructured and structured grid, *.fts.
// 8 -- GMSH, *.msh.
int gridtype = 0;
int axisup = 1;
int from_gtype = 5;
#########################################################################
# File path #
#########################################################################
// from_gfile: path of original data file for unstructure grid convert from.
// out_gfile: path of target file for grid convert to, *.fts type of file usually.
string from_gfile = "./grid/cavity.cas";
string out_gfile = "./grid/cavity.fts";

View File

@ -1,5 +0,0 @@
红山开源风雷算例库原始网格获取百度网盘链接:
链接http://pan.baidu.com/s/1aZ9cdkp6CkT9il4fEpnTcA
提取码w47m
plot3D格式网格需同时下载.grd和.inp文件

View File

@ -1,71 +0,0 @@
# nBoundaryConditions: Number of global boundary conditions.
# bcName : Boundary condition name.
# bcType(in PHengLEI): Boundary condition type.
# How to set boundary condition, for example:
# string bcName = "Wall";
# {
# int bcType = 2;
# int viscousType = 1;
# double wallTemperature = -1.0;
# double uWall = 0.0;
# double vWall = 0.0;
# double wWall = 0.0;
# }
# string bcName = "Inflow";
# {
# int bcType = 5;
# int inflowParaType = 0;
# double refMachNumber = 0.73;
# double attackd = 2.79;
# double angleSlide = 0.0;
# double refReNumber = 6.5e6;
# double refDimensionalTemperature = 288.15;
# }
# For more information, see examples/bin/boundary_condition.hypara file!!!
int nBoundaryConditions = 3;
string bcName = "in";
{
int bcType = 5;
string flowType = "FLOW_VELOCITY_INLET";
string kineticBoundaryType = "TURB_K_INLET";
string epsilonBoundaryType = "TURB_EPSILON_INLET";
double flowW = 50;
double kinetic = 9.375004;
double epsilon = 54151.86;
}
string bcName = "out";
{
int bcType = 6;
string flowType = "FLOW_PRESSURE_OUTLET";
string kineticBoundaryType = "TURB_K_PRESSUREOUTLET";
string epsilonBoundaryType = "TURB_EPSILON_PRESSUREOUTLET";
double flowP = 0;
double kinetic = 9.375004;
double epsilon = 54151.86;
}
string bcName = "wall";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
string kineticBoundaryType = "TURB_K_WALL";
string epsilonBoundaryType = "TURB_EPSILON_WALL";
}
# 'bcType' is defined as following:
# -2: WAKE
# -1: INTERFACE
# 0 : NO_BOUNDARY_CONDITION
# 1 : EXTRAPOLATION
# 2 : SOLID_SURFACE
# 3 : SYMMETRY
# 4 : FARFIELD
# 5 : INFLOW
# 6 : OUTFLOW
# 52: PRESSURE_INLET
# 62: PRESSURE_OUTLET
# 61: OUTFLOW_CONFINED
# 7 : POLE

View File

@ -1,202 +0,0 @@
#########################################################################
# General Control Parameter #
#########################################################################
// nIsComputeWallDist: Whether to compute the wall distance.
// 0 -- Compute wall distance.
// 1 -- Not compute.
// gridfile: The partitioned Grid file path, using relative path,
// which is relative to the working directory.
// 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.
// intervalStepRes: The step intervals for residual 'res.dat' saved.
// 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.
// compressible: An indicator that distinguishes density base from pressure base. 0-incompressible, 1-compressible
// isUnsteady: An indicator that distinguishes unsteady problem from steady problem. 0-steady, 1-unsteady
// startTime: The initial time of the unsteady simulation.
// endTime: The end time of the unsteady simulation.
// dt: The time interval of the unsteady simulation.
// innerIter: The number of step for current time.
// OutputTimeStep: The interval step of output for unsteady simulation.
int nIsComputeWallDist = 1;
string gridfile = "./grid/pipe.fts";
int maxSimuStep = 10000;
int intervalStepFlow = 1000;
int intervalStepPlot = 1000;
int intervalStepRes = 1000;
double gridScaleFactor = 1;
int compressible = 0;
int iunsteady = 0;
double startTime = 0.0;
double endTime = 5;
double dt = 0.1;
int innerIter = 10;
int OutputTimeStep = 5;
#########################################################################
# Post-Processing #
#########################################################################
// nVisualVariables: Number of variables want to be dumped for tecplot visualization.
// visualVariables : Variable types dumped, listed as following:
// -- U(22), V(23), W(24), P(25), CP(26), T(27), DEN(28), VIS(29), TE(31), ED(32), enthalpy(57)
// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!!
// Variables order must from small to big.
// plotFieldType: If dump out the field results to visulization.
int plotFieldType = 1;
//int nVisualVariables = 4;
//int visualVariables[] = [22, 23, 24, 25];
int nVisualVariables = 7;
int visualVariables[] = [22, 23, 24, 25, 29,31,32];
#########################################################################
# Flow Parameter #
#########################################################################
string FLOW[] = "FLOW";
// Initial value of variables or constant
double initRho = 1.225;
double initMu = 1.7894e-05;
double initU = 0;
double initV = 0;
double initW = 50;
double initP = 0;
// Relaxing factor
double urfU = 0.4;
double urfV = 0.4;
double urfW = 0.4;
double urfP = 0.3;
double urfFlux = 0.4;
// Tolerance for governing equations
double resU = 1e-6;
double resV = 1e-6;
double resW = 1e-5;
double resP = 1e-5;
// Solver for solving linear system
// : CGS/GMRES/BiCGSTAB/AMG
string iterSolvU = "BiCGSTAB";
string iterSolvV = "BiCGSTAB";
string iterSolvW = "BiCGSTAB";
string iterSolvP = "AMG";
// Max Iter for solving linear system
int maxSweepU = 30;
int maxSweepV = 30;
int maxSweepW = 30;
int maxSweepP = 30;
// Tolerance for solving linear system
double iterSolvTolU = 1e-4;
double iterSolvTolV = 1e-4;
double iterSolvTolW = 1e-4;
double iterSolvTolP = 1e-3;
// Gradient Calculation
// : GAUSS/LSQ
string UGradCalc = "GAUSS";
string VGradCalc = "GAUSS";
string WGradCalc = "GAUSS";
string PGradCalc = "GAUSS";
// Convection scheme
// : UPWIND/CDS/QUICK/SUDS
string flowConvCalc = "UPWIND";
// Diffusion scheme(central difference)
// : NON_ORTHOGONAL
string flowDiffCalc = "NON_ORTHOGONAL";
// Transient scheme
// : CRANK_NICOLSON/IMPLICIT_2ND_ORDER/IMPLICIT_EULER
string flowTranCalc = "IMPLICIT_EULER";
// Source for flow
// : FLOW_DEFAULT/FLOW_GRAVITY
string flowSourceCalc[] = "FLOW_DEFAULT";
//string flowSourceCalc[] = "FLOW_DEFAULT FLOW_GRAVITY";
int bodyForceFlag = 0;
double gravityX = 0.0;
double gravityY = -9.81;
double gravityZ = 0.0;
#########################################################################
# Turbulence Parameter #
#########################################################################
int viscousType = 13; //SPALART_ALLMARAS = 11, KEPSILON = 13
//turb K-EPSILON
string TURB_K_EPSILON[] = ["TURB_K","TURB_EPSILON"];
string TURB_K_EPSILON_SCALAR_NAME[] = ["kinetic", "epsilon"];
string TURB_K[] = ["TURB_K"];
string TURB_K_SCALAR_NAME[] = ["kinetic"];
string TURB_EPSILON[] = ["TURB_EPSILON"];
string TURB_EPSILON_SCALAR_NAME[] = ["epsilon"];
double urfMu = 0.6;
string turbIterSolv = "BiCGSTAB";
int turbMaxSweep = 30;
double turbIterSolvTol = 1e-12;
// turb k
double kineticInitValue = 9.375001;
string kineticConvCalc = "UPWIND";
string kineticDiffCalc = "NON_ORTHOGONAL";
string kineticSourceCalc[] = "TURB_K_DEFAULT";
double kineticUrf = 0.6;
double kineticRes = 1e-6;
// turb epsilon
double epsilonInitValue = 54151.86;
string epsilonConvCalc = "UPWIND";
string epsilonDiffCalc = "NON_ORTHOGONAL";
string epsilonSourceCalc[] = "TURB_EPSILON_DEFAULT";
double epsilonUrf = 0.6;
double epsilonRes = 1e-6;
#########################################################################
# Energy Parameter #
#########################################################################
// energyType: The energy solver switch. 0-off, 1-on
// ENERGY[]: Solver binding for factory mode.
// ENERGY_SCALAR_NAME[]: The name of variable to be solved in energy equation.
// energyPrintName[]: The output on the screen during the solution.
int energyType = 0;
string ENERGY[] = ["ENERGY"];
string ENERGY_SCALAR_NAME[] = "enthalpy";
string energyPrintName[] = ["H"];
// Initial value of variables or constant
double initT = 273.0;
double initK = 0.026;
double initCPg = 1007.0;
double urfT = 0.8;
double urfH = 0.7;
double enthalpyInitValue = 0.21;
// Discrete schemes
string energyConvCalc = "UPWIND";
string energyDiffCalc = "NON_ORTHOGONAL";
string energySourceCalc[] = ["EMPTY"];
string energyGradCalc = "GAUSS";
string energyTranCalc = "IMPLICIT_EULER";
// Set for solving linear equations
string enthalpyIterSolv = "BiCGSTAB";
int enthalpyMaxSweep = 30;
double enthalpyIterSolvTol = 1e-12;
double enthalpyRes = 1e-6;

View File

@ -1,30 +0,0 @@
#########################################################################
# Grid data type #
#########################################################################
// gridtype: Grid type for generation, conversion, reconstruction, merging.
// 0 -- Unstructured grid.
// 1 -- Structured grid.
// axisup: Type of Cartisien coordinates system, used in grid conversion.
// 1 -- Y upward. (default)
// 2 -- Z upward.
// from_gtype: Type of grid data type in grid conversion process.
// -1 -- MULTI_TYPE.
// 1 -- PHengLEI, *.fts.
// 2 -- CGNS, *.cgns.
// 3 -- Plot3D type of structured grid, *.dat/*.grd.
// 4 -- Fieldview type of unstructured grid, *.dat/*.inp.
// 5 -- Fluent, *.cas/*.msh.
// 6 -- Ustar, mgrid.in.
// 7 -- Hybrid, include both of unstructured and structured grid, *.fts.
// 8 -- GMSH, *.msh.
int gridtype = 0;
int axisup = 1;
int from_gtype = 5;
#########################################################################
# File path #
#########################################################################
// from_gfile: path of original data file for unstructure grid convert from.
// out_gfile: path of target file for grid convert to, *.fts type of file usually.
string from_gfile = "./grid/pipe.cas";
string out_gfile = "./grid/pipe.fts";

View File

@ -1,5 +0,0 @@
红山开源风雷算例库原始网格获取百度网盘链接:
链接http://pan.baidu.com/s/1aZ9cdkp6CkT9il4fEpnTcA
提取码w47m
plot3D格式网格需同时下载.grd和.inp文件

View File

@ -1,63 +0,0 @@
# nBoundaryConditons : number of global boundary conditions.
# bcName : Boundary Condition Name.
# bcType(in PHengLEI): Boundary Condition Type.
# Account of how to set boundaryconditon.
# string bcName = "Farfield";
# {
# int bcType = 4;
# int inflowParaType = 1;
# double attackd = 0;
# double refReNumber = 6.5e6;
# double refMachNumber = 3.5;
# double angleSlide = 0;
# }
int nBoundaryConditions = 5;
string bcName = "sym";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
}
string bcName = "symf";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
}
string bcName = "wall";
{
string bodyName = "body";
int bcType = 2;
string flowType = "FLOW_SOLID_SURFACE";
}
string bcName = "in";
{
int bcType = 5;
string flowType = "FLOW_VELOCITY_INLET";
double flowU =0.1;
}
string bcName = "out";
{
int bcType = 6;
string flowType = "FLOW_PRESSURE_OUTLET";
double flowU =0.1;
double flowP =0;
}
# 'bcType' is defined as following:
# 99: PERIODIC
# -2: WAKE
# -1: INTERFACE
# 0 : NO_BOUNDARY_CONDITION
# 1 : EXTRAPOLATION
# 2 : SOLID_SURFACE
# 3 : SYMMETRY
# 4 : FARFIELD
# 5 : INFLOW
# 6 : OUTFLOW
# 52: PRESSURE_INLET
# 62: PRESSURE_OUTLET
# 61: OUTFLOW_CONFINED
# 7 : POLE

View File

@ -1,212 +0,0 @@
#########################################################################
# General Control Parameter #
#########################################################################
// nIsComputeWallDist: Whether to compute the wall distance.
// 0 -- Compute wall distance.
// 1 -- Not compute.
// gridfile: The partitioned Grid file path, using relative path,
// which is relative to the working directory.
// 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.
// intervalStepRes: The step intervals for residual 'res.dat' saved.
// 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.
// compressible: An indicator that distinguishes density base from pressure base. 0-incompressible, 1-compressible
// isUnsteady: An indicator that distinguishes unsteady problem from steady problem. 0-steady, 1-unsteady
// startTime: The initial time of the unsteady simulation.
// endTime: The end time of the unsteady simulation.
// dt: The time interval of the unsteady simulation.
// innerIter: The number of step for current time.
// OutputTimeStep: The interval step of output for unsteady simulation.
int nIsComputeWallDist = 1;
string gridfile = "./grid/suboff.fts";
iint maxSimuStep = 10000;
int intervalStepFlow = 2000;
int intervalStepPlot = 2000;
int intervalStepRes = 2000;
double gridScaleFactor = 1.0;
int compressible = 0;
int iunsteady = 0;
double startTime = 0.0;
double endTime = 5;
double dt = 0.1;
int innerIter = 10;
int OutputTimeStep = 5;
#########################################################################
# Post-Processing #
#########################################################################
// nVisualVariables: Number of variables want to be dumped for tecplot visualization.
// visualVariables : Variable types dumped, listed as following:
// -- U(22), V(23), W(24), P(25), CP(26), T(27), DEN(28), VIS(29), TE(31), ED(32), enthalpy(57)
// Important Warning: Array size of visualVariables MUST be equal to nVisualVariables!!!
// Variables order must from small to big.
// plotFieldType: If dump out the field results to visulization.
int plotFieldType = 1;
int nVisualVariables = 4;
int visualVariables[] = [22, 23, 24, 25];
#########################################################################
# Flow Parameter #
#########################################################################
string FLOW[] = "FLOW";
// Initial value of variables or constant
double initRho = 998.3;
double initMu = 1.93345725;
double initU = 0.1;
double initV = 0;
double initW = 0;
double initP = 0;
// Relaxing factor
double urfU = 0.4;
double urfV = 0.4;
double urfW = 0.4;
double urfP = 0.3;
double urfFlux = 0.4;
// Tolerance for governing equations
double resU = 1e-6;
double resV = 1e-6;
double resW = 1e-5;
double resP = 1e-5;
// Solver for solving linear system
// : CGS/GMRES/BiCGSTAB/AMG
string iterSolvU = "BiCGSTAB";
string iterSolvV = "BiCGSTAB";
string iterSolvW = "BiCGSTAB";
string iterSolvP = "GMRES";
// Max Iter for solving linear system
int maxSweepU = 30;
int maxSweepV = 30;
int maxSweepW = 30;
int maxSweepP = 30;
// Tolerance for solving linear system
double iterSolvTolU = 1e-4;
double iterSolvTolV = 1e-4;
double iterSolvTolW = 1e-4;
double iterSolvTolP = 1e-3;
// Gradient Calculation
// : GAUSS/LSQ
string UGradCalc = "GAUSS";
string VGradCalc = "GAUSS";
string WGradCalc = "GAUSS";
string PGradCalc = "GAUSS";
// Convection scheme
// : UPWIND/CDS/QUICK/SUDS
string flowConvCalc = "QUICK";
// Diffusion scheme(central difference)
// : NON_ORTHOGONAL
string flowDiffCalc = "NON_ORTHOGONAL";
// Transient scheme
// : CRANK_NICOLSON/IMPLICIT_2ND_ORDER/IMPLICIT_EULER
string flowTranCalc = "IMPLICIT_EULER";
// Source for flow
// : FLOW_DEFAULT/FLOW_GRAVITY
string flowSourceCalc[] = "FLOW_DEFAULT";
//string flowSourceCalc[] = "FLOW_DEFAULT FLOW_GRAVITY";
int bodyForceFlag = 0;
//double gravityX = 0.0;
//double gravityY = -9.81;
//double gravityZ = 0.0;
#########################################################################
# Turbulence Parameter #
#########################################################################
//int viscousType = 13; //SPALART_ALLMARAS = 11, KEPSILON = 13
//turb SA
//string TURB_SA[] = ["TURB_SA"];
//string TURB_SA_SCALAR_NAME[] = ["kinetic"];
//double urfMu = 1.0;
//double kineticInitValue = 1.0;
//string kineticConvCalc = "UPWIND";
//string kineticDiffCalc = "NON_ORTHOGONAL";
//string kineticSourceCalc[] = "TURB_SA_DEFAULT";
//double kineticUrf = 1.0
//double kineticRes = 1e-6;
//string turbIterSolv = "BiCGSTAB";
//int turbMaxSweep = 30;
//double turbIterSolvTol = 1e-12;
//turb K-EPSILON
string TURB_K_EPSILON[] = ["TURB_K","TURB_EPSILON"];
string TURB_K_EPSILON_SCALAR_NAME[] = ["kinetic", "epsilon"];
string TURB_K[] = ["TURB_K"];
string TURB_K_SCALAR_NAME[] = ["kinetic"];
string TURB_EPSILON[] = ["TURB_EPSILON"];
string TURB_EPSILON_SCALAR_NAME[] = ["epsilon"];
double urfMu = 0.4;
// turb k
double kineticInitValue = 3.750003e-05;
string kineticConvCalc = "UPWIND";
string kineticDiffCalc = "NON_ORTHOGONAL";
string kineticSourceCalc[] = "TURB_K_DEFAULT";
double kineticUrf = 0.4;
double kineticRes = 1e-6;
// turb epsilon
double epsilonInitValue = 8.664311e-07;
string epsilonConvCalc = "UPWIND";
string epsilonDiffCalc = "NON_ORTHOGONAL";
string epsilonSourceCalc[] = "TURB_EPSILON_DEFAULT";
double epsilonUrf = 0.4;
double epsilonRes = 1e-6;
#########################################################################
# Energy Parameter #
#########################################################################
// energyType: The energy solver switch. 0-off, 1-on
// ENERGY[]: Solver binding for factory mode.
// ENERGY_SCALAR_NAME[]: The name of variable to be solved in energy equation.
// energyPrintName[]: The output on the screen during the solution.
int energyType = 0;
string ENERGY[] = ["ENERGY"];
string ENERGY_SCALAR_NAME[] = "enthalpy";
string energyPrintName[] = ["H"];
// Initial value of variables or constant
double initT = 273.0;
double initK = 0.026;
double initCPg = 1007.0;
double urfT = 0.8;
double urfH = 0.7;
double enthalpyInitValue = 0.21;
// Discrete schemes
string energyConvCalc = "UPWIND";
string energyDiffCalc = "NON_ORTHOGONAL";
string energySourceCalc[] = ["EMPTY"];
string energyGradCalc = "GAUSS";
string energyTranCalc = "IMPLICIT_EULER";
// Set for solving linear equations
string enthalpyIterSolv = "BiCGSTAB";
int enthalpyMaxSweep = 30;
double enthalpyIterSolvTol = 1e-12;
double enthalpyRes = 1e-6;

View File

@ -1,30 +0,0 @@
#########################################################################
# Grid data type #
#########################################################################
// gridtype: Grid type for generation, conversion, reconstruction, merging.
// 0 -- Unstructured grid.
// 1 -- Structured grid.
// axisup: Type of Cartisien coordinates system, used in grid conversion.
// 1 -- Y upward. (default)
// 2 -- Z upward.
// from_gtype: Type of grid data type in grid conversion process.
// -1 -- MULTI_TYPE.
// 1 -- PHengLEI, *.fts.
// 2 -- CGNS, *.cgns.
// 3 -- Plot3D type of structured grid, *.dat/*.grd.
// 4 -- Fieldview type of unstructured grid, *.dat/*.inp.
// 5 -- Fluent, *.cas/*.msh.
// 6 -- Ustar, mgrid.in.
// 7 -- Hybrid, include both of unstructured and structured grid, *.fts.
// 8 -- GMSH, *.msh.
int gridtype = 0;
int axisup = 1;
int from_gtype = 5;
#########################################################################
# File path #
#########################################################################
// from_gfile: path of original data file for unstructure grid convert from.
// out_gfile: path of target file for grid convert to, *.fts type of file usually.
string from_gfile = "./grid/suboff.cas";
string out_gfile = "./grid/suboff.fts";

View File

@ -1,5 +0,0 @@
红山开源风雷算例库原始网格获取百度网盘链接:
链接http://pan.baidu.com/s/1aZ9cdkp6CkT9il4fEpnTcA
提取码w47m
plot3D格式网格需同时下载.grd和.inp文件

View File

@ -0,0 +1,35 @@
0 MRT set 1, BGK set 0
0 continue.plt CONTI, resume :1 , new 0 //follows input datafile name //use ASCII文件 continue.plt
0 LES yes: 1 , no: 0
0 mesh_3d.dat GEO read complex geo? yes:1, no:0 //follows input datafile name
0 ! MB multiblock LBM? yes:1, no:0
1 2e-3 !CONV using converge criterion? yes:1, no:0
201 NX
201 ! NY
1 ! NZ
1 NX2
1 NY2
1 ! NZ2
0 ! LowX
0 ! LowY
0 ! LowZ
1 ! x_np
1 ! y_np
1 ! z_np
500 ! framerate
50000 total steps to terminate
1.0 ! density
0.6 tau
(0.0, 0.0, 0.0000000) Volumetric force vector (gx, gy, gz)
D2Q9 ! velocity set
Cavity ! boundary condition
! note: in the following, boundary types: periodic,velocity, pressure
! are allowed. if "velocity" is applied, please strictly follow the format "velocity (%lf, %lf, %lf)".
nonslip xmin face
nonslip xmax face
nonslip ymin face
velocity (0.1, 0.0, 0.0) ymax face,
periodic zmin face
periodic zmax face
------------------- initial velocity field
(0.0, 0.00, 0.0)

View File

@ -17,12 +17,12 @@ string defaultParaFile = "./bin/cfd_para.hypara";
int ndim = 2; int ndim = 2;
int nparafile = 1; int nparafile = 1;
int nsimutask = 0; //int nsimutask = 0;
string parafilename = "./bin/cfd_para_incompressible.hypara"
//string parafilename = "./bin/cfd_para_subsonic.hypara"; //string parafilename = "./bin/cfd_para_subsonic.hypara";
//string parafilename = "./bin/cfd_para_transonic.hypara"; //string parafilename = "./bin/cfd_para_transonic.hypara";
//string parafilename = "./bin/cfd_para_supersonic.hypara"; //string parafilename = "./bin/cfd_para_supersonic.hypara";
//string parafilename = "./bin/cfd_para_hypersonic.hypara"; //string parafilename = "./bin/cfd_para_hypersonic.hypara";
//string parafilename = "./bin/cfd_para_incompressible.hypara";
//int nsimutask = 1; //int nsimutask = 1;
//string parafilename = "./bin/grid_para.hypara"; //string parafilename = "./bin/grid_para.hypara";
@ -39,6 +39,9 @@ string parafilename = "./bin/cfd_para_incompressible.hypara"
//int nsimutask = 1; //int nsimutask = 1;
//string parafilename = "./bin/grid_refine_para.hypara"; //string parafilename = "./bin/grid_refine_para.hypara";
int nsimutask = 13;
string parafilename = "./bin/cfd_para.hypara";
//int nsimutask = 14; //int nsimutask = 14;
//string parafilename = "./bin/integrative_solver.hypara"; //string parafilename = "./bin/integrative_solver.hypara";

View File

@ -0,0 +1,35 @@
0 MRT set 1, BGK set 0
1 continue.plt CONTI, resume :1 , new 0 //follows input datafile name //use ASCII文件 continue.plt
1 LES yes: 1 , no: 0
0 mesh_3d.dat GEO read complex geo? yes:1, no:0 //follows input datafile name
0 ! MB multiblock LBM? yes:1, no:0
0 2e-3 !CONV using converge criterion? yes:1, no:0
128 NX
128 ! NY
256 ! NZ
1 NX2
1 NY2
1 ! NZ2
0 ! LowX
0 ! LowY
0 ! LowZ
4 ! x_np
4 ! y_np
2 ! z_np
5000 ! framerate
20000 total steps to terminate
1.0 ! density
0.506 tau
(9.2e-8,0.0,0.0) Volumetric force
D3Q19 ! velocity set
ChannelTurb ! boundary condition
! note: in the following, boundary types: periodic,velocity, pressure
! are allowed. if "velocity" is applied, please strictly follow the format "velocity (%lf, %lf, %lf)".
periodic xmin face
periodic xmax face
periodic ymin face
periodic ymax face,
nonslip zmin face
nonslip zmax face
------------------- initial velocity field
(0.0, 0.00, 0.0)

View File

@ -17,12 +17,12 @@ string defaultParaFile = "./bin/cfd_para.hypara";
int ndim = 3; int ndim = 3;
int nparafile = 1; int nparafile = 1;
int nsimutask = 0; //int nsimutask = 0;
string parafilename = "./bin/cfd_para_incompressible.hypara"
//string parafilename = "./bin/cfd_para_subsonic.hypara"; //string parafilename = "./bin/cfd_para_subsonic.hypara";
//string parafilename = "./bin/cfd_para_transonic.hypara"; //string parafilename = "./bin/cfd_para_transonic.hypara";
//string parafilename = "./bin/cfd_para_supersonic.hypara"; //string parafilename = "./bin/cfd_para_supersonic.hypara";
//string parafilename = "./bin/cfd_para_hypersonic.hypara"; //string parafilename = "./bin/cfd_para_hypersonic.hypara";
//string parafilename = "./bin/cfd_para_incompressible.hypara";
//int nsimutask = 1; //int nsimutask = 1;
//string parafilename = "./bin/grid_para.hypara"; //string parafilename = "./bin/grid_para.hypara";
@ -39,6 +39,9 @@ string parafilename = "./bin/cfd_para_incompressible.hypara"
//int nsimutask = 1; //int nsimutask = 1;
//string parafilename = "./bin/grid_refine_para.hypara"; //string parafilename = "./bin/grid_refine_para.hypara";
int nsimutask = 13;
string parafilename = "./bin/cfd_para.hypara";
//int nsimutask = 14; //int nsimutask = 14;
//string parafilename = "./bin/integrative_solver.hypara"; //string parafilename = "./bin/integrative_solver.hypara";

View File

@ -0,0 +1,35 @@
1 MRT set 1, BGK set 0
0 continue.plt CONTI, resume :1 , new 0 //follows input datafile name //use ASCII文件 continue.plt
0 LES yes: 1 , no: 0
0 mesh_3d.dat GEO read complex geo? yes:1, no:0 //follows input datafile name
0 ! MB multiblock LBM? yes:1, no:0
1 2e-3 !CONV using converge criterion? yes:1, no:0
100 NX
100 ! NY
100 ! NZ
1 NX2
1 NY2
1 ! NZ2
0 ! LowX
0 ! LowY
0 ! LowZ
2 ! x_np
2 ! y_np
1 ! z_np
500 ! framerate
50000 total steps to terminate
1.0 ! density
0.6 tau
(2.2e-7,0.0,0.0) Volumetric force
D3Q19 ! velocity set
Poiseuille ! boundary condition
! note: in the following, boundary types: periodic,velocity, pressure
! are allowed. if "velocity" is applied, please strictly follow the format "velocity (%lf, %lf, %lf)".
periodic xmin face
periodic xmax face
periodic ymin face
periodic ymax face,
nonslip zmin face
nonslip zmax face
------------------- initial velocity field
(0.0, 0.00, 0.0)

View File

@ -17,12 +17,12 @@ string defaultParaFile = "./bin/cfd_para.hypara";
int ndim = 3; int ndim = 3;
int nparafile = 1; int nparafile = 1;
int nsimutask = 0; //int nsimutask = 0;
string parafilename = "./bin/cfd_para_incompressible.hypara"
//string parafilename = "./bin/cfd_para_subsonic.hypara"; //string parafilename = "./bin/cfd_para_subsonic.hypara";
//string parafilename = "./bin/cfd_para_transonic.hypara"; //string parafilename = "./bin/cfd_para_transonic.hypara";
//string parafilename = "./bin/cfd_para_supersonic.hypara"; //string parafilename = "./bin/cfd_para_supersonic.hypara";
//string parafilename = "./bin/cfd_para_hypersonic.hypara"; //string parafilename = "./bin/cfd_para_hypersonic.hypara";
//string parafilename = "./bin/cfd_para_incompressible.hypara";
//int nsimutask = 1; //int nsimutask = 1;
//string parafilename = "./bin/grid_para.hypara"; //string parafilename = "./bin/grid_para.hypara";
@ -39,6 +39,9 @@ string parafilename = "./bin/cfd_para_incompressible.hypara"
//int nsimutask = 1; //int nsimutask = 1;
//string parafilename = "./bin/grid_refine_para.hypara"; //string parafilename = "./bin/grid_refine_para.hypara";
int nsimutask = 13;
string parafilename = "./bin/cfd_para.hypara";
//int nsimutask = 14; //int nsimutask = 14;
//string parafilename = "./bin/integrative_solver.hypara"; //string parafilename = "./bin/integrative_solver.hypara";

View File

@ -0,0 +1,35 @@
0 MRT set 1, BGK set 0
0 continue.plt CONTI, resume :1 , new 0 //follows input datafile name //use ASCII文件 continue.plt
0 LES yes: 1 , no: 0
1 mesh_3d.dat GEO read complex geo? yes:1, no:0 //follows input datafile name
0 ! MB multiblock LBM? yes:1, no:0
0 2e-3 !CONV using converge criterion? yes:1, no:0
100 NX
300 ! NY
100 ! NZ
1 NX2
1 NY2
1 ! NZ2
0 ! LowX
0 ! LowY
0 ! LowZ
2 ! x_np
2 ! y_np
2 ! z_np
400 ! framerate
2000 total steps to terminate
1.0 ! density
0.56 tau
(0.0,0.0,0.0) Volumetric force
D3Q19 ! velocity set
3Dspoiler ! boundary condition
! note: in the following, boundary types: periodic,velocity, pressure
! are allowed. if "velocity" is applied, please strictly follow the format "velocity (%lf, %lf, %lf)".
velocity (0.00, 0.1, 0.0) xmin face
velocity (0.00, 0.1, 0.0) xmax face
velocity (0.00, 0.1, 0.0) ymin face
pressure 1.0 ymax face,
velocity (0.00, 0.1, 0.0) zmin face
velocity (0.00, 0.1, 0.0) zmax face
------------------- initial velocity field
(0.0, 0.1, 0.0)

View File

@ -0,0 +1,55 @@
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.
int ndim = 3;
int nparafile = 1;
//int nsimutask = 0;
//string parafilename = "./bin/cfd_para_subsonic.hypara";
//string parafilename = "./bin/cfd_para_transonic.hypara";
//string parafilename = "./bin/cfd_para_supersonic.hypara";
//string parafilename = "./bin/cfd_para_hypersonic.hypara";
//string parafilename = "./bin/cfd_para_incompressible.hypara";
//int nsimutask = 1;
//string parafilename = "./bin/grid_para.hypara";
//int nsimutask = 2;
//string parafilename = "./bin/cfd_para.hypara";
//int nsimutask = 3;
//string parafilename = "./bin/partition.hypara";
//int nsimutask = 1;
//string parafilename = "./bin/grid_deform_para.hypara";
//int nsimutask = 1;
//string parafilename = "./bin/grid_refine_para.hypara";
int nsimutask = 13;
string parafilename = "./bin/cfd_para.hypara";
//int nsimutask = 14;
//string parafilename = "./bin/integrative_solver.hypara";
//int nsimutask = 99;
//string parafilename = "./bin/post_processing.hypara";
// ---------------- Advanced Parameters, DO NOT care it ----------------
int numberOfGridProcessor = 0;
// ATP read
//@string parafilename1 = ""
//@string parafilename2 = "";

File diff suppressed because it is too large Load Diff

File diff suppressed because it is too large Load Diff

View File

@ -0,0 +1,33 @@
0 MRT set 1, BGK set 0
1 ic.plt CONTI, resume :1 , new 0 //follows input datafile name
0 LES yes: 1 , no: 0
0 mesh_3d.dat GEO read complex geo? yes:1, no:0 //follows input datafile name
0 ! MB multiblock LBM? yes:1, no:0
0 2.e-3 !CONV using converge criterion? yes:1, no:0
201 NX
201 ! NY
1 ! NZ
240 NX2
160 NY2
1 ! NZ2
500 ! LowX
160 ! LowY
0 ! LowZ
200 ! framerate
50000 total steps to terminate
1.0 ! density
0.8 tau
(0.0, 0.0, 0.0000000) Volumetric force vector (gx, gy, gz)
D2Q9 ! velocity set
Cavity ! boundary condition
! note: in the following, boundary types: periodic,velocity, pressure
! are allowed. if "velocity" is applied, please strictly follow the format "velocity (%lf, %lf, %lf)".
nonslip xmin face
nonslip xmax face
nonslip ymin face
velocity (0.1, 0.00, 0.0) ymax face,
nonslip zmin face
nonslip zmax face
------------------- initial velocity field
(0.0, 0.00, 0.0)

View File

@ -0,0 +1,58 @@
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.
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/cfd_para_incompressible.hypara";
//int nsimutask = 1;
//string parafilename = "./bin/grid_para.hypara";
//int nsimutask = 2;
//string parafilename = "./bin/cfd_para.hypara";
//int nsimutask = 3;
//string parafilename = "./bin/partition.hypara";
//int nsimutask = 1;
//string parafilename = "./bin/grid_deform_para.hypara";
//int nsimutask = 1;
//string parafilename = "./bin/grid_refine_para.hypara";
//int nsimutask = 5;
//string parafilename = "./bin/overset_grid_view.hypara";
int nsimutask = 17;
string parafilename = "./bin/cfd_para.hypara";
//int nsimutask = 14;
//string parafilename = "./bin/integrative_solver.hypara";
//int nsimutask = 99;
//string parafilename = "./bin/post_processing.hypara";
// ---------------- Advanced Parameters, DO NOT care it ----------------
int numberOfGridProcessor = 0;
// ATP read
//@string parafilename1 = ""
//@string parafilename2 = "";

File diff suppressed because it is too large Load Diff

View File

@ -0,0 +1,33 @@
0 MRT set 1, BGK set 0
0 ic.plt CONTI, resume :1 , new 0 //follows input datafile name
0 LES yes: 1 , no: 0
1 mesh_2d.dat GEO read complex geo? yes:1, no:0 //follows input datafile name
1 ! MB multiblock LBM? yes:1, no:0
0 2.e-3 !CONV using converge criterion? yes:1, no:0
600 NX
400 ! NY
1 ! NZ
240 NX2
160 NY2
1 ! NZ2
200 ! LowX
160 ! LowY
0 ! LowZ
200 ! framerate
50000 total steps to terminate
1.0 ! density
0.54 tau
(0.0, 0.0, 0.0000000) Volumetric force vector (gx, gy, gz)
D2Q9 ! velocity set
Poiseuille ! boundary condition
! note: in the following, boundary types: periodic,velocity, pressure
! are allowed. if "velocity" is applied, please strictly follow the format "velocity (%lf, %lf, %lf)".
velocity (0.1, 0.00, 0.0) xmin face
pressure 1.0 xmax face
velocity (0.1, 0.00, 0.0) ymin face
velocity (0.1, 0.00, 0.0) ymax face,
nonslip zmin face
nonslip zmax face
------------------- initial velocity field
(0.1, 0.00, 0.0)

View File

@ -17,12 +17,12 @@ string defaultParaFile = "./bin/cfd_para.hypara";
int ndim = 2; int ndim = 2;
int nparafile = 1; int nparafile = 1;
int nsimutask = 0; //int nsimutask = 0;
string parafilename = "./bin/cfd_para_incompressible.hypara"
//string parafilename = "./bin/cfd_para_subsonic.hypara"; //string parafilename = "./bin/cfd_para_subsonic.hypara";
//string parafilename = "./bin/cfd_para_transonic.hypara"; //string parafilename = "./bin/cfd_para_transonic.hypara";
//string parafilename = "./bin/cfd_para_supersonic.hypara"; //string parafilename = "./bin/cfd_para_supersonic.hypara";
//string parafilename = "./bin/cfd_para_hypersonic.hypara"; //string parafilename = "./bin/cfd_para_hypersonic.hypara";
//string parafilename = "./bin/cfd_para_incompressible.hypara";
//int nsimutask = 1; //int nsimutask = 1;
//string parafilename = "./bin/grid_para.hypara"; //string parafilename = "./bin/grid_para.hypara";
@ -39,6 +39,9 @@ string parafilename = "./bin/cfd_para_incompressible.hypara"
//int nsimutask = 1; //int nsimutask = 1;
//string parafilename = "./bin/grid_refine_para.hypara"; //string parafilename = "./bin/grid_refine_para.hypara";
int nsimutask = 17;
string parafilename = "./bin/cfd_para.hypara";
//int nsimutask = 14; //int nsimutask = 14;
//string parafilename = "./bin/integrative_solver.hypara"; //string parafilename = "./bin/integrative_solver.hypara";

View File

@ -0,0 +1,303 @@
Title = "finite-element data"
variables = x, y, z
zone n= 150, E= 150,f=FEpoint,et = triangle
100 80 0
99.9825 80.8375 0
99.9299 81.6736 0
99.8423 82.5067 0
99.7199 83.3354 0
99.563 84.1582 0
99.3717 84.9738 0
99.1464 85.7806 0
98.8875 86.5773 0
98.5955 87.3625 0
98.2709 88.1347 0
97.9142 88.8927 0
97.5261 89.6351 0
97.1073 90.3605 0
96.6584 91.0678 0
96.1803 91.7557 0
95.6739 92.423 0
95.1399 93.0684 0
94.5794 93.6909 0
93.9933 94.2895 0
93.3826 94.8629 0
92.7485 95.4103 0
92.092 95.9306 0
91.4143 96.423 0
90.7165 96.8866 0
90 97.3205 0
89.2659 97.7241 0
88.5156 98.0965 0
87.7503 98.4373 0
86.9714 98.7456 0
86.1803 99.0211 0
85.3784 99.2633 0
84.567 99.4716 0
83.7476 99.6457 0
82.9217 99.7854 0
82.0906 99.8904 0
81.2558 99.9605 0
80.4188 99.9956 0
79.5812 99.9956 0
78.7442 99.9605 0
77.9094 99.8904 0
77.0783 99.7854 0
76.2524 99.6457 0
75.433 99.4716 0
74.6216 99.2633 0
73.8197 99.0211 0
73.0286 98.7456 0
72.2497 98.4373 0
71.4844 98.0965 0
70.7341 97.7241 0
70 97.3205 0
69.2835 96.8866 0
68.5857 96.423 0
67.908 95.9306 0
67.2515 95.4103 0
66.6174 94.8629 0
66.0067 94.2895 0
65.4206 93.6909 0
64.8601 93.0684 0
64.3261 92.423 0
63.8197 91.7557 0
63.3416 91.0678 0
62.8927 90.3605 0
62.4739 89.6351 0
62.0858 88.8927 0
61.7291 88.1347 0
61.4045 87.3625 0
61.1125 86.5773 0
60.8536 85.7806 0
60.6283 84.9738 0
60.437 84.1582 0
60.2801 83.3354 0
60.1577 82.5067 0
60.0701 81.6736 0
60.0175 80.8375 0
60 80 0
60.0175 79.1625 0
60.0701 78.3264 0
60.1577 77.4933 0
60.2801 76.6646 0
60.437 75.8418 0
60.6283 75.0262 0
60.8536 74.2194 0
61.1125 73.4227 0
61.4045 72.6375 0
61.7291 71.8653 0
62.0858 71.1073 0
62.4739 70.3649 0
62.8927 69.6395 0
63.3416 68.9322 0
63.8197 68.2443 0
64.3261 67.577 0
64.8601 66.9316 0
65.4206 66.3091 0
66.0067 65.7105 0
66.6174 65.1371 0
67.2515 64.5897 0
67.908 64.0694 0
68.5857 63.577 0
69.2835 63.1134 0
70 62.6795 0
70.7341 62.2759 0
71.4844 61.9035 0
72.2497 61.5627 0
73.0286 61.2544 0
73.8197 60.9789 0
74.6216 60.7367 0
75.433 60.5284 0
76.2524 60.3543 0
77.0783 60.2146 0
77.9094 60.1096 0
78.7442 60.0395 0
79.5812 60.0044 0
80.4188 60.0044 0
81.2558 60.0395 0
82.0906 60.1096 0
82.9217 60.2146 0
83.7476 60.3543 0
84.567 60.5284 0
85.3784 60.7367 0
86.1803 60.9789 0
86.9714 61.2544 0
87.7503 61.5627 0
88.5156 61.9035 0
89.2659 62.2759 0
90 62.6795 0
90.7165 63.1134 0
91.4143 63.577 0
92.092 64.0694 0
92.7485 64.5897 0
93.3826 65.1371 0
93.9933 65.7105 0
94.5794 66.3091 0
95.1399 66.9316 0
95.6739 67.577 0
96.1803 68.2443 0
96.6584 68.9322 0
97.1073 69.6395 0
97.5261 70.3649 0
97.9142 71.1073 0
98.2709 71.8653 0
98.5955 72.6375 0
98.8875 73.4227 0
99.1464 74.2194 0
99.3717 75.0262 0
99.563 75.8418 0
99.7199 76.6646 0
99.8423 77.4933 0
99.9299 78.3264 0
99.9825 79.1625 0
1 2 1
2 3 2
3 4 3
4 5 4
5 6 5
6 7 6
7 8 7
8 9 8
9 10 9
10 11 10
11 12 11
12 13 12
13 14 13
14 15 14
15 16 15
16 17 16
17 18 17
18 19 18
19 20 19
20 21 20
21 22 21
22 23 22
23 24 23
24 25 24
25 26 25
26 27 26
27 28 27
28 29 28
29 30 29
30 31 30
31 32 31
32 33 32
33 34 33
34 35 34
35 36 35
36 37 36
37 38 37
38 39 38
39 40 39
40 41 40
41 42 41
42 43 42
43 44 43
44 45 44
45 46 45
46 47 46
47 48 47
48 49 48
49 50 49
50 51 50
51 52 51
52 53 52
53 54 53
54 55 54
55 56 55
56 57 56
57 58 57
58 59 58
59 60 59
60 61 60
61 62 61
62 63 62
63 64 63
64 65 64
65 66 65
66 67 66
67 68 67
68 69 68
69 70 69
70 71 70
71 72 71
72 73 72
73 74 73
74 75 74
75 76 75
76 77 76
77 78 77
78 79 78
79 80 79
80 81 80
81 82 81
82 83 82
83 84 83
84 85 84
85 86 85
86 87 86
87 88 87
88 89 88
89 90 89
90 91 90
91 92 91
92 93 92
93 94 93
94 95 94
95 96 95
96 97 96
97 98 97
98 99 98
99 100 99
100 101 100
101 102 101
102 103 102
103 104 103
104 105 104
105 106 105
106 107 106
107 108 107
108 109 108
109 110 109
110 111 110
111 112 111
112 113 112
113 114 113
114 115 114
115 116 115
116 117 116
117 118 117
118 119 118
119 120 119
120 121 120
121 122 121
122 123 122
123 124 123
124 125 124
125 126 125
126 127 126
127 128 127
128 129 128
129 130 129
130 131 130
131 132 131
132 133 132
133 134 133
134 135 134
135 136 135
136 137 136
137 138 137
138 139 138
139 140 139
140 141 140
141 142 141
142 143 142
143 144 143
144 145 144
145 146 145
146 147 146
147 148 147
148 149 148
149 150 149
150 1 150