Salome HOME
f0c1568618a65ca6179cb942d091071d6685ce3d
[tools/solverlab.git] / CoreFlows / Models / inc / StationaryDiffusionEquation.hxx
1 //============================================================================
2 /**
3  * \file StationaryDiffusionEquation.hxx
4  * \author Michael NDJINGA
5  * \version 1.0
6  * \date June 2019
7  * \brief Stationary heat diffusion equation solved with either finite elements or finite volume method. 
8  * -\lambda\Delta T=\Phi + \lambda_{sf} (T_{fluid}-T)
9  * Dirichlet (imposed temperature) or Neumann (imposed normal flux) boundary conditions.
10  * */
11 //============================================================================
12
13 /*! \class StationaryDiffusionEquation StationaryDiffusionEquation.hxx "StationaryDiffusionEquation.hxx"
14  *  \brief Scalar stationary heat equation solved with either finite elements or finite volume method. 
15  *  \details see \ref StationaryDiffusionEqPage for more details
16  * -\lambda\Delta T=\Phi(T) + \lambda_{sf} (T_{fluid}-T)
17  */
18  
19 #ifndef StationaryDiffusionEquation_HXX_
20 #define StationaryDiffusionEquation_HXX_
21
22 #include "ProblemCoreFlows.hxx"
23
24 using namespace std;
25
26 /*! Boundary condition type  */
27 enum BoundaryTypeStationaryDiffusion    { NeumannStationaryDiffusion, DirichletStationaryDiffusion, NoneBCStationaryDiffusion};
28
29 /** \struct LimitField
30  * \brief value of some fields on the boundary  */
31 struct LimitFieldStationaryDiffusion{
32         LimitFieldStationaryDiffusion(){bcType=NoneBCStationaryDiffusion; T=0; normalFlux=0;}
33         LimitFieldStationaryDiffusion(BoundaryTypeStationaryDiffusion _bcType, double _T,       double _normalFlux){
34                 bcType=_bcType; T=_T; normalFlux=_normalFlux;
35         }
36
37         BoundaryTypeStationaryDiffusion bcType;
38         double T; //for Dirichlet
39         double normalFlux; //for Neumann
40 };
41
42 class StationaryDiffusionEquation
43 {
44
45 public :
46         /** \fn StationaryDiffusionEquation
47                          * \brief Constructor for the temperature diffusion in a solid
48                          * \param [in] int : space dimension
49                          * \param [in] bool : numerical method
50                          * \param [in] double : solid conductivity
51                          *  */
52
53         StationaryDiffusionEquation( int dim,bool FECalculation=true,double lambda=1,MPI_Comm comm = MPI_COMM_WORLD);
54
55     void setMesh(const Mesh &M);
56     void setFileName(string fileName){
57         _fileName = fileName;
58     }
59     bool solveStationaryProblem();
60     
61     //Linear system and spectrum
62     void setLinearSolver(linearSolver kspType, preconditioner pcType);
63     double getConditionNumber(bool isSingular=false, double tol=1e-6) const;
64     std::vector< double > getEigenvalues (int nev, EPSWhich which=EPS_SMALLEST_MAGNITUDE, double tol=1e-6) const;
65     std::vector< Vector > getEigenvectors(int nev, EPSWhich which=EPS_SMALLEST_MAGNITUDE, double tol=1e-6) const;
66     Field getEigenvectorsField(int nev, EPSWhich which=EPS_SMALLEST_MAGNITUDE, double tol=1e-6) const;
67
68         //Gestion du calcul
69         void initialize();
70         void terminate();//vide la mémoire et enregistre le résultat final
71         double computeDiffusionMatrix(bool & stop);
72     double computeTimeStep(bool & stop);//For coupling calculations
73         bool iterateNewtonStep(bool &ok);
74         void save();
75
76     /* Boundary conditions */
77         void setBoundaryFields(map<string, LimitFieldStationaryDiffusion> boundaryFields){
78                 _limitField = boundaryFields;
79     };
80         /** \fn setDirichletBoundaryCondition
81                          * \brief adds a new boundary condition of type Dirichlet
82                          * \details
83                          * \param [in] string : the name of the boundary
84                          * \param [in] double : the value of the temperature at the boundary
85                          * \param [out] void
86                          *  */
87         void setDirichletBoundaryCondition(string groupName,double Temperature){
88                 _limitField[groupName]=LimitFieldStationaryDiffusion(DirichletStationaryDiffusion,Temperature,-1);
89         };
90
91         /** \fn setNeumannBoundaryCondition
92                          * \brief adds a new boundary condition of type Neumann
93                          * \details
94                          * \param [in] string : the name of the boundary
95                          * \param [in] double : outward normal flux
96                          * \param [out] void
97                          *  */
98         void setNeumannBoundaryCondition(string groupName, double normalFlux=0){
99                 _limitField[groupName]=LimitFieldStationaryDiffusion(NeumannStationaryDiffusion,-1, normalFlux);
100         };
101
102         void setDirichletValues(map< int, double> dirichletBoundaryValues);
103         void setNeumannValues  (map< int, double>   neumannBoundaryValues);
104         
105         void setConductivity(double conductivite){
106                 _conductivity=conductivite;
107         };
108         void setDiffusiontensor(Matrix DiffusionTensor){
109                 _DiffusionTensor=DiffusionTensor;
110         };
111
112
113         //get input fields to prepare the simulation or coupling
114         vector<string> getInputFieldsNames();
115         void setInputField(const string& nameField, Field& inputField );//supply of a required input field
116         
117         void setFluidTemperatureField(Field coupledTemperatureField);
118         void setFluidTemperature(double fluidTemperature){      _fluidTemperature=fluidTemperature;     }
119         Field& getFluidTemperatureField(){      return _fluidTemperatureField;  }
120         
121         /** \fn setHeatPowerField
122          * \brief set the heat power field (variable in space)
123          * \details
124          * \param [in] Field
125          * \param [out] void
126          *  */
127         void setHeatPowerField(Field heatPower);
128
129         /** \fn setHeatPowerField
130          * \brief set the heat power field (variable in space)
131          * \details
132          * \param [in] string fileName (including file path)
133          * \param [in] string fieldName
134          * \param [out] void
135          *  */
136         void setHeatPowerField(string fileName, string fieldName, int iteration = 0, int order = 0, int meshLevel=0);
137
138         /** \fn getHeatPowerField
139          * \brief returns the heat power field
140          * \details
141          * \param [in] void
142          * \param [out] Field
143          *  */
144         Field getHeatPowerField(){
145                 return _heatPowerField;
146         }
147         //get output fields names for postprocessing or coupling
148         vector<string> getOutputFieldsNames() ;//liste tous les champs que peut fournir le code pour le postraitement
149         Field&         getOutputField(const string& nameField );//Renvoie un champs pour le postraitement
150
151     Field& getOutputTemperatureField();
152         Field& getRodTemperatureField();
153
154         /** \fn setVerbose
155          * \brief Updates display options
156          * \details
157          * \param [in] bool
158          * \param [in] bool
159          * \param [out] void
160          *  */
161         void setVerbose(bool verbose,  bool system=false)
162         {
163                 _verbose = verbose;
164                 _system = system;
165         };
166
167 protected :
168         //Main unknown field
169         Field _VV;
170
171         int _Ndim;//space dimension
172         int _nVar;//Number of equations to solve=1
173
174     //Mesh data
175         Mesh _mesh;
176     bool _meshSet;
177         bool _initializedMemory;
178         int _Nmailles;//number of cells for FV calculation
179         int _neibMaxNbCells;//maximum number of cells around a cell
180     
181         double _precision;
182         double _precision_Newton;
183         double _erreur_rel;//norme(Uk+1-Uk)
184     bool _computationCompletedSuccessfully;
185     
186         //Linear solver and petsc
187         KSP _ksp;
188         KSPType _ksptype;
189         PC _pc;
190         PCType _pctype;
191         string _pc_hypre;
192         int _maxPetscIts;//nombre maximum d'iteration gmres autorisé au cours d'une resolution de système lineaire
193         int _maxNewtonIts;//nombre maximum d'iteration de Newton autorise au cours de la resolution d'un pas de temps
194         int _PetscIts;//the number of iterations of the linear solver
195         int _NEWTON_its;
196         Mat  _A;//Linear system matrix
197         Vec _b;//Linear system right hand side
198         double _MaxIterLinearSolver;//nombre maximum d'iteration gmres obtenu au cours par les resolution de systemes lineaires au cours d'un pas de tmeps
199         bool _conditionNumber;//computes an estimate of the condition number
200
201         map<string, LimitFieldStationaryDiffusion> _limitField;
202     bool _onlyNeumannBC;//if true then the linear system is singular and should be solved up to a constant vector
203     
204         bool _diffusionMatrixSet;
205         Vector _normale;
206         Matrix _DiffusionTensor;
207         Vec _deltaT, _Tk, _Tkm1, _b0;
208         Vec _Tk_seq; // Local sequential copy of the parallel vector _Tk, used for saving result files
209
210         double _dt_src;
211     
212         //Heat transfert variables
213         double _conductivity, _fluidTemperature;
214         Field _heatPowerField, _fluidTemperatureField;
215         bool _heatPowerFieldSet, _fluidTemperatureFieldSet;
216         double _heatTransfertCoeff, _heatSource;
217
218         //Display variables
219         bool _verbose, _system;
220         ofstream * _runLogFile;//for creation of a log file to save the history of the simulation
221     //saving parameters
222         string _fileName;//name of the calculation
223         string _path;//path to execution directory used for saving results
224         saveFormat _saveFormat;//file saving format : MED, VTK or CSV
225
226         double computeRHS(bool & stop);
227         double computeDiffusionMatrixFV(bool & stop);
228         double computeDiffusionMatrixFE(bool & stop);
229
230     /************ Data for FE calculation *************/
231     bool _FECalculation;
232         int _Nnodes;/* number of nodes for FE calculation */
233         int _neibMaxNbNodes;/* maximum number of nodes around a node */
234         int _NunknownNodes;/* number of unknown nodes for FE calculation */
235         int _NboundaryNodes;/* total number of boundary nodes */
236         int _NdirichletNodes;/* number of boundary nodes with Dirichlet BC for FE calculation */
237     std::vector< int > _boundaryNodeIds;/* List of boundary nodes */
238     std::vector< int > _dirichletNodeIds;/* List of boundary nodes with Dirichlet BC */
239
240     /********* Possibility to set a boundary field as DirichletNeumann boundary condition *********/
241     bool _dirichletValuesSet;
242     bool _neumannValuesSet;
243     std::map< int, double> _dirichletBoundaryValues;
244     std::map< int, double> _neumannBoundaryValues;
245
246         /**** MPI related variables ***/
247         PetscMPIInt    _mpi_size;        /* size of communicator */
248         PetscMPIInt    _mpi_rank;        /* processor rank */
249         VecScatter _scat;                       /* For the distribution of a local vector */
250         int _globalNbUnknowns, _localNbUnknowns;
251         int _d_nnz, _o_nnz;                     /* local and "non local" numbers of non zeros corfficients */
252 };
253
254 #endif /* StationaryDiffusionEquation_HXX_ */