]> SALOME platform Git repositories - tools/solverlab.git/commitdiff
Salome HOME
Improved message displays
authormichael <michael@localhost.localdomain>
Wed, 24 Nov 2021 15:06:38 +0000 (16:06 +0100)
committermichael <michael@localhost.localdomain>
Wed, 24 Nov 2021 15:06:38 +0000 (16:06 +0100)
CoreFlows/Models/src/DiffusionEquation.cxx
CoreFlows/Models/src/DriftModel.cxx
CoreFlows/Models/src/FiveEqsTwoFluid.cxx
CoreFlows/Models/src/IsothermalTwoFluid.cxx
CoreFlows/Models/src/ProblemFluid.cxx
CoreFlows/Models/src/TransportEquation.cxx

index 51c78eae79aec047b2418ec96bb661cad3949cb9..4c4a7181251067a8af6c5bb6bcb9e21f6997d227 100755 (executable)
@@ -72,7 +72,7 @@ DiffusionEquation::DiffusionEquation(int dim, bool FECalculation,double rho,doub
     /* Control input value are acceptable */
     if(rho<_precision or cp<_precision)
     {
-        PetscPrintf(PETSC_COMM_WORLD,"rho = %.2f, cp = %.2f, precision = %.2f\n",rho,cp,_precision);
+        PetscPrintf(PETSC_COMM_WORLD,"rho = %.2f, cp = %.2f, precision = %.2e\n",rho,cp,_precision);
         throw CdmathException("Error : parameters rho and cp should be strictly positive");
     }
     if(lambda < 0.)
@@ -86,11 +86,11 @@ DiffusionEquation::DiffusionEquation(int dim, bool FECalculation,double rho,doub
         throw CdmathException("Error : parameter dim cannot  be negative");
     }
 
-    PetscPrintf(PETSC_COMM_WORLD,"Diffusion problem with density %.2f, specific heat %.2f, conductivity %.2f", rho,cp,lambda);
+    PetscPrintf(PETSC_COMM_WORLD,"\n Diffusion problem with density %.2e, specific heat %.2e, conductivity %.2e", rho,cp,lambda);
     if(FECalculation)
-        PetscPrintf(PETSC_COMM_WORLD," and finite elements method\n");
+        PetscPrintf(PETSC_COMM_WORLD," and finite elements method\n\n");
     else
-        PetscPrintf(PETSC_COMM_WORLD," and finite volumes method\n");
+        PetscPrintf(PETSC_COMM_WORLD," and finite volumes method\n\n");
     
     _FECalculation=FECalculation;
     
@@ -120,8 +120,6 @@ DiffusionEquation::DiffusionEquation(int dim, bool FECalculation,double rho,doub
 
        _fileName = "SolverlabDiffusionProblem";
 
-       _runLogFile=new ofstream;
-
     /* Default diffusion tensor is diagonal */
        _DiffusionTensor=Matrix(_Ndim);
        for(int idim=0;idim<_Ndim;idim++)
@@ -140,14 +138,14 @@ void DiffusionEquation::initialize()
                        *_runLogFile<< "Problem : dim = "<<_Ndim<< " but mesh dim= "<<_mesh.getMeshDimension()<<", mesh space dim= "<<_mesh.getSpaceDimension()<<endl;
                        *_runLogFile<<"DiffusionEquation::initialize: mesh has incorrect dimension"<<endl;
                        _runLogFile->close();
-                       throw CdmathException("DiffusionEquation::initialize: mesh has incorrect  dimension");
+                       throw CdmathException("!!!!!!!!DiffusionEquation::initialize: mesh has incorrect  dimension");
                }
        
                if(!_initialDataSet)
-                       throw CdmathException("DiffusionEquation::initialize() set initial data first");
+                       throw CdmathException("!!!!!!!!DiffusionEquation::initialize() set initial data first");
                else
                {
-                   PetscPrintf(PETSC_COMM_SELF,"Initialising the diffusion of a solid temperature using ");
+                   PetscPrintf(PETSC_COMM_SELF,"\n Initialising the diffusion of a solid temperature using ");
                    *_runLogFile<<"Initialising the diffusion of a solid temperature using ";
                    if(!_FECalculation)
                    {
@@ -314,7 +312,7 @@ double DiffusionEquation::computeDiffusionMatrix(bool & stop)
     else
         result=computeDiffusionMatrixFV(stop);
 
-       PetscPrintf(PETSC_COMM_WORLD,"Maximum diffusivity is %.2f, CFL = %.2f, Delta x = %.2f\n",_maxvp,_cfl,_minl);
+       PetscPrintf(PETSC_COMM_WORLD,"Maximum diffusivity is %.2e, CFL = %.2f, Delta x = %.2e\n",_maxvp,_cfl,_minl);
 
     MatAssemblyBegin(_A, MAT_FINAL_ASSEMBLY);
        MatAssemblyEnd(  _A, MAT_FINAL_ASSEMBLY);
@@ -602,7 +600,7 @@ bool DiffusionEquation::initTimeStep(double dt){
     }
     else//dt<=0
     {
-        PetscPrintf(PETSC_COMM_WORLD,"DiffusionEquation::initTimeStep %.2f = \n",dt);
+        PetscPrintf(PETSC_COMM_WORLD,"DiffusionEquation::initTimeStep %.2e = \n",dt);
         throw CdmathException("Error DiffusionEquation::initTimeStep : cannot set time step to zero");        
     }
     //At this stage _b contains _b0 + power + heat exchange
@@ -704,8 +702,8 @@ void DiffusionEquation::validateTimeStep()
 }
 
 void DiffusionEquation::save(){
-    PetscPrintf(PETSC_COMM_WORLD,"Saving numerical results\n\n");
-    *_runLogFile<< "Saving numerical results"<< endl<<endl;
+    PetscPrintf(PETSC_COMM_WORLD,"Saving numerical results at time step number %d \n\n", _nbTimeStep);
+    *_runLogFile<< "Saving numerical results at time step number "<< _nbTimeStep << endl<<endl;
 
        string resultFile(_path+"/DiffusionEquation");//Results
 
index 0181fe1dbd97259d1d97595e77b53589db6eaf06..68b0ff79ae687447913054d322413df8deba9d2e 100755 (executable)
@@ -71,11 +71,14 @@ DriftModel::DriftModel(pressureEstimate pEstimate, int dim, bool useDellacherieE
        *_runLogFile<<"Vapour saturation enthalpy "<< _hsatv<<" J/Kg"<<endl;
        cout<<"Latent heat "<< _latentHeat<<endl;
        *_runLogFile<<"Latent heat "<< _latentHeat<<endl;
+
+       _fileName = "SolverlabDriftModel";
+    PetscPrintf(PETSC_COMM_WORLD,"\n Drift model problem for two phase flow\n");
 }
 
 void DriftModel::initialize(){
-       cout<<"Initialising the drift model"<<endl;
-       *_runLogFile<<"Initialising the drift model"<<endl;
+       cout<<"\n Initialising the drift model"<<endl;
+       *_runLogFile<<"\n Initialising the drift model"<<endl;
 
        _Uroe = new double[_nVar];
        _gravite = vector<double>(_nVar,0);//Not to be confused with _GravityField3d (size _Ndim). _gravite (size _Nvar) is usefull for dealing with source term and implicitation of gravity vector
@@ -3475,6 +3478,9 @@ void DriftModel::getDensityDerivatives(double concentration, double pression, do
 }
 
 void DriftModel::save(){
+    PetscPrintf(PETSC_COMM_WORLD,"Saving numerical results at time step number %d \n\n", _nbTimeStep);
+    *_runLogFile<< "Saving numerical results at time step number "<< _nbTimeStep << endl<<endl;
+
        string prim(_path+"/DriftModelPrim_");
        string cons(_path+"/DriftModelCons_");
        string allFields(_path+"/");
index a7761c2c2b203826274fbaccaaf88aaa9e1710eb..69a195e1b293dee393bb881f17c09dfad5807655 100755 (executable)
@@ -45,15 +45,18 @@ FiveEqsTwoFluid::FiveEqsTwoFluid(pressureEstimate pEstimate, int dim){
        }
        _latentHeat=_hsatv-_hsatl;
        _intPressCoeff=1.5;
+
+       _fileName = "SolverlabFiveEquationTwoFluid";
+    PetscPrintf(PETSC_COMM_WORLD,"\n Five equation two-fluid problem for two phase flow\n");
 }
 
 void FiveEqsTwoFluid::initialize()
 {
-       cout<<"Initialising the five equation two fluid model"<<endl;
-       *_runLogFile<<"Initialising the five equation two fluid model"<<endl;
+       cout<<"\n Initialising the five equation two fluid model"<<endl;
+       *_runLogFile<<"\n Initialising the five equation two fluid model"<<endl;
 
        if(static_cast<StiffenedGas*>(_fluides[0])==NULL || static_cast<StiffenedGas*>(_fluides[1])==NULL)
-               throw CdmathException("FiveEqsTwoFluid::initialize: both phase must have stiffened gas EOS");
+               throw CdmathException("!!!!!!!!FiveEqsTwoFluid::initialize: both phase must have stiffened gas EOS");
 
        _Uroe = new double[_nVar+1];
 
@@ -2230,6 +2233,9 @@ void FiveEqsTwoFluid::testConservation()
 }
 
 void FiveEqsTwoFluid::save(){
+    PetscPrintf(PETSC_COMM_WORLD,"Saving numerical results at time step number %d \n\n", _nbTimeStep);
+    *_runLogFile<< "Saving numerical results at time step number "<< _nbTimeStep << endl<<endl;
+
        string prim(_path+"/FiveEqsTwoFluidPrim_");
        string cons(_path+"/FiveEqsTwoFluidCons_");
        prim+=_fileName;
index 546c6a6d85960b632b92408ab6c985e43a9cb3d9..978b6f292c4d09641174aa19d2af794484be2a6c 100755 (executable)
@@ -37,11 +37,14 @@ IsothermalTwoFluid::IsothermalTwoFluid(pressureEstimate pEstimate, int dim){
                _fluides[1] = new StiffenedGas(594,1.55e7,_Temperature,_internalEnergy2, 621,3100);  //stiffened gas law for water at pressure 155 bar and temperature 345°C:
        }
        _intPressCoeff=1.5;
+
+       _fileName = "SolverlabIsothermalTwoFluid";
+    PetscPrintf(PETSC_COMM_WORLD,"\n Isothermal two-fluid problem for two phase flow\n");
 }
 
 void IsothermalTwoFluid::initialize(){
-       cout<<"Initialising the isothermal two-fluid model"<<endl;
-       *_runLogFile<<"Initialising the isothermal two-fluid model"<<endl;
+       cout<<"\n Initialising the isothermal two-fluid model\n"<<endl;
+       *_runLogFile<<"\n Initialising the isothermal two-fluid model\n"<<endl;
 
        _Uroe = new double[_nVar+1];
 
@@ -1619,6 +1622,9 @@ void IsothermalTwoFluid::testConservation()
 }
 
 void IsothermalTwoFluid::save(){
+    PetscPrintf(PETSC_COMM_WORLD,"Saving numerical results at time step number %d \n\n", _nbTimeStep);
+    *_runLogFile<< "Saving numerical results at time step number "<< _nbTimeStep << endl<<endl;
+
        string prim(_path+"/IsothermalTwoFluidPrim_");
        string cons(_path+"/IsothermalTwoFluidCons_");
        prim+=_fileName;
index 5a4ce49dfade9d64bd08948b1414749edfb666c2..77c92ff5ceb2898191664e87738580598ac16c63 100755 (executable)
@@ -45,15 +45,15 @@ void ProblemFluid::initialize()
 {
        if(!_initialDataSet)
        {
-               *_runLogFile<<"ProblemFluid::initialize() set initial data first"<<endl;
+               *_runLogFile<<"!!!!!!!!ProblemFluid::initialize() set initial data first"<<endl;
                _runLogFile->close();
-               throw CdmathException("ProblemFluid::initialize() set initial data first");
+               throw CdmathException("!!!!!!!!ProblemFluid::initialize() set initial data first");
        }
        else if (_VV.getTypeOfField() != CELLS)
        {
-               *_runLogFile<<"Initial data should be a field on CELLS, not NODES, neither FACES"<<endl;
+               *_runLogFile<<"!!!!!!!!Initial data should be a field on CELLS, not NODES, neither FACES"<<endl;
                _runLogFile->close();
-               throw CdmathException("ProblemFluid::initialize() Initial data should be a field on CELLS, not NODES, neither FACES");
+               throw CdmathException("!!!!!!!!ProblemFluid::initialize() Initial data should be a field on CELLS, not NODES, neither FACES");
        }
        cout << "Number of Phases = " << _nbPhases << " mesh dimension = "<<_Ndim<<" number of variables = "<<_nVar<<endl;
        *_runLogFile << "Number of Phases = " << _nbPhases << " spaceDim= "<<_Ndim<<" number of variables= "<<_nVar<<endl;
index 615398a5ad4710b7b11ae247d5177092de5f7ebc..c394250edddaae478c4db6738ba4d02d977308ba 100755 (executable)
@@ -56,6 +56,9 @@ TransportEquation::TransportEquation(phase fluid, pressureMagnitude pEstimate,ve
        _FECalculation=false;//Only finite volumes available
        _rodTemperatureFieldSet=false;
        _rodTemperature=0;
+
+       _fileName = "SolverlabTransportProblem";
+    PetscPrintf(PETSC_COMM_WORLD,"\n Transport problem of fluid enthalpy with constant velocity\n");
 }
 
 void TransportEquation::initialize()
@@ -63,11 +66,11 @@ void TransportEquation::initialize()
        if(_mpi_rank==0)
        {
                if(!_initialDataSet)
-                       throw CdmathException("TransportEquation::initialize() set initial data first");
+                       throw CdmathException("!!!!!!!!TransportEquation::initialize() set initial data first");
                else if (_VV.getTypeOfField() != CELLS)
-                       throw CdmathException("TransportEquation::initialize() Initial data should be a field on CELLS, not NODES, neither FACES");
+                       throw CdmathException("!!!!!!!!TransportEquation::initialize() Initial data should be a field on CELLS, not NODES, neither FACES");
                else
-                       PetscPrintf(PETSC_COMM_SELF,"Initialising the transport of a fluid enthalpy\n");
+                       PetscPrintf(PETSC_COMM_SELF,"\n Initialising the transport of a fluid enthalpy\n");
        
                /**************** Field creation *********************/
        
@@ -267,7 +270,7 @@ double TransportEquation::computeTransportMatrix(){
        _transportMatrixSet=true;
 
        MPI_Bcast(&_maxvp, 1, MPI_DOUBLE, 0, PETSC_COMM_WORLD);
-       PetscPrintf(PETSC_COMM_WORLD, "Maximum speed is %.2f, CFL = %.2f, Delta x = %.2f\n",_maxvp,_cfl,_minl);
+       PetscPrintf(PETSC_COMM_WORLD, "Maximum conductivity is %.2e, CFL = %.2f, Delta x = %.2e\n",_maxvp,_cfl,_minl);
 
     MatAssemblyBegin(_A, MAT_FINAL_ASSEMBLY);
        MatAssemblyEnd(  _A, MAT_FINAL_ASSEMBLY);
@@ -359,7 +362,7 @@ bool TransportEquation::initTimeStep(double dt){
        }
     else//dt<=0
     {
-        PetscPrintf(PETSC_COMM_WORLD,"TransportEquation::initTimeStep %.2f = \n",dt);
+        PetscPrintf(PETSC_COMM_WORLD,"TransportEquation::initTimeStep %.2e = \n",dt);
         throw CdmathException("Error TransportEquation::initTimeStep : cannot set time step to zero");        
     }
     //At this stage _b contains _b0 + power + heat exchange
@@ -515,7 +518,8 @@ void TransportEquation::terminate(){
 }
 
 void TransportEquation::save(){
-    PetscPrintf(PETSC_COMM_WORLD,"Saving numerical results\n\n");
+    PetscPrintf(PETSC_COMM_WORLD,"Saving numerical results at time step number %d \n\n", _nbTimeStep);
+    *_runLogFile<< "Saving numerical results at time step number "<< _nbTimeStep << endl<<endl;
 
        string resultFile(_path+"/TransportEquation_");///Results
        resultFile+=_fileName;