void CALLBACK COutput::WaveOutCallback(HWAVE hWave, UINT uMsg, DWORD dwInstance, DWORD dwParam1, DWORD dwParam2) { if (uMsg == WOM_DONE) { COutput* pOutput = (COutput*)((WAVEHDR*)dwParam1)->dwUser; pOutput->PutBuffer((WAVEHDR*)dwParam1); } }
void CALLBACK COutput::WaveOutCallback2(HWAVE hWave, UINT uMsg, DWORD dwInstance, DWORD dwParam1, DWORD dwParam2) { if (uMsg == WOM_DONE) { COutput* pOutput = (COutput*)((WAVEHDR*)dwParam1)->dwUser; if (pOutput->m_fScanPeek) pOutput->CheckPeek((WAVEHDR*)dwParam1); InterlockedIncrement((long*)&pOutput->m_nSubBuf); SetEvent(pOutput->m_hEventThread); } }
int main(int argc, char *argv[]) { /*--- Variable definitions ---*/ unsigned short iZone, nZone; ofstream ConvHist_file; char file_name[200]; int rank = MASTER_NODE; int size = SINGLE_NODE; #ifndef NO_MPI /*--- MPI initialization, and buffer setting ---*/ #ifdef WINDOWS MPI_Init(&argc,&argv); MPI_Comm_rank(MPI_COMM_WORLD,&rank); MPI_Comm_size(MPI_COMM_WORLD,&size); #else MPI::Init(argc, argv); rank = MPI::COMM_WORLD.Get_rank(); size = MPI::COMM_WORLD.Get_size(); #endif #endif /*--- Pointer to different structures that will be used throughout the entire code ---*/ COutput *output = NULL; CGeometry **geometry = NULL; CSolver **solver = NULL; CConfig **config = NULL; /*--- Definition of the containers per zones ---*/ solver = new CSolver*[MAX_ZONES]; config = new CConfig*[MAX_ZONES]; geometry = new CGeometry *[MAX_ZONES]; /*--- Only one zone is allowed ---*/ nZone = 1; for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the configuration class per zones ---*/ if (argc == 2) config[iZone] = new CConfig(argv[1], SU2_SOL, iZone, nZone, 0, VERB_HIGH); else { strcpy (file_name, "default.cfg"); config[iZone] = new CConfig(file_name, SU2_SOL, iZone, nZone, 0, VERB_HIGH); } #ifndef NO_MPI /*--- Change the name of the input-output files for a parallel computation ---*/ config[iZone]->SetFileNameDomain(rank+1); #endif /*--- Definition of the geometry class and open the mesh file ---*/ geometry[iZone] = new CPhysicalGeometry(config[iZone], iZone+1, nZone); /*--- Create the vertex structure (required for MPI) ---*/ if (rank == MASTER_NODE) cout << "Identify vertices." <<endl; geometry[iZone]->SetVertex(config[iZone]); /*--- Perform the non-dimensionalization for the flow equations using the specified reference values. ---*/ config[iZone]->SetNondimensionalization(geometry[iZone]->GetnDim(), iZone); } #ifndef NO_MPI /*--- Synchronization point after the geometrical definition subroutine ---*/ #ifdef WINDOWS MPI_Barrier(MPI_COMM_WORLD); #else MPI::COMM_WORLD.Barrier(); #endif #endif if (rank == MASTER_NODE) cout << endl <<"------------------------- Solution Postprocessing -----------------------" << endl; #ifndef NO_MPI /*--- Synchronization point after the solution subroutine ---*/ #ifdef WINDOWS MPI_Barrier(MPI_COMM_WORLD); #else MPI::COMM_WORLD.Barrier(); #endif #endif /*--- Definition of the output class (one for all the zones) ---*/ output = new COutput(); /*--- Check whether this is an unsteady simulation, and call the solution merging routines accordingly.---*/ if (config[ZONE_0]->GetWrt_Unsteady()) { /*--- Unsteady simulation: merge all unsteady time steps. First, find the frequency and total number of files to write. ---*/ double Physical_dt, Physical_t; unsigned long iExtIter = 0; bool StopCalc = false; bool SolutionInstantiated = false; /*--- Check for an unsteady restart. Update ExtIter if necessary. ---*/ if (config[ZONE_0]->GetWrt_Unsteady() && config[ZONE_0]->GetRestart()) iExtIter = config[ZONE_0]->GetUnst_RestartIter(); while (iExtIter < config[ZONE_0]->GetnExtIter()) { /*--- Check several conditions in order to merge the correct time step files. ---*/ Physical_dt = config[ZONE_0]->GetDelta_UnstTime(); Physical_t = (iExtIter+1)*Physical_dt; if (Physical_t >= config[ZONE_0]->GetTotal_UnstTime()) StopCalc = true; if ((iExtIter+1 == config[ZONE_0]->GetnExtIter()) || ((iExtIter % config[ZONE_0]->GetWrt_Sol_Freq() == 0) && (iExtIter != 0) && !((config[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND))) || (StopCalc) || (((config[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND)) && ((iExtIter == 0) || (iExtIter % config[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) { /*--- Set the current iteration number in the config class. ---*/ config[ZONE_0]->SetExtIter(iExtIter); /*--- Read in the restart file for this time step ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Either instantiate the solution class or load a restart file. ---*/ if (SolutionInstantiated == false && (iExtIter == 0 || (config[ZONE_0]->GetRestart() && (iExtIter == config[ZONE_0]->GetUnst_RestartIter() || iExtIter % config[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0 || iExtIter+1 == config[ZONE_0]->GetnExtIter())))) { solver[iZone] = new CBaselineSolver(geometry[iZone], config[iZone], MESH_0); SolutionInstantiated = true; } else solver[iZone]->LoadRestart(geometry, &solver, config[iZone], int(MESH_0)); } if (rank == MASTER_NODE) cout << "Writing the volume solution for time step " << iExtIter << "." << endl; output->SetBaselineResult_Files(solver, geometry, config, iExtIter, nZone); } iExtIter++; if (StopCalc) break; } } else if (config[ZONE_0]->GetUnsteady_Simulation() == TIME_SPECTRAL) { /*--- Time-spectral simulation: merge files for each time instance (each zone). ---*/ unsigned short nTimeSpectral = config[ZONE_0]->GetnTimeInstances(); unsigned short iTimeSpectral; for (iTimeSpectral = 0; iTimeSpectral < nTimeSpectral; iTimeSpectral++) { /*--- Set the current instance number in the config class to "ExtIter." ---*/ config[ZONE_0]->SetExtIter(iTimeSpectral); /*--- Read in the restart file for this time step ---*/ /*--- N.B. In SU2_SOL, nZone != nTimeInstances ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Either instantiate the solution class or load a restart file. ---*/ if (iTimeSpectral == 0) solver[iZone] = new CBaselineSolver(geometry[iZone], config[iZone], MESH_0); else solver[iZone]->LoadRestart(geometry, &solver, config[iZone], int(MESH_0)); } /*--- Print progress in solution writing to the screen. ---*/ if (rank == MASTER_NODE) { cout << "Writing the volume solution for time instance " << iTimeSpectral << "." << endl; } output->SetBaselineResult_Files(solver, geometry, config, iTimeSpectral, nZone); } } else { /*--- Steady simulation: merge the single solution file. ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the solution class ---*/ solver[iZone] = new CBaselineSolver(geometry[iZone], config[iZone], MESH_0); } output->SetBaselineResult_Files(solver, geometry, config, 0, nZone); } #ifndef NO_MPI /*--- Finalize MPI parallelization ---*/ #ifdef WINDOWS MPI_Finalize(); #else MPI::Finalize(); #endif #endif /*--- End solver ---*/ if (rank == MASTER_NODE) cout << endl <<"------------------------- Exit Success (SU2_SOL) ------------------------" << endl << endl; return EXIT_SUCCESS; }
int main(int argc, char *argv[]) { bool StopCalc = false; su2double StartTime = 0.0, StopTime = 0.0, UsedTime = 0.0; unsigned long ExtIter = 0; unsigned short iMesh, iZone, nZone, nDim; char config_file_name[MAX_STRING_SIZE]; char runtime_file_name[MAX_STRING_SIZE]; ofstream ConvHist_file; int rank = MASTER_NODE; int size = SINGLE_NODE; /*--- MPI initialization, and buffer setting ---*/ #ifdef HAVE_MPI int *bptr, bl; SU2_MPI::Init(&argc, &argv); MPI_Buffer_attach( malloc(BUFSIZE), BUFSIZE ); MPI_Comm_rank(MPI_COMM_WORLD, &rank); MPI_Comm_size(MPI_COMM_WORLD, &size); #endif /*--- Create pointers to all of the classes that may be used throughout the SU2_CFD code. In general, the pointers are instantiated down a heirarchy over all zones, multigrid levels, equation sets, and equation terms as described in the comments below. ---*/ CDriver *driver = NULL; CIteration **iteration_container = NULL; COutput *output = NULL; CIntegration ***integration_container = NULL; CGeometry ***geometry_container = NULL; CSolver ****solver_container = NULL; CNumerics *****numerics_container = NULL; CConfig **config_container = NULL; CSurfaceMovement **surface_movement = NULL; CVolumetricMovement **grid_movement = NULL; CFreeFormDefBox*** FFDBox = NULL; CInterpolator ***interpolator_container = NULL; CTransfer ***transfer_container = NULL; /*--- Load in the number of zones and spatial dimensions in the mesh file (If no config file is specified, default.cfg is used) ---*/ if (argc == 2) { strcpy(config_file_name, argv[1]); } else { strcpy(config_file_name, "default.cfg"); } /*--- Read the name and format of the input mesh file to get from the mesh file the number of zones and dimensions from the numerical grid (required for variables allocation) ---*/ CConfig *config = NULL; config = new CConfig(config_file_name, SU2_CFD); nZone = GetnZone(config->GetMesh_FileName(), config->GetMesh_FileFormat(), config); nDim = GetnDim(config->GetMesh_FileName(), config->GetMesh_FileFormat()); delete config; /*--- Definition and of the containers for all possible zones. ---*/ iteration_container = new CIteration*[nZone]; solver_container = new CSolver***[nZone]; integration_container = new CIntegration**[nZone]; numerics_container = new CNumerics****[nZone]; config_container = new CConfig*[nZone]; geometry_container = new CGeometry**[nZone]; surface_movement = new CSurfaceMovement*[nZone]; grid_movement = new CVolumetricMovement*[nZone]; FFDBox = new CFreeFormDefBox**[nZone]; interpolator_container = new CInterpolator**[nZone]; transfer_container = new CTransfer**[nZone]; for (iZone = 0; iZone < nZone; iZone++) { solver_container[iZone] = NULL; integration_container[iZone] = NULL; numerics_container[iZone] = NULL; config_container[iZone] = NULL; geometry_container[iZone] = NULL; surface_movement[iZone] = NULL; grid_movement[iZone] = NULL; FFDBox[iZone] = NULL; interpolator_container[iZone] = NULL; transfer_container[iZone] = NULL; } /*--- Loop over all zones to initialize the various classes. In most cases, nZone is equal to one. This represents the solution of a partial differential equation on a single block, unstructured mesh. ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the configuration option class for all zones. In this constructor, the input configuration file is parsed and all options are read and stored. ---*/ config_container[iZone] = new CConfig(config_file_name, SU2_CFD, iZone, nZone, nDim, VERB_HIGH); /*--- Definition of the geometry class to store the primal grid in the partitioning process. ---*/ CGeometry *geometry_aux = NULL; /*--- All ranks process the grid and call ParMETIS for partitioning ---*/ geometry_aux = new CPhysicalGeometry(config_container[iZone], iZone, nZone); /*--- Color the initial grid and set the send-receive domains (ParMETIS) ---*/ geometry_aux->SetColorGrid_Parallel(config_container[iZone]); /*--- Allocate the memory of the current domain, and divide the grid between the ranks. ---*/ geometry_container[iZone] = new CGeometry *[config_container[iZone]->GetnMGLevels()+1]; geometry_container[iZone][MESH_0] = new CPhysicalGeometry(geometry_aux, config_container[iZone]); /*--- Deallocate the memory of geometry_aux ---*/ delete geometry_aux; /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone][MESH_0]->SetSendReceive(config_container[iZone]); /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone][MESH_0]->SetBoundaries(config_container[iZone]); } if (rank == MASTER_NODE) cout << endl <<"------------------------- Geometry Preprocessing ------------------------" << endl; /*--- Preprocessing of the geometry for all zones. In this routine, the edge- based data structure is constructed, i.e. node and cell neighbors are identified and linked, face areas and volumes of the dual mesh cells are computed, and the multigrid levels are created using an agglomeration procedure. ---*/ Geometrical_Preprocessing(geometry_container, config_container, nZone); for (iZone = 0; iZone < nZone; iZone++) { /*--- Computation of wall distances for turbulence modeling ---*/ if (rank == MASTER_NODE) cout << "Computing wall distances." << endl; if ((config_container[iZone]->GetKind_Solver() == RANS) || (config_container[iZone]->GetKind_Solver() == ADJ_RANS) || (config_container[iZone]->GetKind_Solver() == DISC_ADJ_RANS)) geometry_container[iZone][MESH_0]->ComputeWall_Distance(config_container[iZone]); /*--- Computation of positive surface area in the z-plane which is used for the calculation of force coefficient (non-dimensionalization). ---*/ geometry_container[iZone][MESH_0]->SetPositive_ZArea(config_container[iZone]); /*--- Set the near-field, interface and actuator disk boundary conditions, if necessary. ---*/ for (iMesh = 0; iMesh <= config_container[iZone]->GetnMGLevels(); iMesh++) { geometry_container[iZone][iMesh]->MatchNearField(config_container[iZone]); geometry_container[iZone][iMesh]->MatchInterface(config_container[iZone]); geometry_container[iZone][iMesh]->MatchActuator_Disk(config_container[iZone]); } } /*--- If activated by the compile directive, perform a partition analysis. ---*/ #if PARTITION Partition_Analysis(geometry_container[ZONE_0][MESH_0], config_container[ZONE_0]); #endif if (rank == MASTER_NODE) cout << endl <<"------------------------- Driver Preprocessing --------------------------" << endl; /*--- First, given the basic information about the number of zones and the solver types from the config, instantiate the appropriate driver for the problem. ---*/ Driver_Preprocessing(&driver, iteration_container, solver_container, geometry_container, integration_container, numerics_container, interpolator_container, transfer_container, config_container, nZone, nDim); /*--- Instantiate the geometry movement classes for the solution of unsteady flows on dynamic meshes, including rigid mesh transformations, dynamically deforming meshes, and time-spectral preprocessing. ---*/ for (iZone = 0; iZone < nZone; iZone++) { if (config_container[iZone]->GetGrid_Movement() || (config_container[iZone]->GetDirectDiff() == D_DESIGN)) { if (rank == MASTER_NODE) cout << "Setting dynamic mesh structure." << endl; grid_movement[iZone] = new CVolumetricMovement(geometry_container[iZone][MESH_0], config_container[iZone]); FFDBox[iZone] = new CFreeFormDefBox*[MAX_NUMBER_FFD]; surface_movement[iZone] = new CSurfaceMovement(); surface_movement[iZone]->CopyBoundary(geometry_container[iZone][MESH_0], config_container[iZone]); /*if (config_container[iZone]->GetUnsteady_Simulation() == SPECTRAL_METHOD && config_container[iZone]->GetGrid_Movement()) SetGrid_Movement(geometry_container[iZone], surface_movement[iZone], grid_movement[iZone], FFDBox[iZone], solver_container[iZone], config_container[iZone], iZone, 0, 0);*/ } if (config_container[iZone]->GetDirectDiff() == D_DESIGN){ if (rank == MASTER_NODE) cout << "Setting surface/volume derivatives." << endl; /*--- Set the surface derivatives, i.e. the derivative of the surface mesh nodes with respect to the design variables ---*/ surface_movement[iZone]->SetSurface_Derivative(geometry_container[iZone][MESH_0],config_container[iZone]); cout << "Done setting Surface Derivatives " << endl; /*--- Call the volume deformation routine with derivative mode enabled. This computes the derivative of the volume mesh with respect to the surface nodes ---*/ grid_movement[iZone]->SetVolume_Deformation(geometry_container[iZone][MESH_0],config_container[iZone], true, true); cout << "Done SetVolume_Deformation " << endl; /*--- Update the multi-grid structure to propagate the derivative information to the coarser levels ---*/ geometry_container[iZone][MESH_0]->UpdateGeometry(geometry_container[iZone],config_container[iZone]); /*--- Set the derivative of the wall-distance with respect to the surface nodes ---*/ if ( (config_container[iZone]->GetKind_Solver() == RANS) || (config_container[iZone]->GetKind_Solver() == ADJ_RANS) || (config_container[iZone]->GetKind_Solver() == DISC_ADJ_RANS)) geometry_container[iZone][MESH_0]->ComputeWall_Distance(config_container[iZone]); } } /*--- Coupling between zones (limited to two zones at the moment) ---*/ bool fsi = config_container[ZONE_0]->GetFSI_Simulation(); if ((nZone == 2) && !(fsi)) { if (rank == MASTER_NODE) cout << endl <<"--------------------- Setting Coupling Between Zones --------------------" << endl; geometry_container[ZONE_0][MESH_0]->MatchZone(config_container[ZONE_0], geometry_container[ZONE_1][MESH_0], config_container[ZONE_1], ZONE_0, nZone); geometry_container[ZONE_1][MESH_0]->MatchZone(config_container[ZONE_1], geometry_container[ZONE_0][MESH_0], config_container[ZONE_0], ZONE_1, nZone); } /*--- Definition of the output class (one for all zones). The output class manages the writing of all restart, volume solution, surface solution, surface comma-separated value, and convergence history files (both in serial and in parallel). ---*/ output = new COutput(); /*--- Open the convergence history file ---*/ if (rank == MASTER_NODE) output->SetConvHistory_Header(&ConvHist_file, config_container[ZONE_0]); /*--- Check for an unsteady restart. Update ExtIter if necessary. ---*/ if (config_container[ZONE_0]->GetWrt_Unsteady() && config_container[ZONE_0]->GetRestart()) ExtIter = config_container[ZONE_0]->GetUnst_RestartIter(); /*--- Check for a dynamic restart (structural analysis). Update ExtIter if necessary. ---*/ if (config_container[ZONE_0]->GetKind_Solver() == FEM_ELASTICITY && config_container[ZONE_0]->GetWrt_Dynamic() && config_container[ZONE_0]->GetRestart()) ExtIter = config_container[ZONE_0]->GetDyn_RestartIter(); /*--- Initiate value at each interface for the mixing plane ---*/ if(config_container[ZONE_0]->GetBoolMixingPlane()) for (iZone = 0; iZone < nZone; iZone++) iteration_container[iZone]->Preprocess(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox, iZone); /*--- Main external loop of the solver. Within this loop, each iteration ---*/ if (rank == MASTER_NODE) cout << endl <<"------------------------------ Begin Solver -----------------------------" << endl; /*--- Set up a timer for performance benchmarking (preprocessing time is not included) ---*/ #ifndef HAVE_MPI StartTime = su2double(clock())/su2double(CLOCKS_PER_SEC); #else StartTime = MPI_Wtime(); #endif /*--- This is temporal and just to check. It will have to be added to the regular history file ---*/ ofstream historyFile_FSI; bool writeHistFSI = config_container[ZONE_0]->GetWrite_Conv_FSI(); if (writeHistFSI && (rank == MASTER_NODE)){ char cstrFSI[200]; string filenameHistFSI = config_container[ZONE_0]->GetConv_FileName_FSI(); strcpy (cstrFSI, filenameHistFSI.data()); historyFile_FSI.open (cstrFSI); historyFile_FSI << "Time,Iteration,Aitken,URes,logResidual,orderMagnResidual" << endl; historyFile_FSI.close(); } while (ExtIter < config_container[ZONE_0]->GetnExtIter()) { /*--- Set the value of the external iteration. ---*/ for (iZone = 0; iZone < nZone; iZone++) config_container[iZone]->SetExtIter(ExtIter); /*--- Read the target pressure ---*/ if (config_container[ZONE_0]->GetInvDesign_Cp() == YES) output->SetCp_InverseDesign(solver_container[ZONE_0][MESH_0][FLOW_SOL], geometry_container[ZONE_0][MESH_0], config_container[ZONE_0], ExtIter); /*--- Read the target heat flux ---*/ if (config_container[ZONE_0]->GetInvDesign_HeatFlux() == YES) output->SetHeat_InverseDesign(solver_container[ZONE_0][MESH_0][FLOW_SOL], geometry_container[ZONE_0][MESH_0], config_container[ZONE_0], ExtIter); /*--- Perform a single iteration of the chosen PDE solver. ---*/ /*--- Run a single iteration of the problem using the driver class. ---*/ driver->Run(iteration_container, output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox, interpolator_container, transfer_container); /*--- Synchronization point after a single solver iteration. Compute the wall clock time required. ---*/ #ifndef HAVE_MPI StopTime = su2double(clock())/su2double(CLOCKS_PER_SEC); #else StopTime = MPI_Wtime(); #endif UsedTime = (StopTime - StartTime); /*--- For specific applications, evaluate and plot the equivalent area. ---*/ if (config_container[ZONE_0]->GetEquivArea() == YES) { output->SetEquivalentArea(solver_container[ZONE_0][MESH_0][FLOW_SOL], geometry_container[ZONE_0][MESH_0], config_container[ZONE_0], ExtIter); } /*--- Check if there is any change in the runtime parameters ---*/ CConfig *runtime = NULL; strcpy(runtime_file_name, "runtime.dat"); runtime = new CConfig(runtime_file_name, config_container[ZONE_0]); runtime->SetExtIter(ExtIter); /*--- Update the convergence history file (serial and parallel computations). ---*/ if (!fsi){ output->SetConvHistory_Body(&ConvHist_file, geometry_container, solver_container, config_container, integration_container, false, UsedTime, ZONE_0); } /*--- Evaluate the new CFL number (adaptive). ---*/ if (config_container[ZONE_0]->GetCFL_Adapt() == YES) { output->SetCFL_Number(solver_container, config_container, ZONE_0); } /*--- Check whether the current simulation has reached the specified convergence criteria, and set StopCalc to true, if so. ---*/ switch (config_container[ZONE_0]->GetKind_Solver()) { case EULER: case NAVIER_STOKES: case RANS: StopCalc = integration_container[ZONE_0][FLOW_SOL]->GetConvergence(); break; case WAVE_EQUATION: StopCalc = integration_container[ZONE_0][WAVE_SOL]->GetConvergence(); break; case HEAT_EQUATION: StopCalc = integration_container[ZONE_0][HEAT_SOL]->GetConvergence(); break; case FEM_ELASTICITY: StopCalc = integration_container[ZONE_0][FEA_SOL]->GetConvergence(); break; case ADJ_EULER: case ADJ_NAVIER_STOKES: case ADJ_RANS: case DISC_ADJ_EULER: case DISC_ADJ_NAVIER_STOKES: case DISC_ADJ_RANS: StopCalc = integration_container[ZONE_0][ADJFLOW_SOL]->GetConvergence(); break; } /*--- Solution output. Determine whether a solution needs to be written after the current iteration, and if so, execute the output file writing routines. ---*/ if ((ExtIter+1 >= config_container[ZONE_0]->GetnExtIter()) || ((ExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq() == 0) && (ExtIter != 0) && !((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND) || (config_container[ZONE_0]->GetUnsteady_Simulation() == TIME_STEPPING))) || (StopCalc) || (((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == TIME_STEPPING)) && ((ExtIter == 0) || (ExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0))) || ((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND) && (!fsi) && ((ExtIter == 0) || ((ExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0) || ((ExtIter-1) % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) || ((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND) && (fsi) && ((ExtIter == 0) || ((ExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) || (((config_container[ZONE_0]->GetDynamic_Analysis() == DYNAMIC) && ((ExtIter == 0) || (ExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0))))){ /*--- Low-fidelity simulations (using a coarser multigrid level approximation to the solution) require an interpolation back to the finest grid. ---*/ if (config_container[ZONE_0]->GetLowFidelitySim()) { integration_container[ZONE_0][FLOW_SOL]->SetProlongated_Solution(RUNTIME_FLOW_SYS, solver_container[ZONE_0][MESH_0][FLOW_SOL], solver_container[ZONE_0][MESH_1][FLOW_SOL], geometry_container[ZONE_0][MESH_0], geometry_container[ZONE_0][MESH_1], config_container[ZONE_0]); integration_container[ZONE_0][FLOW_SOL]->Smooth_Solution(RUNTIME_FLOW_SYS, solver_container[ZONE_0][MESH_0][FLOW_SOL], geometry_container[ZONE_0][MESH_0], 3, 1.25, config_container[ZONE_0]); solver_container[ZONE_0][MESH_0][config_container[ZONE_0]->GetContainerPosition(RUNTIME_FLOW_SYS)]->Set_MPI_Solution(geometry_container[ZONE_0][MESH_0], config_container[ZONE_0]); solver_container[ZONE_0][MESH_0][config_container[ZONE_0]->GetContainerPosition(RUNTIME_FLOW_SYS)]->Preprocessing(geometry_container[ZONE_0][MESH_0], solver_container[ZONE_0][MESH_0], config_container[ZONE_0], MESH_0, 0, RUNTIME_FLOW_SYS, true); } if (rank == MASTER_NODE) cout << endl << "-------------------------- File Output Summary --------------------------"; /*--- Execute the routine for writing restart, volume solution, surface solution, and surface comma-separated value files. ---*/ output->SetResult_Files(solver_container, geometry_container, config_container, ExtIter, nZone); /*--- Output a file with the forces breakdown. ---*/ output->SetForces_Breakdown(geometry_container, solver_container, config_container, integration_container, ZONE_0); /*--- Compute the forces at different sections. ---*/ if (config_container[ZONE_0]->GetPlot_Section_Forces()) { output->SetForceSections(solver_container[ZONE_0][MESH_0][FLOW_SOL], geometry_container[ZONE_0][MESH_0], config_container[ZONE_0], ExtIter); } if (rank == MASTER_NODE) cout << "-------------------------------------------------------------------------" << endl << endl; } /*--- If the convergence criteria has been met, terminate the simulation. ---*/ if (StopCalc) break; ExtIter++; } /*--- Output some information to the console. ---*/ if (rank == MASTER_NODE) { /*--- Print out the number of non-physical points and reconstructions ---*/ if (config_container[ZONE_0]->GetNonphysical_Points() > 0) cout << "Warning: there are " << config_container[ZONE_0]->GetNonphysical_Points() << " non-physical points in the solution." << endl; if (config_container[ZONE_0]->GetNonphysical_Reconstr() > 0) cout << "Warning: " << config_container[ZONE_0]->GetNonphysical_Reconstr() << " reconstructed states for upwinding are non-physical." << endl; /*--- Close the convergence history file. ---*/ ConvHist_file.close(); cout << "History file, closed." << endl; } /*--- Deallocations: further work is needed, * these routines can be used to check for memory leaks---*/ /* if (rank == MASTER_NODE) cout << endl <<"------------------------ Driver Postprocessing ------------------------" << endl; driver->Postprocessing(iteration_container, solver_container, geometry_container, integration_container, numerics_container, interpolator_container, transfer_container, config_container, nZone); delete driver; */ /*--- Geometry class deallocation ---*/ if (rank == MASTER_NODE) cout << endl <<"------------------------ Geometry Postprocessing ------------------------" << endl; for (iZone = 0; iZone < nZone; iZone++) { if (geometry_container[iZone]!=NULL){ for (unsigned short iMGlevel = 1; iMGlevel < config_container[iZone]->GetnMGLevels()+1; iMGlevel++){ if (geometry_container[iZone][iMGlevel]!=NULL) delete geometry_container[iZone][iMGlevel]; } delete [] geometry_container[iZone]; } } delete [] geometry_container; /*--- Free-form deformation class deallocation ---*/ for (iZone = 0; iZone < nZone; iZone++) { delete FFDBox[iZone]; } delete [] FFDBox; /*--- Grid movement and surface movement class deallocation ---*/ delete [] surface_movement; delete [] grid_movement; /*Deallocate config container*/ if (rank == MASTER_NODE) cout << endl <<"------------------------- Config Postprocessing -------------------------" << endl; if (config_container!=NULL){ for (iZone = 0; iZone < nZone; iZone++) { if (config_container[iZone]!=NULL){ delete config_container[iZone]; } } delete [] config_container; } /*--- Deallocate output container ---*/ if (output!=NULL) delete output; /*--- Synchronization point after a single solver iteration. Compute the wall clock time required. ---*/ #ifndef HAVE_MPI StopTime = su2double(clock())/su2double(CLOCKS_PER_SEC); #else StopTime = MPI_Wtime(); #endif /*--- Compute/print the total time for performance benchmarking. ---*/ UsedTime = StopTime-StartTime; if (rank == MASTER_NODE) { cout << "\nCompleted in " << fixed << UsedTime << " seconds on "<< size; if (size == 1) cout << " core." << endl; else cout << " cores." << endl; } /*--- Exit the solver cleanly ---*/ if (rank == MASTER_NODE) cout << endl <<"------------------------- Exit Success (SU2_CFD) ------------------------" << endl << endl; #ifdef HAVE_MPI /*--- Finalize MPI parallelization ---*/ MPI_Buffer_detach(&bptr, &bl); MPI_Finalize(); #endif return EXIT_SUCCESS; }
int main(int argc, char *argv[]) { unsigned short iZone, nZone = SINGLE_ZONE; su2double StartTime = 0.0, StopTime = 0.0, UsedTime = 0.0; char config_file_name[MAX_STRING_SIZE], *cstr = NULL; ofstream Gradient_file; su2double** Gradient; unsigned short iDV, iDV_Value; int rank, size; /*--- MPI initialization, and buffer setting ---*/ #ifdef HAVE_MPI SU2_MPI::Init(&argc,&argv); SU2_MPI::Comm MPICommunicator(MPI_COMM_WORLD); #else SU2_Comm MPICommunicator(0); #endif rank = SU2_MPI::GetRank(); size = SU2_MPI::GetSize(); /*--- Pointer to different structures that will be used throughout the entire code ---*/ CConfig **config_container = NULL; CGeometry **geometry_container = NULL; CSurfaceMovement **surface_movement = NULL; CVolumetricMovement **grid_movement = NULL; COutput *output = NULL; /*--- Load in the number of zones and spatial dimensions in the mesh file (if no config file is specified, default.cfg is used) ---*/ if (argc == 2) { strcpy(config_file_name,argv[1]); } else { strcpy(config_file_name, "default.cfg"); } /*--- Read the name and format of the input mesh file to get from the mesh file the number of zones and dimensions from the numerical grid (required for variables allocation) ---*/ CConfig *config = NULL; config = new CConfig(config_file_name, SU2_DEF); nZone = CConfig::GetnZone(config->GetMesh_FileName(), config->GetMesh_FileFormat(), config); /*--- Definition of the containers per zones ---*/ config_container = new CConfig*[nZone]; geometry_container = new CGeometry*[nZone]; surface_movement = new CSurfaceMovement*[nZone]; grid_movement = new CVolumetricMovement*[nZone]; for (iZone = 0; iZone < nZone; iZone++) { config_container[iZone] = NULL; geometry_container[iZone] = NULL; grid_movement [iZone] = NULL; surface_movement[iZone] = NULL; } /*--- Loop over all zones to initialize the various classes. In most cases, nZone is equal to one. This represents the solution of a partial differential equation on a single block, unstructured mesh. ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the configuration option class for all zones. In this constructor, the input configuration file is parsed and all options are read and stored. ---*/ config_container[iZone] = new CConfig(config_file_name, SU2_DOT, iZone, nZone, 0, VERB_HIGH); /*--- Set the MPI communicator ---*/ config_container[iZone]->SetMPICommunicator(MPICommunicator); /*--- Definition of the geometry class to store the primal grid in the partitioning process. ---*/ CGeometry *geometry_aux = NULL; /*--- All ranks process the grid and call ParMETIS for partitioning ---*/ geometry_aux = new CPhysicalGeometry(config_container[iZone], iZone, nZone); /*--- Color the initial grid and set the send-receive domains (ParMETIS) ---*/ geometry_aux->SetColorGrid_Parallel(config_container[iZone]); /*--- Allocate the memory of the current domain, and divide the grid between the nodes ---*/ geometry_container[iZone] = new CPhysicalGeometry(geometry_aux, config_container[iZone]); /*--- Deallocate the memory of geometry_aux ---*/ delete geometry_aux; /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone]->SetSendReceive(config_container[iZone]); /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone]->SetBoundaries(config_container[iZone]); } /*--- Set up a timer for performance benchmarking (preprocessing time is included) ---*/ #ifdef HAVE_MPI StartTime = MPI_Wtime(); #else StartTime = su2double(clock())/su2double(CLOCKS_PER_SEC); #endif for (iZone = 0; iZone < nZone; iZone++){ if (rank == MASTER_NODE) cout << endl <<"----------------------- Preprocessing computations ----------------------" << endl; /*--- Compute elements surrounding points, points surrounding points ---*/ if (rank == MASTER_NODE) cout << "Setting local point connectivity." <<endl; geometry_container[iZone]->SetPoint_Connectivity(); /*--- Check the orientation before computing geometrical quantities ---*/ geometry_container[iZone]->SetBoundVolume(); if (config_container[iZone]->GetReorientElements()) { if (rank == MASTER_NODE) cout << "Checking the numerical grid orientation of the elements." <<endl; geometry_container[iZone]->Check_IntElem_Orientation(config_container[iZone]); geometry_container[iZone]->Check_BoundElem_Orientation(config_container[iZone]); } /*--- Create the edge structure ---*/ if (rank == MASTER_NODE) cout << "Identify edges and vertices." <<endl; geometry_container[iZone]->SetEdges(); geometry_container[iZone]->SetVertex(config_container[iZone]); /*--- Compute center of gravity ---*/ if (rank == MASTER_NODE) cout << "Computing centers of gravity." << endl; geometry_container[iZone]->SetCoord_CG(); /*--- Create the dual control volume structures ---*/ if (rank == MASTER_NODE) cout << "Setting the bound control volume structure." << endl; geometry_container[iZone]->SetBoundControlVolume(config_container[ZONE_0], ALLOCATE); /*--- Store the global to local mapping after preprocessing. ---*/ if (rank == MASTER_NODE) cout << "Storing a mapping from global to local point index." << endl; geometry_container[iZone]->SetGlobal_to_Local_Point(); /*--- Load the surface sensitivities from file. This is done only once: if this is an unsteady problem, a time-average of the surface sensitivities at each node is taken within this routine. ---*/ if (!config_container[iZone]->GetDiscrete_Adjoint()){ if (rank == MASTER_NODE) cout << "Reading surface sensitivities at each node from file." << endl; geometry_container[iZone]->SetBoundSensitivity(config_container[iZone]); } else { if (rank == MASTER_NODE) cout << "Reading volume sensitivities at each node from file." << endl; grid_movement[iZone] = new CVolumetricMovement(geometry_container[iZone], config_container[iZone]); geometry_container[iZone]->SetSensitivity(config_container[iZone]); if (rank == MASTER_NODE) cout << endl <<"---------------------- Mesh sensitivity computation ---------------------" << endl; grid_movement[iZone]->SetVolume_Deformation(geometry_container[iZone], config_container[iZone], false, true); } } if (config_container[ZONE_0]->GetDiscrete_Adjoint()){ if (rank == MASTER_NODE) cout << endl <<"------------------------ Mesh sensitivity Output ------------------------" << endl; output = new COutput(config_container[ZONE_0]); output->SetSensitivity_Files(geometry_container, config_container, nZone); } if (config_container[ZONE_0]->GetDesign_Variable(0) != NONE){ /*--- Initialize structure to store the gradient ---*/ Gradient = new su2double*[config_container[ZONE_0]->GetnDV()]; for (iDV = 0; iDV < config_container[ZONE_0]->GetnDV(); iDV++){ Gradient[iDV] = new su2double[config_container[ZONE_0]->GetnDV_Value(iDV)]; for (iDV_Value = 0; iDV_Value < config_container[ZONE_0]->GetnDV_Value(iDV); iDV_Value++){ Gradient[iDV][iDV_Value] = 0.0; } } if (rank == MASTER_NODE) cout << endl <<"---------- Start gradient evaluation using sensitivity information ----------" << endl; /*--- Write the gradient in a external file ---*/ if (rank == MASTER_NODE) { cstr = new char [config_container[ZONE_0]->GetObjFunc_Grad_FileName().size()+1]; strcpy (cstr, config_container[ZONE_0]->GetObjFunc_Grad_FileName().c_str()); Gradient_file.open(cstr, ios::out); } /*--- Loop through each zone and add it's contribution to the gradient array ---*/ for (iZone = 0; iZone < nZone; iZone++){ /*--- Definition of the Class for surface deformation ---*/ surface_movement[iZone] = new CSurfaceMovement(); /*--- Copy coordinates to the surface structure ---*/ surface_movement[iZone]->CopyBoundary(geometry_container[iZone], config_container[iZone]); /*--- If AD mode is enabled we can use it to compute the projection, * otherwise we use finite differences. ---*/ if (config_container[iZone]->GetAD_Mode()){ SetProjection_AD(geometry_container[iZone], config_container[iZone], surface_movement[iZone] , Gradient); }else{ SetProjection_FD(geometry_container[iZone], config_container[iZone], surface_movement[iZone] , Gradient); } } /*--- Print gradients to screen and file ---*/ OutputGradient(Gradient, config_container[ZONE_0], Gradient_file); if (rank == MASTER_NODE) Gradient_file.close(); for (iDV = 0; iDV < config_container[ZONE_0]->GetnDV(); iDV++){ delete [] Gradient[iDV]; } delete [] Gradient; } if (rank == MASTER_NODE) cout << endl <<"------------------------- Solver Postprocessing -------------------------" << endl; if (geometry_container != NULL) { for (iZone = 0; iZone < nZone; iZone++) { if (geometry_container[iZone] != NULL) { delete geometry_container[iZone]; } } delete [] geometry_container; } if (rank == MASTER_NODE) cout << "Deleted CGeometry container." << endl; if (surface_movement != NULL) { for (iZone = 0; iZone < nZone; iZone++) { if (surface_movement[iZone] != NULL) { delete surface_movement[iZone]; } } delete [] surface_movement; } if (rank == MASTER_NODE) cout << "Deleted CSurfaceMovement class." << endl; if (grid_movement != NULL) { for (iZone = 0; iZone < nZone; iZone++) { if (grid_movement[iZone] != NULL) { delete grid_movement[iZone]; } } delete [] grid_movement; } if (rank == MASTER_NODE) cout << "Deleted CVolumetricMovement class." << endl; delete config; config = NULL; if (config_container != NULL) { for (iZone = 0; iZone < nZone; iZone++) { if (config_container[iZone] != NULL) { delete config_container[iZone]; } } delete [] config_container; } if (rank == MASTER_NODE) cout << "Deleted CConfig container." << endl; if (output != NULL) delete output; if (rank == MASTER_NODE) cout << "Deleted COutput class." << endl; if (cstr != NULL) delete cstr; /*--- Synchronization point after a single solver iteration. Compute the wall clock time required. ---*/ #ifdef HAVE_MPI StopTime = MPI_Wtime(); #else StopTime = su2double(clock())/su2double(CLOCKS_PER_SEC); #endif /*--- Compute/print the total time for performance benchmarking. ---*/ UsedTime = StopTime-StartTime; if (rank == MASTER_NODE) { cout << "\nCompleted in " << fixed << UsedTime << " seconds on "<< size; if (size == 1) cout << " core." << endl; else cout << " cores." << endl; } /*--- Exit the solver cleanly ---*/ if (rank == MASTER_NODE) cout << endl <<"------------------------- Exit Success (SU2_DOT) ------------------------" << endl << endl; /*--- Finalize MPI parallelization ---*/ #ifdef HAVE_MPI SU2_MPI::Finalize(); #endif return EXIT_SUCCESS; }
int main(int argc, char *argv[]) { bool StopCalc = false; unsigned long StartTime, StopTime, TimeUsed = 0, ExtIter = 0; unsigned short iMesh, iZone, iSol, nZone, nDim; ofstream ConvHist_file; int rank = MASTER_NODE; #ifndef NO_MPI /*--- MPI initialization, and buffer setting ---*/ void *buffer, *old_buffer; int size, bufsize; bufsize = MAX_MPI_BUFFER; buffer = new char[bufsize]; MPI::Init(argc, argv); MPI::Attach_buffer(buffer, bufsize); rank = MPI::COMM_WORLD.Get_rank(); size = MPI::COMM_WORLD.Get_size(); #ifdef TIME /*--- Set up a timer for parallel performance benchmarking ---*/ double start, finish, time; MPI::COMM_WORLD.Barrier(); start = MPI::Wtime(); #endif #endif /*--- Create pointers to all of the classes that may be used throughout the SU2_CFD code. In general, the pointers are instantiated down a heirarchy over all zones, multigrid levels, equation sets, and equation terms as described in the comments below. ---*/ COutput *output = NULL; CIntegration ***integration_container = NULL; CGeometry ***geometry_container = NULL; CSolver ****solver_container = NULL; CNumerics *****numerics_container = NULL; CConfig **config_container = NULL; CSurfaceMovement **surface_movement = NULL; CVolumetricMovement **grid_movement = NULL; CFreeFormDefBox*** FFDBox = NULL; /*--- Load in the number of zones and spatial dimensions in the mesh file (If no config file is specified, default.cfg is used) ---*/ char config_file_name[200]; if (argc == 2){ strcpy(config_file_name,argv[1]); } else{ strcpy(config_file_name, "default.cfg"); } /*--- Read the name and format of the input mesh file ---*/ CConfig *config = NULL; config = new CConfig(config_file_name); /*--- Get the number of zones and dimensions from the numerical grid (required for variables allocation) ---*/ nZone = GetnZone(config->GetMesh_FileName(), config->GetMesh_FileFormat(), config); nDim = GetnDim(config->GetMesh_FileName(), config->GetMesh_FileFormat()); /*--- Definition and of the containers for all possible zones. ---*/ solver_container = new CSolver***[nZone]; integration_container = new CIntegration**[nZone]; numerics_container = new CNumerics****[nZone]; config_container = new CConfig*[nZone]; geometry_container = new CGeometry **[nZone]; surface_movement = new CSurfaceMovement *[nZone]; grid_movement = new CVolumetricMovement *[nZone]; FFDBox = new CFreeFormDefBox**[nZone]; for (iZone = 0; iZone < nZone; iZone++) { solver_container[iZone] = NULL; integration_container[iZone] = NULL; numerics_container[iZone] = NULL; config_container[iZone] = NULL; geometry_container[iZone] = NULL; surface_movement[iZone] = NULL; grid_movement[iZone] = NULL; FFDBox[iZone] = NULL; } /*--- Loop over all zones to initialize the various classes. In most cases, nZone is equal to one. This represents the solution of a partial differential equation on a single block, unstructured mesh. ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the configuration option class for all zones. In this constructor, the input configuration file is parsed and all options are read and stored. ---*/ config_container[iZone] = new CConfig(config_file_name, SU2_CFD, iZone, nZone, VERB_HIGH); #ifndef NO_MPI /*--- Change the name of the input-output files for a parallel computation ---*/ config_container[iZone]->SetFileNameDomain(rank+1); #endif /*--- Perform the non-dimensionalization for the flow equations using the specified reference values. ---*/ config_container[iZone]->SetNondimensionalization(nDim, iZone); /*--- Definition of the geometry class. Within this constructor, the mesh file is read and the primal grid is stored (node coords, connectivity, & boundary markers. MESH_0 is the index of the finest mesh. ---*/ geometry_container[iZone] = new CGeometry *[config_container[iZone]->GetMGLevels()+1]; geometry_container[iZone][MESH_0] = new CPhysicalGeometry(config_container[iZone], iZone+1, nZone); } if (rank == MASTER_NODE) cout << endl <<"------------------------- Geometry Preprocessing ------------------------" << endl; /*--- Preprocessing of the geometry for all zones. In this routine, the edge- based data structure is constructed, i.e. node and cell neighbors are identified and linked, face areas and volumes of the dual mesh cells are computed, and the multigrid levels are created using an agglomeration procedure. ---*/ Geometrical_Preprocessing(geometry_container, config_container, nZone); #ifndef NO_MPI /*--- Synchronization point after the geometrical definition subroutine ---*/ MPI::COMM_WORLD.Barrier(); #endif if (rank == MASTER_NODE) cout << endl <<"------------------------- Solver Preprocessing --------------------------" << endl; for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the solver class: solver_container[#ZONES][#MG_GRIDS][#EQ_SYSTEMS]. The solver classes are specific to a particular set of governing equations, and they contain the subroutines with instructions for computing each spatial term of the PDE, i.e. loops over the edges to compute convective and viscous fluxes, loops over the nodes to compute source terms, and routines for imposing various boundary condition type for the PDE. ---*/ solver_container[iZone] = new CSolver** [config_container[iZone]->GetMGLevels()+1]; for (iMesh = 0; iMesh <= config_container[iZone]->GetMGLevels(); iMesh++) solver_container[iZone][iMesh] = NULL; for (iMesh = 0; iMesh <= config_container[iZone]->GetMGLevels(); iMesh++) { solver_container[iZone][iMesh] = new CSolver* [MAX_SOLS]; for (iSol = 0; iSol < MAX_SOLS; iSol++) solver_container[iZone][iMesh][iSol] = NULL; } Solver_Preprocessing(solver_container[iZone], geometry_container[iZone], config_container[iZone], iZone); #ifndef NO_MPI /*--- Synchronization point after the solution preprocessing subroutine ---*/ MPI::COMM_WORLD.Barrier(); #endif if (rank == MASTER_NODE) cout << endl <<"----------------- Integration and Numerics Preprocessing ----------------" << endl; /*--- Definition of the integration class: integration_container[#ZONES][#EQ_SYSTEMS]. The integration class orchestrates the execution of the spatial integration subroutines contained in the solver class (including multigrid) for computing the residual at each node, R(U) and then integrates the equations to a steady state or time-accurately. ---*/ integration_container[iZone] = new CIntegration*[MAX_SOLS]; Integration_Preprocessing(integration_container[iZone], geometry_container[iZone], config_container[iZone], iZone); #ifndef NO_MPI /*--- Synchronization point after the integration definition subroutine ---*/ MPI::COMM_WORLD.Barrier(); #endif /*--- Definition of the numerical method class: numerics_container[#ZONES][#MG_GRIDS][#EQ_SYSTEMS][#EQ_TERMS]. The numerics class contains the implementation of the numerical methods for evaluating convective or viscous fluxes between any two nodes in the edge-based data structure (centered, upwind, galerkin), as well as any source terms (piecewise constant reconstruction) evaluated in each dual mesh volume. ---*/ numerics_container[iZone] = new CNumerics***[config_container[iZone]->GetMGLevels()+1]; Numerics_Preprocessing(numerics_container[iZone], solver_container[iZone], geometry_container[iZone], config_container[iZone], iZone); #ifndef NO_MPI /*--- Synchronization point after the solver definition subroutine ---*/ MPI::COMM_WORLD.Barrier(); #endif /*--- Computation of wall distances for turbulence modeling ---*/ if ( (config_container[iZone]->GetKind_Solver() == RANS) || (config_container[iZone]->GetKind_Solver() == ADJ_RANS) ) geometry_container[iZone][MESH_0]->ComputeWall_Distance(config_container[iZone]); /*--- Computation of positive surface area in the z-plane which is used for the calculation of force coefficient (non-dimensionalization). ---*/ geometry_container[iZone][MESH_0]->SetPositive_ZArea(config_container[iZone]); /*--- Set the near-field and interface boundary conditions, if necessary. ---*/ for (iMesh = 0; iMesh <= config_container[iZone]->GetMGLevels(); iMesh++) { geometry_container[iZone][iMesh]->MatchNearField(config_container[iZone]); geometry_container[iZone][iMesh]->MatchInterface(config_container[iZone]); } /*--- Instantiate the geometry movement classes for the solution of unsteady flows on dynamic meshes, including rigid mesh transformations, dynamically deforming meshes, and time-spectral preprocessing. ---*/ if (config_container[iZone]->GetGrid_Movement()) { if (rank == MASTER_NODE) cout << "Setting dynamic mesh structure." << endl; grid_movement[iZone] = new CVolumetricMovement(geometry_container[iZone][MESH_0]); FFDBox[iZone] = new CFreeFormDefBox*[MAX_NUMBER_FFD]; surface_movement[iZone] = new CSurfaceMovement(); surface_movement[iZone]->CopyBoundary(geometry_container[iZone][MESH_0], config_container[iZone]); if (config_container[iZone]->GetUnsteady_Simulation() == TIME_SPECTRAL) SetGrid_Movement(geometry_container[iZone], surface_movement[iZone], grid_movement[iZone], FFDBox[iZone], solver_container[iZone], config_container[iZone], iZone, 0); } } /*--- For the time-spectral solver, set the grid node velocities. ---*/ if (config_container[ZONE_0]->GetUnsteady_Simulation() == TIME_SPECTRAL) SetTimeSpectral_Velocities(geometry_container, config_container, nZone); /*--- Coupling between zones (limited to two zones at the moment) ---*/ if (nZone == 2) { if (rank == MASTER_NODE) cout << endl <<"--------------------- Setting Coupling Between Zones --------------------" << endl; geometry_container[ZONE_0][MESH_0]->MatchZone(config_container[ZONE_0], geometry_container[ZONE_1][MESH_0], config_container[ZONE_1], ZONE_0, nZone); geometry_container[ZONE_1][MESH_0]->MatchZone(config_container[ZONE_1], geometry_container[ZONE_0][MESH_0], config_container[ZONE_0], ZONE_1, nZone); } /*--- Definition of the output class (one for all zones). The output class manages the writing of all restart, volume solution, surface solution, surface comma-separated value, and convergence history files (both in serial and in parallel). ---*/ output = new COutput(); /*--- Open the convergence history file ---*/ if (rank == MASTER_NODE) output->SetHistory_Header(&ConvHist_file, config_container[ZONE_0]); /*--- Check for an unsteady restart. Update ExtIter if necessary. ---*/ if (config_container[ZONE_0]->GetWrt_Unsteady() && config_container[ZONE_0]->GetRestart()) ExtIter = config_container[ZONE_0]->GetUnst_RestartIter(); /*--- Main external loop of the solver. Within this loop, each iteration ---*/ if (rank == MASTER_NODE) cout << endl <<"------------------------------ Begin Solver -----------------------------" << endl; while (ExtIter < config_container[ZONE_0]->GetnExtIter()) { /*--- Set a timer for each iteration. Store the current iteration and update the value of the CFL number (if there is CFL ramping specified) in the config class. ---*/ StartTime = clock(); for (iZone = 0; iZone < nZone; iZone++) { config_container[iZone]->SetExtIter(ExtIter); config_container[iZone]->UpdateCFL(ExtIter); } /*--- Perform a single iteration of the chosen PDE solver. ---*/ switch (config_container[ZONE_0]->GetKind_Solver()) { case EULER: case NAVIER_STOKES: case RANS: MeanFlowIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case TNE2_EULER: case TNE2_NAVIER_STOKES: TNE2Iteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case FLUID_STRUCTURE_EULER: case FLUID_STRUCTURE_NAVIER_STOKES: FluidStructureIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case WAVE_EQUATION: WaveIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case HEAT_EQUATION: HeatIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case POISSON_EQUATION: PoissonIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case LINEAR_ELASTICITY: FEAIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case ADJ_EULER: case ADJ_NAVIER_STOKES: case ADJ_RANS: AdjMeanFlowIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case ADJ_TNE2_EULER: case ADJ_TNE2_NAVIER_STOKES: AdjTNE2Iteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; } /*--- Synchronization point after a single solver iteration. Compute the wall clock time required. ---*/ #ifndef NO_MPI MPI::COMM_WORLD.Barrier(); #endif StopTime = clock(); TimeUsed += (StopTime - StartTime); /*--- For specific applications, evaluate and plot the equivalent area or flow rate. ---*/ if ((config_container[ZONE_0]->GetKind_Solver() == EULER) && (config_container[ZONE_0]->GetEquivArea() == YES)) { output->SetEquivalentArea(solver_container[ZONE_0][MESH_0][FLOW_SOL], geometry_container[ZONE_0][MESH_0], config_container[ZONE_0], ExtIter); } /*--- Update the convergence history file (serial and parallel computations). ---*/ output->SetConvergence_History(&ConvHist_file, geometry_container, solver_container, config_container, integration_container, false, TimeUsed, ZONE_0); /*--- Check whether the current simulation has reached the specified convergence criteria, and set StopCalc to true, if so. ---*/ switch (config_container[ZONE_0]->GetKind_Solver()) { case EULER: case NAVIER_STOKES: case RANS: StopCalc = integration_container[ZONE_0][FLOW_SOL]->GetConvergence(); break; case TNE2_EULER: case TNE2_NAVIER_STOKES: StopCalc = integration_container[ZONE_0][TNE2_SOL]->GetConvergence(); break; case WAVE_EQUATION: StopCalc = integration_container[ZONE_0][WAVE_SOL]->GetConvergence(); break; case HEAT_EQUATION: StopCalc = integration_container[ZONE_0][HEAT_SOL]->GetConvergence(); break; case LINEAR_ELASTICITY: StopCalc = integration_container[ZONE_0][FEA_SOL]->GetConvergence(); break; case ADJ_EULER: case ADJ_NAVIER_STOKES: case ADJ_RANS: StopCalc = integration_container[ZONE_0][ADJFLOW_SOL]->GetConvergence(); break; case ADJ_TNE2_EULER: case ADJ_TNE2_NAVIER_STOKES: StopCalc = integration_container[ZONE_0][ADJTNE2_SOL]->GetConvergence(); break; } /*--- Solution output. Determine whether a solution needs to be written after the current iteration, and if so, execute the output file writing routines. ---*/ if ((ExtIter+1 == config_container[ZONE_0]->GetnExtIter()) || ((ExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq() == 0) && (ExtIter != 0) && !((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND))) || (StopCalc) || (((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND)) && ((ExtIter == 0) || (ExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) { /*--- Low-fidelity simulations (using a coarser multigrid level approximation to the solution) require an interpolation back to the finest grid. ---*/ if (config_container[ZONE_0]->GetLowFidelitySim()) { integration_container[ZONE_0][FLOW_SOL]->SetProlongated_Solution(RUNTIME_FLOW_SYS, solver_container[ZONE_0][MESH_0], solver_container[ZONE_0][MESH_1], geometry_container[ZONE_0][MESH_0], geometry_container[ZONE_0][MESH_1], config_container[ZONE_0]); integration_container[ZONE_0][FLOW_SOL]->Smooth_Solution(RUNTIME_FLOW_SYS, solver_container[ZONE_0][MESH_0], geometry_container[ZONE_0][MESH_0], 3, 1.25, config_container[ZONE_0]); solver_container[ZONE_0][MESH_0][config_container[ZONE_0]->GetContainerPosition(RUNTIME_FLOW_SYS)]->Set_MPI_Solution(geometry_container[ZONE_0][MESH_0], config_container[ZONE_0]); solver_container[ZONE_0][MESH_0][config_container[ZONE_0]->GetContainerPosition(RUNTIME_FLOW_SYS)]->Preprocessing(geometry_container[ZONE_0][MESH_0], solver_container[ZONE_0][MESH_0], config_container[ZONE_0], MESH_0, 0, RUNTIME_FLOW_SYS); } /*--- Execute the routine for writing restart, volume solution, surface solution, and surface comma-separated value files. ---*/ output->SetResult_Files(solver_container, geometry_container, config_container, ExtIter, nZone); } /*--- If the convergence criteria has been met, terminate the simulation. ---*/ if (StopCalc) break; ExtIter++; } /*--- Close the convergence history file. ---*/ if (rank == MASTER_NODE) { ConvHist_file.close(); cout << endl <<"History file, closed." << endl; } /* if (config->GetKind_Solver() == RANS){ if (config->GetKind_Turb_Model() == ML){ // Tell the ML code to stop running string mlWriteFilename = config->GetML_Turb_Model_Write(); ofstream mlWrite; mlWrite.open(mlWriteFilename.c_str()); mlWrite << int(-1) << flush; mlWrite.close(); } } */ /*--- Solver class deallocation ---*/ // for (iZone = 0; iZone < nZone; iZone++) { // for (iMesh = 0; iMesh <= config_container[iZone]->GetMGLevels(); iMesh++) { // for (iSol = 0; iSol < MAX_SOLS; iSol++) { // if (solver_container[iZone][iMesh][iSol] != NULL) { // delete solver_container[iZone][iMesh][iSol]; // } // } // delete solver_container[iZone][iMesh]; // } // delete solver_container[iZone]; // } // delete [] solver_container; // if (rank == MASTER_NODE) cout <<"Solution container, deallocated." << endl; /*--- Geometry class deallocation ---*/ // for (iZone = 0; iZone < nZone; iZone++) { // for (iMesh = 0; iMesh <= config_container[iZone]->GetMGLevels(); iMesh++) { // delete geometry_container[iZone][iMesh]; // } // delete geometry_container[iZone]; // } // delete [] geometry_container; // cout <<"Geometry container, deallocated." << endl; /*--- Integration class deallocation ---*/ // cout <<"Integration container, deallocated." << endl; #ifndef NO_MPI /*--- Compute/print the total time for parallel performance benchmarking. ---*/ #ifdef TIME MPI::COMM_WORLD.Barrier(); finish = MPI::Wtime(); time = finish-start; if (rank == MASTER_NODE) { cout << "\nCompleted in " << fixed << time << " seconds on "<< size; if (size == 1) cout << " core.\n" << endl; else cout << " cores.\n" << endl; } #endif /*--- Finalize MPI parallelization ---*/ old_buffer = buffer; MPI::Detach_buffer(old_buffer); // delete [] buffer; MPI::Finalize(); #endif /*--- Exit the solver cleanly ---*/ if (rank == MASTER_NODE) cout << endl <<"------------------------- Exit Success (SU2_CFD) ------------------------" << endl << endl; return EXIT_SUCCESS; }
int main(int argc, char *argv[]) { unsigned short iZone, nZone = SINGLE_ZONE, iMarker; su2double StartTime = 0.0, StopTime = 0.0, UsedTime = 0.0; char config_file_name[MAX_STRING_SIZE]; int rank = MASTER_NODE, size = SINGLE_NODE; string str; bool allmoving=true; /*--- MPI initialization ---*/ #ifdef HAVE_MPI SU2_MPI::Init(&argc,&argv); MPI_Comm_rank(MPI_COMM_WORLD,&rank); MPI_Comm_size(MPI_COMM_WORLD,&size); #endif /*--- Pointer to different structures that will be used throughout the entire code ---*/ CConfig **config_container = NULL; CGeometry **geometry_container = NULL; CSurfaceMovement *surface_movement = NULL; CVolumetricMovement *grid_movement = NULL; COutput *output = NULL; /*--- Load in the number of zones and spatial dimensions in the mesh file (if no config file is specified, default.cfg is used) ---*/ if (argc == 2){ strcpy(config_file_name,argv[1]); } else{ strcpy(config_file_name, "default.cfg"); } /*--- Definition of the containers per zones ---*/ config_container = new CConfig*[nZone]; geometry_container = new CGeometry*[nZone]; output = new COutput(); for (iZone = 0; iZone < nZone; iZone++) { config_container[iZone] = NULL; geometry_container[iZone] = NULL; } /*--- Loop over all zones to initialize the various classes. In most cases, nZone is equal to one. This represents the solution of a partial differential equation on a single block, unstructured mesh. ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the configuration option class for all zones. In this constructor, the input configuration file is parsed and all options are read and stored. ---*/ config_container[iZone] = new CConfig(config_file_name, SU2_DEF, iZone, nZone, 0, VERB_HIGH); /*--- Definition of the geometry class to store the primal grid in the partitioning process. ---*/ CGeometry *geometry_aux = NULL; /*--- All ranks process the grid and call ParMETIS for partitioning ---*/ geometry_aux = new CPhysicalGeometry(config_container[iZone], iZone, nZone); /*--- Color the initial grid and set the send-receive domains (ParMETIS) ---*/ geometry_aux->SetColorGrid_Parallel(config_container[iZone]); /*--- Allocate the memory of the current domain, and divide the grid between the nodes ---*/ geometry_container[iZone] = new CPhysicalGeometry(geometry_aux, config_container[iZone]); /*--- Deallocate the memory of geometry_aux ---*/ delete geometry_aux; /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone]->SetSendReceive(config_container[iZone]); /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone]->SetBoundaries(config_container[iZone]); } /*--- Set up a timer for performance benchmarking (preprocessing time is included) ---*/ #ifdef HAVE_MPI StartTime = MPI_Wtime(); #else StartTime = su2double(clock())/su2double(CLOCKS_PER_SEC); #endif /*--- Computational grid preprocesing ---*/ if (rank == MASTER_NODE) cout << endl << "----------------------- Preprocessing computations ----------------------" << endl; /*--- Compute elements surrounding points, points surrounding points ---*/ if (rank == MASTER_NODE) cout << "Setting local point connectivity." <<endl; geometry_container[ZONE_0]->SetPoint_Connectivity(); /*--- Check the orientation before computing geometrical quantities ---*/ if (rank == MASTER_NODE) cout << "Checking the numerical grid orientation of the interior elements." <<endl; geometry_container[ZONE_0]->Check_IntElem_Orientation(config_container[ZONE_0]); /*--- Create the edge structure ---*/ if (rank == MASTER_NODE) cout << "Identify edges and vertices." <<endl; geometry_container[ZONE_0]->SetEdges(); geometry_container[ZONE_0]->SetVertex(config_container[ZONE_0]); /*--- Compute center of gravity ---*/ if (rank == MASTER_NODE) cout << "Computing centers of gravity." << endl; geometry_container[ZONE_0]->SetCoord_CG(); /*--- Create the dual control volume structures ---*/ if (rank == MASTER_NODE) cout << "Setting the bound control volume structure." << endl; geometry_container[ZONE_0]->SetBoundControlVolume(config_container[ZONE_0], ALLOCATE); /*--- Output original grid for visualization, if requested (surface and volumetric) ---*/ if (config_container[ZONE_0]->GetVisualize_Deformation()) { output->SetMesh_Files(geometry_container, config_container, SINGLE_ZONE, true, false); // if (rank == MASTER_NODE) cout << "Writing an STL file of the surface mesh." << endl; // if (size > 1) SPRINTF (buffer_char, "_%d.stl", rank+1); else SPRINTF (buffer_char, ".stl"); // strcpy (out_file, "Surface_Grid"); strcat(out_file, buffer_char); geometry[ZONE_0]->SetBoundSTL(out_file, true, config[ZONE_0]); } /*--- Surface grid deformation using design variables ---*/ if (rank == MASTER_NODE) cout << endl << "------------------------- Surface grid deformation ----------------------" << endl; /*--- Definition and initialization of the surface deformation class ---*/ surface_movement = new CSurfaceMovement(); /*--- Copy coordinates to the surface structure ---*/ surface_movement->CopyBoundary(geometry_container[ZONE_0], config_container[ZONE_0]); /*--- Surface grid deformation ---*/ if (rank == MASTER_NODE) cout << "Performing the deformation of the surface grid." << endl; surface_movement->SetSurface_Deformation(geometry_container[ZONE_0], config_container[ZONE_0]); if (config_container[ZONE_0]->GetDesign_Variable(0) != FFD_SETTING) { if (rank == MASTER_NODE) cout << endl << "----------------------- Volumetric grid deformation ---------------------" << endl; /*--- Definition of the Class for grid movement ---*/ grid_movement = new CVolumetricMovement(geometry_container[ZONE_0], config_container[ZONE_0]); } /*--- For scale, translation and rotation if all boundaries are moving they are set via volume method * Otherwise, the surface deformation has been set already in SetSurface_Deformation. --- */ allmoving = true; /*--- Loop over markers, set flag to false if any are not moving ---*/ for (iMarker = 0; iMarker < config_container[ZONE_0]->GetnMarker_All(); iMarker++){ if (config_container[ZONE_0]->GetMarker_All_DV(iMarker) == NO) allmoving = false; } /*--- Volumetric grid deformation/transformations ---*/ if (config_container[ZONE_0]->GetDesign_Variable(0) == SCALE && allmoving) { if (rank == MASTER_NODE) cout << "Performing a scaling of the volumetric grid." << endl; grid_movement->SetVolume_Scaling(geometry_container[ZONE_0], config_container[ZONE_0], false); } else if (config_container[ZONE_0]->GetDesign_Variable(0) == TRANSLATION && allmoving) { if (rank == MASTER_NODE) cout << "Performing a translation of the volumetric grid." << endl; grid_movement->SetVolume_Translation(geometry_container[ZONE_0], config_container[ZONE_0], false); } else if (config_container[ZONE_0]->GetDesign_Variable(0) == ROTATION && allmoving) { if (rank == MASTER_NODE) cout << "Performing a rotation of the volumetric grid." << endl; grid_movement->SetVolume_Rotation(geometry_container[ZONE_0], config_container[ZONE_0], false); } else if (config_container[ZONE_0]->GetDesign_Variable(0) != FFD_SETTING) { if (rank == MASTER_NODE) cout << "Performing the deformation of the volumetric grid." << endl; grid_movement->SetVolume_Deformation(geometry_container[ZONE_0], config_container[ZONE_0], false); } /*--- Computational grid preprocesing ---*/ if (rank == MASTER_NODE) cout << endl << "----------------------- Write deformed grid files -----------------------" << endl; /*--- Output deformed grid for visualization, if requested (surface and volumetric), in parallel requires to move all the data to the master node---*/ output = new COutput(); output->SetMesh_Files(geometry_container, config_container, SINGLE_ZONE, false, true); /*--- Write the the free-form deformation boxes after deformation. ---*/ if (rank == MASTER_NODE) cout << "Adding any FFD information to the SU2 file." << endl; surface_movement->WriteFFDInfo(geometry_container[ZONE_0], config_container[ZONE_0]); /*--- Synchronization point after a single solver iteration. Compute the wall clock time required. ---*/ #ifdef HAVE_MPI StopTime = MPI_Wtime(); #else StopTime = su2double(clock())/su2double(CLOCKS_PER_SEC); #endif /*--- Compute/print the total time for performance benchmarking. ---*/ UsedTime = StopTime-StartTime; if (rank == MASTER_NODE) { cout << "\nCompleted in " << fixed << UsedTime << " seconds on "<< size; if (size == 1) cout << " core." << endl; else cout << " cores." << endl; } /*--- Exit the solver cleanly ---*/ if (rank == MASTER_NODE) cout << endl << "------------------------- Exit Success (SU2_DEF) ------------------------" << endl << endl; /*--- Finalize MPI parallelization ---*/ #ifdef HAVE_MPI MPI_Finalize(); #endif return EXIT_SUCCESS; }
int main(int argc, char *argv[]) { double StartTime = 0.0, StopTime = 0.0, UsedTime = 0.0; char buffer_char[50], out_file[MAX_STRING_SIZE], in_file[MAX_STRING_SIZE], mesh_file[MAX_STRING_SIZE]; int rank = MASTER_NODE, size = SINGLE_NODE; string str; #ifdef HAVE_MPI /*--- MPI initialization ---*/ MPI_Init(&argc,&argv); MPI_Comm_rank(MPI_COMM_WORLD,&rank); MPI_Comm_size(MPI_COMM_WORLD,&size); #endif /*--- Pointer to different structures that will be used throughout the entire code ---*/ CConfig **config = NULL; CGeometry **geometry = NULL; CSurfaceMovement *surface_movement = NULL; CVolumetricMovement *grid_movement = NULL; COutput *output = NULL; /*--- Definition of the containers by zone (currently only one zone is allowed, but this can be extended if necessary). ---*/ config = new CConfig*[SINGLE_ZONE]; geometry = new CGeometry*[SINGLE_ZONE]; output = new COutput(); /*--- Definition of the configuration class, and open the config file ---*/ if (argc == 2) config[ZONE_0] = new CConfig(argv[1], SU2_DEF, ZONE_0, SINGLE_ZONE, 0, VERB_HIGH); else { strcpy (mesh_file, "default.cfg"); config[ZONE_0] = new CConfig(mesh_file, SU2_DEF, ZONE_0, SINGLE_ZONE, 0, VERB_HIGH); } #ifdef HAVE_MPI /*--- Change the name of the input-output files for the parallel computation ---*/ config[ZONE_0]->SetFileNameDomain(rank+1); #endif /*--- Definition of the geometry class ---*/ geometry[ZONE_0] = new CPhysicalGeometry(config[ZONE_0], ZONE_0, SINGLE_ZONE); /*--- Set up a timer for performance benchmarking (preprocessing time is not included) ---*/ #ifdef HAVE_MPI MPI_Barrier(MPI_COMM_WORLD); StartTime = MPI_Wtime(); #else StartTime = double(clock())/double(CLOCKS_PER_SEC); #endif /*--- Computational grid preprocesing ---*/ if (rank == MASTER_NODE) cout << endl << "----------------------- Preprocessing computations ----------------------" << endl; /*--- Compute elements surrounding points, points surrounding points ---*/ if (rank == MASTER_NODE) cout << "Setting local point connectivity." <<endl; geometry[ZONE_0]->SetPoint_Connectivity(); /*--- Check the orientation before computing geometrical quantities ---*/ if (rank == MASTER_NODE) cout << "Checking the numerical grid orientation of the interior elements." <<endl; geometry[ZONE_0]->Check_IntElem_Orientation(config[ZONE_0]); /*--- Create the edge structure ---*/ if (rank == MASTER_NODE) cout << "Identify edges and vertices." <<endl; geometry[ZONE_0]->SetEdges(); geometry[ZONE_0]->SetVertex(config[ZONE_0]); /*--- Compute center of gravity ---*/ if (rank == MASTER_NODE) cout << "Computing centers of gravity." << endl; geometry[ZONE_0]->SetCG(); /*--- Create the dual control volume structures ---*/ if (rank == MASTER_NODE) cout << "Setting the bound control volume structure." << endl; geometry[ZONE_0]->SetBoundControlVolume(config[ZONE_0], ALLOCATE); /*--- Output original grid for visualization, if requested (surface and volumetric) ---*/ if (config[ZONE_0]->GetVisualize_Deformation()) { output->SetMesh_Files(geometry, config, SINGLE_ZONE, true); // if (rank == MASTER_NODE) cout << "Writing an STL file of the surface mesh." << endl; // if (size > 1) sprintf (buffer_char, "_%d.stl", rank+1); else sprintf (buffer_char, ".stl"); // strcpy (out_file, "Surface_Grid"); strcat(out_file, buffer_char); geometry[ZONE_0]->SetBoundSTL(out_file, true, config[ZONE_0]); } /*--- Surface grid deformation using design variables ---*/ if (rank == MASTER_NODE) cout << endl << "------------------------- Surface grid deformation ----------------------" << endl; /*--- Definition and initialization of the surface deformation class ---*/ surface_movement = new CSurfaceMovement(); surface_movement->CopyBoundary(geometry[ZONE_0], config[ZONE_0]); /*--- Surface grid deformation ---*/ if (rank == MASTER_NODE) cout << "Performing the deformation of the surface grid." << endl; surface_movement->SetSurface_Deformation(geometry[ZONE_0], config[ZONE_0]); #ifdef HAVE_MPI /*--- MPI syncronization point ---*/ MPI_Barrier(MPI_COMM_WORLD); #endif /*--- Volumetric grid deformation ---*/ if (config[ZONE_0]->GetDesign_Variable(0) != FFD_SETTING) { if (rank == MASTER_NODE) cout << endl << "----------------------- Volumetric grid deformation ---------------------" << endl; /*--- Definition of the Class for grid movement ---*/ grid_movement = new CVolumetricMovement(geometry[ZONE_0]); if (rank == MASTER_NODE) cout << "Performing the deformation of the volumetric grid." << endl; grid_movement->SetVolume_Deformation(geometry[ZONE_0], config[ZONE_0], false); } /*--- Computational grid preprocesing ---*/ if (rank == MASTER_NODE) cout << endl << "----------------------- Write deformed grid files -----------------------" << endl; /*--- Output deformed grid for visualization, if requested (surface and volumetric), in parallel requires to move all the data to the master node---*/ if (config[ZONE_0]->GetVisualize_Deformation()) { output = new COutput(); output->SetMesh_Files(geometry, config, SINGLE_ZONE, false); // if (rank == MASTER_NODE) cout << "Writing a STL file of the surface mesh." << endl; // if (size > 1) sprintf (buffer_char, "_%d.stl", rank+1); else sprintf (buffer_char, ".stl"); // strcpy (out_file, "Surface_Grid"); strcat(out_file, buffer_char); geometry[ZONE_0]->SetBoundSTL(out_file, false, config[ZONE_0] ); } /*--- Write the new SU2 native mesh after deformation (one per MPI rank). ---*/ if (rank == MASTER_NODE) cout << "Writing a SU2 file of the volumetric mesh." << endl; if (size > 1) sprintf (buffer_char, "_%d.su2", rank+1); else sprintf (buffer_char, ".su2"); str = config[ZONE_0]->GetMesh_Out_FileName(); str.erase (str.end()-4, str.end()); strcpy (out_file, str.c_str()); strcat(out_file, buffer_char); str = config[ZONE_0]->GetMesh_FileName(); strcpy (in_file, str.c_str()); geometry[ZONE_0]->SetMeshFile(config[ZONE_0], out_file, in_file); /*--- Write the the free-form deformation boxes after deformation. ---*/ if (rank == MASTER_NODE) cout << "Adding FFD information to the SU2 file." << endl; surface_movement->WriteFFDInfo(geometry[ZONE_0], config[ZONE_0], out_file); /*--- Synchronization point after a single solver iteration. Compute the wall clock time required. ---*/ #ifdef HAVE_MPI MPI_Barrier(MPI_COMM_WORLD); StopTime = MPI_Wtime(); #else StopTime = double(clock())/double(CLOCKS_PER_SEC); #endif /*--- Compute/print the total time for performance benchmarking. ---*/ UsedTime = StopTime-StartTime; if (rank == MASTER_NODE) { cout << "\nCompleted in " << fixed << UsedTime << " seconds on "<< size; if (size == 1) cout << " core." << endl; else cout << " cores." << endl; } /*--- Exit the solver cleanly ---*/ if (rank == MASTER_NODE) cout << endl << "------------------------- Exit Success (SU2_DEF) ------------------------" << endl << endl; #ifdef HAVE_MPI /*--- Finalize MPI parallelization ---*/ MPI_Barrier(MPI_COMM_WORLD); MPI_Finalize(); #endif return EXIT_SUCCESS; }
int main(int argc, char *argv[]) { unsigned short iZone, nZone = SINGLE_ZONE; double StartTime = 0.0, StopTime = 0.0, UsedTime = 0.0; ofstream ConvHist_file; char config_file_name[MAX_STRING_SIZE]; int rank = MASTER_NODE; int size = SINGLE_NODE; /*--- MPI initialization ---*/ #ifdef HAVE_MPI MPI_Init(&argc,&argv); MPI_Comm_rank(MPI_COMM_WORLD,&rank); MPI_Comm_size(MPI_COMM_WORLD,&size); #endif /*--- Pointer to different structures that will be used throughout the entire code ---*/ COutput *output = NULL; CGeometry **geometry_container = NULL; CSolver **solver_container = NULL; CConfig **config_container = NULL; /*--- Load in the number of zones and spatial dimensions in the mesh file (if no config file is specified, default.cfg is used) ---*/ if (argc == 2) { strcpy(config_file_name,argv[1]); } else { strcpy(config_file_name, "default.cfg"); } /*--- Definition of the containers per zones ---*/ solver_container = new CSolver*[nZone]; config_container = new CConfig*[nZone]; geometry_container = new CGeometry*[nZone]; for (iZone = 0; iZone < nZone; iZone++) { solver_container[iZone] = NULL; config_container[iZone] = NULL; geometry_container[iZone] = NULL; } /*--- Loop over all zones to initialize the various classes. In most cases, nZone is equal to one. This represents the solution of a partial differential equation on a single block, unstructured mesh. ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the configuration option class for all zones. In this constructor, the input configuration file is parsed and all options are read and stored. ---*/ config_container[iZone] = new CConfig(config_file_name, SU2_SOL, iZone, nZone, 0, VERB_HIGH); /*--- Definition of the geometry class to store the primal grid in the partitioning process. ---*/ CGeometry *geometry_aux = NULL; /*--- All ranks process the grid and call ParMETIS for partitioning ---*/ geometry_aux = new CPhysicalGeometry(config_container[iZone], iZone, nZone); /*--- Color the initial grid and set the send-receive domains (ParMETIS) ---*/ geometry_aux->SetColorGrid_Parallel(config_container[iZone]); /*--- Allocate the memory of the current domain, and divide the grid between the nodes ---*/ geometry_container[iZone] = new CPhysicalGeometry(geometry_aux, config_container[iZone], 1); /*--- Deallocate the memory of geometry_aux ---*/ delete geometry_aux; /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone]->SetSendReceive(config_container[iZone]); /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone]->SetBoundaries(config_container[iZone]); /*--- Create the vertex structure (required for MPI) ---*/ if (rank == MASTER_NODE) cout << "Identify vertices." <<endl; geometry_container[iZone]->SetVertex(config_container[iZone]); } /*--- Set up a timer for performance benchmarking (preprocessing time is included) ---*/ #ifdef HAVE_MPI StartTime = MPI_Wtime(); #else StartTime = double(clock())/double(CLOCKS_PER_SEC); #endif if (rank == MASTER_NODE) cout << endl <<"------------------------- Solution Postprocessing -----------------------" << endl; /*--- Definition of the output class (one for all the zones) ---*/ output = new COutput(); /*--- Check whether this is an unsteady simulation, and call the solution merging routines accordingly.---*/ if (config_container[ZONE_0]->GetWrt_Unsteady()) { /*--- Unsteady simulation: merge all unsteady time steps. First, find the frequency and total number of files to write. ---*/ double Physical_dt, Physical_t; unsigned long iExtIter = 0; bool StopCalc = false; bool SolutionInstantiated = false; /*--- Check for an unsteady restart. Update ExtIter if necessary. ---*/ if (config_container[ZONE_0]->GetWrt_Unsteady() && config_container[ZONE_0]->GetRestart()) iExtIter = config_container[ZONE_0]->GetUnst_RestartIter(); while (iExtIter < config_container[ZONE_0]->GetnExtIter()) { /*--- Check several conditions in order to merge the correct time step files. ---*/ Physical_dt = config_container[ZONE_0]->GetDelta_UnstTime(); Physical_t = (iExtIter+1)*Physical_dt; if (Physical_t >= config_container[ZONE_0]->GetTotal_UnstTime()) StopCalc = true; if ((iExtIter+1 == config_container[ZONE_0]->GetnExtIter()) || ((iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq() == 0) && (iExtIter != 0) && !((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND))) || (StopCalc) || (((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND)) && ((iExtIter == 0) || (iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) { /*--- Set the current iteration number in the config class. ---*/ config_container[ZONE_0]->SetExtIter(iExtIter); /*--- Read in the restart file for this time step ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Either instantiate the solution class or load a restart file. ---*/ if (SolutionInstantiated == false && (iExtIter == 0 || (config_container[ZONE_0]->GetRestart() && (iExtIter == config_container[ZONE_0]->GetUnst_RestartIter() || iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0 || iExtIter+1 == config_container[ZONE_0]->GetnExtIter())))) { solver_container[iZone] = new CBaselineSolver(geometry_container[iZone], config_container[iZone], MESH_0); SolutionInstantiated = true; } else solver_container[iZone]->LoadRestart(geometry_container, &solver_container, config_container[iZone], int(MESH_0)); } if (rank == MASTER_NODE) cout << "Writing the volume solution for time step " << iExtIter << "." << endl; output->SetBaselineResult_Files(solver_container, geometry_container, config_container, iExtIter, nZone); } iExtIter++; if (StopCalc) break; } } else if (config_container[ZONE_0]->GetUnsteady_Simulation() == TIME_SPECTRAL) { /*--- Time-spectral simulation: merge files for each time instance (each zone). ---*/ unsigned short nTimeSpectral = config_container[ZONE_0]->GetnTimeInstances(); unsigned short iTimeSpectral; for (iTimeSpectral = 0; iTimeSpectral < nTimeSpectral; iTimeSpectral++) { /*--- Set the current instance number in the config class to "ExtIter." ---*/ config_container[ZONE_0]->SetExtIter(iTimeSpectral); /*--- Read in the restart file for this time step ---*/ /*--- N.B. In SU2_SOL, nZone != nTimeInstances ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Either instantiate the solution class or load a restart file. ---*/ if (iTimeSpectral == 0) solver_container[iZone] = new CBaselineSolver(geometry_container[iZone], config_container[iZone], MESH_0); else solver_container[iZone]->LoadRestart(geometry_container, &solver_container, config_container[iZone], int(MESH_0)); } /*--- Print progress in solution writing to the screen. ---*/ if (rank == MASTER_NODE) { cout << "Writing the volume solution for time instance " << iTimeSpectral << "." << endl; } output->SetBaselineResult_Files(solver_container, geometry_container, config_container, iTimeSpectral, nZone); } } else { /*--- Steady simulation: merge the single solution file. ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the solution class ---*/ solver_container[iZone] = new CBaselineSolver(geometry_container[iZone], config_container[iZone], MESH_0); } output->SetBaselineResult_Files(solver_container, geometry_container, config_container, 0, nZone); } /*--- Synchronization point after a single solver iteration. Compute the wall clock time required. ---*/ #ifdef HAVE_MPI StopTime = MPI_Wtime(); #else StopTime = double(clock())/double(CLOCKS_PER_SEC); #endif /*--- Compute/print the total time for performance benchmarking. ---*/ UsedTime = StopTime-StartTime; if (rank == MASTER_NODE) { cout << "\nCompleted in " << fixed << UsedTime << " seconds on "<< size; if (size == 1) cout << " core." << endl; else cout << " cores." << endl; } /*--- Exit the solver cleanly ---*/ if (rank == MASTER_NODE) cout << endl <<"------------------------- Exit Success (SU2_SOL) ------------------------" << endl << endl; /*--- Finalize MPI parallelization ---*/ #ifdef HAVE_MPI MPI_Finalize(); #endif return EXIT_SUCCESS; }
int main(int argc, char *argv[]) { bool StopCalc = false; double StartTime = 0.0, StopTime = 0.0, UsedTime = 0.0; unsigned long ExtIter = 0; unsigned short iMesh, iZone, iSol, nZone, nDim; char config_file_name[MAX_STRING_SIZE]; char runtime_file_name[MAX_STRING_SIZE]; ofstream ConvHist_file; int rank = MASTER_NODE; int size = SINGLE_NODE; /*--- MPI initialization, and buffer setting ---*/ #ifdef HAVE_MPI int *bptr, bl; MPI_Init(&argc, &argv); MPI_Buffer_attach( malloc(BUFSIZE), BUFSIZE ); MPI_Comm_rank(MPI_COMM_WORLD, &rank); MPI_Comm_size(MPI_COMM_WORLD, &size); #endif /*--- Create pointers to all of the classes that may be used throughout the SU2_CFD code. In general, the pointers are instantiated down a heirarchy over all zones, multigrid levels, equation sets, and equation terms as described in the comments below. ---*/ COutput *output = NULL; CIntegration ***integration_container = NULL; CGeometry ***geometry_container = NULL; CSolver ****solver_container = NULL; CNumerics *****numerics_container = NULL; CConfig **config_container = NULL; CSurfaceMovement **surface_movement = NULL; CVolumetricMovement **grid_movement = NULL; CFreeFormDefBox*** FFDBox = NULL; /*--- Load in the number of zones and spatial dimensions in the mesh file (If no config file is specified, default.cfg is used) ---*/ if (argc == 2) { strcpy(config_file_name, argv[1]); } else { strcpy(config_file_name, "default.cfg"); } /*--- Read the name and format of the input mesh file to get from the mesh file the number of zones and dimensions from the numerical grid (required for variables allocation) ---*/ CConfig *config = NULL; config = new CConfig(config_file_name, SU2_CFD); nZone = GetnZone(config->GetMesh_FileName(), config->GetMesh_FileFormat(), config); nDim = GetnDim(config->GetMesh_FileName(), config->GetMesh_FileFormat()); /*--- Definition and of the containers for all possible zones. ---*/ solver_container = new CSolver***[nZone]; integration_container = new CIntegration**[nZone]; numerics_container = new CNumerics****[nZone]; config_container = new CConfig*[nZone]; geometry_container = new CGeometry**[nZone]; surface_movement = new CSurfaceMovement*[nZone]; grid_movement = new CVolumetricMovement*[nZone]; FFDBox = new CFreeFormDefBox**[nZone]; for (iZone = 0; iZone < nZone; iZone++) { solver_container[iZone] = NULL; integration_container[iZone] = NULL; numerics_container[iZone] = NULL; config_container[iZone] = NULL; geometry_container[iZone] = NULL; surface_movement[iZone] = NULL; grid_movement[iZone] = NULL; FFDBox[iZone] = NULL; } /*--- Loop over all zones to initialize the various classes. In most cases, nZone is equal to one. This represents the solution of a partial differential equation on a single block, unstructured mesh. ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the configuration option class for all zones. In this constructor, the input configuration file is parsed and all options are read and stored. ---*/ config_container[iZone] = new CConfig(config_file_name, SU2_CFD, iZone, nZone, nDim, VERB_HIGH); /*--- Definition of the geometry class to store the primal grid in the partitioning process. ---*/ CGeometry *geometry_aux = NULL; /*--- All ranks process the grid and call ParMETIS for partitioning ---*/ geometry_aux = new CPhysicalGeometry(config_container[iZone], iZone, nZone); /*--- Color the initial grid and set the send-receive domains (ParMETIS) ---*/ geometry_aux->SetColorGrid_Parallel(config_container[iZone]); /*--- Allocate the memory of the current domain, and divide the grid between the ranks. ---*/ geometry_container[iZone] = new CGeometry *[config_container[iZone]->GetnMGLevels()+1]; geometry_container[iZone][MESH_0] = new CPhysicalGeometry(geometry_aux, config_container[iZone], 1); /*--- Deallocate the memory of geometry_aux ---*/ delete geometry_aux; /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone][MESH_0]->SetSendReceive(config_container[iZone]); /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone][MESH_0]->SetBoundaries(config_container[iZone]); } if (rank == MASTER_NODE) cout << endl <<"------------------------- Geometry Preprocessing ------------------------" << endl; /*--- Preprocessing of the geometry for all zones. In this routine, the edge- based data structure is constructed, i.e. node and cell neighbors are identified and linked, face areas and volumes of the dual mesh cells are computed, and the multigrid levels are created using an agglomeration procedure. ---*/ Geometrical_Preprocessing(geometry_container, config_container, nZone); if (rank == MASTER_NODE) cout << endl <<"------------------------- Solver Preprocessing --------------------------" << endl; for (iZone = 0; iZone < nZone; iZone++) { /*--- Computation of wall distances for turbulence modeling ---*/ if ( (config_container[iZone]->GetKind_Solver() == RANS) || (config_container[iZone]->GetKind_Solver() == ADJ_RANS) ) geometry_container[iZone][MESH_0]->ComputeWall_Distance(config_container[iZone]); /*--- Computation of positive surface area in the z-plane which is used for the calculation of force coefficient (non-dimensionalization). ---*/ geometry_container[iZone][MESH_0]->SetPositive_ZArea(config_container[iZone]); /*--- Set the near-field, interface and actuator disk boundary conditions, if necessary. ---*/ for (iMesh = 0; iMesh <= config_container[iZone]->GetnMGLevels(); iMesh++) { geometry_container[iZone][iMesh]->MatchNearField(config_container[iZone]); geometry_container[iZone][iMesh]->MatchInterface(config_container[iZone]); geometry_container[iZone][iMesh]->MatchActuator_Disk(config_container[iZone]); } /*--- Definition of the solver class: solver_container[#ZONES][#MG_GRIDS][#EQ_SYSTEMS]. The solver classes are specific to a particular set of governing equations, and they contain the subroutines with instructions for computing each spatial term of the PDE, i.e. loops over the edges to compute convective and viscous fluxes, loops over the nodes to compute source terms, and routines for imposing various boundary condition type for the PDE. ---*/ solver_container[iZone] = new CSolver** [config_container[iZone]->GetnMGLevels()+1]; for (iMesh = 0; iMesh <= config_container[iZone]->GetnMGLevels(); iMesh++) solver_container[iZone][iMesh] = NULL; for (iMesh = 0; iMesh <= config_container[iZone]->GetnMGLevels(); iMesh++) { solver_container[iZone][iMesh] = new CSolver* [MAX_SOLS]; for (iSol = 0; iSol < MAX_SOLS; iSol++) solver_container[iZone][iMesh][iSol] = NULL; } Solver_Preprocessing(solver_container[iZone], geometry_container[iZone], config_container[iZone], iZone); if (rank == MASTER_NODE) cout << endl <<"----------------- Integration and Numerics Preprocessing ----------------" << endl; /*--- Definition of the integration class: integration_container[#ZONES][#EQ_SYSTEMS]. The integration class orchestrates the execution of the spatial integration subroutines contained in the solver class (including multigrid) for computing the residual at each node, R(U) and then integrates the equations to a steady state or time-accurately. ---*/ integration_container[iZone] = new CIntegration*[MAX_SOLS]; Integration_Preprocessing(integration_container[iZone], geometry_container[iZone], config_container[iZone], iZone); if (rank == MASTER_NODE) cout << "Integration Preprocessing." << endl; /*--- Definition of the numerical method class: numerics_container[#ZONES][#MG_GRIDS][#EQ_SYSTEMS][#EQ_TERMS]. The numerics class contains the implementation of the numerical methods for evaluating convective or viscous fluxes between any two nodes in the edge-based data structure (centered, upwind, galerkin), as well as any source terms (piecewise constant reconstruction) evaluated in each dual mesh volume. ---*/ numerics_container[iZone] = new CNumerics***[config_container[iZone]->GetnMGLevels()+1]; Numerics_Preprocessing(numerics_container[iZone], solver_container[iZone], geometry_container[iZone], config_container[iZone], iZone); if (rank == MASTER_NODE) cout << "Numerics Preprocessing." << endl; /*--- Instantiate the geometry movement classes for the solution of unsteady flows on dynamic meshes, including rigid mesh transformations, dynamically deforming meshes, and time-spectral preprocessing. ---*/ if (config_container[iZone]->GetGrid_Movement()) { if (rank == MASTER_NODE) cout << "Setting dynamic mesh structure." << endl; grid_movement[iZone] = new CVolumetricMovement(geometry_container[iZone][MESH_0]); FFDBox[iZone] = new CFreeFormDefBox*[MAX_NUMBER_FFD]; surface_movement[iZone] = new CSurfaceMovement(); surface_movement[iZone]->CopyBoundary(geometry_container[iZone][MESH_0], config_container[iZone]); if (config_container[iZone]->GetUnsteady_Simulation() == TIME_SPECTRAL) SetGrid_Movement(geometry_container[iZone], surface_movement[iZone], grid_movement[iZone], FFDBox[iZone], solver_container[iZone], config_container[iZone], iZone, 0, 0); } } /*--- For the time-spectral solver, set the grid node velocities. ---*/ if (config_container[ZONE_0]->GetUnsteady_Simulation() == TIME_SPECTRAL) SetTimeSpectral_Velocities(geometry_container, config_container, nZone); /*--- Coupling between zones (limited to two zones at the moment) ---*/ if (nZone == 2) { if (rank == MASTER_NODE) cout << endl <<"--------------------- Setting Coupling Between Zones --------------------" << endl; geometry_container[ZONE_0][MESH_0]->MatchZone(config_container[ZONE_0], geometry_container[ZONE_1][MESH_0], config_container[ZONE_1], ZONE_0, nZone); geometry_container[ZONE_1][MESH_0]->MatchZone(config_container[ZONE_1], geometry_container[ZONE_0][MESH_0], config_container[ZONE_0], ZONE_1, nZone); } /*--- Definition of the output class (one for all zones). The output class manages the writing of all restart, volume solution, surface solution, surface comma-separated value, and convergence history files (both in serial and in parallel). ---*/ output = new COutput(); /*--- Open the convergence history file ---*/ if (rank == MASTER_NODE) output->SetConvHistory_Header(&ConvHist_file, config_container[ZONE_0]); /*--- Check for an unsteady restart. Update ExtIter if necessary. ---*/ if (config_container[ZONE_0]->GetWrt_Unsteady() && config_container[ZONE_0]->GetRestart()) ExtIter = config_container[ZONE_0]->GetUnst_RestartIter(); /*--- Main external loop of the solver. Within this loop, each iteration ---*/ if (rank == MASTER_NODE) cout << endl <<"------------------------------ Begin Solver -----------------------------" << endl; /*--- Set up a timer for performance benchmarking (preprocessing time is not included) ---*/ #ifndef HAVE_MPI StartTime = double(clock())/double(CLOCKS_PER_SEC); #else StartTime = MPI_Wtime(); #endif while (ExtIter < config_container[ZONE_0]->GetnExtIter()) { /*--- Set the value of the external iteration. ---*/ config_container[ZONE_0]->SetExtIter(ExtIter); /*--- Read the target pressure ---*/ if (config_container[ZONE_0]->GetInvDesign_Cp() == YES) output->SetCp_InverseDesign(solver_container[ZONE_0][MESH_0][FLOW_SOL], geometry_container[ZONE_0][MESH_0], config_container[ZONE_0], ExtIter); /*--- Read the target heat flux ---*/ if (config_container[ZONE_0]->GetInvDesign_HeatFlux() == YES) output->SetHeat_InverseDesign(solver_container[ZONE_0][MESH_0][FLOW_SOL], geometry_container[ZONE_0][MESH_0], config_container[ZONE_0], ExtIter); /*--- Perform a single iteration of the chosen PDE solver. ---*/ switch (config_container[ZONE_0]->GetKind_Solver()) { case EULER: case NAVIER_STOKES: case RANS: MeanFlowIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case TNE2_EULER: case TNE2_NAVIER_STOKES: TNE2Iteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case FLUID_STRUCTURE_EULER: case FLUID_STRUCTURE_NAVIER_STOKES: FluidStructureIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case WAVE_EQUATION: WaveIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case HEAT_EQUATION: HeatIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case POISSON_EQUATION: PoissonIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case LINEAR_ELASTICITY: FEAIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case ADJ_EULER: case ADJ_NAVIER_STOKES: case ADJ_RANS: AdjMeanFlowIteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; case ADJ_TNE2_EULER: case ADJ_TNE2_NAVIER_STOKES: AdjTNE2Iteration(output, integration_container, geometry_container, solver_container, numerics_container, config_container, surface_movement, grid_movement, FFDBox); break; } /*--- Synchronization point after a single solver iteration. Compute the wall clock time required. ---*/ #ifndef HAVE_MPI StopTime = double(clock())/double(CLOCKS_PER_SEC); #else StopTime = MPI_Wtime(); #endif UsedTime = (StopTime - StartTime); /*--- For specific applications, evaluate and plot the equivalent area. ---*/ if (config_container[ZONE_0]->GetEquivArea() == YES) { output->SetEquivalentArea(solver_container[ZONE_0][MESH_0][FLOW_SOL], geometry_container[ZONE_0][MESH_0], config_container[ZONE_0], ExtIter); } /*--- Check if there is any change in the runtime parameters ---*/ CConfig *runtime = NULL; strcpy(runtime_file_name, "runtime.dat"); runtime = new CConfig(runtime_file_name, config_container[ZONE_0]); /*--- Update the convergence history file (serial and parallel computations). ---*/ output->SetConvHistory_Body(&ConvHist_file, geometry_container, solver_container, config_container, integration_container, false, UsedTime, ZONE_0); /*--- Evaluate the new CFL number (adaptive). ---*/ if (config_container[ZONE_0]->GetCFL_Adapt() == YES) { output->SetCFL_Number(solver_container, config_container, ZONE_0); } /*--- Check whether the current simulation has reached the specified convergence criteria, and set StopCalc to true, if so. ---*/ switch (config_container[ZONE_0]->GetKind_Solver()) { case EULER: case NAVIER_STOKES: case RANS: StopCalc = integration_container[ZONE_0][FLOW_SOL]->GetConvergence(); break; case TNE2_EULER: case TNE2_NAVIER_STOKES: StopCalc = integration_container[ZONE_0][TNE2_SOL]->GetConvergence(); break; case WAVE_EQUATION: StopCalc = integration_container[ZONE_0][WAVE_SOL]->GetConvergence(); break; case HEAT_EQUATION: StopCalc = integration_container[ZONE_0][HEAT_SOL]->GetConvergence(); break; case LINEAR_ELASTICITY: StopCalc = integration_container[ZONE_0][FEA_SOL]->GetConvergence(); break; case ADJ_EULER: case ADJ_NAVIER_STOKES: case ADJ_RANS: StopCalc = integration_container[ZONE_0][ADJFLOW_SOL]->GetConvergence(); break; case ADJ_TNE2_EULER: case ADJ_TNE2_NAVIER_STOKES: StopCalc = integration_container[ZONE_0][ADJTNE2_SOL]->GetConvergence(); break; } /*--- Solution output. Determine whether a solution needs to be written after the current iteration, and if so, execute the output file writing routines. ---*/ if ((ExtIter+1 >= config_container[ZONE_0]->GetnExtIter()) || ((ExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq() == 0) && (ExtIter != 0) && !((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND))) || (StopCalc) || (((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND)) && ((ExtIter == 0) || (ExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) { /*--- Low-fidelity simulations (using a coarser multigrid level approximation to the solution) require an interpolation back to the finest grid. ---*/ if (config_container[ZONE_0]->GetLowFidelitySim()) { integration_container[ZONE_0][FLOW_SOL]->SetProlongated_Solution(RUNTIME_FLOW_SYS, solver_container[ZONE_0][MESH_0][FLOW_SOL], solver_container[ZONE_0][MESH_1][FLOW_SOL], geometry_container[ZONE_0][MESH_0], geometry_container[ZONE_0][MESH_1], config_container[ZONE_0]); integration_container[ZONE_0][FLOW_SOL]->Smooth_Solution(RUNTIME_FLOW_SYS, solver_container[ZONE_0][MESH_0][FLOW_SOL], geometry_container[ZONE_0][MESH_0], 3, 1.25, config_container[ZONE_0]); solver_container[ZONE_0][MESH_0][config_container[ZONE_0]->GetContainerPosition(RUNTIME_FLOW_SYS)]->Set_MPI_Solution(geometry_container[ZONE_0][MESH_0], config_container[ZONE_0]); solver_container[ZONE_0][MESH_0][config_container[ZONE_0]->GetContainerPosition(RUNTIME_FLOW_SYS)]->Preprocessing(geometry_container[ZONE_0][MESH_0], solver_container[ZONE_0][MESH_0], config_container[ZONE_0], MESH_0, 0, RUNTIME_FLOW_SYS, false); } if (rank == MASTER_NODE) cout << endl << "-------------------------- File Output Summary --------------------------"; /*--- Execute the routine for writing restart, volume solution, surface solution, and surface comma-separated value files. ---*/ output->SetResult_Files(solver_container, geometry_container, config_container, ExtIter, nZone); /*--- Output a file with the forces breakdown. ---*/ output->SetForces_Breakdown(geometry_container, solver_container, config_container, integration_container, ZONE_0); /*--- Compute the forces at different sections. ---*/ if (config_container[ZONE_0]->GetPlot_Section_Forces()) { output->SetForceSections(solver_container[ZONE_0][MESH_0][FLOW_SOL], geometry_container[ZONE_0][MESH_0], config_container[ZONE_0], ExtIter); } if (rank == MASTER_NODE) cout << "-------------------------------------------------------------------------" << endl << endl; } /*--- If the convergence criteria has been met, terminate the simulation. ---*/ if (StopCalc) break; ExtIter++; } /*--- Output some information to the console. ---*/ if (rank == MASTER_NODE) { /*--- Print out the number of non-physical points and reconstructions ---*/ if (config_container[ZONE_0]->GetNonphysical_Points() > 0) cout << "Warning: there are " << config_container[ZONE_0]->GetNonphysical_Points() << " non-physical points in the solution." << endl; if (config_container[ZONE_0]->GetNonphysical_Reconstr() > 0) cout << "Warning: " << config_container[ZONE_0]->GetNonphysical_Reconstr() << " reconstructed states for upwinding are non-physical." << endl; /*--- Close the convergence history file. ---*/ ConvHist_file.close(); cout << "History file, closed." << endl; } // /*--- Deallocate config container ---*/ // // for (iZone = 0; iZone < nZone; iZone++) { // if (config_container[iZone] != NULL) { // delete config_container[iZone]; // } // } // if (config_container != NULL) delete[] config_container; /*--- Synchronization point after a single solver iteration. Compute the wall clock time required. ---*/ #ifndef HAVE_MPI StopTime = double(clock())/double(CLOCKS_PER_SEC); #else StopTime = MPI_Wtime(); #endif /*--- Compute/print the total time for performance benchmarking. ---*/ UsedTime = StopTime-StartTime; if (rank == MASTER_NODE) { cout << "\nCompleted in " << fixed << UsedTime << " seconds on "<< size; if (size == 1) cout << " core." << endl; else cout << " cores." << endl; } /*--- Exit the solver cleanly ---*/ if (rank == MASTER_NODE) cout << endl <<"------------------------- Exit Success (SU2_CFD) ------------------------" << endl << endl; #ifdef HAVE_MPI /*--- Finalize MPI parallelization ---*/ MPI_Buffer_detach(&bptr, &bl); MPI_Finalize(); #endif return EXIT_SUCCESS; }
int main(int argc, char *argv[]) { unsigned short iZone, nZone = SINGLE_ZONE, iInst; su2double StartTime = 0.0, StopTime = 0.0, UsedTime = 0.0; ofstream ConvHist_file; char config_file_name[MAX_STRING_SIZE]; int rank = MASTER_NODE; int size = SINGLE_NODE; bool fem_solver = false; bool periodic = false; bool multizone = false; /*--- MPI initialization ---*/ #ifdef HAVE_MPI SU2_MPI::Init(&argc,&argv); SU2_MPI::Comm MPICommunicator(MPI_COMM_WORLD); #else SU2_Comm MPICommunicator(0); #endif rank = SU2_MPI::GetRank(); size = SU2_MPI::GetSize(); /*--- Pointer to different structures that will be used throughout the entire code ---*/ COutput *output = NULL; CGeometry ***geometry_container = NULL; CSolver ***solver_container = NULL; CConfig **config_container = NULL; CConfig *driver_config = NULL; unsigned short *nInst = NULL; /*--- Load in the number of zones and spatial dimensions in the mesh file (if no config file is specified, default.cfg is used) ---*/ if (argc == 2 || argc == 3) { strcpy(config_file_name,argv[1]); } else { strcpy(config_file_name, "default.cfg"); } CConfig *config = NULL; config = new CConfig(config_file_name, SU2_SOL); if (config->GetKind_Solver() == MULTIZONE) nZone = config->GetnConfigFiles(); else nZone = CConfig::GetnZone(config->GetMesh_FileName(), config->GetMesh_FileFormat(), config); periodic = CConfig::GetPeriodic(config->GetMesh_FileName(), config->GetMesh_FileFormat(), config); /*--- Definition of the containers per zones ---*/ solver_container = new CSolver**[nZone]; config_container = new CConfig*[nZone]; geometry_container = new CGeometry**[nZone]; nInst = new unsigned short[nZone]; driver_config = NULL; for (iZone = 0; iZone < nZone; iZone++) { solver_container[iZone] = NULL; config_container[iZone] = NULL; geometry_container[iZone] = NULL; nInst[iZone] = 1; } /*--- Initialize the configuration of the driver ---*/ driver_config = new CConfig(config_file_name, SU2_SOL, ZONE_0, nZone, 0, VERB_NONE); /*--- Initialize a char to store the zone filename ---*/ char zone_file_name[MAX_STRING_SIZE]; /*--- Store a boolean for multizone problems ---*/ multizone = (driver_config->GetKind_Solver() == MULTIZONE); /*--- Loop over all zones to initialize the various classes. In most cases, nZone is equal to one. This represents the solution of a partial differential equation on a single block, unstructured mesh. ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the configuration option class for all zones. In this constructor, the input configuration file is parsed and all options are read and stored. ---*/ if (multizone){ strcpy(zone_file_name, driver_config->GetConfigFilename(iZone).c_str()); config_container[iZone] = new CConfig(zone_file_name, SU2_SOL, iZone, nZone, 0, VERB_HIGH); } else{ config_container[iZone] = new CConfig(config_file_name, SU2_SOL, iZone, nZone, 0, VERB_HIGH); } config_container[iZone]->SetMPICommunicator(MPICommunicator); } /*--- Set the multizone part of the problem. ---*/ if (driver_config->GetKind_Solver() == MULTIZONE){ for (iZone = 0; iZone < nZone; iZone++) { /*--- Set the interface markers for multizone ---*/ config_container[iZone]->SetMultizone(driver_config, config_container); } } /*--- Read the geometry for each zone ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Determine whether or not the FEM solver is used, which decides the type of geometry classes that are instantiated. ---*/ fem_solver = ((config_container[iZone]->GetKind_Solver() == FEM_EULER) || (config_container[iZone]->GetKind_Solver() == FEM_NAVIER_STOKES) || (config_container[iZone]->GetKind_Solver() == FEM_RANS) || (config_container[iZone]->GetKind_Solver() == FEM_LES) || (config_container[iZone]->GetKind_Solver() == DISC_ADJ_FEM_EULER) || (config_container[iZone]->GetKind_Solver() == DISC_ADJ_FEM_NS) || (config_container[iZone]->GetKind_Solver() == DISC_ADJ_FEM_RANS)); /*--- Read the number of instances for each zone ---*/ nInst[iZone] = config_container[iZone]->GetnTimeInstances(); geometry_container[iZone] = new CGeometry*[nInst[iZone]]; solver_container[iZone] = new CSolver*[nInst[iZone]]; for (iInst = 0; iInst < nInst[iZone]; iInst++){ /*--- Allocate solver. ---*/ solver_container[iZone][iInst] = NULL; config_container[iZone]->SetiInst(iInst); /*--- Definition of the geometry class to store the primal grid in the partitioning process. ---*/ CGeometry *geometry_aux = NULL; /*--- All ranks process the grid and call ParMETIS for partitioning ---*/ geometry_aux = new CPhysicalGeometry(config_container[iZone], iZone, nZone); /*--- Color the initial grid and set the send-receive domains (ParMETIS) ---*/ if ( fem_solver ) geometry_aux->SetColorFEMGrid_Parallel(config_container[iZone]); else geometry_aux->SetColorGrid_Parallel(config_container[iZone]); /*--- Allocate the memory of the current domain, and divide the grid between the nodes ---*/ geometry_container[iZone][iInst] = NULL; /*--- Until we finish the new periodic BC implementation, use the old partitioning routines for cases with periodic BCs. The old routines will be entirely removed eventually in favor of the new methods. ---*/ if( fem_solver ) { switch( config_container[iZone]->GetKind_FEM_Flow() ) { case DG: { geometry_container[iZone][iInst] = new CMeshFEM_DG(geometry_aux, config_container[iZone]); break; } } } else { if (periodic) { geometry_container[iZone][iInst] = new CPhysicalGeometry(geometry_aux, config_container[iZone]); } else { geometry_container[iZone][iInst] = new CPhysicalGeometry(geometry_aux, config_container[iZone], periodic); } } /*--- Deallocate the memory of geometry_aux ---*/ delete geometry_aux; /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone][iInst]->SetSendReceive(config_container[iZone]); /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone][iInst]->SetBoundaries(config_container[iZone]); /*--- Create the vertex structure (required for MPI) ---*/ if (rank == MASTER_NODE) cout << "Identify vertices." <<endl; geometry_container[iZone][iInst]->SetVertex(config_container[iZone]); /*--- Store the global to local mapping after preprocessing. ---*/ if (rank == MASTER_NODE) cout << "Storing a mapping from global to local point index." << endl; geometry_container[iZone][iInst]->SetGlobal_to_Local_Point(); /* Test for a fem solver, because some more work must be done. */ if (fem_solver) { /*--- Carry out a dynamic cast to CMeshFEM_DG, such that it is not needed to define all virtual functions in the base class CGeometry. ---*/ CMeshFEM_DG *DGMesh = dynamic_cast<CMeshFEM_DG *>(geometry_container[iZone][iInst]); /*--- Determine the standard elements for the volume elements. ---*/ if (rank == MASTER_NODE) cout << "Creating standard volume elements." << endl; DGMesh->CreateStandardVolumeElements(config_container[iZone]); /*--- Create the face information needed to compute the contour integral for the elements in the Discontinuous Galerkin formulation. ---*/ if (rank == MASTER_NODE) cout << "Creating face information." << endl; DGMesh->CreateFaces(config_container[iZone]); } } } /*--- Determine whether the simulation is a FSI simulation ---*/ bool fsi = config_container[ZONE_0]->GetFSI_Simulation(); /*--- Set up a timer for performance benchmarking (preprocessing time is included) ---*/ #ifdef HAVE_MPI StartTime = MPI_Wtime(); #else StartTime = su2double(clock())/su2double(CLOCKS_PER_SEC); #endif if (rank == MASTER_NODE) cout << endl <<"------------------------- Solution Postprocessing -----------------------" << endl; /*--- Definition of the output class (one for all the zones) ---*/ output = new COutput(config_container[ZONE_0]); /*--- Check whether this is an FSI, fluid unsteady, harmonic balance or structural dynamic simulation and call the solution merging routines accordingly.---*/ if (multizone){ bool TimeDomain = driver_config->GetTime_Domain(); if (TimeDomain){ su2double Physical_dt, Physical_t; unsigned long TimeIter = 0; bool StopCalc = false; /*--- Physical time step ---*/ Physical_dt = driver_config->GetTime_Step(); /*--- Check for an unsteady restart. Update TimeIter if necessary. ---*/ if (driver_config->GetRestart()){ TimeIter = driver_config->GetRestart_Iter(); } /*--- Instantiate the solvers for each zone. ---*/ for (iZone = 0; iZone < nZone; iZone++){ config_container[iZone]->SetiInst(INST_0); config_container[iZone]->SetExtIter(TimeIter); solver_container[iZone][INST_0] = new CBaselineSolver(geometry_container[iZone][INST_0], config_container[iZone]); } /*--- Loop over the whole time domain ---*/ while (TimeIter < driver_config->GetnTime_Iter()) { /*--- Check if the maximum time has been surpassed. ---*/ Physical_t = (TimeIter+1)*Physical_dt; if (Physical_t >= driver_config->GetMax_Time()) StopCalc = true; if ((TimeIter+1 == driver_config->GetnTime_Iter()) || // The last time iteration (StopCalc) || // We have surpassed the requested time ((TimeIter == 0) || (TimeIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)) // The iteration has been requested ){ /*--- Load the restart for all the zones. ---*/ for (iZone = 0; iZone < nZone; iZone++){ /*--- Set the current iteration number in the config class. ---*/ config_container[iZone]->SetExtIter(TimeIter); /*--- So far, only enabled for single-instance problems ---*/ config_container[iZone]->SetiInst(INST_0); solver_container[iZone][INST_0]->LoadRestart(geometry_container[iZone], &solver_container[iZone], config_container[iZone], SU2_TYPE::Int(MESH_0), true); } if (rank == MASTER_NODE) cout << "Writing the volume solution for time step " << TimeIter << ", t = " << Physical_t << " s ." << endl; output->SetBaselineResult_Files(solver_container, geometry_container, config_container, TimeIter, nZone); } TimeIter++; if (StopCalc) break; } } else { /*--- Steady simulation: merge the solution files for each zone. ---*/ for (iZone = 0; iZone < nZone; iZone++) { config_container[iZone]->SetiInst(INST_0); /*--- Definition of the solution class ---*/ solver_container[iZone][INST_0] = new CBaselineSolver(geometry_container[iZone][INST_0], config_container[iZone]); solver_container[iZone][INST_0]->LoadRestart(geometry_container[iZone], &solver_container[iZone], config_container[iZone], SU2_TYPE::Int(MESH_0), true); } output->SetBaselineResult_Files(solver_container, geometry_container, config_container, 0, nZone); } } else if (fsi){ if (nZone < 2){ SU2_MPI::Error("For multizone computations, please add the number of zones as a second argument for SU2_SOL.", CURRENT_FUNCTION); } su2double Physical_dt, Physical_t; unsigned long iExtIter = 0, iExtIterFlow = 0, iExtIterFEM = 0; bool StopCalc = false; bool SolutionInstantiatedFlow = false, SolutionInstantiatedFEM = false; /*--- Check for an unsteady restart. Update ExtIter if necessary. ---*/ if (config_container[ZONE_0]->GetRestart()){ iExtIterFlow = config_container[ZONE_0]->GetUnst_RestartIter(); iExtIterFEM = config_container[ZONE_1]->GetDyn_RestartIter(); if (iExtIterFlow != iExtIterFEM) { SU2_MPI::Error("For multizone computations, please add the number of zones as a second argument for SU2_SOL.", CURRENT_FUNCTION); } else { iExtIter = iExtIterFlow; } } while (iExtIter < config_container[ZONE_0]->GetnExtIter()) { /*--- Check several conditions in order to merge the correct time step files. ---*/ Physical_dt = config_container[ZONE_0]->GetDelta_UnstTime(); Physical_t = (iExtIter+1)*Physical_dt; if (Physical_t >= config_container[ZONE_0]->GetTotal_UnstTime()) StopCalc = true; if ( ((iExtIter+1 == config_container[ZONE_0]->GetnExtIter()) || ((iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq() == 0) && (iExtIter != 0) && !((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND))) || (StopCalc) || (((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND)) && ((iExtIter == 0) || (iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) && ((iExtIter+1 == config_container[ZONE_1]->GetnExtIter()) || (StopCalc) || ((config_container[ZONE_1]->GetDynamic_Analysis() == DYNAMIC) && ((iExtIter == 0) || (iExtIter % config_container[ZONE_1]->GetWrt_Sol_Freq_DualTime() == 0)))) ){ /*--- Set the current iteration number in the config class. ---*/ config_container[ZONE_0]->SetExtIter(iExtIter); config_container[ZONE_1]->SetExtIter(iExtIter); /*--- Read in the restart file for this time step ---*/ /*--- For the fluid zone (ZONE_0) ---*/ /*--- Either instantiate the solution class or load a restart file. ---*/ if (SolutionInstantiatedFlow == false && (iExtIter == 0 || ((config_container[ZONE_0]->GetRestart() && (SU2_TYPE::Int(iExtIter) == config_container[ZONE_0]->GetUnst_RestartIter())) || iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0 || iExtIter+1 == config_container[ZONE_0]->GetnExtIter()))) { solver_container[ZONE_0][INST_0] = new CBaselineSolver(geometry_container[ZONE_0][INST_0], config_container[ZONE_0]); SolutionInstantiatedFlow = true; } solver_container[ZONE_0][INST_0]->LoadRestart_FSI(geometry_container[ZONE_0][INST_0], config_container[ZONE_0], SU2_TYPE::Int(MESH_0)); /*--- For the structural zone (ZONE_1) ---*/ /*--- Either instantiate the solution class or load a restart file. ---*/ /*--- Either instantiate the solution class or load a restart file. ---*/ if (SolutionInstantiatedFEM == false && (iExtIter == 0 || ((config_container[ZONE_1]->GetRestart() && (SU2_TYPE::Int(iExtIter) == config_container[ZONE_1]->GetDyn_RestartIter())) || iExtIter % config_container[ZONE_1]->GetWrt_Sol_Freq_DualTime() == 0 || iExtIter+1 == config_container[ZONE_1]->GetnExtIter()))) { solver_container[ZONE_1][INST_0] = new CBaselineSolver(geometry_container[ZONE_1][INST_0], config_container[ZONE_1]); SolutionInstantiatedFEM = true; } solver_container[ZONE_1][INST_0]->LoadRestart_FSI(geometry_container[ZONE_1][INST_0], config_container[ZONE_1], SU2_TYPE::Int(MESH_0)); if (rank == MASTER_NODE) cout << "Writing the volume solution for time step " << iExtIter << "." << endl; output->SetBaselineResult_Files(solver_container, geometry_container, config_container, iExtIter, nZone); } iExtIter++; if (StopCalc) break; } } else if (fem_solver) { if (config_container[ZONE_0]->GetWrt_Unsteady()) { /*--- Unsteady DG simulation: merge all unsteady time steps. First, find the frequency and total number of files to write. ---*/ su2double Physical_dt, Physical_t; unsigned long iExtIter = 0; bool StopCalc = false; bool *SolutionInstantiated = new bool[nZone]; for (iZone = 0; iZone < nZone; iZone++) SolutionInstantiated[iZone] = false; /*--- Check for an unsteady restart. Update ExtIter if necessary. ---*/ if (config_container[ZONE_0]->GetWrt_Unsteady() && config_container[ZONE_0]->GetRestart()) iExtIter = config_container[ZONE_0]->GetUnst_RestartIter(); while (iExtIter < config_container[ZONE_0]->GetnExtIter()) { /*--- Check several conditions in order to merge the correct time step files. ---*/ Physical_dt = config_container[ZONE_0]->GetDelta_UnstTime(); Physical_t = (iExtIter+1)*Physical_dt; if (Physical_t >= config_container[ZONE_0]->GetTotal_UnstTime()) StopCalc = true; if ((iExtIter+1 == config_container[ZONE_0]->GetnExtIter()) || ((iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq() == 0) && (iExtIter != 0) && !(config_container[ZONE_0]->GetUnsteady_Simulation() == TIME_STEPPING)) || (StopCalc) || ((config_container[ZONE_0]->GetUnsteady_Simulation() == TIME_STEPPING) && ((iExtIter == 0) || (iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) { /*--- Read in the restart file for this time step ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Set the current iteration number in the config class. ---*/ config_container[iZone]->SetExtIter(iExtIter); /*--- Either instantiate the solution class or load a restart file. ---*/ if (SolutionInstantiated[iZone] == false && (iExtIter == 0 || (config_container[ZONE_0]->GetRestart() && ((long)iExtIter == config_container[ZONE_0]->GetUnst_RestartIter() || iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0 || iExtIter+1 == config_container[ZONE_0]->GetnExtIter())))) { solver_container[iZone][INST_0] = new CBaselineSolver_FEM(geometry_container[iZone][INST_0], config_container[iZone]); SolutionInstantiated[iZone] = true; } solver_container[iZone][INST_0]->LoadRestart(&geometry_container[iZone][INST_0], &solver_container[iZone], config_container[iZone], (int)iExtIter, true); } if (rank == MASTER_NODE) cout << "Writing the volume solution for time step " << iExtIter << "." << endl; output->SetBaselineResult_Files_FEM(solver_container, geometry_container, config_container, iExtIter, nZone); } iExtIter++; if (StopCalc) break; } } else { /*--- Steady simulation: merge the single solution file. ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the solution class ---*/ solver_container[iZone][INST_0] = new CBaselineSolver_FEM(geometry_container[iZone][INST_0], config_container[iZone]); solver_container[iZone][INST_0]->LoadRestart(&geometry_container[iZone][INST_0], &solver_container[iZone], config_container[iZone], SU2_TYPE::Int(MESH_0), true); } output->SetBaselineResult_Files_FEM(solver_container, geometry_container, config_container, 0, nZone); } } else { if (config_container[ZONE_0]->GetWrt_Unsteady()) { /*--- Unsteady simulation: merge all unsteady time steps. First, find the frequency and total number of files to write. ---*/ su2double Physical_dt, Physical_t; unsigned long iExtIter = 0; bool StopCalc = false; bool *SolutionInstantiated = new bool[nZone]; for (iZone = 0; iZone < nZone; iZone++) SolutionInstantiated[iZone] = false; /*--- Check for an unsteady restart. Update ExtIter if necessary. ---*/ if (config_container[ZONE_0]->GetWrt_Unsteady() && config_container[ZONE_0]->GetRestart()) iExtIter = config_container[ZONE_0]->GetUnst_RestartIter(); while (iExtIter < config_container[ZONE_0]->GetnExtIter()) { /*--- Check several conditions in order to merge the correct time step files. ---*/ Physical_dt = config_container[ZONE_0]->GetDelta_UnstTime(); Physical_t = (iExtIter+1)*Physical_dt; if (Physical_t >= config_container[ZONE_0]->GetTotal_UnstTime()) StopCalc = true; if ((iExtIter+1 == config_container[ZONE_0]->GetnExtIter()) || ((iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq() == 0) && (iExtIter != 0) && !((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND))) || (StopCalc) || (((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND)) && ((iExtIter == 0) || (iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) { /*--- Read in the restart file for this time step ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Set the current iteration number in the config class. ---*/ config_container[iZone]->SetExtIter(iExtIter); /*--- Either instantiate the solution class or load a restart file. ---*/ if (SolutionInstantiated[iZone] == false && (iExtIter == 0 || (config_container[ZONE_0]->GetRestart() && ((long)iExtIter == config_container[ZONE_0]->GetUnst_RestartIter() || iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0 || iExtIter+1 == config_container[ZONE_0]->GetnExtIter())))) { solver_container[iZone][INST_0] = new CBaselineSolver(geometry_container[iZone][INST_0], config_container[iZone]); SolutionInstantiated[iZone] = true; } config_container[iZone]->SetiInst(INST_0); solver_container[iZone][INST_0]->LoadRestart(geometry_container[iZone], &solver_container[iZone], config_container[iZone], SU2_TYPE::Int(MESH_0), true); } if (rank == MASTER_NODE) cout << "Writing the volume solution for time step " << iExtIter << "." << endl; output->SetBaselineResult_Files(solver_container, geometry_container, config_container, iExtIter, nZone); } iExtIter++; if (StopCalc) break; } } else if (config_container[ZONE_0]->GetUnsteady_Simulation() == HARMONIC_BALANCE) { /*--- Read in the restart file for this time step ---*/ for (iZone = 0; iZone < nZone; iZone++) { for (iInst = 0; iInst < nInst[iZone]; iInst++){ config_container[iZone]->SetiInst(iInst); /*--- Either instantiate the solution class or load a restart file. ---*/ solver_container[iZone][iInst] = new CBaselineSolver(geometry_container[iZone][iInst], config_container[iZone]); solver_container[iZone][iInst]->LoadRestart(geometry_container[iZone], &solver_container[iZone], config_container[iZone], SU2_TYPE::Int(MESH_0), true); /*--- Print progress in solution writing to the screen. ---*/ if (rank == MASTER_NODE) { cout << "Storing the volume solution for time instance " << iInst << "." << endl; } } } output->SetBaselineResult_Files(solver_container, geometry_container, config_container, iZone, nZone); } else if (config_container[ZONE_0]->GetWrt_Dynamic()){ /*--- Dynamic simulation: merge all unsteady time steps. First, find the frequency and total number of files to write. ---*/ su2double Physical_dt, Physical_t; unsigned long iExtIter = 0; bool StopCalc = false; bool SolutionInstantiated = false; /*--- Check for an dynamic restart (structural analysis). Update ExtIter if necessary. ---*/ if (config_container[ZONE_0]->GetKind_Solver() == FEM_ELASTICITY && config_container[ZONE_0]->GetWrt_Dynamic() && config_container[ZONE_0]->GetRestart()) iExtIter = config_container[ZONE_0]->GetDyn_RestartIter(); while (iExtIter < config_container[ZONE_0]->GetnExtIter()) { /*--- Check several conditions in order to merge the correct time step files. ---*/ /*--- If the solver is structural, the total and delta_t are obtained from different functions. ---*/ Physical_dt = config_container[ZONE_0]->GetDelta_DynTime(); Physical_t = (iExtIter+1)*Physical_dt; if (Physical_t >= config_container[ZONE_0]->GetTotal_DynTime()) StopCalc = true; if ((iExtIter+1 == config_container[ZONE_0]->GetnExtIter()) || (StopCalc) || ((config_container[ZONE_0]->GetDynamic_Analysis() == DYNAMIC) && ((iExtIter == 0) || (iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) { /*--- Set the current iteration number in the config class. ---*/ config_container[ZONE_0]->SetExtIter(iExtIter); /*--- Read in the restart file for this time step ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Either instantiate the solution class or load a restart file. ---*/ if (SolutionInstantiated == false && (iExtIter == 0 || ((config_container[ZONE_0]->GetRestart() && (SU2_TYPE::Int(iExtIter) == config_container[ZONE_0]->GetDyn_RestartIter())) || iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0 || iExtIter+1 == config_container[ZONE_0]->GetnExtIter()))) { solver_container[iZone][INST_0] = new CBaselineSolver(geometry_container[iZone][INST_0], config_container[iZone]); SolutionInstantiated = true; } config_container[iZone]->SetiInst(INST_0); solver_container[iZone][INST_0]->LoadRestart(geometry_container[iZone], &solver_container[iZone], config_container[iZone], SU2_TYPE::Int(MESH_0), true); } if (rank == MASTER_NODE) cout << "Writing the volume solution for time step " << iExtIter << "." << endl; output->SetBaselineResult_Files(solver_container, geometry_container, config_container, iExtIter, nZone); } iExtIter++; if (StopCalc) break; } } else { /*--- Steady simulation: merge the single solution file. ---*/ for (iZone = 0; iZone < nZone; iZone++) { config_container[iZone]->SetiInst(INST_0); /*--- Definition of the solution class ---*/ solver_container[iZone][INST_0] = new CBaselineSolver(geometry_container[iZone][INST_0], config_container[iZone]); solver_container[iZone][INST_0]->LoadRestart(geometry_container[iZone], &solver_container[iZone], config_container[iZone], SU2_TYPE::Int(MESH_0), true); } output->SetBaselineResult_Files(solver_container, geometry_container, config_container, 0, nZone); } } delete config; config = NULL; if (rank == MASTER_NODE) cout << endl <<"------------------------- Solver Postprocessing -------------------------" << endl; if (geometry_container != NULL) { for (iZone = 0; iZone < nZone; iZone++) { for (iInst = 0; iInst < nInst[iZone]; iInst++){ if (geometry_container[iZone][iInst] != NULL) { delete geometry_container[iZone][iInst]; } } if (geometry_container[iZone] != NULL) delete geometry_container[iZone]; } delete [] geometry_container; } if (rank == MASTER_NODE) cout << "Deleted CGeometry container." << endl; if (solver_container != NULL) { for (iZone = 0; iZone < nZone; iZone++) { for (iInst = 0; iInst < nInst[iZone]; iInst++){ if (solver_container[iZone][iInst] != NULL) { delete solver_container[iZone][iInst]; } } if (solver_container[iZone] != NULL) delete solver_container[iZone]; } delete [] solver_container; } if (rank == MASTER_NODE) cout << "Deleted CSolver class." << endl; if (config_container != NULL) { for (iZone = 0; iZone < nZone; iZone++) { if (config_container[iZone] != NULL) { delete config_container[iZone]; } } delete [] config_container; } if (rank == MASTER_NODE) cout << "Deleted CConfig container." << endl; if (output != NULL) delete output; if (rank == MASTER_NODE) cout << "Deleted COutput class." << endl; /*--- Synchronization point after a single solver iteration. Compute the wall clock time required. ---*/ #ifdef HAVE_MPI StopTime = MPI_Wtime(); #else StopTime = su2double(clock())/su2double(CLOCKS_PER_SEC); #endif /*--- Compute/print the total time for performance benchmarking. ---*/ UsedTime = StopTime-StartTime; if (rank == MASTER_NODE) { cout << "\nCompleted in " << fixed << UsedTime << " seconds on "<< size; if (size == 1) cout << " core." << endl; else cout << " cores." << endl; } /*--- Exit the solver cleanly ---*/ if (rank == MASTER_NODE) cout << endl <<"------------------------- Exit Success (SU2_SOL) ------------------------" << endl << endl; /*--- Finalize MPI parallelization ---*/ #ifdef HAVE_MPI SU2_MPI::Finalize(); #endif return EXIT_SUCCESS; }
int main(int argc, char *argv[]) { unsigned short iZone, nZone = SINGLE_ZONE; su2double StartTime = 0.0, StopTime = 0.0, UsedTime = 0.0; ofstream ConvHist_file; char config_file_name[MAX_STRING_SIZE]; int rank = MASTER_NODE; int size = SINGLE_NODE; bool periodic = false; /*--- MPI initialization ---*/ #ifdef HAVE_MPI SU2_MPI::Init(&argc,&argv); SU2_MPI::Comm MPICommunicator(MPI_COMM_WORLD); #else SU2_Comm MPICommunicator(0); #endif rank = SU2_MPI::GetRank(); size = SU2_MPI::GetSize(); /*--- Pointer to different structures that will be used throughout the entire code ---*/ COutput *output = NULL; CGeometry **geometry_container = NULL; CSolver **solver_container = NULL; CConfig **config_container = NULL; /*--- Load in the number of zones and spatial dimensions in the mesh file (if no config file is specified, default.cfg is used) ---*/ if (argc == 2 || argc == 3) { strcpy(config_file_name,argv[1]); } else { strcpy(config_file_name, "default.cfg"); } CConfig *config = NULL; config = new CConfig(config_file_name, SU2_SOL); nZone = CConfig::GetnZone(config->GetMesh_FileName(), config->GetMesh_FileFormat(), config); periodic = CConfig::GetPeriodic(config->GetMesh_FileName(), config->GetMesh_FileFormat(), config); /*--- Definition of the containers per zones ---*/ solver_container = new CSolver*[nZone]; config_container = new CConfig*[nZone]; geometry_container = new CGeometry*[nZone]; for (iZone = 0; iZone < nZone; iZone++) { solver_container[iZone] = NULL; config_container[iZone] = NULL; geometry_container[iZone] = NULL; } /*--- Loop over all zones to initialize the various classes. In most cases, nZone is equal to one. This represents the solution of a partial differential equation on a single block, unstructured mesh. ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the configuration option class for all zones. In this constructor, the input configuration file is parsed and all options are read and stored. ---*/ config_container[iZone] = new CConfig(config_file_name, SU2_SOL, iZone, nZone, 0, VERB_HIGH); config_container[iZone]->SetMPICommunicator(MPICommunicator); /*--- Definition of the geometry class to store the primal grid in the partitioning process. ---*/ CGeometry *geometry_aux = NULL; /*--- All ranks process the grid and call ParMETIS for partitioning ---*/ geometry_aux = new CPhysicalGeometry(config_container[iZone], iZone, nZone); /*--- Color the initial grid and set the send-receive domains (ParMETIS) ---*/ geometry_aux->SetColorGrid_Parallel(config_container[iZone]); /*--- Until we finish the new periodic BC implementation, use the old partitioning routines for cases with periodic BCs. The old routines will be entirely removed eventually in favor of the new methods. ---*/ if (periodic) { geometry_container[iZone] = new CPhysicalGeometry(geometry_aux, config_container[iZone]); } else { geometry_container[iZone] = new CPhysicalGeometry(geometry_aux, config_container[iZone], periodic); } /*--- Deallocate the memory of geometry_aux ---*/ delete geometry_aux; /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone]->SetSendReceive(config_container[iZone]); /*--- Add the Send/Receive boundaries ---*/ geometry_container[iZone]->SetBoundaries(config_container[iZone]); /*--- Create the vertex structure (required for MPI) ---*/ if (rank == MASTER_NODE) cout << "Identify vertices." <<endl; geometry_container[iZone]->SetVertex(config_container[iZone]); /*--- Store the global to local mapping after preprocessing. ---*/ if (rank == MASTER_NODE) cout << "Storing a mapping from global to local point index." << endl; geometry_container[iZone]->SetGlobal_to_Local_Point(); } /*--- Determine whether the simulation is a FSI simulation ---*/ bool fsi = config_container[ZONE_0]->GetFSI_Simulation(); /*--- Set up a timer for performance benchmarking (preprocessing time is included) ---*/ #ifdef HAVE_MPI StartTime = MPI_Wtime(); #else StartTime = su2double(clock())/su2double(CLOCKS_PER_SEC); #endif if (rank == MASTER_NODE) cout << endl <<"------------------------- Solution Postprocessing -----------------------" << endl; /*--- Definition of the output class (one for all the zones) ---*/ output = new COutput(config_container[ZONE_0]); /*--- Check whether this is an FSI, fluid unsteady, harmonic balance or structural dynamic simulation and call the solution merging routines accordingly.---*/ if (fsi){ if (nZone < 2){ SU2_MPI::Error("For multizone computations, please add the number of zones as a second argument for SU2_SOL.", CURRENT_FUNCTION); } su2double Physical_dt, Physical_t; unsigned long iExtIter = 0, iExtIterFlow = 0, iExtIterFEM = 0; bool StopCalc = false; bool SolutionInstantiatedFlow = false, SolutionInstantiatedFEM = false; /*--- Check for an unsteady restart. Update ExtIter if necessary. ---*/ if (config_container[ZONE_0]->GetRestart()){ iExtIterFlow = config_container[ZONE_0]->GetUnst_RestartIter(); iExtIterFEM = config_container[ZONE_1]->GetDyn_RestartIter(); if (iExtIterFlow != iExtIterFEM) { SU2_MPI::Error("For multizone computations, please add the number of zones as a second argument for SU2_SOL.", CURRENT_FUNCTION); } else { iExtIter = iExtIterFlow; } } while (iExtIter < config_container[ZONE_0]->GetnExtIter()) { /*--- Check several conditions in order to merge the correct time step files. ---*/ Physical_dt = config_container[ZONE_0]->GetDelta_UnstTime(); Physical_t = (iExtIter+1)*Physical_dt; if (Physical_t >= config_container[ZONE_0]->GetTotal_UnstTime()) StopCalc = true; if ( ((iExtIter+1 == config_container[ZONE_0]->GetnExtIter()) || ((iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq() == 0) && (iExtIter != 0) && !((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND))) || (StopCalc) || (((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND)) && ((iExtIter == 0) || (iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) && ((iExtIter+1 == config_container[ZONE_1]->GetnExtIter()) || (StopCalc) || ((config_container[ZONE_1]->GetDynamic_Analysis() == DYNAMIC) && ((iExtIter == 0) || (iExtIter % config_container[ZONE_1]->GetWrt_Sol_Freq_DualTime() == 0)))) ){ /*--- Set the current iteration number in the config class. ---*/ config_container[ZONE_0]->SetExtIter(iExtIter); config_container[ZONE_1]->SetExtIter(iExtIter); /*--- Read in the restart file for this time step ---*/ /*--- For the fluid zone (ZONE_0) ---*/ /*--- Either instantiate the solution class or load a restart file. ---*/ if (SolutionInstantiatedFlow == false && (iExtIter == 0 || ((config_container[ZONE_0]->GetRestart() && (SU2_TYPE::Int(iExtIter) == config_container[ZONE_0]->GetUnst_RestartIter())) || iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0 || iExtIter+1 == config_container[ZONE_0]->GetnExtIter()))) { solver_container[ZONE_0] = new CBaselineSolver(geometry_container[ZONE_0], config_container[ZONE_0]); SolutionInstantiatedFlow = true; } solver_container[ZONE_0]->LoadRestart_FSI(geometry_container[ZONE_0], &solver_container, config_container[ZONE_0], SU2_TYPE::Int(MESH_0)); /*--- For the structural zone (ZONE_1) ---*/ /*--- Either instantiate the solution class or load a restart file. ---*/ /*--- Either instantiate the solution class or load a restart file. ---*/ if (SolutionInstantiatedFEM == false && (iExtIter == 0 || ((config_container[ZONE_1]->GetRestart() && (SU2_TYPE::Int(iExtIter) == config_container[ZONE_1]->GetDyn_RestartIter())) || iExtIter % config_container[ZONE_1]->GetWrt_Sol_Freq_DualTime() == 0 || iExtIter+1 == config_container[ZONE_1]->GetnExtIter()))) { solver_container[ZONE_1] = new CBaselineSolver(geometry_container[ZONE_1], config_container[ZONE_1]); SolutionInstantiatedFEM = true; } solver_container[ZONE_1]->LoadRestart_FSI(geometry_container[ZONE_1], &solver_container, config_container[ZONE_1], SU2_TYPE::Int(MESH_0)); if (rank == MASTER_NODE) cout << "Writing the volume solution for time step " << iExtIter << "." << endl; output->SetBaselineResult_Files(solver_container, geometry_container, config_container, iExtIter, nZone); } iExtIter++; if (StopCalc) break; } } else { if (config_container[ZONE_0]->GetWrt_Unsteady()) { /*--- Unsteady simulation: merge all unsteady time steps. First, find the frequency and total number of files to write. ---*/ su2double Physical_dt, Physical_t; unsigned long iExtIter = 0; bool StopCalc = false; bool *SolutionInstantiated = new bool[nZone]; for (iZone = 0; iZone < nZone; iZone++) SolutionInstantiated[iZone] = false; /*--- Check for an unsteady restart. Update ExtIter if necessary. ---*/ if (config_container[ZONE_0]->GetWrt_Unsteady() && config_container[ZONE_0]->GetRestart()) iExtIter = config_container[ZONE_0]->GetUnst_RestartIter(); while (iExtIter < config_container[ZONE_0]->GetnExtIter()) { /*--- Check several conditions in order to merge the correct time step files. ---*/ Physical_dt = config_container[ZONE_0]->GetDelta_UnstTime(); Physical_t = (iExtIter+1)*Physical_dt; if (Physical_t >= config_container[ZONE_0]->GetTotal_UnstTime()) StopCalc = true; if ((iExtIter+1 == config_container[ZONE_0]->GetnExtIter()) || ((iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq() == 0) && (iExtIter != 0) && !((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND))) || (StopCalc) || (((config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_1ST) || (config_container[ZONE_0]->GetUnsteady_Simulation() == DT_STEPPING_2ND)) && ((iExtIter == 0) || (iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) { /*--- Read in the restart file for this time step ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Set the current iteration number in the config class. ---*/ config_container[iZone]->SetExtIter(iExtIter); /*--- Either instantiate the solution class or load a restart file. ---*/ if (SolutionInstantiated[iZone] == false && (iExtIter == 0 || (config_container[ZONE_0]->GetRestart() && ((long)iExtIter == config_container[ZONE_0]->GetUnst_RestartIter() || iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0 || iExtIter+1 == config_container[ZONE_0]->GetnExtIter())))) { solver_container[iZone] = new CBaselineSolver(geometry_container[iZone], config_container[iZone]); SolutionInstantiated[iZone] = true; } solver_container[iZone]->LoadRestart(geometry_container, &solver_container, config_container[iZone], SU2_TYPE::Int(MESH_0), true); } if (rank == MASTER_NODE) cout << "Writing the volume solution for time step " << iExtIter << "." << endl; output->SetBaselineResult_Files(solver_container, geometry_container, config_container, iExtIter, nZone); } iExtIter++; if (StopCalc) break; } } else if (config_container[ZONE_0]->GetUnsteady_Simulation() == HARMONIC_BALANCE) { /*--- Read in the restart file for this time step ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Either instantiate the solution class or load a restart file. ---*/ solver_container[iZone] = new CBaselineSolver(geometry_container[iZone], config_container[iZone]); solver_container[iZone]->LoadRestart(geometry_container, &solver_container, config_container[iZone], SU2_TYPE::Int(MESH_0), true); /*--- Print progress in solution writing to the screen. ---*/ if (rank == MASTER_NODE) { cout << "Storing the volume solution for time instance " << iZone << "." << endl; } } output->SetBaselineResult_Files(solver_container, geometry_container, config_container, iZone, nZone); } else if (config_container[ZONE_0]->GetWrt_Dynamic()){ /*--- Dynamic simulation: merge all unsteady time steps. First, find the frequency and total number of files to write. ---*/ su2double Physical_dt, Physical_t; unsigned long iExtIter = 0; bool StopCalc = false; bool SolutionInstantiated = false; /*--- Check for an dynamic restart (structural analysis). Update ExtIter if necessary. ---*/ if (config_container[ZONE_0]->GetKind_Solver() == FEM_ELASTICITY && config_container[ZONE_0]->GetWrt_Dynamic() && config_container[ZONE_0]->GetRestart()) iExtIter = config_container[ZONE_0]->GetDyn_RestartIter(); while (iExtIter < config_container[ZONE_0]->GetnExtIter()) { /*--- Check several conditions in order to merge the correct time step files. ---*/ /*--- If the solver is structural, the total and delta_t are obtained from different functions. ---*/ Physical_dt = config_container[ZONE_0]->GetDelta_DynTime(); Physical_t = (iExtIter+1)*Physical_dt; if (Physical_t >= config_container[ZONE_0]->GetTotal_DynTime()) StopCalc = true; if ((iExtIter+1 == config_container[ZONE_0]->GetnExtIter()) || (StopCalc) || ((config_container[ZONE_0]->GetDynamic_Analysis() == DYNAMIC) && ((iExtIter == 0) || (iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0)))) { /*--- Set the current iteration number in the config class. ---*/ config_container[ZONE_0]->SetExtIter(iExtIter); /*--- Read in the restart file for this time step ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Either instantiate the solution class or load a restart file. ---*/ if (SolutionInstantiated == false && (iExtIter == 0 || ((config_container[ZONE_0]->GetRestart() && (SU2_TYPE::Int(iExtIter) == config_container[ZONE_0]->GetDyn_RestartIter())) || iExtIter % config_container[ZONE_0]->GetWrt_Sol_Freq_DualTime() == 0 || iExtIter+1 == config_container[ZONE_0]->GetnExtIter()))) { solver_container[iZone] = new CBaselineSolver(geometry_container[iZone], config_container[iZone]); SolutionInstantiated = true; } solver_container[iZone]->LoadRestart(geometry_container, &solver_container, config_container[iZone], SU2_TYPE::Int(MESH_0), true); } if (rank == MASTER_NODE) cout << "Writing the volume solution for time step " << iExtIter << "." << endl; output->SetBaselineResult_Files(solver_container, geometry_container, config_container, iExtIter, nZone); } iExtIter++; if (StopCalc) break; } } else { /*--- Steady simulation: merge the single solution file. ---*/ for (iZone = 0; iZone < nZone; iZone++) { /*--- Definition of the solution class ---*/ solver_container[iZone] = new CBaselineSolver(geometry_container[iZone], config_container[iZone]); solver_container[iZone]->LoadRestart(geometry_container, &solver_container, config_container[iZone], SU2_TYPE::Int(MESH_0), true); } output->SetBaselineResult_Files(solver_container, geometry_container, config_container, 0, nZone); } } delete config; config = NULL; if (rank == MASTER_NODE) cout << endl <<"------------------------- Solver Postprocessing -------------------------" << endl; if (geometry_container != NULL) { for (iZone = 0; iZone < nZone; iZone++) { if (geometry_container[iZone] != NULL) { delete geometry_container[iZone]; } } delete [] geometry_container; } if (rank == MASTER_NODE) cout << "Deleted CGeometry container." << endl; if (solver_container != NULL) { for (iZone = 0; iZone < nZone; iZone++) { if (solver_container[iZone] != NULL) { delete solver_container[iZone]; } } delete [] solver_container; } if (rank == MASTER_NODE) cout << "Deleted CSolver class." << endl; if (config_container != NULL) { for (iZone = 0; iZone < nZone; iZone++) { if (config_container[iZone] != NULL) { delete config_container[iZone]; } } delete [] config_container; } if (rank == MASTER_NODE) cout << "Deleted CConfig container." << endl; if (output != NULL) delete output; if (rank == MASTER_NODE) cout << "Deleted COutput class." << endl; /*--- Synchronization point after a single solver iteration. Compute the wall clock time required. ---*/ #ifdef HAVE_MPI StopTime = MPI_Wtime(); #else StopTime = su2double(clock())/su2double(CLOCKS_PER_SEC); #endif /*--- Compute/print the total time for performance benchmarking. ---*/ UsedTime = StopTime-StartTime; if (rank == MASTER_NODE) { cout << "\nCompleted in " << fixed << UsedTime << " seconds on "<< size; if (size == 1) cout << " core." << endl; else cout << " cores." << endl; } /*--- Exit the solver cleanly ---*/ if (rank == MASTER_NODE) cout << endl <<"------------------------- Exit Success (SU2_SOL) ------------------------" << endl << endl; /*--- Finalize MPI parallelization ---*/ #ifdef HAVE_MPI SU2_MPI::Finalize(); #endif return EXIT_SUCCESS; }