diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/Condensation.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/Condensation.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/Condensation.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/Condensation.mo"	2022-03-10 09:58:17.116149083 +0000
@@ -7,13 +7,13 @@
   Medium.ThermodynamicState state "State of fluid at infinite conditions";
   
   // User defined parameters
-  parameter Modelica.SIunits.Area A = 1 "Wall surface area";
+  parameter Modelica.Units.SI.Area A = 1 "Wall surface area";
   parameter Real add_on = 1 "add on mass transfer coefficient";
   
   // Internal variables
-  Modelica.SIunits.MassFlowRate m_flow "Mass flow rate >0 if condensation";
-  Modelica.SIunits.SpecificHeatCapacityAtConstantPressure cp "Specific Heat Capacity";
-  Modelica.SIunits.Density d_sat "Saturation density of the condensable species";
+  Modelica.Units.SI.MassFlowRate m_flow "Mass flow rate >0 if condensation";
+  Modelica.Units.SI.SpecificHeatCapacityAtConstantPressure cp "Specific Heat Capacity";
+  Modelica.Units.SI.Density d_sat "Saturation density of the condensable species";
   Real betaV(unit = "m/s") "mass transfer coefficient";
 
   // Imported Modules
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/FreeAeraulicConvection.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/FreeAeraulicConvection.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/FreeAeraulicConvection.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/FreeAeraulicConvection.mo"	2022-03-10 09:58:17.084149079 +0000
@@ -4,7 +4,7 @@
 
   import TAeZoSysPro.HeatTransfer.Types.FreeConvectionCorrelation ;
   import TAeZoSysPro.HeatTransfer.Functions.FreeConvection ;
-  import SI = Modelica.SIunits ;
+  import Modelica.Units.SI;
   //
   replaceable package Medium = TAeZoSysPro.Media.MyMedia ;
   // User defined parameters
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/FreeConvection.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/FreeConvection.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/FreeConvection.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/FreeConvection.mo"	2022-03-10 09:58:17.040149073 +0000
@@ -4,7 +4,7 @@
 
   import Correlations = TAeZoSysPro.HeatTransfer.Types.FreeConvectionCorrelation ;
   import Functions = TAeZoSysPro.HeatTransfer.Functions.FreeConvection ;
-  import SI = Modelica.SIunits ;
+  import Modelica.Units.SI;
   //
   replaceable package Medium = TAeZoSysPro.Media.MyMedia;
   // User defined parameters
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/GasNode.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/GasNode.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/GasNode.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/GasNode.mo"	2022-03-10 09:58:17.024149070 +0000
@@ -4,7 +4,7 @@
   // additionnal package
     import Modelica.Fluid.Types;
     import Modelica.Fluid.Types.Dynamics;
-    import SI = Modelica.SIunits ; 
+    import Modelica.Units.SI; 
 // Medium declaration
     replaceable package Medium = TAeZoSysPro.Media.MyMedia;
     Medium.BaseProperties medium(preferredMediumStates = (if energyDynamics == Dynamics.SteadyState and massDynamics == Dynamics.SteadyState then false else true));
@@ -55,12 +55,11 @@
 protected
     Real[Medium.nC] mC_scaled(min=fill(Modelica.Constants.eps, Medium.nC)) "Scaled masses of trace substances in the fluid";
     parameter Medium.ExtraProperty C_start[Medium.nC](quantity=Medium.extraPropertiesNames) = Medium.C_default;
-       
-//    parameter Medium.MassFraction X_start[Medium.nX] = if Medium.mediumName == "Moist air" then 
-//                                                        cat(1, {Medium.massFraction_pTphi(p = p_start, T = T_start, phi = RH_start)}, {1-Medium.massFraction_pTphi(p = p_start, T = T_start, phi = RH_start)})
-//                                                       else 
-//                                                        Medium.X_default ;
-    parameter Medium.MassFraction X_start[Medium.nX] = Medium.X_default ;
+       //    parameter Medium.MassFraction X_start[Medium.nX] = if Medium.mediumName == "Moist air" then
+  //                                                        cat(1, {Medium.massFraction_pTphi(p = p_start, T = T_start, phi = RH_start)}, {1-Medium.massFraction_pTphi(p = p_start, T = T_start, phi = RH_start)})
+  //                                                       else
+  //                                                        Medium.X_default ;
+  parameter Medium.MassFraction X_start[Medium.nX] = Medium.X_default ;
 protected 
 
 initial equation
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/GasNode_two_phases.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/GasNode_two_phases.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/GasNode_two_phases.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/GasNode_two_phases.mo"	2022-03-10 09:58:16.996149068 +0000
@@ -1,17 +1,17 @@
-﻿within TAeZoSysPro.FluidDynamics.BasesClasses;
+within TAeZoSysPro.FluidDynamics.BasesClasses;
 model GasNode_two_phases
   model FogModel
-    Modelica.SIunits.Density d_condensable "Density of the condensable species";
-    Modelica.SIunits.Density d_sat "Saturation density of the condensable species";
-    Modelica.SIunits.Pressure p_sat "Saturation pressure of the condensable species";
-    Modelica.SIunits.Diameter d_drop "Diameter of equivalent droplet";
-    Modelica.SIunits.Velocity Vel "Velocity of droplet";
-    parameter Modelica.SIunits.Area A "Surface area through which fog drains";
-    Modelica.SIunits.MassFlowRate m_flow_fog "Mass flow rate of droplet leaving the control volume";
-    Modelica.SIunits.ReynoldsNumber Re "Reynolds number";
+    Modelica.Units.SI.Density d_condensable "Density of the condensable species";
+    Modelica.Units.SI.Density d_sat "Saturation density of the condensable species";
+    Modelica.Units.SI.Pressure p_sat "Saturation pressure of the condensable species";
+    Modelica.Units.SI.Diameter d_drop "Diameter of equivalent droplet";
+    Modelica.Units.SI.Velocity Vel "Velocity of droplet";
+    parameter Modelica.Units.SI.Area A "Surface area through which fog drains";
+    Modelica.Units.SI.MassFlowRate m_flow_fog "Mass flow rate of droplet leaving the control volume";
+    Modelica.Units.SI.ReynoldsNumber Re "Reynolds number";
     input Medium.ThermodynamicState state;
-    constant Modelica.SIunits.Density d_liquidPhase = 1000 "Density of the liquid phase of the condensation species";
-    parameter Modelica.SIunits.NumberDensityOfMolecules n_drops = 150 * 1e6 "Number density of droplets in fog";
+    constant Modelica.Units.SI.Density d_liquidPhase = 1000 "Density of the liquid phase of the condensation species";
+    parameter Modelica.Units.SI.NumberDensityOfMolecules n_drops = 150 * 1e6 "Number density of droplets in fog";
   equation
     // Temporary equations
     d_condensable = Medium.density(state) * state.X[Medium.Water];
@@ -128,7 +128,7 @@
   // additionnal package
   import Modelica.Fluid.Types;
   import Modelica.Fluid.Types.Dynamics;
-  import SI = Modelica.SIunits;
+  import Modelica.Units.SI;
   // Medium declaration
   replaceable package Medium = TAeZoSysPro.Media.MyMedia;
   Medium.BaseProperties medium(preferredMediumStates = if energyDynamics == Dynamics.SteadyState and massDynamics == Dynamics.SteadyState then false else true);
@@ -153,7 +153,7 @@
   parameter Integer nPorts = 0 "Number of fluidport" annotation (
     Dialog(connectorSizing = true));
   parameter SI.Volume V = 1 "Geometric Volume of the gas node";
-  parameter Modelica.SIunits.Area A = V ^ (2 / 3)  "Surface area through which fog drains";
+  parameter Modelica.Units.SI.Area A = V ^ (2 / 3)  "Surface area through which fog drains";
   // Internal variables
   // Potential variables
   SI.Mass m "Mass of mixture";
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/Interface_liq_gas.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/Interface_liq_gas.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/Interface_liq_gas.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/Interface_liq_gas.mo"	2022-03-10 09:58:16.940149060 +0000
@@ -1,7 +1,7 @@
 within TAeZoSysPro.FluidDynamics.BasesClasses;
 
 model Interface_liq_gas
-  import SI = Modelica.SIunits;
+  import Modelica.Units.SI;
 //
   replaceable package Medium = TAeZoSysPro.Media.MyMedia;
   replaceable package MediumLiquid = Modelica.Media.Water.WaterIF97_ph;  
@@ -12,8 +12,8 @@
     Dialog(group = "Geometrical properties"));
   parameter SI.Emissivity eps = 0.96 "Emissivity of liquid interface" annotation(
     Dialog(group = "Geometrical properties"));
-  parameter Modelica.SIunits.NumberDensityOfMolecules n_bubbles = 150 * 1e6 "Number density of bubble in node" ;
-  constant Modelica.SIunits.CoefficientOfFriction Cx = 0.47 "drag coefficient for a sphere" ;
+  parameter Modelica.Units.SI.NumberDensityOfMolecules n_bubbles = 150 * 1e6 "Number density of bubble in node" ;
+  constant Modelica.Units.SI.CoefficientOfFriction Cx = 0.47 "drag coefficient for a sphere" ;
     
 // Internal variables
   //for convection
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/LiquidNode.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/LiquidNode.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/LiquidNode.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/LiquidNode.mo"	2022-03-10 09:58:16.872149051 +0000
@@ -4,7 +4,7 @@
   // additionnal package
   import Modelica.Fluid.Types;
   import Modelica.Fluid.Types.Dynamics;
-  import SI = Modelica.SIunits;
+  import Modelica.Units.SI;
   // Medium declaration
   replaceable package Medium = Modelica.Media.Water.WaterIF97_ph;
   replaceable package MediumGas = TAeZoSysPro.Media.MyMedia;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/MolecularDiffusion.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/MolecularDiffusion.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/MolecularDiffusion.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/BasesClasses/MolecularDiffusion.mo"	2022-03-10 09:58:16.836149048 +0000
@@ -5,19 +5,19 @@
   replaceable package Medium = TAeZoSysPro.Media.MyMedia;
 
   // User defined parameters
-  parameter Modelica.SIunits.Thickness Th = 1 "Thickness between concentration potential difference";
-  parameter Modelica.SIunits.CrossSection A = 0;
-  parameter Modelica.SIunits.DiffusionCoefficient D=25*1e-6;
+  parameter Modelica.Units.SI.Thickness Th = 1 "Thickness between concentration potential difference";
+  parameter Modelica.Units.SI.CrossSection A = 0;
+  parameter Modelica.Units.SI.DiffusionCoefficient D=25*1e-6;
 
   // Internal variables
   Real grad_X[Medium.nX](each quantity="spatial gradient",each unit="m-1") "gradient of mass fraction";
-  Modelica.SIunits.MassFlowRate[Medium.nX] m_flow;
-  Modelica.SIunits.Density d_mean;
-  Modelica.SIunits.Temperature T_mean;
-  Modelica.SIunits.SpecificEnthalpy[Medium.nX] h;
+  Modelica.Units.SI.MassFlowRate[Medium.nX] m_flow;
+  Modelica.Units.SI.Density d_mean;
+  Modelica.Units.SI.Temperature T_mean;
+  Modelica.Units.SI.SpecificEnthalpy[Medium.nX] h;
   Real J[Medium.nX](each quantity="mass flux rate",each unit="kg.m-2.s-1") "Gradient of mass fraction";
-  Modelica.SIunits.MassFraction[Medium.nX] X_a;
-  Modelica.SIunits.MassFraction[Medium.nX]      X_b;
+  Modelica.Units.SI.MassFraction[Medium.nX] X_a;
+  Modelica.Units.SI.MassFraction[Medium.nX]      X_b;
 
   // Imported modules
   TAeZoSysPro.FluidDynamics.Interfaces.FlowPort_a flowPort_a(redeclare package   Medium = Medium) annotation (
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/BurstMembrane.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/BurstMembrane.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/BurstMembrane.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/BurstMembrane.mo"	2022-03-10 09:58:16.660149025 +0000
@@ -4,11 +4,11 @@
    replaceable package Medium = TAeZoSysPro.Media.MyMedia "Medium in the component" annotation (choicesAllMatching = true);
 
    // User defined parameters
-   parameter Modelica.SIunits.PressureDifference dp_burst = 7000 "Pressure difference to which the disk burst";
+   parameter Modelica.Units.SI.PressureDifference dp_burst = 7000 "Pressure difference to which the disk burst";
 
    // Internal variables
    Boolean bursted "Bursted membrane" ;
-   Modelica.SIunits.PressureDifference dp ;
+   Modelica.Units.SI.PressureDifference dp ;
    Medium.MassFlowRate m_flow ;
 
    // Imported modules
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/HalfWall.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/HalfWall.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/HalfWall.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/HalfWall.mo"	2022-03-10 09:58:16.648149024 +0000
@@ -13,25 +13,25 @@
     Dialog(group = "Meshing properties"));
   parameter Real q = 1.2 "Growth rate (if geometricalGrowth chosen)" annotation(
     Dialog(group = "Meshing properties"));
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h = 10 "Decoupled value of the heat transfer (if biot segment chosen)" annotation(
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h = 10 "Decoupled value of the heat transfer (if biot segment chosen)" annotation(
     Dialog(group = "Meshing properties"));
   parameter Integer N(min = 2) = integer(max(2, 5 * Th / 0.2 * 1e-6 * d * cp / k)) "Number of layers : 2 to 65535" annotation(
     Dialog(group = "Meshing properties"));
-  parameter Modelica.SIunits.Area A = 0 "Wall area " annotation(
+  parameter Modelica.Units.SI.Area A = 0 "Wall area " annotation(
     Dialog(group = "Geometrical properties"));
-  parameter Modelica.SIunits.Height Lc = 0 "Wall characteristic length" annotation(
+  parameter Modelica.Units.SI.Height Lc = 0 "Wall characteristic length" annotation(
     Dialog(group = "Geometrical properties"));
-  parameter Modelica.SIunits.Length Th = 0 "Wall thickness" annotation(
+  parameter Modelica.Units.SI.Length Th = 0 "Wall thickness" annotation(
     Dialog(group = "Geometrical properties"));
   parameter Dynamics energyDynamics = Dynamics.SteadyStateInitial "Formulation of energy balance" annotation(
     Dialog(group = "Dynamic properties"));
-  parameter Modelica.SIunits.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
+  parameter Modelica.Units.SI.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
     Dialog(group = "Dynamic properties"));
-  parameter Modelica.SIunits.SpecificHeatCapacity cp = 0 "Wall specific heat capacity" annotation(
+  parameter Modelica.Units.SI.SpecificHeatCapacity cp = 0 "Wall specific heat capacity" annotation(
     Dialog(group = "Thermal properties"));
-  parameter Modelica.SIunits.Density d(displayUnit = "kg/m3") = 0 "Wall density" annotation(
+  parameter Modelica.Units.SI.Density d(displayUnit = "kg/m3") = 0 "Wall density" annotation(
     Dialog(group = "Thermal properties"));
-  parameter Modelica.SIunits.ThermalConductivity k = 0 "Wall conductivity" annotation(
+  parameter Modelica.Units.SI.ThermalConductivity k = 0 "Wall conductivity" annotation(
     Dialog(group = "Thermal properties"));
   parameter Real add_on_conv = 1 "Custom add-on for convection" annotation(
     Dialog(group = "Convection properties"));
@@ -39,15 +39,15 @@
     Dialog(group = "Convection properties"));
   parameter TAeZoSysPro.HeatTransfer.Types.FreeConvectionCorrelation correlation = Correlations.vertical_plate_ASHRAE "free convection Correlation" annotation(
     Dialog(group = "Convection properties"));
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h_cv_const = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h_cv_const = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
     Dialog(group = "Convection properties"));
   //
-  parameter Modelica.SIunits.Emissivity eps = 0 "Wall emissivity " annotation(
+  parameter Modelica.Units.SI.Emissivity eps = 0 "Wall emissivity " annotation(
     Dialog(group = "Radiative properties"));
   parameter Real add_on_rad = 1 "Custom add-on" annotation(
     Dialog(group = "Radiative properties"));
   // Internal variables
-  Modelica.SIunits.BiotNumber Bi;
+  Modelica.Units.SI.BiotNumber Bi;
   // Components inside wall are defined
   TAeZoSysPro.HeatTransfer.BasesClasses.PartialWall partialWall(A = A, N = N, T_start = T_start, Th = Th, cp = cp, d = d, energyDynamics = energyDynamics, h = h, k = k, mesh = mesh, q = q, symmetricalMesh = false) annotation(
     Placement(visible = true, transformation(origin = {46.5, 0.5}, extent = {{-29.5, -29.5}, {29.5, 29.5}}, rotation = 0)));
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/InertMass.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/InertMass.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/InertMass.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/InertMass.mo"	2022-03-10 09:58:16.612149018 +0000
@@ -9,21 +9,21 @@
 //Media
   replaceable package Medium = TAeZoSysPro.Media.MyMedia ;
   // User defined parameters
-  parameter Modelica.SIunits.Area A_conv = 0 "Convective surface area " annotation(
+  parameter Modelica.Units.SI.Area A_conv = 0 "Convective surface area " annotation(
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Area A_rad = A_conv "Radiative surface area " annotation(
+  parameter Modelica.Units.SI.Area A_rad = A_conv "Radiative surface area " annotation(
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Length Lc = 1 "characteritic dimension for correlation" annotation(
+  parameter Modelica.Units.SI.Length Lc = 1 "characteritic dimension for correlation" annotation(
   Dialog(group="Geometrical properties"));
    
   parameter Dynamics energyDynamics = Dynamics.SteadyStateInitial "Formulation of energy balance" annotation(
   Dialog(group="Dynamic properties"));
-  parameter Modelica.SIunits.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
+  parameter Modelica.Units.SI.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
   Dialog(group="Dynamic properties"));
   
-  parameter Modelica.SIunits.SpecificHeatCapacity cp = 0 "Specific heat capacity" annotation(
+  parameter Modelica.Units.SI.SpecificHeatCapacity cp = 0 "Specific heat capacity" annotation(
   Dialog(group="Thermal properties"));
-  parameter Modelica.SIunits.Mass m= 0 "Mass of the component" annotation(
+  parameter Modelica.Units.SI.Mass m= 0 "Mass of the component" annotation(
   Dialog(group="Thermal properties"));
   
   parameter Real add_on_conv = 1 "Custom add-on for convection" annotation(
@@ -32,10 +32,10 @@
     Dialog(group = "Convection properties"));
   parameter TAeZoSysPro.HeatTransfer.Types.FreeConvectionCorrelation correlation = Correlations.vertical_plate_ASHRAE "free convection Correlation" annotation(
     Dialog(group = "Convection properties"));
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h_cv_const = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h_cv_const = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
     Dialog(group = "Convection properties"));
   //
-  parameter Modelica.SIunits.Emissivity eps = 0 "Wall emissivity " annotation(
+  parameter Modelica.Units.SI.Emissivity eps = 0 "Wall emissivity " annotation(
     Dialog(group = "Radiative properties"));
   parameter Real add_on_rad = 1 "Custom add-on" annotation(
     Dialog(group = "Radiative properties"));
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/Wall.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/Wall.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/Wall.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/Wall.mo"	2022-03-10 09:58:16.560149012 +0000
@@ -15,28 +15,28 @@
   Dialog(group="Meshing properties"));
   parameter Real q = 1.2 "Growth rate (if geometricalGrowth chosen)" annotation(
   Dialog(group="Meshing properties"));
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h = 10 "Decoupled value of the heat transfer (if biot segment chosen)" annotation(
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h = 10 "Decoupled value of the heat transfer (if biot segment chosen)" annotation(
   Dialog(group="Meshing properties"));  
   parameter Integer N(min=2) = integer(max(2, 5 * Th / 0.2 * 1e-6 * d * cp / k)) "Number of layers : 2 to 65535" annotation(
   Dialog(group="Meshing properties"));
   
-  parameter Modelica.SIunits.Area A = 0 "Wall area " annotation(
+  parameter Modelica.Units.SI.Area A = 0 "Wall area " annotation(
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Height Lc = 0 "Wall characteristic length" annotation(
+  parameter Modelica.Units.SI.Height Lc = 0 "Wall characteristic length" annotation(
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Length Th = 0 "Wall thickness" annotation(
+  parameter Modelica.Units.SI.Length Th = 0 "Wall thickness" annotation(
   Dialog(group="Geometrical properties"));
   
   parameter Dynamics energyDynamics = Dynamics.SteadyStateInitial "Formulation of energy balance" annotation(
   Dialog(group="Dynamic properties"));
-  parameter Modelica.SIunits.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
+  parameter Modelica.Units.SI.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
   Dialog(group="Dynamic properties"));
   
-  parameter Modelica.SIunits.SpecificHeatCapacity cp = 0 "Wall specific heat capacity" annotation(
+  parameter Modelica.Units.SI.SpecificHeatCapacity cp = 0 "Wall specific heat capacity" annotation(
   Dialog(group="Thermal properties"));
-  parameter Modelica.SIunits.Density d(displayUnit="kg/m3") = 0 "Wall density" annotation(
+  parameter Modelica.Units.SI.Density d(displayUnit="kg/m3") = 0 "Wall density" annotation(
   Dialog(group="Thermal properties"));
-  parameter Modelica.SIunits.ThermalConductivity k = 0 "Wall conductivity" annotation(
+  parameter Modelica.Units.SI.ThermalConductivity k = 0 "Wall conductivity" annotation(
   Dialog(group="Thermal properties"));
   
   parameter Real add_on_conv = 1 "Custom add-on for convection" annotation(
@@ -47,21 +47,21 @@
     Dialog(group = "Convection properties"));
   parameter TAeZoSysPro.HeatTransfer.Types.FreeConvectionCorrelation correlation_b = if correlation_a == Correlations.ceiling_ASHRAE then Correlations.ground_ASHRAE elseif correlation_a == Correlations.ground_ASHRAE then Correlations.ceiling_ASHRAE else correlation_a "free convection Correlation" annotation(
     Dialog(group = "Convection properties"));
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h_cv_const_a = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h_cv_const_a = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
     Dialog(group = "Convection properties"));
   
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h_cv_const_b = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h_cv_const_b = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
     Dialog(group = "Convection properties"));
   //
-  parameter Modelica.SIunits.Emissivity eps_a = 0 "Wall emissivity " annotation(
+  parameter Modelica.Units.SI.Emissivity eps_a = 0 "Wall emissivity " annotation(
     Dialog(group = "Radiative properties"));
-  parameter Modelica.SIunits.Emissivity eps_b = 0 "Wall emissivity " annotation(
+  parameter Modelica.Units.SI.Emissivity eps_b = 0 "Wall emissivity " annotation(
     Dialog(group = "Radiative properties"));
   parameter Real add_on_rad = 1 "Custom add-on" annotation(
     Dialog(group = "Radiative properties"));
 
 // Internal variables
-  Modelica.SIunits.BiotNumber Bi_a, Bi_b ;
+  Modelica.Units.SI.BiotNumber Bi_a, Bi_b ;
 
 // Components inside wall are defined
   TAeZoSysPro.HeatTransfer.BasesClasses.PartialWall partialWall(A = A, N = N, T_start = T_start, Th = Th, cp = cp, d = d, energyDynamics = energyDynamics, h = h, k = k, mesh = mesh, q = q, symmetricalMesh = true)  annotation(
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/WallLeaks.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/WallLeaks.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/WallLeaks.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Buildings/WallLeaks.mo"	2022-03-10 09:58:16.456148998 +0000
@@ -3,7 +3,7 @@
 model WallLeaks
   package Medium = TAeZoSysPro.Media.MyMedia;
   //
-  parameter Modelica.SIunits.Area A "Wall surface area" annotation(
+  parameter Modelica.Units.SI.Area A "Wall surface area" annotation(
     Dialog(group = "Geometry"));
   parameter Real leakSurfaceRatio(min=0.0, max=1.0) = 1e-4 "ratio of leak surface m²leak / m²wall" annotation(
     Dialog(group = "Geometry"));
@@ -13,18 +13,18 @@
   parameter Real leakExponent = 1.35 "Exponent for Behavior model of the leak" annotation(
     Dialog(group = "Flow"));
   //
-  Modelica.SIunits.PressureDifference dp;
-  Modelica.SIunits.MassFlowRate m_flow "Mass flow rate through the leak(s)";
-  Modelica.SIunits.Density d, d_a, d_b;
+  Modelica.Units.SI.PressureDifference dp;
+  Modelica.Units.SI.MassFlowRate m_flow "Mass flow rate through the leak(s)";
+  Modelica.Units.SI.Density d, d_a, d_b;
   //
   Modelica.Fluid.Interfaces.FluidPort_a port_a(replaceable package Medium = Medium) annotation(
     Placement(visible = true, transformation(origin = {-100, 50}, extent = {{-10, -10}, {10, 10}}, rotation = 0), iconTransformation(origin = {-100, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
   Modelica.Fluid.Interfaces.FluidPort_b port_b(replaceable package Medium = Medium) annotation(
     Placement(visible = true, transformation(origin = {100, 50}, extent = {{-10, -10}, {10, 10}}, rotation = 0), iconTransformation(origin = {100, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
 
-protected 
-  parameter Modelica.SIunits.PressureDifference dp_small = 0.01;
-
+protected
+ 
+  parameter Modelica.Units.SI.PressureDifference dp_small = 0.01;
 equation
 //
   d_a = Medium.density_phX(p = port_a.p, 
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Filters/Filter.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Filters/Filter.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Filters/Filter.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Filters/Filter.mo"	2022-03-10 09:58:16.432148996 +0000
@@ -7,15 +7,15 @@
   // User defined parameters
   parameter Real K(unit = "m3/(s.Pa)") = V_flow_nominal / dp_nominal "linear pressure loss coefficient" annotation (
     Dialog(group = "Flow"));
-  parameter Modelica.SIunits.Pressure dp_nominal "Nominal pressure drop" annotation(
+  parameter Modelica.Units.SI.Pressure dp_nominal "Nominal pressure drop" annotation(
   Dialog(group="Nominal operating point"));
-  parameter Modelica.SIunits.VolumeFlowRate V_flow_nominal "Nominal volume flowrate" annotation(
+  parameter Modelica.Units.SI.VolumeFlowRate V_flow_nominal "Nominal volume flowrate" annotation(
   Dialog(group="Nominal operating point"));
   
   // Internal variables
-  Modelica.SIunits.PressureDifference dp;
-  Modelica.SIunits.MassFlowRate m_flow "Aperture flow kg/s";
-  Modelica.SIunits.Density d;
+  Modelica.Units.SI.PressureDifference dp;
+  Modelica.Units.SI.MassFlowRate m_flow "Aperture flow kg/s";
+  Modelica.Units.SI.Density d;
   
   // Imported modules
   Modelica.Fluid.Interfaces.FluidPort_a port_a(redeclare package Medium = Medium) annotation (
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/HeatExchangers/AnalyticExchanger.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/HeatExchangers/AnalyticExchanger.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/HeatExchangers/AnalyticExchanger.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/HeatExchangers/AnalyticExchanger.mo"	2022-03-10 09:58:16.392148990 +0000
@@ -6,7 +6,7 @@
   import TAeZoSysPro.HeatTransfer.Functions.ExchangerEffectiveness ;
   import TAeZoSysPro.HeatTransfer.Functions.ExchangerHeatTransferCoeff ;  
   //
-  import SI = Modelica.SIunits ;
+  import Modelica.Units.SI;
   
   // Medium declaration
   replaceable package MediumA = TAeZoSysPro.Media.MyMedia ;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/HeatExchangers/DiscreteExchanger.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/HeatExchangers/DiscreteExchanger.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/HeatExchangers/DiscreteExchanger.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/HeatExchangers/DiscreteExchanger.mo"	2022-03-10 09:58:16.372148988 +0000
@@ -7,7 +7,7 @@
   import TAeZoSysPro.HeatTransfer.Functions.ExchangerEffectiveness ;
   import TAeZoSysPro.HeatTransfer.Functions.ExchangerHeatTransferCoeff ;  
 //
-  import SI = Modelica.SIunits ;
+  import Modelica.Units.SI;
   // Medium declaration
   replaceable package MediumA = TAeZoSysPro.Media.MyMedia ;
   replaceable package MediumB = TAeZoSysPro.Media.MyMedia ;
@@ -15,9 +15,9 @@
   replaceable function effectiveness = ExchangerEffectiveness.counterCurrent ;
   replaceable function heatTransferCoeff = ExchangerHeatTransferCoeff.user_defined ;
   // User defined parameters
-  parameter Modelica.SIunits.Area A = 1.0 "equivalent exchange surface area" annotation(Dialog(group="Geometrical parameters"));
-  parameter Modelica.SIunits.Length L_A = 1.0 "Length of the side A of the exchanger" annotation(Dialog(group="Geometrical parameters"));
-  parameter Modelica.SIunits.Length L_B = 1.0 "Length of the side B of the exchanger" annotation(Dialog(group="Geometrical parameters"));
+  parameter Modelica.Units.SI.Area A = 1.0 "equivalent exchange surface area" annotation(Dialog(group="Geometrical parameters"));
+  parameter Modelica.Units.SI.Length L_A = 1.0 "Length of the side A of the exchanger" annotation(Dialog(group="Geometrical parameters"));
+  parameter Modelica.Units.SI.Length L_B = 1.0 "Length of the side B of the exchanger" annotation(Dialog(group="Geometrical parameters"));
   parameter SI.Area CrossSectionA = 1 "Cross section of the pipe for the fluid A" annotation(Dialog(group="Geometrical parameters")) ; 
   parameter SI.Area CrossSectionB = 1 "Cross section of the pipe for the fluid B" annotation(Dialog(group="Geometrical parameters"));
   parameter Real ksi_fixedA = 1.0 annotation(Dialog(group="Flow parameters"));
@@ -25,12 +25,12 @@
   parameter Integer N = 3 "Number of discrete layers" ;
   parameter FlowConfiguration flowConfiguration = FlowConfiguration.CounterCurrent ;
   // Internal variables
-  Modelica.SIunits.ThermalConductance Qc_A(min=0) "Thermal flow rate unit of fluid A";
-  Modelica.SIunits.ThermalConductance Qc_B(min=0) "Thermal flow rate unit of fluid B";
-  Modelica.SIunits.Temperature T_A_in, T_A_out, T_B_in, T_B_out;
-  Modelica.SIunits.CoefficientOfHeatTransfer h_global "Heat transfer coeffcient between fluid A and B" ;
-  Modelica.SIunits.HeatFlowRate Q_flow "Heat flow exchanged";
-  Modelica.SIunits.Energy E "Energy passed throught the component" ;
+  Modelica.Units.SI.ThermalConductance Qc_A(min=0) "Thermal flow rate unit of fluid A";
+  Modelica.Units.SI.ThermalConductance Qc_B(min=0) "Thermal flow rate unit of fluid B";
+  Modelica.Units.SI.Temperature T_A_in, T_A_out, T_B_in, T_B_out;
+  Modelica.Units.SI.CoefficientOfHeatTransfer h_global "Heat transfer coeffcient between fluid A and B" ;
+  Modelica.Units.SI.HeatFlowRate Q_flow "Heat flow exchanged";
+  Modelica.Units.SI.Energy E "Energy passed throught the component" ;
   MediumA.ThermodynamicState stateA_in "State of fluid A a inlet"  ;
   MediumB.ThermodynamicState stateB_in "State of fluid B a inlet"  ;
   SI.SpecificHeatCapacity cp_A ;
@@ -101,9 +101,8 @@
     k1 = 2 * MediumB.density(stateB_in) / ksi_fixedB, 
     k2 = 2 * MediumB.density(stateB_in) / ksi_fixedB);
     dp_B = port_B_in.p - port_B_out.p;
-    
-// transport 
-  // boundary equations
+// transport
+// boundary equations
   transport_A.u_ghost_left[1] = T_A_in "left BC";
   transport_B.u_ghost_left[1] = T_B_in "left BC";
   transport_A.u_ghost_right[1] = T_A_in "right BC";
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/BaseClasses/PartialPump.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/BaseClasses/PartialPump.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/BaseClasses/PartialPump.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/BaseClasses/PartialPump.mo"	2022-03-10 09:58:16.304148979 +0000
@@ -10,7 +10,7 @@
   parameter Boolean checkValve = false "= true to prevent reverse flow" annotation(
     Dialog(group = "Assumptions"),
     Evaluate = true) ;
-  parameter Modelica.SIunits.Conversions.NonSIunits.AngularVelocity_rpm N_nominal "Nominal rotational speed for flow characteristic" annotation(
+  parameter Modelica.Units.NonSI.AngularVelocity_rpm N_nominal "Nominal rotational speed for flow characteristic" annotation(
   Dialog(group="Characteristics"));
   parameter Medium.Density d_nominal = Medium.density_pTX(Medium.p_default, Medium.T_default, Medium.X_default) "Nominal fluid density for characteristic" annotation(
   Dialog(group="Characteristics"));
@@ -35,14 +35,14 @@
                choicesAllMatching=true);
    
 // Internal variables
-  Modelica.SIunits.VolumeFlowRate V_flow "Volume flow rate at port_a" ;
-  Modelica.SIunits.MassFlowRate m_flow "Mass flow rate" ;
-  Modelica.SIunits.Power P "Power given to the fluid" ;
-  Modelica.SIunits.Density d "Density at port_a";
-  Modelica.SIunits.Position head "Pump head";
-  Modelica.SIunits.PressureDifference dp "Pressure difference between port_a and port_b" ;
-  Modelica.SIunits.Efficiency eta "Isentropic efficiency" ;
-  Modelica.SIunits.Conversions.NonSIunits.AngularVelocity_rpm N "Shaft rotational speed";
+  Modelica.Units.SI.VolumeFlowRate V_flow "Volume flow rate at port_a" ;
+  Modelica.Units.SI.MassFlowRate m_flow "Mass flow rate" ;
+  Modelica.Units.SI.Power P "Power given to the fluid" ;
+  Modelica.Units.SI.Density d "Density at port_a";
+  Modelica.Units.SI.Position head "Pump head";
+  Modelica.Units.SI.PressureDifference dp "Pressure difference between port_a and port_b" ;
+  Modelica.Units.SI.Efficiency eta "Isentropic efficiency" ;
+  Modelica.Units.NonSI.AngularVelocity_rpm N "Shaft rotational speed";
   Medium.ThermodynamicState state "State at inlet" ;
   // Imported components
   Modelica.Fluid.Interfaces.FluidPort_a port_a(redeclare package Medium = Medium, m_flow(min = if not checkValve then -Constants.inf else 0)) annotation(
@@ -50,7 +50,7 @@
   Modelica.Fluid.Interfaces.FluidPort_b port_b(redeclare package Medium = Medium, m_flow(max = if not checkValve then +Constants.inf else 0)) annotation(
     Placement(visible = true, transformation(origin = {100, -2}, extent = {{-10, -10}, {10, 10}}, rotation = 0), iconTransformation(origin = {100, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
 
-  constant Modelica.SIunits.Acceleration g = Constants.g_n ;
+  constant Modelica.Units.SI.Acceleration g = Constants.g_n ;
 equation
 // Temporary variables
   
@@ -62,8 +62,7 @@
   d = Medium.density(state) ;
   head = -dp/(d*g) ;
   head = (N/N_nominal)^2*flowCharacteristic(V_flow*N_nominal/N) ;
-  //V_flow = flowCharacteristic(head) ;  
-
+//V_flow = flowCharacteristic(head) ;
 // Power consumption
   if use_powerCharacteristic then
     P = (N/N_nominal)^2*(d/d_nominal)*powerCharacteristic(V_flow*(N_nominal/N));
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/BaseClasses/PumpCharacteristics/polynomialFlow.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/BaseClasses/PumpCharacteristics/polynomialFlow.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/BaseClasses/PumpCharacteristics/polynomialFlow.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/BaseClasses/PumpCharacteristics/polynomialFlow.mo"	2022-03-10 09:58:16.268148976 +0000
@@ -5,19 +5,19 @@
 
   extends Modelica.Fluid.Machines.BaseClasses.PumpCharacteristics.baseFlow ;
 
-  input Modelica.SIunits.VolumeFlowRate V_flow_nominal[:]
+  input Modelica.Units.SI.VolumeFlowRate V_flow_nominal[:]
       "Volume flow rate for N operating points (single pump)" annotation(Dialog);
-  input Modelica.SIunits.Position head_nominal[:] "Pump head for N operating points" annotation(Dialog);
+  input Modelica.Units.SI.Position head_nominal[:] "Pump head for N operating points" annotation(Dialog);
   input Integer OrderPolyFitting(max = 3) = 3 "Order of the polynom that fits the fan curve";
   
   protected
   Integer N = size(V_flow_nominal,1) "Number of nominal operating points";
   Real[OrderPolyFitting + 1] coeff "[^0,^1,^2,...,^OrderPolyFitting]";
   Real[N, OrderPolyFitting + 1] A ;
-  Modelica.SIunits.VolumeFlowRate V_flow_min = min(V_flow_nominal);
-  Modelica.SIunits.VolumeFlowRate V_flow_max = max(V_flow_nominal);
-  Modelica.SIunits.Position head_min "Head from the fitting at V_flow_min ";
-  Modelica.SIunits.Position head_max "Head from the fitting at V_flow_max ";
+  Modelica.Units.SI.VolumeFlowRate V_flow_min = min(V_flow_nominal);
+  Modelica.Units.SI.VolumeFlowRate V_flow_max = max(V_flow_nominal);
+  Modelica.Units.SI.Position head_min "Head from the fitting at V_flow_min ";
+  Modelica.Units.SI.Position head_max "Head from the fitting at V_flow_max ";
   Real poly ; 
 
 algorithm
@@ -35,66 +35,60 @@
 // Compute the coefficient to fit the curve
   
 coeff := Modelica.Math.Matrices.leastSquares(A = A, b = head_nominal);
-
-// Compute the minimal head with the fitting coefficients  
-  poly := coeff[OrderPolyFitting+1] ;
+// Compute the minimal head with the fitting coefficients
+  poly := coeff[OrderPolyFitting + 1];
   for i in 1:OrderPolyFitting loop
     poly := poly * V_flow_min + coeff[OrderPolyFitting+1-i] ;
   end for ; 
   head_min := poly ;
-
-// Compute the maximal head with the fitting coefficients  
-  poly := coeff[OrderPolyFitting+1] ;
+// Compute the maximal head with the fitting coefficients
+  poly := coeff[OrderPolyFitting + 1];
   for i in 1:OrderPolyFitting loop
     poly := poly * V_flow_max + coeff[OrderPolyFitting+1-i] ;
   end for ; 
-  head_max := poly ; 
-  
-  if V_flow >= V_flow_max then /* Linear extrapolation until zero head */
-    // poly is the derivative of the curve at V_flow_max
-    poly := coeff[OrderPolyFitting+1] * (OrderPolyFitting) ;
-    for i in 1:OrderPolyFitting-1 loop
-      poly := poly * V_flow_max + coeff[OrderPolyFitting+1-i] * (OrderPolyFitting-i) ;
-    end for ;
-    head := head_max + (V_flow - V_flow_max) * poly ;
-    if head < 0.0 then // head is threshold at 0.0 ;
-      head := 0.0 ;
-    end if ;
-    
-  elseif V_flow <= V_flow_min and V_flow > 0.0 then /* Linear extrapolation */
-    // poly is the derivative of the curve at V_flow_min
-    poly := coeff[OrderPolyFitting+1] * (OrderPolyFitting) ;
-    for i in 1:OrderPolyFitting-1 loop
-      poly := poly * V_flow_min + coeff[OrderPolyFitting+1-i] * (OrderPolyFitting-i) ;
-    end for ;
-    head := head_min + (V_flow - V_flow_min) * poly ;  
-  
+  head_max := poly ;
+  if V_flow >= V_flow_max then
+    poly := coeff[OrderPolyFitting + 1] * OrderPolyFitting;
+    for i in 1:OrderPolyFitting - 1 loop
+      poly := poly * V_flow_max + coeff[OrderPolyFitting + 1 - i] * (OrderPolyFitting - i);
+    end for;
+    head := head_max + (V_flow - V_flow_max) * poly;
+    if head < 0.0 then
+      head := 0.0;
+    end if;
+  elseif V_flow <= V_flow_min and V_flow > 0.0 then
+    poly := coeff[OrderPolyFitting + 1] * OrderPolyFitting;
+    for i in 1:OrderPolyFitting - 1 loop
+      poly := poly * V_flow_min + coeff[OrderPolyFitting + 1 - i] * (OrderPolyFitting - i);
+    end for;
+    head := head_min + (V_flow - V_flow_min) * poly;
   elseif V_flow <= 0.0 then
     if V_flow_min <= 0.0 then
-      head := coeff[1] ;
-  
+      head := coeff[1];
     else
-      // poly is the derivative of the curve at V_flow_min
-      poly := coeff[OrderPolyFitting+1] * (OrderPolyFitting) ;
-      for i in 1:OrderPolyFitting-1 loop
-        poly := poly * V_flow_min + coeff[OrderPolyFitting+1-i] * (OrderPolyFitting-i) ;
-      end for ;
-      head := head_min + (0 - V_flow_min) * poly ;
-    end if ;
-    
+      poly := coeff[OrderPolyFitting + 1] * OrderPolyFitting;
+      for i in 1:OrderPolyFitting - 1 loop
+        poly := poly * V_flow_min + coeff[OrderPolyFitting + 1 - i] * (OrderPolyFitting - i);
+      end for;
+      head := head_min + (0 - V_flow_min) * poly;
+    end if;
   else
-    poly := coeff[OrderPolyFitting+1] ;
+    poly := coeff[OrderPolyFitting + 1];
     for i in 1:OrderPolyFitting loop
-      poly := poly * V_flow + coeff[OrderPolyFitting+1-i] ;
-    end for ;
-    
-    head := poly ;    
-    if head < 0.0 then // head is threshold at 0.0 ;
-      head := 0.0 ;
-    end if ;
-  
-  end if ;
-  
+      poly := poly * V_flow + coeff[OrderPolyFitting + 1 - i];
+    end for;
+    head := poly;
+    if head < 0.0 then
+      head := 0.0;
+    end if;
+  end if;
+/* Linear extrapolation until zero head */  // poly is the derivative of the curve at V_flow_max
+// head is threshold at 0.0 ;
+/* Linear extrapolation */
+// poly is the derivative of the curve at V_flow_min
+// poly is the derivative of the curve at V_flow_min
+// head is threshold at 0.0 ;
+
 annotation(
   inverse(V_flow = polynomialFlow_inv(V_flow_nominal=V_flow_nominal,
                                       head_nominal = head_nominal,
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/BaseClasses/PumpCharacteristics/polynomialFlow_inv.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/BaseClasses/PumpCharacteristics/polynomialFlow_inv.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/BaseClasses/PumpCharacteristics/polynomialFlow_inv.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/BaseClasses/PumpCharacteristics/polynomialFlow_inv.mo"	2022-03-10 09:58:16.248148972 +0000
@@ -4,12 +4,12 @@
   import Modelica.Math.Vectors ;
   extends Modelica.Icons.Function ;
 
-  input Modelica.SIunits.Position head "Pump head";
-  input Modelica.SIunits.VolumeFlowRate V_flow_nominal[:]
+  input Modelica.Units.SI.Position head "Pump head";
+  input Modelica.Units.SI.VolumeFlowRate V_flow_nominal[:]
       "Volume flow rate for N operating points (single pump)" annotation(Dialog);
-  input Modelica.SIunits.Position head_nominal[:] "Pump head for N operating points" annotation(Dialog);
+  input Modelica.Units.SI.Position head_nominal[:] "Pump head for N operating points" annotation(Dialog);
   input Integer OrderPolyFitting(min = 1) = 3 "Order of the polynom that fits the fan curve";
-  output Modelica.SIunits.VolumeFlowRate V_flow "Volumetric flow rate";
+  output Modelica.Units.SI.VolumeFlowRate V_flow "Volumetric flow rate";
     
   protected
   Integer N = size(V_flow_nominal,1) "Number of nominal operating points";
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/ControlledVolumeFlowPump.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/ControlledVolumeFlowPump.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/ControlledVolumeFlowPump.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/ControlledVolumeFlowPump.mo"	2022-03-10 09:58:16.232148970 +0000
@@ -10,16 +10,16 @@
     Dialog(group = "Assumptions"),
     Evaluate = true) ;
   parameter Boolean use_V_flow_set = false "= true to use input signal V_flow_set instead of V_flow_nominal";
-  parameter Modelica.SIunits.VolumeFlowRate V_flow_nominal "Nominal volume flow rate, fixed if not use_V_flow_set";
-  parameter Modelica.SIunits.Efficiency eta = 0.8 "Isentropic efficiency" ;
+  parameter Modelica.Units.SI.VolumeFlowRate V_flow_nominal "Nominal volume flow rate, fixed if not use_V_flow_set";
+  parameter Modelica.Units.SI.Efficiency eta = 0.8 "Isentropic efficiency" ;
 
 // Internal variables
-  Modelica.SIunits.VolumeFlowRate V_flow "Volume flow rate at port_a" ;
-  Modelica.SIunits.MassFlowRate m_flow "Mass flow rate" ;
-  Modelica.SIunits.Power P "Power given to the fluid" ;
-  Modelica.SIunits.Density d "Density at port_a";
-  Modelica.SIunits.Position head "Pump head";
-  Modelica.SIunits.PressureDifference dp "Pressure difference between port_a and port_b" ;
+  Modelica.Units.SI.VolumeFlowRate V_flow "Volume flow rate at port_a" ;
+  Modelica.Units.SI.MassFlowRate m_flow "Mass flow rate" ;
+  Modelica.Units.SI.Power P "Power given to the fluid" ;
+  Modelica.Units.SI.Density d "Density at port_a";
+  Modelica.Units.SI.Position head "Pump head";
+  Modelica.Units.SI.PressureDifference dp "Pressure difference between port_a and port_b" ;
   Medium.ThermodynamicState state "State at inlet" ;
   
   // Imported modules
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/PrescribedPump.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/PrescribedPump.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/PrescribedPump.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Machines/PrescribedPump.mo"	2022-03-10 09:58:16.192148966 +0000
@@ -6,7 +6,7 @@
   
 //User defined parameters
   parameter Boolean use_N_in = false "Get the rotational speed from the input connector" ;
-  parameter Modelica.SIunits.Conversions.NonSIunits.AngularVelocity_rpm N_const = N_nominal "Constant rotational speed" annotation(Dialog(enable = not use_N_in));
+  parameter Modelica.Units.NonSI.AngularVelocity_rpm N_const = N_nominal "Constant rotational speed" annotation(Dialog(enable = not use_N_in));
   
 //Imported modules
   Modelica.Blocks.Interfaces.RealInput N_in(unit="rev/min") if use_N_in "Prescribed rotational speed" annotation (Placement(transformation(
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/MassExchangers/AnalyticWetExchanger.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/MassExchangers/AnalyticWetExchanger.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/MassExchangers/AnalyticWetExchanger.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/MassExchangers/AnalyticWetExchanger.mo"	2022-03-10 09:58:16.180148964 +0000
@@ -3,7 +3,7 @@
 model AnalyticWetExchanger
   //extends TAeZoSysPro.HeatTransfer.BasesClasses.PartialHeatExchanger(final S = ExchangeSurface);
   //
-  import SI = Modelica.SIunits;
+  import Modelica.Units.SI;
   /*  in : refers to the inlet of the boundaries of the exchanger (carreful, counter flow considered)
       out : refers to the outlet of the boundaries of the exchanger (carreful, counter flow considered)
       mid : refers to the the conditions at the transition between the dry and wet part of the exchanger
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/HorizontalOpening.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/HorizontalOpening.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/HorizontalOpening.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/HorizontalOpening.mo"	2022-03-10 09:58:16.088148952 +0000
@@ -6,24 +6,24 @@
   
   // User defined parameters
   parameter Real Cd = 0.61 "discharge coefficient";
-  parameter Modelica.SIunits.CrossSection A = 1 "Opening cross section";
-  parameter Modelica.SIunits.Length L_down = 1 "Distance from bottom node";
-  parameter Modelica.SIunits.Length L_up = 1 "Distance from top node";
-  parameter Modelica.SIunits.Length NotionalLength = 1e-4 "Opening's thickness";
+  parameter Modelica.Units.SI.CrossSection A = 1 "Opening cross section";
+  parameter Modelica.Units.SI.Length L_down = 1 "Distance from bottom node";
+  parameter Modelica.Units.SI.Length L_up = 1 "Distance from top node";
+  parameter Modelica.Units.SI.Length NotionalLength = 1e-4 "Opening's thickness";
   parameter Dynamics massDynamics = Dynamics.SteadyStateInitial "Formulation of mass balance";
-  parameter Modelica.SIunits.Velocity Vel_start = 0.0 "Start value for velocity, if not steady state";
+  parameter Modelica.Units.SI.Velocity Vel_start = 0.0 "Start value for velocity, if not steady state";
   
   // Internal variables
-  Modelica.SIunits.Pressure p_a "Pressure at port_a";
-  Modelica.SIunits.Pressure p_b "Pressure at port_b";
-  Modelica.SIunits.PressureDifference dp; 
-  Modelica.SIunits.Pressure p_down;
-  Modelica.SIunits.Pressure p_up;
-  Modelica.SIunits.Velocity Vel;
-  Modelica.SIunits.MassFlowRate m_flow "Mass flow rate throught the opening"; 
-  Modelica.SIunits.Density d;
-  Modelica.SIunits.IsentropicExponent gamma "Isentropic exponent";
-  Modelica.SIunits.MachNumber M "Mach number at the opening";
+  Modelica.Units.SI.Pressure p_a "Pressure at port_a";
+  Modelica.Units.SI.Pressure p_b "Pressure at port_b";
+  Modelica.Units.SI.PressureDifference dp; 
+  Modelica.Units.SI.Pressure p_down;
+  Modelica.Units.SI.Pressure p_up;
+  Modelica.Units.SI.Velocity Vel;
+  Modelica.Units.SI.MassFlowRate m_flow "Mass flow rate throught the opening"; 
+  Modelica.Units.SI.Density d;
+  Modelica.Units.SI.IsentropicExponent gamma "Isentropic exponent";
+  Modelica.Units.SI.MachNumber M "Mach number at the opening";
   Medium.ThermodynamicState state, state_a, state_b;  
   
   // Imported modules
@@ -32,11 +32,11 @@
   TAeZoSysPro.FluidDynamics.Interfaces.FlowPort_b port_b(redeclare package Medium = Medium) annotation (
     Placement(visible = true, transformation(origin = {0, -50}, extent = {{-10, -10}, {10, 10}}, rotation = 0), iconTransformation(origin = {0, -70}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
 
-protected
-  Modelica.SIunits.SpecificEnthalpy h_a "Specific enthalpy from port_a" ;
-  Modelica.SIunits.SpecificEnthalpy h_b "Specific enthalpy from port_b" ;
-  parameter Modelica.SIunits.Velocity Vel_small = 0.001 ; 
+protected 
 
+  Modelica.Units.SI.SpecificEnthalpy h_a "Specific enthalpy from port_a" ;
+  Modelica.Units.SI.SpecificEnthalpy h_b "Specific enthalpy from port_b" ;
+  parameter Modelica.Units.SI.Velocity Vel_small = 0.001 ;
 initial equation
   if massDynamics == Dynamics.SteadyStateInitial then
     der(Vel) = 0;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/SimpleOpening.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/SimpleOpening.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/SimpleOpening.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/SimpleOpening.mo"	2022-03-10 09:58:16.048148948 +0000
@@ -6,20 +6,20 @@
   replaceable package Medium = TAeZoSysPro.Media.MyMedia ;
   // User defined parameters
   parameter Real Cd = 0.61 "discharge coefficient";
-  parameter Modelica.SIunits.CrossSection A = 1 "Opening cross section";
-  parameter Modelica.SIunits.Length NotionalLength = 0.1 "Opening's thickness";
+  parameter Modelica.Units.SI.CrossSection A = 1 "Opening cross section";
+  parameter Modelica.Units.SI.Length NotionalLength = 0.1 "Opening's thickness";
   parameter Dynamics massDynamics = Dynamics.SteadyStateInitial "Formulation of mass balance";
-  parameter Modelica.SIunits.Velocity Vel_start = 0.0 "Start value for velocity, if not steady state";
+  parameter Modelica.Units.SI.Velocity Vel_start = 0.0 "Start value for velocity, if not steady state";
   
   // Internal variables
-  Modelica.SIunits.Pressure p_a "Pressure at port_a";
-  Modelica.SIunits.Pressure p_b "Pressure at port_b";
-  Modelica.SIunits.PressureDifference dp;
-  Modelica.SIunits.Velocity Vel;
-  Modelica.SIunits.MassFlowRate m_flow "Mass flow rate through the opening";
-  Modelica.SIunits.Density d;
-  Modelica.SIunits.IsentropicExponent gamma "Isentropic exponent";
-  Modelica.SIunits.MachNumber M "Mach number at the opening";
+  Modelica.Units.SI.Pressure p_a "Pressure at port_a";
+  Modelica.Units.SI.Pressure p_b "Pressure at port_b";
+  Modelica.Units.SI.PressureDifference dp;
+  Modelica.Units.SI.Velocity Vel;
+  Modelica.Units.SI.MassFlowRate m_flow "Mass flow rate through the opening";
+  Modelica.Units.SI.Density d;
+  Modelica.Units.SI.IsentropicExponent gamma "Isentropic exponent";
+  Modelica.Units.SI.MachNumber M "Mach number at the opening";
   Medium.ThermodynamicState state, state_a, state_b;  
   
   // Imported modules
@@ -29,11 +29,11 @@
     Placement(visible = true, transformation(origin = {38, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0), iconTransformation(origin = {70, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
 
 protected
-  Modelica.SIunits.SpecificEnthalpy h_a "Specific enthalpy from port_a" ;
-  Modelica.SIunits.SpecificEnthalpy h_b "Specific enthalpy from port_b" ;
   
-  parameter Modelica.SIunits.Velocity Vel_small = 0.001 ;
+  Modelica.Units.SI.SpecificEnthalpy h_a "Specific enthalpy from port_a" ;
+  Modelica.Units.SI.SpecificEnthalpy h_b "Specific enthalpy from port_b" ;
   
+  parameter Modelica.Units.SI.Velocity Vel_small = 0.001 ;
 initial equation
   if massDynamics == Dynamics.SteadyStateInitial then
     der(Vel) = 0;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/SimpleOpeningComp.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/SimpleOpeningComp.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/SimpleOpeningComp.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/SimpleOpeningComp.mo"	2022-03-10 09:58:16.000148941 +0000
@@ -5,21 +5,21 @@
   
   // User defined parameters
   parameter Real Cd = 0.61 "discharge coefficient";
-  parameter Modelica.SIunits.CrossSection A = 1 "Opening cross section";
+  parameter Modelica.Units.SI.CrossSection A = 1 "Opening cross section";
   
   // Internal variables
-  Modelica.SIunits.PressureDifference dp;
-  Modelica.SIunits.Velocity Vel "Velocity at the orifice";
-  Modelica.SIunits.Velocity c "Sound velocity";
-  Modelica.SIunits.MassFlowRate m_flow "Mass flow rate throught the opening";
-  Modelica.SIunits.Density d "density at the orifice";
+  Modelica.Units.SI.PressureDifference dp;
+  Modelica.Units.SI.Velocity Vel "Velocity at the orifice";
+  Modelica.Units.SI.Velocity c "Sound velocity";
+  Modelica.Units.SI.MassFlowRate m_flow "Mass flow rate throught the opening";
+  Modelica.Units.SI.Density d "density at the orifice";
   
   //  Modelica.SIunits.Density d_comp "Densite au col";
-  Modelica.SIunits.AbsolutePressure p_a;
-  Modelica.SIunits.AbsolutePressure p_b;
-  Modelica.SIunits.IsentropicExponent gamma "isentropic exponent";
-  Modelica.SIunits.MachNumber M "Mach number at the orifice";
-  Modelica.SIunits.Temperature T "Temperature at the orifice";
+  Modelica.Units.SI.AbsolutePressure p_a;
+  Modelica.Units.SI.AbsolutePressure p_b;
+  Modelica.Units.SI.IsentropicExponent gamma "isentropic exponent";
+  Modelica.Units.SI.MachNumber M "Mach number at the orifice";
+  Modelica.Units.SI.Temperature T "Temperature at the orifice";
   Medium.ThermodynamicState state "State of upstream flow";
   Medium.ThermodynamicState state_a, state_b "States at ports";
   
@@ -30,9 +30,9 @@
     Placement(visible = true, transformation(origin = {70, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0), iconTransformation(origin = {70, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
 
 protected
-  Modelica.SIunits.SpecificEnthalpy h_a "Specific enthalpy from port_a" ;
-  Modelica.SIunits.SpecificEnthalpy h_b "Specific enthalpy from port_b" ;
-  parameter Modelica.SIunits.PressureDifference dp_small = 0.001 ;
+  Modelica.Units.SI.SpecificEnthalpy h_a "Specific enthalpy from port_a" ;
+  Modelica.Units.SI.SpecificEnthalpy h_b "Specific enthalpy from port_b" ;
+  parameter Modelica.Units.SI.PressureDifference dp_small = 0.001 ;
   
 equation
 //
@@ -73,17 +73,14 @@
 // solution 2: The velocity is computed from the compressible Bernoulli relation
 //solution 2.1: more stable around dp = 0 but induces an interation variable
 //  2 * gamma / (gamma - 1) * max(p_a, p_b) / Medium.density(state) * (1- (1 + (gamma - 1) / 2 * M ^ 2) ^ (-1)) - Modelica.Fluid.Utilities.regSquare2(
-//    x = Vel, 
-//    x_small = 0.01, 
-//    k1 = 1, 
+//    x = Vel,
+//    x_small = 0.01,
+//    k1 = 1,
 //    k2 = 1) = 0.0 ;
-//solution 2.0: infinite derivative at dp = 0    
-//  Vel = sign(dp) * sqrt(2 * gamma / (gamma - 1) * max(p_a, p_b) / Medium.density(state) * (1- (1 + (gamma - 1) / 2 * M ^ 2) ^ (-1)) )  ;    
-
+//solution 2.0: infinite derivative at dp = 0
+//  Vel = sign(dp) * sqrt(2 * gamma / (gamma - 1) * max(p_a, p_b) / Medium.density(state) * (1- (1 + (gamma - 1) / 2 * M ^ 2) ^ (-1)) )  ;
 //Blocking mass flow calculation
 //  m_flow_blocked = sign(dp) * max(pa, pb) * (gamma / r / T0) ^ 0.5 * Ar * Cd * ((gamma + 1) / 2) ^ ((1 + gamma) / 2 / (1 - gamma)) "From Barre Saint Venant and Hugoniot";
-
-
 // Port handover
   port_a.m_flow = m_flow * TAeZoSysPro.FluidDynamics.Utilities.regStep(
     x = dp, 
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/VerticalOpening.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/VerticalOpening.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/VerticalOpening.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Orifices/VerticalOpening.mo"	2022-03-10 09:58:15.960148936 +0000
@@ -6,24 +6,24 @@
   
   // User defined parameters
   parameter Real Cd = 0.61 "discharge coefficient";
-  parameter Modelica.SIunits.CrossSection A = 1 "Opening cross section";
-  parameter Modelica.SIunits.Height H = 1 "Opening's Height";
+  parameter Modelica.Units.SI.CrossSection A = 1 "Opening cross section";
+  parameter Modelica.Units.SI.Height H = 1 "Opening's Height";
   parameter Integer N = 5 "Number discrete layer along the height of the opening";  
-  parameter Modelica.SIunits.Length NotionalLength = 1e-4 "Opening's thickness";
+  parameter Modelica.Units.SI.Length NotionalLength = 1e-4 "Opening's thickness";
   parameter Dynamics massDynamics = Dynamics.SteadyStateInitial "Formulation of mass balance";
-  parameter Modelica.SIunits.Velocity Vel_start = 0.0 "Start value for velocity, if not steady state";
+  parameter Modelica.Units.SI.Velocity Vel_start = 0.0 "Start value for velocity, if not steady state";
     
   // Internal variables
-  Modelica.SIunits.Pressure p_a "Pressure at port_a";
-  Modelica.SIunits.Pressure p_b "Pressure at port_b";
-  Modelica.SIunits.PressureDifference dp_i[N];
-  Modelica.SIunits.PressureDifference dp;
-  Modelica.SIunits.MassFlowRate m_flow_i[N] ; 
-  Modelica.SIunits.Velocity Vel[N] ;   
-  Modelica.SIunits.MassFlowRate m_flow "Mass flow rate throught the opening";
-  Modelica.SIunits.Density d[N];
-  Modelica.SIunits.IsentropicExponent gamma "Isentropic exponent";
-  Modelica.SIunits.MachNumber M "Mach number at the opening";
+  Modelica.Units.SI.Pressure p_a "Pressure at port_a";
+  Modelica.Units.SI.Pressure p_b "Pressure at port_b";
+  Modelica.Units.SI.PressureDifference dp_i[N];
+  Modelica.Units.SI.PressureDifference dp;
+  Modelica.Units.SI.MassFlowRate m_flow_i[N] ; 
+  Modelica.Units.SI.Velocity Vel[N] ;   
+  Modelica.Units.SI.MassFlowRate m_flow "Mass flow rate throught the opening";
+  Modelica.Units.SI.Density d[N];
+  Modelica.Units.SI.IsentropicExponent gamma "Isentropic exponent";
+  Modelica.Units.SI.MachNumber M "Mach number at the opening";
   Medium.ThermodynamicState state, state_a, state_b;
   
   // Imported modules
@@ -32,13 +32,13 @@
   TAeZoSysPro.FluidDynamics.Interfaces.FlowPort_b port_b(redeclare package Medium = Medium) annotation (
     Placement(visible = true, transformation(origin = {38, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0), iconTransformation(origin = {70, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
 
-protected
-  parameter Modelica.SIunits.Height H_fluidStream = H * Cd ^0.5 "Minimal height between top and bottom flow path";
-  Modelica.SIunits.MassFlowRate mX_flow_i[N, Medium.nX] ;
-  Modelica.SIunits.SpecificEnthalpy h_a "Specific enthalpy from port_a" ;
-  Modelica.SIunits.SpecificEnthalpy h_b "Specific enthalpy from port_b" ;
-  parameter Modelica.SIunits.Velocity Vel_small = 0.001 ;  
+protected  
 
+  parameter Modelica.Units.SI.Height H_fluidStream = H * Cd ^0.5 "Minimal height between top and bottom flow path";
+  Modelica.Units.SI.MassFlowRate mX_flow_i[N, Medium.nX] ;
+  Modelica.Units.SI.SpecificEnthalpy h_a "Specific enthalpy from port_a" ;
+  Modelica.Units.SI.SpecificEnthalpy h_b "Specific enthalpy from port_b" ;
+  parameter Modelica.Units.SI.Velocity Vel_small = 0.001 ;
 initial equation
   if massDynamics == Dynamics.SteadyStateInitial then
     der(Vel) = fill(0.0, N);
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Pipes/DynamicPipe.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Pipes/DynamicPipe.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Pipes/DynamicPipe.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Pipes/DynamicPipe.mo"	2022-03-10 09:58:15.920148932 +0000
@@ -7,23 +7,23 @@
 // Medium
   replaceable package Medium = TAeZoSysPro.Media.MyMedia ;
   // User defined parameters
-  parameter Modelica.SIunits.Area A "Inner cross section area" annotation(
+  parameter Modelica.Units.SI.Area A "Inner cross section area" annotation(
     Dialog(group = "Geometry"));
-  parameter Modelica.SIunits.Length L "Pipe length" annotation(
+  parameter Modelica.Units.SI.Length L "Pipe length" annotation(
     Dialog(group = "Geometry"));
   parameter Integer N = 3 "Number of discrete layers" ;  
   parameter Real ksi = 1 "dynamic pressure loss" annotation(
     Dialog(group = "Flow"));
   parameter Dynamics energyDynamics = Dynamics.SteadyStateInitial "Formulation of energy balance";
-  parameter Modelica.SIunits.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial";
+  parameter Modelica.Units.SI.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial";
   parameter Dynamics massDynamics = Dynamics.SteadyStateInitial "Formulation of mass balance";
-  parameter Modelica.SIunits.Temperature X_start[:] = Medium.X_default "Start value for mass fractions, if massDynamics = FixedInitial";
+  parameter Modelica.Units.SI.Temperature X_start[:] = Medium.X_default "Start value for mass fractions, if massDynamics = FixedInitial";
   // Internal variables
-  Modelica.SIunits.Density d_a "Density if flow positive at port_a" ;
-  Modelica.SIunits.Density d_b "Density if flow positive at port_b" ;
-  Modelica.SIunits.PressureDifference dp;
-  Modelica.SIunits.Velocity Vel;
-  Modelica.SIunits.MassFlowRate m_flow "Aperture flow kg/s";
+  Modelica.Units.SI.Density d_a "Density if flow positive at port_a" ;
+  Modelica.Units.SI.Density d_b "Density if flow positive at port_b" ;
+  Modelica.Units.SI.PressureDifference dp;
+  Modelica.Units.SI.Velocity Vel;
+  Modelica.Units.SI.MassFlowRate m_flow "Aperture flow kg/s";
   // Imported Modules
   Modelica.Fluid.Interfaces.FluidPort_a port_a(replaceable package Medium = Medium) annotation(
     Placement(visible = true, transformation(origin = {-100, -2}, extent = {{-10, -10}, {10, 10}}, rotation = 0), iconTransformation(origin = {-100, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Pipes/StaticPipe.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Pipes/StaticPipe.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Pipes/StaticPipe.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Pipes/StaticPipe.mo"	2022-03-10 09:58:15.872148925 +0000
@@ -5,17 +5,17 @@
   replaceable package Medium = TAeZoSysPro.Media.MyMedia ;
   
   // User defined parameters
-  parameter Modelica.SIunits.Area A "Inner cross section area" annotation(
+  parameter Modelica.Units.SI.Area A "Inner cross section area" annotation(
     Dialog(group = "Geometry"));
   parameter Real ksi = 1 "dynamic pressure loss" annotation(
     Dialog(group = "Flow"));
   
   // Internal variables
-  Modelica.SIunits.Density d_a "Density if flow positive at port_a" ;
-  Modelica.SIunits.Density d_b "Density if flow positive at port_b" ;
-  Modelica.SIunits.PressureDifference dp;
-  Modelica.SIunits.Velocity Vel;
-  Modelica.SIunits.MassFlowRate m_flow "Aperture flow kg/s";
+  Modelica.Units.SI.Density d_a "Density if flow positive at port_a" ;
+  Modelica.Units.SI.Density d_b "Density if flow positive at port_b" ;
+  Modelica.Units.SI.PressureDifference dp;
+  Modelica.Units.SI.Velocity Vel;
+  Modelica.Units.SI.MassFlowRate m_flow "Aperture flow kg/s";
   
   // Imported Modules
   Modelica.Fluid.Interfaces.FluidPort_a port_a(redeclare package Medium = Medium) annotation (
@@ -23,9 +23,9 @@
   Modelica.Fluid.Interfaces.FluidPort_b port_b(redeclare package Medium = Medium) annotation (
     Placement(visible = true, transformation(origin = {100, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0), iconTransformation(origin = {100, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
 
-  //
-  final parameter Modelica.SIunits.PressureDifference dp_small = 0.01;
 
+  //
+  final parameter Modelica.Units.SI.PressureDifference dp_small = 0.01;
 equation
 
 // mass balance
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Valves/BaseClasses/PartialDamper.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Valves/BaseClasses/PartialDamper.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Valves/BaseClasses/PartialDamper.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Valves/BaseClasses/PartialDamper.mo"	2022-03-10 09:58:15.828148919 +0000
@@ -3,7 +3,7 @@
 model PartialDamper "Base model for dampers"
   // Import section
   import Modelica.Fluid.Types.CvTypes;
-  import SI = Modelica.SIunits ;
+  import Modelica.Units.SI;
 
   // Replaceable classes
   replaceable function valveCharacteristic = 
@@ -65,10 +65,10 @@
      min=if allowFlowReversal then -Modelica.Constants.inf else 0,
      start = m_flow_start) "Mass flow rate in design flow direction";
      
-  Modelica.SIunits.Pressure dp(start=dp_start)
+  Modelica.Units.SI.Pressure dp(start=dp_start)
       "Pressure difference between port_a and port_b (= port_a.p - port_b.p)";
 
-  Modelica.SIunits.VolumeFlowRate V_flow=
+  Modelica.Units.SI.VolumeFlowRate V_flow=
       m_flow/Modelica.Fluid.Utilities.regStep(m_flow,
                   Medium.density(state_a),
                   Medium.density(state_b),
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Valves/CommissioningDamper.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Valves/CommissioningDamper.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Valves/CommissioningDamper.mo"	2022-03-10 09:57:44.036144891 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Components/Valves/CommissioningDamper.mo"	2022-03-10 09:58:15.776148913 +0000
@@ -5,13 +5,13 @@
 
   // User defined parameters
   parameter Medium.MassFlowRate m_flow_nominal "Nominal mass flow rate" annotation(Dialog(group="Nominal operating point")) ;
-  parameter Modelica.SIunits.Pressure dp_nominal "Nominal pressure drop" annotation(Dialog(group="Nominal operating point")) ;    
-  parameter Modelica.SIunits.Pressure dp_small = 0.01 * dp_nominal "Regularisation of zero flow" annotation(Dialog(tab="Advanced"));
+  parameter Modelica.Units.SI.Pressure dp_nominal "Nominal pressure drop" annotation(Dialog(group="Nominal operating point")) ;    
+  parameter Modelica.Units.SI.Pressure dp_small = 0.01 * dp_nominal "Regularisation of zero flow" annotation(Dialog(tab="Advanced"));
   parameter Real Kv(fixed = false) "(Metric) flow coefficient";
   parameter Real Fxt=0.5 "F_gamma*xt critical ratio";
     
   // Internal variables
-  Modelica.SIunits.Pressure dp(start=dp_nominal) "Pressure difference between port_a and port_b (= port_a.p - port_b.p)" ;
+  Modelica.Units.SI.Pressure dp(start=dp_nominal) "Pressure difference between port_a and port_b (= port_a.p - port_b.p)" ;
   Medium.MassFlowRate m_flow(start = m_flow_nominal) "Mass flow rate in design flow direction";
   
   // Imported modules
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Interfaces/FlowPort.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Interfaces/FlowPort.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Interfaces/FlowPort.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Interfaces/FlowPort.mo"	2022-03-10 09:58:15.640148895 +0000
@@ -7,7 +7,7 @@
   Medium.Temperature T;
   Medium.Density[Medium.nX] d;
   flow Medium.MassFlowRate[Medium.nX] m_flow;
-  flow Modelica.SIunits.EnthalpyFlowRate H_flow;
+  flow Modelica.Units.SI.EnthalpyFlowRate H_flow;
   
   annotation(
     Documentation(info = "<html>
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Sources/Atmosphere.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Sources/Atmosphere.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Sources/Atmosphere.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/FluidDynamics/Sources/Atmosphere.mo"	2022-03-10 09:58:15.564148885 +0000
@@ -12,8 +12,8 @@
   parameter Boolean use_RH_in = false "Get the relative humidity from the input connector" annotation(
   Evaluate=true, HideResult=true, choices(checkBox=true)) ;
   
-  parameter Modelica.SIunits.Temperature T = 293.15 "Atmosphere temperature" ;
-  parameter Modelica.SIunits.Pressure p = 101325 "Atmosphere Pressure" ;
+  parameter Modelica.Units.SI.Temperature T = 293.15 "Atmosphere temperature" ;
+  parameter Modelica.Units.SI.Pressure p = 101325 "Atmosphere Pressure" ;
   parameter Real RH = 0.6 "Atmosphere relative humidity" ;
 
   parameter Integer nPorts = 0 "Number of fluidport" annotation(Dialog(connectorSizing=true));
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/CarrollRadiation.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/CarrollRadiation.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/CarrollRadiation.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/CarrollRadiation.mo"	2022-03-10 09:58:15.468148873 +0000
@@ -6,16 +6,16 @@
    
   // User defined parameters
   parameter Real add_on = 1 "Custom add-on";
-  parameter Modelica.SIunits.Area A = 0 "Wall Surface Area " annotation(
+  parameter Modelica.Units.SI.Area A = 0 "Wall Surface Area " annotation(
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Emissivity eps = 1 "Grey wall surface emissivity" annotation(
+  parameter Modelica.Units.SI.Emissivity eps = 1 "Grey wall surface emissivity" annotation(
   Dialog(group="Radiative properties"));
   // Constants
   constant Real sigma = Modelica.Constants.sigma "Stefan-Boltzmann constant";
   
   // Internal variables
-  Modelica.SIunits.CoefficientOfHeatTransfer h_rad "Heat transfer coefficient";
-  Modelica.SIunits.Energy E "Energy passed throught the component" ;
+  Modelica.Units.SI.CoefficientOfHeatTransfer h_rad "Heat transfer coefficient";
+  Modelica.Units.SI.Energy E "Energy passed throught the component" ;
   
   // Imported components
   Modelica.Blocks.Interfaces.RealInput Fview annotation(
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/Conduction.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/Conduction.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/Conduction.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/Conduction.mo"	2022-03-10 09:58:15.436148869 +0000
@@ -1,4 +1,4 @@
-﻿within TAeZoSysPro.HeatTransfer.BasesClasses;
+within TAeZoSysPro.HeatTransfer.BasesClasses;
 model Conduction
   encapsulated type ConductionType = enumeration(
       Linear
@@ -11,23 +11,23 @@
 
   // User defined parameters
   parameter Real add_on = 1 "Custom add-on";
-  parameter Modelica.SIunits.ThermalConductivity k = 0 "Thermal conductivity" annotation (
+  parameter Modelica.Units.SI.ThermalConductivity k = 0 "Thermal conductivity" annotation (
   Dialog(group="Thermal properties"));
   parameter ConductionType conduction = ConductionType.Linear annotation (
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Thickness Th = 0 "Material thickness" annotation (
+  parameter Modelica.Units.SI.Thickness Th = 0 "Material thickness" annotation (
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Area A = 0 "Cross section (if linear conduction)" annotation (
+  parameter Modelica.Units.SI.Area A = 0 "Cross section (if linear conduction)" annotation (
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Length L = 0 "Cylinder length (if cylindric conduction)" annotation (
+  parameter Modelica.Units.SI.Length L = 0 "Cylinder length (if cylindric conduction)" annotation (
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Radius Ri = 0 "Internal radius(if cylindric conduction)" annotation (
+  parameter Modelica.Units.SI.Radius Ri = 0 "Internal radius(if cylindric conduction)" annotation (
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Conversions.NonSIunits.Angle_deg Angle = 360 "Angle of cylindrical part (if cylindric conduction)" annotation (
+  parameter Modelica.Units.NonSI.Angle_deg Angle = 360 "Angle of cylindrical part (if cylindric conduction)" annotation (
   Dialog(group="Geometrical properties"));
 
   // Internal variables
-  Modelica.SIunits.Energy E "Energy passed throught the component";
+  Modelica.Units.SI.Energy E "Energy passed throught the component";
 
 initial equation
   E = 0.0;
@@ -35,7 +35,7 @@
 equation
 
   if conduction == ConductionType.Radial then
-    Q_flow = add_on * (Modelica.SIunits.Conversions.from_deg(Angle) * L * k) / log((Ri + Th) / Ri) * dT;
+    Q_flow = add_on * (Modelica.Units.Conversions.from_deg(Angle) * L * k) / log((Ri + Th) / Ri) * dT;
 
   elseif conduction == ConductionType.Linear then
     Q_flow = add_on * k * (A / Th) * dT;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/ForcedConvection.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/ForcedConvection.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/ForcedConvection.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/ForcedConvection.mo"	2022-03-10 09:58:15.420148867 +0000
@@ -3,7 +3,7 @@
 
   import Correlations = TAeZoSysPro.HeatTransfer.Types.ForcedConvectionCorrelation;
   import Functions = TAeZoSysPro.HeatTransfer.Functions.ForcedConvection;
-  import SI = Modelica.SIunits;
+  import Modelica.Units.SI;
   extends Modelica.Thermal.HeatTransfer.Interfaces.Element1D;
   //
   replaceable package Medium = TAeZoSysPro.Media.MyMedia;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/FreeConvection.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/FreeConvection.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/FreeConvection.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/FreeConvection.mo"	2022-03-10 09:58:15.392148864 +0000
@@ -4,7 +4,7 @@
 
   import Correlations = TAeZoSysPro.HeatTransfer.Types.FreeConvectionCorrelation ;
   import Functions = TAeZoSysPro.HeatTransfer.Functions.FreeConvection ;
-  import SI = Modelica.SIunits ;
+  import Modelica.Units.SI;
   extends Modelica.Thermal.HeatTransfer.Interfaces.Element1D;
   //
   replaceable package Medium = TAeZoSysPro.Media.MyMedia;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/FreeConvection_dT_decoupled.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/FreeConvection_dT_decoupled.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/FreeConvection_dT_decoupled.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/FreeConvection_dT_decoupled.mo"	2022-03-10 09:58:15.364148861 +0000
@@ -3,7 +3,7 @@
 model FreeConvection_dT_decoupled
   import Correlations = TAeZoSysPro.HeatTransfer.Types.FreeConvectionCorrelation;
   import Functions = TAeZoSysPro.HeatTransfer.Functions.FreeConvection;
-  import SI = Modelica.SIunits;
+  import Modelica.Units.SI;
   //
   replaceable package Medium = TAeZoSysPro.Media.MyMedia;
   // User defined parameters
@@ -18,7 +18,7 @@
     Dialog(group = "Flow properties"));
   // Internal variables
   Medium.Temperature T_mean "Mean temperature between fluid and wall";
-  Modelica.SIunits.TemperatureDifference dT "port_a.T - T_fluid";
+  Modelica.Units.SI.TemperatureDifference dT "port_a.T - T_fluid";
   SI.CoefficientOfHeatTransfer h_cv "Heat transfert coefficient";
   SI.Density d "Density of fluid at T_mean";
   SI.SpecificHeatCapacity cp "Specific heat capacity of fluid at T_mean";
@@ -28,7 +28,7 @@
   SI.GrashofNumber Gr "Grashof Number";
   SI.RayleighNumber Ra "Rayleigh Number";
   SI.NusseltNumber Nu "Nusselt Number";
-  Modelica.SIunits.HeatFlowRate Q_flow "Heat flow rate from port_a -> port_b";
+  Modelica.Units.SI.HeatFlowRate Q_flow "Heat flow rate from port_a -> port_b";
   SI.Energy E "Energy passed throught the component";
   // Imported modules
   Modelica.Blocks.Interfaces.RealInput T_fluid annotation(
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/HeatCapacitor.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/HeatCapacitor.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/HeatCapacitor.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/HeatCapacitor.mo"	2022-03-10 09:58:15.332148856 +0000
@@ -4,15 +4,15 @@
   import TAeZoSysPro.HeatTransfer.Types.Dynamics ;
  
 // User defined parameters :
-  parameter Modelica.SIunits.SpecificHeatCapacity cp = 0 "Specific heat capacity of element" annotation(
+  parameter Modelica.Units.SI.SpecificHeatCapacity cp = 0 "Specific heat capacity of element" annotation(
   Dialog(group="Thermal properties"));
-  parameter Modelica.SIunits.Mass m = 0 "Mass of element";
+  parameter Modelica.Units.SI.Mass m = 0 "Mass of element";
   parameter Dynamics energyDynamics = Dynamics.SteadyStateInitial "Formulation of energy balance";
-  parameter Modelica.SIunits.Temperature T_start = 293.15 "Start value for temperature, if not steady state";
+  parameter Modelica.Units.SI.Temperature T_start = 293.15 "Start value for temperature, if not steady state";
   
   // Internal variables
-  Modelica.SIunits.Temperature T "Temperature of element";
-  Modelica.SIunits.Energy E "Energy storage";
+  Modelica.Units.SI.Temperature T "Temperature of element";
+  Modelica.Units.SI.Energy E "Energy storage";
   
   // Imported components
   Modelica.Thermal.HeatTransfer.Interfaces.HeatPort_a port annotation(
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/LumpVolume.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/LumpVolume.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/LumpVolume.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/LumpVolume.mo"	2022-03-10 09:58:15.308148854 +0000
@@ -11,14 +11,14 @@
   Medium.BaseProperties medium(preferredMediumStates= true, p = p, Xi = Medium.reference_X[1:Medium.nXi]) ;     //preferredMediumStates = true for having a static state selection
   
   // User defined parameters
-  parameter Modelica.SIunits.Volume V = 1 "Air node volume [m3]";
+  parameter Modelica.Units.SI.Volume V = 1 "Air node volume [m3]";
   parameter Dynamics energyDynamics = Dynamics.FixedInitial "Formulation of energy balance";
-  parameter Modelica.SIunits.Temperature T_start = 293.15 "Start value for temperature, if not steady state";
-  final parameter Modelica.SIunits.Pressure p = Medium.reference_p "Constant pressure";
+  parameter Modelica.Units.SI.Temperature T_start = 293.15 "Start value for temperature, if not steady state";
+  final parameter Modelica.Units.SI.Pressure p = Medium.reference_p "Constant pressure";
   
   //Internal variables
-  Modelica.SIunits.Energy E "Energy storage";
-  Modelica.SIunits.Mass m "Mass of the volume";
+  Modelica.Units.SI.Energy E "Energy storage";
+  Modelica.Units.SI.Mass m "Mass of the volume";
   Medium.Temperature T "temperature of the fluid";
 
   Modelica.Thermal.HeatTransfer.Interfaces.HeatPort_a port_a annotation(
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/PartialHeatExchanger.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/PartialHeatExchanger.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/PartialHeatExchanger.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/PartialHeatExchanger.mo"	2022-03-10 09:58:15.296148852 +0000
@@ -3,21 +3,19 @@
 partial model PartialHeatExchanger
 
   //User defined parameters
-  parameter Modelica.SIunits.Area A = 1.0 "equivalent exchange surface area" annotation(Dialog(group="Geometrical parameters"));
+  parameter Modelica.Units.SI.Area A = 1.0 "equivalent exchange surface area" annotation(Dialog(group="Geometrical parameters"));
   
   // Internal variables
   Real NTU "Number of transfer unit";
   Real Cr "Ratio of thermal condutance";
-  Modelica.SIunits.Efficiency Eff "Exchanger effectiveness";
-  Modelica.SIunits.ThermalConductance Qc_A(min=0) "Thermal flow rate unit of fluid A";
-  Modelica.SIunits.ThermalConductance Qc_B(min=0) "Thermal flow rate unit of fluid B";
-  Modelica.SIunits.Temperature T_A_in, T_A_out, T_B_in, T_B_out;
-  Modelica.SIunits.CoefficientOfHeatTransfer h_global "Heat transfer coeffcient between fluid A and B" ;
-  Modelica.SIunits.HeatFlowRate Q_flow "Heat flow exchanged";
-  Modelica.SIunits.Energy E "Energy passed throught the component" ;
-  
-  //Imported modules 
-
+  Modelica.Units.SI.Efficiency Eff "Exchanger effectiveness";
+  Modelica.Units.SI.ThermalConductance Qc_A(min=0) "Thermal flow rate unit of fluid A";
+  Modelica.Units.SI.ThermalConductance Qc_B(min=0) "Thermal flow rate unit of fluid B";
+  Modelica.Units.SI.Temperature T_A_in, T_A_out, T_B_in, T_B_out;
+  Modelica.Units.SI.CoefficientOfHeatTransfer h_global "Heat transfer coeffcient between fluid A and B" ;
+  Modelica.Units.SI.HeatFlowRate Q_flow "Heat flow exchanged";
+  Modelica.Units.SI.Energy E "Energy passed throught the component" ;
+  //Imported modules
 initial equation
   E = 0.0 ;
 
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/PartialWall.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/PartialWall.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/PartialWall.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/BasesClasses/PartialWall.mo"	2022-03-10 09:58:15.268148848 +0000
@@ -13,11 +13,11 @@
     Dialog(group = "Mesh properties"));    
     parameter Real q = 1.2  "Growth rate (if geometricalGrowth)" annotation(
     Dialog(group = "Mesh properties"));
-    parameter Modelica.SIunits.CoefficientOfHeatTransfer h = 10 "Decoupled value of the heat transfer coefficient (if biot)" annotation(
+    parameter Modelica.Units.SI.CoefficientOfHeatTransfer h = 10 "Decoupled value of the heat transfer coefficient (if biot)" annotation(
     Dialog(group = "Mesh properties"));  
     parameter Boolean symmetricalMesh = true "Axial symmetry mesh where the axis is the middle of the domain" annotation(
     Dialog(group = "Mesh properties"));  
-    final parameter Modelica.SIunits.Position x[:] = 
+    final parameter Modelica.Units.SI.Position x[:] = 
       if mesh == MeshGrid.uniform then
         MeshFunction.uniformGrid(L=Th, N=N)
       elseif mesh == MeshGrid.geometricalGrowth then
@@ -31,23 +31,23 @@
                 
     parameter Real add_on = 1 "Custom add-on";
     parameter Dynamics energyDynamics = Dynamics.SteadyStateInitial "Formulation of energy balance";
-    parameter Modelica.SIunits.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial";
+    parameter Modelica.Units.SI.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial";
   //
-    parameter Modelica.SIunits.SpecificHeatCapacity cp = 0 "Wall specific heat capacity" annotation(
+    parameter Modelica.Units.SI.SpecificHeatCapacity cp = 0 "Wall specific heat capacity" annotation(
     Dialog(group = "Medium properties"));
-    parameter Modelica.SIunits.Density d = 0 "Wall density" annotation(
+    parameter Modelica.Units.SI.Density d = 0 "Wall density" annotation(
     Dialog(group = "Medium properties"));
-    parameter Modelica.SIunits.ThermalConductivity k = 0 "Wall conductivity" annotation(
+    parameter Modelica.Units.SI.ThermalConductivity k = 0 "Wall conductivity" annotation(
     Dialog(group = "Medium properties"));
   //
-    parameter Modelica.SIunits.Thickness Th = 0 "Material thickness" annotation(
+    parameter Modelica.Units.SI.Thickness Th = 0 "Material thickness" annotation(
     Dialog(group="Geometrical properties"));
-    parameter Modelica.SIunits.Area A = 1 "Wall area" annotation(
+    parameter Modelica.Units.SI.Area A = 1 "Wall area" annotation(
     Dialog(group = "Geometrical properties"));
 
   // Internal variables
-    Modelica.SIunits.Energy E "Energy stored in the wall";
-    final parameter Modelica.SIunits.Position[N+2] x_node = cat(1, {0},{(x[i+1]+x[i])/2 for i in 1:N}, {Th}) ;
+    Modelica.Units.SI.Energy E "Energy stored in the wall";
+    final parameter Modelica.Units.SI.Position[N+2] x_node = cat(1, {0},{(x[i+1]+x[i])/2 for i in 1:N}, {Th}) ;
 
   // Imported components
     Modelica.Thermal.HeatTransfer.Interfaces.HeatPort_a port_a annotation(
@@ -64,8 +64,8 @@
     Placement(visible = true, transformation(origin = {-2, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
 
 
-final parameter Modelica.SIunits.ThermalDiffusionCoefficient D_th = k / (d * cp) "Thermal diffusivity";
 
+final parameter Modelica.Units.SI.ThermalDiffusionCoefficient D_th = k / (d * cp) "Thermal diffusivity";
 initial equation
   // Energy at time 0 second is equal to 0J
   E = 0;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/CabinetPower.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/CabinetPower.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/CabinetPower.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/CabinetPower.mo"	2022-03-10 09:58:15.232148844 +0000
@@ -8,41 +8,41 @@
   // User defined temperature
   parameter Dynamics energyDynamics = Dynamics.SteadyStateInitial "Formulation of energy balance" annotation(
   Dialog(group="Dynamic properties"));
-  parameter Modelica.SIunits.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
+  parameter Modelica.Units.SI.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
   Dialog(group="Dynamic properties"));
   parameter Real add_on_conv = 1 "Custom add_on for convection" annotation(
   Dialog(group="Dynamic properties"));
   
   //
-  parameter Modelica.SIunits.Area A_conv_emitter = 0 "Convection area emitter" annotation(
+  parameter Modelica.Units.SI.Area A_conv_emitter = 0 "Convection area emitter" annotation(
     Dialog(group = "Emitter"));
-  parameter Modelica.SIunits.Area A_rad_emitter = 0 "Radiative area emitter" annotation(
+  parameter Modelica.Units.SI.Area A_rad_emitter = 0 "Radiative area emitter" annotation(
     Dialog(group = "Emitter"));
-  parameter Modelica.SIunits.Height Lc_emitter = 0 "Characteristic length emitter for convection correlation" annotation(
+  parameter Modelica.Units.SI.Height Lc_emitter = 0 "Characteristic length emitter for convection correlation" annotation(
     Dialog(group = "Emitter"));
-  parameter Modelica.SIunits.SpecificHeatCapacity cp_emitter = 0 "Specific heat capacity of emitter" annotation(
+  parameter Modelica.Units.SI.SpecificHeatCapacity cp_emitter = 0 "Specific heat capacity of emitter" annotation(
     Dialog(group = "Emitter"));
-  parameter Modelica.SIunits.Mass m_emitter = 0 "Mass of emitter" annotation(
+  parameter Modelica.Units.SI.Mass m_emitter = 0 "Mass of emitter" annotation(
     Dialog(group = "Emitter"));
-  parameter Modelica.SIunits.Emissivity eps_emitter = 1 "Emitter emissivity" annotation(
+  parameter Modelica.Units.SI.Emissivity eps_emitter = 1 "Emitter emissivity" annotation(
     Dialog(group = "Emitter"));
   //
-  parameter Modelica.SIunits.Area A_in_casing = 0 "Inner area of casing" annotation(
+  parameter Modelica.Units.SI.Area A_in_casing = 0 "Inner area of casing" annotation(
     Dialog(group = "Assembly"));
-  parameter Modelica.SIunits.Area A_conv_casing = 0 "Convection outer area of casing" annotation(
+  parameter Modelica.Units.SI.Area A_conv_casing = 0 "Convection outer area of casing" annotation(
     Dialog(group = "Assembly"));
-  parameter Modelica.SIunits.Area A_rad_casing = 0 "Radiative outer area of casing" annotation(
+  parameter Modelica.Units.SI.Area A_rad_casing = 0 "Radiative outer area of casing" annotation(
     Dialog(group = "Assembly"));
-  parameter Modelica.SIunits.Height Lc_casing = 0 "Characteristic length of casing" annotation(
+  parameter Modelica.Units.SI.Height Lc_casing = 0 "Characteristic length of casing" annotation(
     Dialog(group = "Assembly"));
-  parameter Modelica.SIunits.SpecificHeatCapacity cp_casing  = 0 "Specific heat capacity of assembly" annotation(
+  parameter Modelica.Units.SI.SpecificHeatCapacity cp_casing  = 0 "Specific heat capacity of assembly" annotation(
     Dialog(group = "Assembly"));
-  parameter Modelica.SIunits.Mass m_casing  = 0 "Mass of Casing" annotation(
+  parameter Modelica.Units.SI.Mass m_casing  = 0 "Mass of Casing" annotation(
     Dialog(group = "Assembly"));
-  parameter Modelica.SIunits.Emissivity eps_casing = 1 "Casing emissivity" annotation(
+  parameter Modelica.Units.SI.Emissivity eps_casing = 1 "Casing emissivity" annotation(
     Dialog(group = "Assembly"));
   // Internal variables
-  Modelica.SIunits.Energy E_released "Energy released into the environement";
+  Modelica.Units.SI.Energy E_released "Energy released into the environement";
   // Imported modules
   Modelica.Thermal.HeatTransfer.Components.BodyRadiation radiation_emitter_casing(Gr = A_rad_emitter / (1 / eps_emitter + A_rad_emitter / A_in_casing * (1 / eps_casing - 1)))  annotation(
     Placement(visible = true, transformation(origin = {0, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/FanVentilation.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/FanVentilation.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/FanVentilation.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/FanVentilation.mo"	2022-03-10 09:58:15.152148833 +0000
@@ -1,18 +1,18 @@
-﻿within TAeZoSysPro.HeatTransfer.Components;
+within TAeZoSysPro.HeatTransfer.Components;
 model FanVentilation
   replaceable package Medium = TAeZoSysPro.Media.MyMedia "Medium in the component";
 
   // User defined parameters
   parameter Boolean Use_External_MassFlow = false;
-  parameter Modelica.SIunits.Power Q_flow_aero_nominal = 0 "Fan power given to fluid at nominal conditions";
-  parameter Modelica.SIunits.VolumeFlowRate V_flow_nominal = 0 "Volume flow rate at nominal conditions";
+  parameter Modelica.Units.SI.Power Q_flow_aero_nominal = 0 "Fan power given to fluid at nominal conditions";
+  parameter Modelica.Units.SI.VolumeFlowRate V_flow_nominal = 0 "Volume flow rate at nominal conditions";
 
   // Internal variables
-  Modelica.SIunits.Power Q_flow_aero "Fan power given to fluid";
-  Modelica.SIunits.SpecificHeatCapacity cp "Mean specific heat capacity";
-  Modelica.SIunits.Density d;
-  Modelica.SIunits.MassFlowRate m_flow;
-  Modelica.SIunits.Energy E "Energy passed throught the component";
+  Modelica.Units.SI.Power Q_flow_aero "Fan power given to fluid";
+  Modelica.Units.SI.SpecificHeatCapacity cp "Mean specific heat capacity";
+  Modelica.Units.SI.Density d;
+  Modelica.Units.SI.MassFlowRate m_flow;
+  Modelica.Units.SI.Energy E "Energy passed throught the component";
   //
   Modelica.Thermal.HeatTransfer.Interfaces.HeatPort_b port_b annotation (
     Placement(visible = true, transformation(origin = {0, 98}, extent = {{-10, -10}, {10, 10}}, rotation = 0), iconTransformation(origin = {100, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/HalfWall.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/HalfWall.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/HalfWall.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/HalfWall.mo"	2022-03-10 09:58:15.100148828 +0000
@@ -15,44 +15,44 @@
   Dialog(group="Meshing properties"));
   parameter Real q = 1.2 "Growth rate (if geometricalGrowth chosen)" annotation(
   Dialog(group="Meshing properties"));
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h = 10 "Decoupled value of the heat transfer (if biot segment chosen)" annotation(
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h = 10 "Decoupled value of the heat transfer (if biot segment chosen)" annotation(
   Dialog(group="Meshing properties"));  
   parameter Integer N(min=2) = integer(max(2, 5 * Th / 0.2 * 1e-6 * d * cp / k)) "Number of layers : 2 to 65535" annotation(
   Dialog(group="Meshing properties"));
   
-  parameter Modelica.SIunits.Area A = 0 "Wall area " annotation(
+  parameter Modelica.Units.SI.Area A = 0 "Wall area " annotation(
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Height Lc = 0 "Wall characteristic length" annotation(
+  parameter Modelica.Units.SI.Height Lc = 0 "Wall characteristic length" annotation(
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Length Th = 0 "Wall thickness" annotation(
+  parameter Modelica.Units.SI.Length Th = 0 "Wall thickness" annotation(
   Dialog(group="Geometrical properties"));
   
   parameter Dynamics energyDynamics = Dynamics.SteadyStateInitial "Formulation of energy balance" annotation(
   Dialog(group="Dynamic properties"));
-  parameter Modelica.SIunits.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
+  parameter Modelica.Units.SI.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
   Dialog(group="Dynamic properties"));
   
-  parameter Modelica.SIunits.SpecificHeatCapacity cp = 0 "Wall specific heat capacity" annotation(
+  parameter Modelica.Units.SI.SpecificHeatCapacity cp = 0 "Wall specific heat capacity" annotation(
   Dialog(group="Thermal properties"));
-  parameter Modelica.SIunits.Density d(displayUnit="kg/m3") = 0 "Wall density" annotation(
+  parameter Modelica.Units.SI.Density d(displayUnit="kg/m3") = 0 "Wall density" annotation(
   Dialog(group="Thermal properties"));
-  parameter Modelica.SIunits.ThermalConductivity k = 0 "Wall conductivity" annotation(
+  parameter Modelica.Units.SI.ThermalConductivity k = 0 "Wall conductivity" annotation(
   Dialog(group="Thermal properties"));
   
   parameter Real add_on_conv = 1 "Custom add-on" annotation(
     Dialog(group = "Convection properties"));
   parameter TAeZoSysPro.HeatTransfer.Types.FreeConvectionCorrelation correlation = Correlations.vertical_plate_ASHRAE "free convection Correlation" annotation(
     Dialog(group = "Convection properties"));
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h_cv_const = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h_cv_const = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
     Dialog(group = "Convection properties"));
   //
-  parameter Modelica.SIunits.Emissivity eps = 0 "Wall emissivity " annotation(
+  parameter Modelica.Units.SI.Emissivity eps = 0 "Wall emissivity " annotation(
     Dialog(group = "Radiative properties"));
   parameter Real add_on_rad = 1 "Custom add-on" annotation(
     Dialog(group = "Radiative properties"));
 
 // Internal variables
-  Modelica.SIunits.BiotNumber Bi ;
+  Modelica.Units.SI.BiotNumber Bi ;
 
 // Components inside wall are defined
   TAeZoSysPro.HeatTransfer.BasesClasses.PartialWall partialWall(A = A, N = N, T_start = T_start, Th = Th, cp = cp, d = d, energyDynamics = energyDynamics, h = h, k = k, mesh = mesh, q = q, symmetricalMesh = false)  annotation(
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/InertMass.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/InertMass.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/InertMass.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/InertMass.mo"	2022-03-10 09:58:15.048148820 +0000
@@ -9,31 +9,31 @@
 //Media
   replaceable package Medium = TAeZoSysPro.Media.MyMedia ;
   // User defined parameters
-  parameter Modelica.SIunits.Area A_conv = 0 "Convective surface area " annotation(
+  parameter Modelica.Units.SI.Area A_conv = 0 "Convective surface area " annotation(
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Area A_rad = A_conv "Radiative surface area " annotation(
+  parameter Modelica.Units.SI.Area A_rad = A_conv "Radiative surface area " annotation(
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Length Lc = 1 "characteritic dimension for correlation" annotation(
+  parameter Modelica.Units.SI.Length Lc = 1 "characteritic dimension for correlation" annotation(
   Dialog(group="Geometrical properties"));
    
   parameter Dynamics energyDynamics = Dynamics.SteadyStateInitial "Formulation of energy balance" annotation(
   Dialog(group="Dynamic properties"));
-  parameter Modelica.SIunits.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
+  parameter Modelica.Units.SI.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
   Dialog(group="Dynamic properties"));
   
-  parameter Modelica.SIunits.SpecificHeatCapacity cp = 0 "Specific heat capacity" annotation(
+  parameter Modelica.Units.SI.SpecificHeatCapacity cp = 0 "Specific heat capacity" annotation(
   Dialog(group="Thermal properties"));
-  parameter Modelica.SIunits.Mass m= 0 "Mass of the component" annotation(
+  parameter Modelica.Units.SI.Mass m= 0 "Mass of the component" annotation(
   Dialog(group="Thermal properties"));
   
   parameter Real add_on_conv = 1 "Custom add-on" annotation(
     Dialog(group = "Convection properties"));
   parameter TAeZoSysPro.HeatTransfer.Types.FreeConvectionCorrelation correlation = Correlations.vertical_plate_ASHRAE "free convection Correlation" annotation(
     Dialog(group = "Convection properties"));
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h_cv_const = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h_cv_const = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
     Dialog(group = "Convection properties"));
   //
-  parameter Modelica.SIunits.Emissivity eps = 0 "Wall emissivity " annotation(
+  parameter Modelica.Units.SI.Emissivity eps = 0 "Wall emissivity " annotation(
     Dialog(group = "Radiative properties"));
   parameter Real add_on_rad = 1 "Custom add-on" annotation(
     Dialog(group = "Radiative properties"));
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/Ventilation.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/Ventilation.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/Ventilation.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/Ventilation.mo"	2022-03-10 09:58:14.996148813 +0000
@@ -4,10 +4,10 @@
   // User defined parameters
   parameter Boolean Use_External_MassFlow = false;
   // Internal variables
-  Modelica.SIunits.SpecificHeatCapacity cp "Mean specific heat capacity";
-  Modelica.SIunits.Density d;
-  Modelica.SIunits.MassFlowRate m_flow;
-  Modelica.SIunits.Energy E "Energy passed throught the component";
+  Modelica.Units.SI.SpecificHeatCapacity cp "Mean specific heat capacity";
+  Modelica.Units.SI.Density d;
+  Modelica.Units.SI.MassFlowRate m_flow;
+  Modelica.Units.SI.Energy E "Energy passed throught the component";
   //
   Modelica.Thermal.HeatTransfer.Interfaces.HeatPort_b port_b annotation (
     Placement(visible = true, transformation(origin = {0, 98}, extent = {{-10, -10}, {10, 10}}, rotation = 0), iconTransformation(origin = {100, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/Wall.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/Wall.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/Wall.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Components/Wall.mo"	2022-03-10 09:58:14.980148812 +0000
@@ -15,28 +15,28 @@
   Dialog(group="Meshing properties"));
   parameter Real q = 1.2 "Growth rate (if geometricalGrowth chosen)" annotation(
   Dialog(group="Meshing properties"));
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h = 10 "Decoupled value of the heat transfer (if biot segment chosen)" annotation(
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h = 10 "Decoupled value of the heat transfer (if biot segment chosen)" annotation(
   Dialog(group="Meshing properties"));  
   parameter Integer N(min=2) = integer(max(2, 5 * Th / 0.2 * 1e-6 * d * cp / k)) "Number of layers : 2 to 65535" annotation(
   Dialog(group="Meshing properties"));
   
-  parameter Modelica.SIunits.Area A = 0 "Wall area " annotation(
+  parameter Modelica.Units.SI.Area A = 0 "Wall area " annotation(
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Height Lc = 0 "Wall characteristic length" annotation(
+  parameter Modelica.Units.SI.Height Lc = 0 "Wall characteristic length" annotation(
   Dialog(group="Geometrical properties"));
-  parameter Modelica.SIunits.Length Th = 0 "Wall thickness" annotation(
+  parameter Modelica.Units.SI.Length Th = 0 "Wall thickness" annotation(
   Dialog(group="Geometrical properties"));
   
   parameter Dynamics energyDynamics = Dynamics.SteadyStateInitial "Formulation of energy balance" annotation(
   Dialog(group="Dynamic properties"));
-  parameter Modelica.SIunits.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
+  parameter Modelica.Units.SI.Temperature T_start = 293.15 "Start value for temperature, if energyDynamics = FixedInitial" annotation(
   Dialog(group="Dynamic properties"));
   
-  parameter Modelica.SIunits.SpecificHeatCapacity cp = 0 "Wall specific heat capacity" annotation(
+  parameter Modelica.Units.SI.SpecificHeatCapacity cp = 0 "Wall specific heat capacity" annotation(
   Dialog(group="Thermal properties"));
-  parameter Modelica.SIunits.Density d(displayUnit="kg/m3") = 0 "Wall density" annotation(
+  parameter Modelica.Units.SI.Density d(displayUnit="kg/m3") = 0 "Wall density" annotation(
   Dialog(group="Thermal properties"));
-  parameter Modelica.SIunits.ThermalConductivity k = 0 "Wall conductivity" annotation(
+  parameter Modelica.Units.SI.ThermalConductivity k = 0 "Wall conductivity" annotation(
   Dialog(group="Thermal properties"));
   
   parameter Real add_on_conv = 1 "Custom add-on" annotation(
@@ -45,21 +45,21 @@
     Dialog(group = "Convection properties"));
   parameter TAeZoSysPro.HeatTransfer.Types.FreeConvectionCorrelation correlation_b = if correlation_a == Correlations.ceiling_ASHRAE then Correlations.ground_ASHRAE elseif correlation_a == Correlations.ground_ASHRAE then Correlations.ceiling_ASHRAE else correlation_a "free convection Correlation" annotation(
     Dialog(group = "Convection properties"));
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h_cv_const_a = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h_cv_const_a = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
     Dialog(group = "Convection properties"));
   
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h_cv_const_b = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h_cv_const_b = 0 "constant heat transfer coefficient (optional: if correlation 'Constant' choosen)" annotation(
     Dialog(group = "Convection properties"));
   //
-  parameter Modelica.SIunits.Emissivity eps_a = 0 "Wall emissivity " annotation(
+  parameter Modelica.Units.SI.Emissivity eps_a = 0 "Wall emissivity " annotation(
     Dialog(group = "Radiative properties"));
-  parameter Modelica.SIunits.Emissivity eps_b = 0 "Wall emissivity " annotation(
+  parameter Modelica.Units.SI.Emissivity eps_b = 0 "Wall emissivity " annotation(
     Dialog(group = "Radiative properties"));
   parameter Real add_on_rad = 1 "Custom add-on" annotation(
     Dialog(group = "Radiative properties"));
 
 // Internal variables
-  Modelica.SIunits.BiotNumber Bi_a, Bi_b ;
+  Modelica.Units.SI.BiotNumber Bi_a, Bi_b ;
 
 // Components inside wall are defined
   TAeZoSysPro.HeatTransfer.BasesClasses.PartialWall partialWall(A = A, N = N, T_start = T_start, Th = Th, cp = cp, d = d, energyDynamics = energyDynamics, h = h, k = k, mesh = mesh, q = q, symmetricalMesh = true)  annotation(
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Inverse/NTU_coCurrent.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Inverse/NTU_coCurrent.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Inverse/NTU_coCurrent.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Inverse/NTU_coCurrent.mo"	2022-03-10 09:58:14.740148782 +0000
@@ -4,7 +4,7 @@
 
   extends Modelica.Icons.Function;
 
-  input Modelica.SIunits.Efficiency Eff "Exchanger effectiveness";
+  input Modelica.Units.SI.Efficiency Eff "Exchanger effectiveness";
   input Real Cr "Ratio of thermal condutance";
   output Real NTU "Number of transfer unit";
 
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Inverse/NTU_counterCurrent.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Inverse/NTU_counterCurrent.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Inverse/NTU_counterCurrent.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Inverse/NTU_counterCurrent.mo"	2022-03-10 09:58:14.724148779 +0000
@@ -3,7 +3,7 @@
 
   extends Modelica.Icons.Function;
 
-  input Modelica.SIunits.Efficiency Eff "Exchanger effectiveness";
+  input Modelica.Units.SI.Efficiency Eff "Exchanger effectiveness";
   input Real Cr "Ratio of thermal condutance";
   output Real NTU "Number of transfer unit";
 
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Tests/test_coCurrent.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Tests/test_coCurrent.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Tests/test_coCurrent.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Tests/test_coCurrent.mo"	2022-03-10 09:58:14.704148777 +0000
@@ -4,7 +4,7 @@
 
   parameter Real NTU = 10 "Number of transfer unit" ;
   Real Cr "Ratio of thermal condutance" ;
-  Modelica.SIunits.Efficiency Eff "Exchanger effectiveness" ;
+  Modelica.Units.SI.Efficiency Eff "Exchanger effectiveness" ;
   Modelica.Blocks.Sources.Ramp ramp1(duration = 1, height = 1)  annotation(
     Placement(visible = true, transformation(origin = {-10, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
 equation
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Tests/test_counterCurrent.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Tests/test_counterCurrent.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Tests/test_counterCurrent.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Tests/test_counterCurrent.mo"	2022-03-10 09:58:14.688148774 +0000
@@ -4,7 +4,7 @@
 
   parameter Real NTU = 10 "Number of transfer unit" ;
   Real Cr "Ratio of thermal condutance" ;
-  Modelica.SIunits.Efficiency Eff "Exchanger effectiveness" ;
+  Modelica.Units.SI.Efficiency Eff "Exchanger effectiveness" ;
   Modelica.Blocks.Sources.Ramp ramp1(duration = 1, height = 1)  annotation(
     Placement(visible = true, transformation(origin = {-10, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
 equation
@@ -12,4 +12,5 @@
   Eff = TAeZoSysPro.HeatTransfer.Functions.ExchangerEffectiveness.counterCurrent(NTU = NTU, Cr = Cr) ;
 
 annotation(
-    experiment(StartTime = 0, StopTime = 1, Tolerance = 1e-6, Interval = 0.01));end test_counterCurrent;
+    experiment(StartTime = 0, StopTime = 1, Tolerance = 1e-6, Interval = 0.01));
+end test_counterCurrent;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Tests/test_crossCurrent.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Tests/test_crossCurrent.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Tests/test_crossCurrent.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/Tests/test_crossCurrent.mo"	2022-03-10 09:58:14.676148774 +0000
@@ -3,7 +3,7 @@
 
   parameter Real NTU = 10 "Number of transfer unit";
   Real Cr "Ratio of thermal condutance";
-  Modelica.SIunits.Efficiency Eff_both_unmixed, Eff_fluidA_mixed, Eff_fluidB_mixed  "Exchanger effectiveness";
+  Modelica.Units.SI.Efficiency Eff_both_unmixed, Eff_fluidA_mixed, Eff_fluidB_mixed  "Exchanger effectiveness";
   Modelica.Blocks.Sources.Ramp ramp1(duration = 1, height = 1)  annotation (
     Placement(visible = true, transformation(origin = {-10, 0}, extent = {{-10, -10}, {10, 10}}, rotation = 0)));
   Real Qc_A, Qc_B;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/baseFunc.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/baseFunc.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/baseFunc.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerEffectiveness/baseFunc.mo"	2022-03-10 09:58:14.668148772 +0000
@@ -6,6 +6,6 @@
   //
   input Real NTU "Number of transfer unit" ;
   input Real Cr "Ratio of thermal condutance" ;
-  output Modelica.SIunits.Efficiency Eff "Exchanger effectiveness" ;
+  output Modelica.Units.SI.Efficiency Eff "Exchanger effectiveness" ;
 
 end baseFunc;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/Tests/test_from_correlations.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/Tests/test_from_correlations.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/Tests/test_from_correlations.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/Tests/test_from_correlations.mo"	2022-03-10 09:58:14.616148765 +0000
@@ -2,16 +2,16 @@
 
 model test_from_correlations
 
-  parameter Modelica.SIunits.ReynoldsNumber Re_A = 1e5 "Reynolds number for flow A" ;
-  parameter Modelica.SIunits.PrandtlNumber Pr_A = 7 "Prandtl number for fluid A" ;
-  parameter Modelica.SIunits.Length Lc_A = 0.2 "Charactereistic length for flow A" ;
-  parameter Modelica.SIunits.ThermalConductivity k_A = 0.06 "Thermal conductivity for fluid A" ;
-  parameter Modelica.SIunits.ReynoldsNumber Re_B = 1e6 "Reynolds number for flow A" ;
-  parameter Modelica.SIunits.PrandtlNumber Pr_B = 1 "Prandtl number for fluid A" ;
-  parameter Modelica.SIunits.Length Lc_B = 1 "Charactereistic length for flow A" ;
-  parameter Modelica.SIunits.ThermalConductivity k_B = 0.03 "Thermal conductivity for fluid A" ;
-  Modelica.SIunits.CoefficientOfHeatTransfer h, h_A, h_B "Heat transfer Coefficient" ;
 
+  parameter Modelica.Units.SI.ReynoldsNumber Re_A = 1e5 "Reynolds number for flow A" ;
+  parameter Modelica.Units.SI.PrandtlNumber Pr_A = 7 "Prandtl number for fluid A" ;
+  parameter Modelica.Units.SI.Length Lc_A = 0.2 "Charactereistic length for flow A" ;
+  parameter Modelica.Units.SI.ThermalConductivity k_A = 0.06 "Thermal conductivity for fluid A" ;
+  parameter Modelica.Units.SI.ReynoldsNumber Re_B = 1e6 "Reynolds number for flow A" ;
+  parameter Modelica.Units.SI.PrandtlNumber Pr_B = 1 "Prandtl number for fluid A" ;
+  parameter Modelica.Units.SI.Length Lc_B = 1 "Charactereistic length for flow A" ;
+  parameter Modelica.Units.SI.ThermalConductivity k_B = 0.03 "Thermal conductivity for fluid A" ;
+  Modelica.Units.SI.CoefficientOfHeatTransfer h, h_A, h_B "Heat transfer Coefficient" ;
 equation
 
   h = TAeZoSysPro.HeatTransfer.Functions.ExchangerHeatTransferCoeff.from_correlations(
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/baseFun.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/baseFun.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/baseFun.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/baseFun.mo"	2022-03-10 09:58:14.604148764 +0000
@@ -4,6 +4,6 @@
 
   extends Modelica.Icons.Function ;
   //
-  output Modelica.SIunits.CoefficientOfHeatTransfer h  "Heat transfer Coefficient" ;
+  output Modelica.Units.SI.CoefficientOfHeatTransfer h  "Heat transfer Coefficient" ;
 
 end baseFun;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/from_correlations.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/from_correlations.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/from_correlations.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/from_correlations.mo"	2022-03-10 09:58:14.596148763 +0000
@@ -3,19 +3,19 @@
 function from_correlations
 
   extends baseFun ;
-  input Modelica.SIunits.ReynoldsNumber Re_A "Reynolds number for flow A" ;
-  input Modelica.SIunits.PrandtlNumber Pr_A "Prandtl number for fluid A" ;
-  input Modelica.SIunits.Length Lc_A "Charactereistic length for flow A" ;
-  input Modelica.SIunits.ThermalConductivity k_A "Thermal conductivity for fluid A" ;
-  input Modelica.SIunits.ReynoldsNumber Re_B "Reynolds number for flow A" ;
-  input Modelica.SIunits.PrandtlNumber Pr_B "Prandtl number for fluid A" ;
-  input Modelica.SIunits.Length Lc_B "Charactereistic length for flow A" ;
-  input Modelica.SIunits.ThermalConductivity k_B "Thermal conductivity for fluid A" ;
-
-protected 
-  Modelica.SIunits.NusseltNumber Nu_A ;
-  Modelica.SIunits.NusseltNumber Nu_B ;
+  input Modelica.Units.SI.ReynoldsNumber Re_A "Reynolds number for flow A" ;
+  input Modelica.Units.SI.PrandtlNumber Pr_A "Prandtl number for fluid A" ;
+  input Modelica.Units.SI.Length Lc_A "Charactereistic length for flow A" ;
+  input Modelica.Units.SI.ThermalConductivity k_A "Thermal conductivity for fluid A" ;
+  input Modelica.Units.SI.ReynoldsNumber Re_B "Reynolds number for flow A" ;
+  input Modelica.Units.SI.PrandtlNumber Pr_B "Prandtl number for fluid A" ;
+  input Modelica.Units.SI.Length Lc_B "Charactereistic length for flow A" ;
+  input Modelica.Units.SI.ThermalConductivity k_B "Thermal conductivity for fluid A" ;
 
+protected
+ 
+  Modelica.Units.SI.NusseltNumber Nu_A ;
+  Modelica.Units.SI.NusseltNumber Nu_B ;
 algorithm
 
   Nu_A := TAeZoSysPro.HeatTransfer.Functions.ForcedConvection.internal_pipe_ASHRAE(Re = Re_A, Pr = Pr_A, dT = 0.0) ;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/user_defined.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/user_defined.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/user_defined.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ExchangerHeatTransferCoeff/user_defined.mo"	2022-03-10 09:58:14.584148761 +0000
@@ -2,7 +2,7 @@
 
 function user_defined
   extends baseFun ;
-  input Modelica.SIunits.CoefficientOfHeatTransfer h_in = 1 ;
+  input Modelica.Units.SI.CoefficientOfHeatTransfer h_in = 1 ;
   
 algorithm
 
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/Tests/crossFlow_cylinder_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/Tests/crossFlow_cylinder_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/Tests/crossFlow_cylinder_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/Tests/crossFlow_cylinder_ASHRAE.mo"	2022-03-10 09:58:14.556148759 +0000
@@ -1,10 +1,10 @@
 within TAeZoSysPro.HeatTransfer.Functions.ForcedConvection.Tests;
 
 model crossFlow_cylinder_ASHRAE
-
-  Modelica.SIunits.NusseltNumber Nu;
-  Modelica.SIunits.ReynoldsNumber Re;
   
+
+  Modelica.Units.SI.NusseltNumber Nu;
+  Modelica.Units.SI.ReynoldsNumber Re;
 equation
 
   Re = 10 ^ time;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/Tests/flat_plate_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/Tests/flat_plate_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/Tests/flat_plate_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/Tests/flat_plate_ASHRAE.mo"	2022-03-10 09:58:14.548148757 +0000
@@ -2,9 +2,9 @@
 
 model flat_plate_ASHRAE
 
-  Modelica.SIunits.NusseltNumber Nu ;
-  Modelica.SIunits.ReynoldsNumber Re ;
 
+  Modelica.Units.SI.NusseltNumber Nu ;
+  Modelica.Units.SI.ReynoldsNumber Re ;
 equation
 
   Re = 5 * 10^(time+5) ;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/Tests/internal_pipe_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/Tests/internal_pipe_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/Tests/internal_pipe_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/Tests/internal_pipe_ASHRAE.mo"	2022-03-10 09:58:14.536148755 +0000
@@ -1,10 +1,10 @@
 within TAeZoSysPro.HeatTransfer.Functions.ForcedConvection.Tests;
 
 model internal_pipe_ASHRAE
-  Modelica.SIunits.TemperatureDifference dT "Temperature difference between wall and fluid";
-  Modelica.SIunits.NusseltNumber Nu;
-  Modelica.SIunits.ReynoldsNumber Re;
   
+  Modelica.Units.SI.TemperatureDifference dT "Temperature difference between wall and fluid";
+  Modelica.Units.SI.NusseltNumber Nu;
+  Modelica.Units.SI.ReynoldsNumber Re;
 equation
 
   dT = 20 ;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/crossFlow_cylinder_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/crossFlow_cylinder_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/crossFlow_cylinder_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/crossFlow_cylinder_ASHRAE.mo"	2022-03-10 09:58:14.528148754 +0000
@@ -1,12 +1,12 @@
 within TAeZoSysPro.HeatTransfer.Functions.ForcedConvection;
 
 function crossFlow_cylinder_ASHRAE
-  extends Modelica.Icons.Function;
+  extends Modelica.Icons.Function;                                                                                  
 
-  input Modelica.SIunits.PrandtlNumber Pr;
-  input Modelica.SIunits.ReynoldsNumber Re;
-  output Modelica.SIunits.NusseltNumber Nu;                                                                                  
 
+  input Modelica.Units.SI.PrandtlNumber Pr;
+  input Modelica.Units.SI.ReynoldsNumber Re;
+  output Modelica.Units.SI.NusseltNumber Nu;
 algorithm
 
   Nu := 0.3 + 0.62 * Re ^ (1 / 2) * Pr ^ (1 / 3) / (1 + (0.4 / Pr) ^ (2 / 3)) ^ (1 / 4) * (1 + (Re / 282000) ^ (5 / 8)) ^ (4 / 5);
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/flat_plate_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/flat_plate_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/flat_plate_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/flat_plate_ASHRAE.mo"	2022-03-10 09:58:14.516148753 +0000
@@ -1,12 +1,12 @@
 within TAeZoSysPro.HeatTransfer.Functions.ForcedConvection;
 
 function flat_plate_ASHRAE
-  extends Modelica.Icons.Function;
+  extends Modelica.Icons.Function;                                                                                  
 
-  input Modelica.SIunits.PrandtlNumber Pr;
-  input Modelica.SIunits.ReynoldsNumber Re;
-  output Modelica.SIunits.NusseltNumber Nu;                                                                                  
 
+  input Modelica.Units.SI.PrandtlNumber Pr;
+  input Modelica.Units.SI.ReynoldsNumber Re;
+  output Modelica.Units.SI.NusseltNumber Nu;
 algorithm
 
   Nu := 0.037 * Re ^ (4 / 5) * Pr ^ (1 / 3);
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/internal_pipe_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/internal_pipe_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/internal_pipe_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/ForcedConvection/internal_pipe_ASHRAE.mo"	2022-03-10 09:58:14.496148750 +0000
@@ -4,10 +4,10 @@
 
   extends Modelica.Icons.Function;
   
-  input Modelica.SIunits.PrandtlNumber Pr;
-  input Modelica.SIunits.ReynoldsNumber Re;
-  input Modelica.SIunits.TemperatureDifference dT; 
-  output Modelica.SIunits.NusseltNumber Nu;
+  input Modelica.Units.SI.PrandtlNumber Pr;
+  input Modelica.Units.SI.ReynoldsNumber Re;
+  input Modelica.Units.SI.TemperatureDifference dT; 
+  output Modelica.Units.SI.NusseltNumber Nu;
   
 protected
   Real n "reynolds exponent" ;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/ceiling_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/ceiling_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/ceiling_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/ceiling_ASHRAE.mo"	2022-03-10 09:58:14.468148748 +0000
@@ -1,11 +1,11 @@
 within TAeZoSysPro.HeatTransfer.Functions.FreeConvection.Tests;
 
 model ceiling_ASHRAE
-
-  Modelica.SIunits.NusseltNumber Nu;
-  Modelica.SIunits.RayleighNumber Ra;
-  parameter Modelica.SIunits.TemperatureDifference dT = -20 "Difference of Temperature plate - fluid";
   
+
+  Modelica.Units.SI.NusseltNumber Nu;
+  Modelica.Units.SI.RayleighNumber Ra;
+  parameter Modelica.Units.SI.TemperatureDifference dT = -20 "Difference of Temperature plate - fluid";
 equation
 
   Ra = min(10 ^ time, 10 ^ 11);
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/ground_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/ground_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/ground_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/ground_ASHRAE.mo"	2022-03-10 09:58:14.460148745 +0000
@@ -2,10 +2,10 @@
 
 model ground_ASHRAE
 
-  Modelica.SIunits.NusseltNumber Nu ;
-  Modelica.SIunits.RayleighNumber Ra ;
-  Modelica.SIunits.TemperatureDifference dT "Difference of Temperature plate - fluid";
 
+  Modelica.Units.SI.NusseltNumber Nu ;
+  Modelica.Units.SI.RayleighNumber Ra ;
+  Modelica.Units.SI.TemperatureDifference dT "Difference of Temperature plate - fluid";
 equation
   Ra = min(10^time, 10^11);
   dT = 20 ;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/horizontal_cylinder_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/horizontal_cylinder_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/horizontal_cylinder_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/horizontal_cylinder_ASHRAE.mo"	2022-03-10 09:58:14.452148745 +0000
@@ -1,10 +1,10 @@
 within TAeZoSysPro.HeatTransfer.Functions.FreeConvection.Tests;
 
 model horizontal_cylinder_ASHRAE
-
-  Modelica.SIunits.NusseltNumber Nu;
-  Modelica.SIunits.RayleighNumber Ra;
   
+
+  Modelica.Units.SI.NusseltNumber Nu;
+  Modelica.Units.SI.RayleighNumber Ra;
 equation
 
   Ra = 10 ^ time;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/vertical_plate_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/vertical_plate_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/vertical_plate_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/vertical_plate_ASHRAE.mo"	2022-03-10 09:58:14.432148742 +0000
@@ -2,9 +2,9 @@
 
 model vertical_plate_ASHRAE
 
-  Modelica.SIunits.NusseltNumber Nu ;
-  Modelica.SIunits.RayleighNumber Ra ;
 
+  Modelica.Units.SI.NusseltNumber Nu ;
+  Modelica.Units.SI.RayleighNumber Ra ;
 equation
   Ra = min(10^time, 10^11);
     
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/vertical_plate_Recknagel.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/vertical_plate_Recknagel.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/vertical_plate_Recknagel.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/Tests/vertical_plate_Recknagel.mo"	2022-03-10 09:58:14.420148741 +0000
@@ -1,11 +1,11 @@
 within TAeZoSysPro.HeatTransfer.Functions.FreeConvection.Tests;
 
 model vertical_plate_Recknagel
-  parameter Modelica.SIunits.Temperature T_ref = 283.15 "Reference temperature";
-  Modelica.SIunits.Temperature T_mean "Mean temperature between plate and fluid";
-  Modelica.SIunits.TemperatureDifference dT "Difference temperature between plate and fluid";
-  Modelica.SIunits.CoefficientOfHeatTransfer h_cv "Convective heat transfer coefficient";
   
+  parameter Modelica.Units.SI.Temperature T_ref = 283.15 "Reference temperature";
+  Modelica.Units.SI.Temperature T_mean "Mean temperature between plate and fluid";
+  Modelica.Units.SI.TemperatureDifference dT "Difference temperature between plate and fluid";
+  Modelica.Units.SI.CoefficientOfHeatTransfer h_cv "Convective heat transfer coefficient";
 equation
 
   dT = time;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/ceiling_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/ceiling_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/ceiling_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/ceiling_ASHRAE.mo"	2022-03-10 09:58:14.404148740 +0000
@@ -4,14 +4,14 @@
 
   extends Modelica.Icons.Function;
 
-  input Modelica.SIunits.TemperatureDifference dT "Temperature difference plate - fluid";
-  input Modelica.SIunits.RayleighNumber Ra;
-  output Modelica.SIunits.NusseltNumber Nu;
+  input Modelica.Units.SI.TemperatureDifference dT "Temperature difference plate - fluid";
+  input Modelica.Units.SI.RayleighNumber Ra;
+  output Modelica.Units.SI.NusseltNumber Nu;
 
 protected
   //boundary Rayleigh number
   constant Real Ra_1 = 200, Ra_2 = 10 ^ 4, Ra_3 = 8 * 10 ^ 6 ;
-  Modelica.SIunits.NusseltNumber Nu_up, Nu_buffer ;
+  Modelica.Units.SI.NusseltNumber Nu_up, Nu_buffer ;
   Real x_small "shift value to enter in the polynomial fitting to remove discontinuities";
   
 algorithm
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/ground_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/ground_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/ground_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/ground_ASHRAE.mo"	2022-03-10 09:58:14.380148736 +0000
@@ -3,14 +3,14 @@
 function ground_ASHRAE
   extends Modelica.Icons.Function;
 
-  input Modelica.SIunits.TemperatureDifference dT;
-  input Modelica.SIunits.RayleighNumber Ra;
-  output Modelica.SIunits.NusseltNumber Nu;
+  input Modelica.Units.SI.TemperatureDifference dT;
+  input Modelica.Units.SI.RayleighNumber Ra;
+  output Modelica.Units.SI.NusseltNumber Nu;
 
 protected
   //boundary Rayleigh number
   constant Real Ra_1 = 200, Ra_2 = 10 ^ 4, Ra_3 = 8 * 10 ^ 6 ;
-  Modelica.SIunits.NusseltNumber Nu_up, Nu_buffer ;
+  Modelica.Units.SI.NusseltNumber Nu_up, Nu_buffer ;
   Real x_small "shift value to enter in the polynomial fitting to remove discontinuities";
   
 algorithm
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/horizontal_cylinder_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/horizontal_cylinder_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/horizontal_cylinder_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/horizontal_cylinder_ASHRAE.mo"	2022-03-10 09:58:14.356148733 +0000
@@ -4,10 +4,10 @@
 
   extends Modelica.Icons.Function;
 
-  input Modelica.SIunits.PrandtlNumber Pr;
-  input Modelica.SIunits.RayleighNumber Ra; 
-  output Modelica.SIunits.NusseltNumber Nu;
 
+  input Modelica.Units.SI.PrandtlNumber Pr;
+  input Modelica.Units.SI.RayleighNumber Ra; 
+  output Modelica.Units.SI.NusseltNumber Nu;
 algorithm
 
   Nu := (0.6 + 0.387 * Ra ^ (1 / 6) / (1 + (0.559 / Pr) ^ (9 / 16)) ^ (8 / 27)) ^ 2;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/vertical_plate_ASHRAE.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/vertical_plate_ASHRAE.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/vertical_plate_ASHRAE.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/vertical_plate_ASHRAE.mo"	2022-03-10 09:58:14.344148731 +0000
@@ -3,10 +3,10 @@
 function vertical_plate_ASHRAE
   extends Modelica.Icons.Function;
 
-  input Modelica.SIunits.PrandtlNumber Pr;
-  input Modelica.SIunits.RayleighNumber Ra; 
-  output Modelica.SIunits.NusseltNumber Nu;
 
+  input Modelica.Units.SI.PrandtlNumber Pr;
+  input Modelica.Units.SI.RayleighNumber Ra; 
+  output Modelica.Units.SI.NusseltNumber Nu;
 algorithm
 
 // the following code were used for avoiding the extrapolation of correlation
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/vertical_plate_Recknagel.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/vertical_plate_Recknagel.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/vertical_plate_Recknagel.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/FreeConvection/vertical_plate_Recknagel.mo"	2022-03-10 09:58:14.320148728 +0000
@@ -3,10 +3,10 @@
 function vertical_plate_Recknagel
   extends Modelica.Icons.Function;
 
-  input Modelica.SIunits.TemperatureDifference dT "Difference temperature between plate and fluid" ;
-  input Modelica.SIunits.Temperature T_mean "Mean temperature between plate and fluid" ;
-  output Modelica.SIunits.CoefficientOfHeatTransfer h_cv "Convective heat transfer coefficient";
 
+  input Modelica.Units.SI.TemperatureDifference dT "Difference temperature between plate and fluid" ;
+  input Modelica.Units.SI.Temperature T_mean "Mean temperature between plate and fluid" ;
+  output Modelica.Units.SI.CoefficientOfHeatTransfer h_cv "Convective heat transfer coefficient";
 algorithm
 
   h_cv := 9.7 * (abs(dT) / T_mean) ^ (1 / 3);
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_biotAndGeometricalGrowthGrid.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_biotAndGeometricalGrowthGrid.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_biotAndGeometricalGrowthGrid.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_biotAndGeometricalGrowthGrid.mo"	2022-03-10 09:58:14.292148725 +0000
@@ -2,23 +2,23 @@
 
 model test_biotAndGeometricalGrowthGrid
 
-  parameter Modelica.SIunits.Length L = 1 "Length of the domain to mesh" ;
+  parameter Modelica.Units.SI.Length L = 1 "Length of the domain to mesh" ;
   parameter Integer N = 8 "number of segments" ;
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h = 10 ;
-  parameter Modelica.SIunits.ThermalConductivity k = 1 ;
-  parameter Modelica.SIunits.Position x[:] = TAeZoSysPro.HeatTransfer.Functions.MeshGrid.biotAndGeometricalGrowthGrid(L = L, 
+
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h = 10 ;
+  parameter Modelica.Units.SI.ThermalConductivity k = 1 ;
+  parameter Modelica.Units.SI.Position x[:] = TAeZoSysPro.HeatTransfer.Functions.MeshGrid.biotAndGeometricalGrowthGrid(L = L, 
                                                                   N = N, 
                                                                   q = 1.2,
                                                                   h = h,
                                                                   k = k,
                                                                   symmetricalMesh = false);
-  parameter Modelica.SIunits.Position x2[:] = TAeZoSysPro.HeatTransfer.Functions.MeshGrid.biotAndGeometricalGrowthGrid(L = L, 
+  parameter Modelica.Units.SI.Position x2[:] = TAeZoSysPro.HeatTransfer.Functions.MeshGrid.biotAndGeometricalGrowthGrid(L = L, 
                                                                   N = N, 
                                                                   q = 2,
                                                                   h = h,
                                                                   k = k,
                                                                   symmetricalMesh = true);
-
 equation
 
 end test_biotAndGeometricalGrowthGrid;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_biotAndUniformGrid.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_biotAndUniformGrid.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_biotAndUniformGrid.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_biotAndUniformGrid.mo"	2022-03-10 09:58:14.276148722 +0000
@@ -2,21 +2,21 @@
 
 model test_biotAndUniformGrid
 
-  parameter Modelica.SIunits.Length L = 1 "Length of the domain to mesh" ;
+  parameter Modelica.Units.SI.Length L = 1 "Length of the domain to mesh" ;
   parameter Integer N = 5 "number of segments" ;
-  parameter Modelica.SIunits.CoefficientOfHeatTransfer h = 10 ;
-  parameter Modelica.SIunits.ThermalConductivity k = 1 ;  
-  parameter Modelica.SIunits.Position x[:] =  TAeZoSysPro.HeatTransfer.Functions.MeshGrid.biotAndUniformGrid(L = L, 
+  
+  parameter Modelica.Units.SI.CoefficientOfHeatTransfer h = 10 ;
+  parameter Modelica.Units.SI.ThermalConductivity k = 1 ;  
+  parameter Modelica.Units.SI.Position x[:] =  TAeZoSysPro.HeatTransfer.Functions.MeshGrid.biotAndUniformGrid(L = L, 
                                                                N = N, 
                                                                h = h, 
                                                                k = k,
                                                                symmetricalMesh = false);
-  parameter Modelica.SIunits.Position x2[:] =  TAeZoSysPro.HeatTransfer.Functions.MeshGrid.biotAndUniformGrid(L = L, 
+  parameter Modelica.Units.SI.Position x2[:] =  TAeZoSysPro.HeatTransfer.Functions.MeshGrid.biotAndUniformGrid(L = L, 
                                                                N = N, 
                                                                h = h, 
                                                                k = k,
                                                                symmetricalMesh =  true);
-  
 equation
 
 end test_biotAndUniformGrid;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_geometricalGrowthGrid.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_geometricalGrowthGrid.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_geometricalGrowthGrid.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_geometricalGrowthGrid.mo"	2022-03-10 09:58:14.268148721 +0000
@@ -2,23 +2,23 @@
 
 model test_geometricalGrowthGrid
 
-  parameter Modelica.SIunits.Length L = 1 "Length of the domain to mesh" ;
+  parameter Modelica.Units.SI.Length L = 1 "Length of the domain to mesh" ;
   parameter Integer N_odd = 5 "Odd number of segments" ;
   parameter Integer N_even = 6 "Even number of segments" ;
-  parameter Modelica.SIunits.Position x[:] = TAeZoSysPro.HeatTransfer.Functions.MeshGrid.geometricalGrowthGrid(L = L, 
+                                                                  
+  parameter Modelica.Units.SI.Position x[:] = TAeZoSysPro.HeatTransfer.Functions.MeshGrid.geometricalGrowthGrid(L = L, 
                                                                   N = N_odd, 
                                                                   q = 1.2,
                                                                   symmetricalMesh = false);
-  parameter Modelica.SIunits.Position x_sym_odd[:] = TAeZoSysPro.HeatTransfer.Functions.MeshGrid.geometricalGrowthGrid(L = L, 
+  parameter Modelica.Units.SI.Position x_sym_odd[:] = TAeZoSysPro.HeatTransfer.Functions.MeshGrid.geometricalGrowthGrid(L = L, 
                                                                   N = N_odd, 
                                                                   q = 1.2,
                                                                   symmetricalMesh = true);
 
-  parameter Modelica.SIunits.Position x_sym_even[:] = TAeZoSysPro.HeatTransfer.Functions.MeshGrid.geometricalGrowthGrid(L = L, 
+  parameter Modelica.Units.SI.Position x_sym_even[:] = TAeZoSysPro.HeatTransfer.Functions.MeshGrid.geometricalGrowthGrid(L = L, 
                                                                   N = N_even, 
                                                                   q = 1.2,
                                                                   symmetricalMesh = true);
-                                                                  
 equation
 
 
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_uniformGrid.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_uniformGrid.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_uniformGrid.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/Tests/test_uniformGrid.mo"	2022-03-10 09:58:14.252148719 +0000
@@ -2,10 +2,10 @@
 
 model test_uniformGrid
 
-  parameter Modelica.SIunits.Length L = 1 "Length of the domain to mesh" ;
+  parameter Modelica.Units.SI.Length L = 1 "Length of the domain to mesh" ;
   parameter Integer N = 5 "number of segments" ;
-  parameter Modelica.SIunits.Position x[:] = TAeZoSysPro.HeatTransfer.Functions.MeshGrid.uniformGrid(L = L, N = N);
 
+  parameter Modelica.Units.SI.Position x[:] = TAeZoSysPro.HeatTransfer.Functions.MeshGrid.uniformGrid(L = L, N = N);
 equation
 
 end test_uniformGrid;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/biotAndGeometricalGrowthGrid.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/biotAndGeometricalGrowthGrid.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/biotAndGeometricalGrowthGrid.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/biotAndGeometricalGrowthGrid.mo"	2022-03-10 09:58:14.244148718 +0000
@@ -2,18 +2,18 @@
 
 function biotAndGeometricalGrowthGrid
 
-  input Modelica.SIunits.Length L "Length of the domain to mesh" ;
+  input Modelica.Units.SI.Length L "Length of the domain to mesh" ;
   input Integer N "number of segments" ;
   input Real q "Growth rate" ;
-  input Modelica.SIunits.CoefficientOfHeatTransfer h "Decoupled value of the heat transfer coefficient" ;
-  input Modelica.SIunits.ThermalConductivity k "Decoupled value of thermal conductivity" ;
+  input Modelica.Units.SI.CoefficientOfHeatTransfer h "Decoupled value of the heat transfer coefficient" ;
+  input Modelica.Units.SI.ThermalConductivity k "Decoupled value of thermal conductivity" ;
   input Boolean symmetricalMesh = true "Axial symmetry mesh where the axis is the middle of the domain";
-  output Modelica.SIunits.Position x[N+1] "Vector of vertice position" ;
+  output Modelica.Units.SI.Position x[N+1] "Vector of vertice position" ;
 
 protected
-  constant Modelica.SIunits.BiotNumber Bi = 0.1 ; 
-  Modelica.SIunits.Distance dx_biot "length of the first segment according to the biot number" ;
-  Modelica.SIunits.Distance dx "size of the first element" ;
+  constant Modelica.Units.SI.BiotNumber Bi = 0.1 ; 
+  Modelica.Units.SI.Distance dx_biot "length of the first segment according to the biot number" ;
+  Modelica.Units.SI.Distance dx "size of the first element" ;
   Integer N_2 "number of segments - 2 for biot segment" ;
 
 algorithm
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/biotAndUniformGrid.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/biotAndUniformGrid.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/biotAndUniformGrid.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/biotAndUniformGrid.mo"	2022-03-10 09:58:14.232148717 +0000
@@ -2,16 +2,16 @@
 
 function biotAndUniformGrid
 
-  input Modelica.SIunits.Length L "Length of the domain to mesh" ;
+  input Modelica.Units.SI.Length L "Length of the domain to mesh" ;
   input Integer N "number of segments" ;
-  input Modelica.SIunits.CoefficientOfHeatTransfer h "Decoupled value of the heat transfer coefficient" ;
-  input Modelica.SIunits.ThermalConductivity k "Decoupled value of thermal conductivity" ;
+  input Modelica.Units.SI.CoefficientOfHeatTransfer h "Decoupled value of the heat transfer coefficient" ;
+  input Modelica.Units.SI.ThermalConductivity k "Decoupled value of thermal conductivity" ;
   input Boolean symmetricalMesh = true "Axial symmetry mesh where the axis is the middle of the domain";
-  output Modelica.SIunits.Position x[N+1] "Vector of vertice position" ;
+  output Modelica.Units.SI.Position x[N+1] "Vector of vertice position" ;
 
 protected
-  constant Modelica.SIunits.BiotNumber Bi = 0.1 ; 
-  Modelica.SIunits.Distance dx "length of the first segment according to the biot number" ;
+  constant Modelica.Units.SI.BiotNumber Bi = 0.1 ; 
+  Modelica.Units.SI.Distance dx "length of the first segment according to the biot number" ;
   
 algorithm
   if N > 2 then
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/geometricalGrowthGrid.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/geometricalGrowthGrid.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/geometricalGrowthGrid.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/geometricalGrowthGrid.mo"	2022-03-10 09:58:14.224148716 +0000
@@ -2,14 +2,14 @@
 
 function geometricalGrowthGrid
 
-  input Modelica.SIunits.Length L "Length of the domain to mesh" ;
+  input Modelica.Units.SI.Length L "Length of the domain to mesh" ;
   input Integer N "number of segments" ;
   input Real q "Growth rate" ;
   input Boolean symmetricalMesh = true "Axial symmetry mesh where the axis is the middle of the domain";
-  output Modelica.SIunits.Position x[N+1] "Vector of vertice position" ;
+  output Modelica.Units.SI.Position x[N+1] "Vector of vertice position" ;
 
 protected
-  Modelica.SIunits.Length dx "size of the first element" ;
+  Modelica.Units.SI.Length dx "size of the first element" ;
 
 algorithm
 
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/uniformGrid.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/uniformGrid.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/uniformGrid.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/MeshGrid/uniformGrid.mo"	2022-03-10 09:58:14.216148716 +0000
@@ -1,9 +1,9 @@
 within TAeZoSysPro.HeatTransfer.Functions.MeshGrid;
 
 function uniformGrid
-  input Modelica.SIunits.Length L "Length of the domain to mesh" ;
+  input Modelica.Units.SI.Length L "Length of the domain to mesh" ;
   input Integer N "number of segments" ;
-  output Modelica.SIunits.Position x[N+1] "Vector of vertice position" ;
+  output Modelica.Units.SI.Position x[N+1] "Vector of vertice position" ;
 
 algorithm
 
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/Radiation/Tests/h_rad.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/Radiation/Tests/h_rad.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/Radiation/Tests/h_rad.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/Radiation/Tests/h_rad.mo"	2022-03-10 09:58:14.180148710 +0000
@@ -2,11 +2,11 @@
 
 model h_rad
 
-  parameter Modelica.SIunits.Temperature T_A = 303.15 ;
-  parameter Modelica.SIunits.Temperature T_B = 283.15 ;
-  constant Modelica.SIunits.Emissivity eps = 1 ;
-  Modelica.SIunits.CoefficientOfHeatTransfer h_rad, h_rad_check ;
 
+  parameter Modelica.Units.SI.Temperature T_A = 303.15 ;
+  parameter Modelica.Units.SI.Temperature T_B = 283.15 ;
+  constant Modelica.Units.SI.Emissivity eps = 1 ;
+  Modelica.Units.SI.CoefficientOfHeatTransfer h_rad, h_rad_check ;
 equation
 
   h_rad = Radiation.h_rad(T_A = T_A, T_B = T_B, R_th = 1/eps) ;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/Radiation/h_rad.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/Radiation/h_rad.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/Radiation/h_rad.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Functions/Radiation/h_rad.mo"	2022-03-10 09:58:14.172148710 +0000
@@ -2,10 +2,10 @@
 
 function h_rad
 
-  input Modelica.SIunits.Temperature T_A ;
-  input Modelica.SIunits.Temperature T_B ;
-  input Modelica.SIunits.ThermalResistance R_th "Thermal resistance between solid A and B (emissivity and view factor)" ;
-  output Modelica.SIunits.CoefficientOfHeatTransfer h_rad ;
+  input Modelica.Units.SI.Temperature T_A ;
+  input Modelica.Units.SI.Temperature T_B ;
+  input Modelica.Units.SI.ThermalResistance R_th "Thermal resistance between solid A and B (emissivity and view factor)" ;
+  output Modelica.Units.SI.CoefficientOfHeatTransfer h_rad ;
   
 algorithm
   
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Interfaces/HeatPort.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Interfaces/HeatPort.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Interfaces/HeatPort.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Interfaces/HeatPort.mo"	2022-03-10 09:58:14.148148706 +0000
@@ -1,8 +1,8 @@
 within TAeZoSysPro.HeatTransfer.Interfaces;
 
 partial connector HeatPort "Thermal port for 1-dim. heat transfer"
-  Modelica.SIunits.Temperature T "Port temperature";
-  flow Modelica.SIunits.HeatFlowRate Q_flow
+  Modelica.Units.SI.Temperature T "Port temperature";
+  flow Modelica.Units.SI.HeatFlowRate Q_flow
     "Heat flow rate (positive if flowing from outside into the component)";
   annotation (Documentation(info="<html>
 
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Sensors/Density.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Sensors/Density.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Sensors/Density.mo"	2022-03-10 09:57:44.040144892 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/HeatTransfer/Sensors/Density.mo"	2022-03-10 09:58:14.100148700 +0000
@@ -2,7 +2,7 @@
 
 model Density "Ideal one port density sensor"
   replaceable package Medium = TAeZoSysPro.Media.MyMedia ;
-  extends Modelica.Icons.RotationalSensor;
+  extends Modelica.Icons.RoundSensor;
   Modelica.Blocks.Interfaces.RealOutput d(final quantity="Density",
                                           final unit="kg/m3",
                                           min=0) "Density in port medium"
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/Media/Air/Air_H2.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/Media/Air/Air_H2.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/Media/Air/Air_H2.mo"	2022-03-10 09:57:44.124144902 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/Media/Air/Air_H2.mo"	2022-03-10 09:58:13.992148686 +0000
@@ -18,18 +18,18 @@
   constant Real k_mair=dihydrogen.MM/dryair.MM "Ratio of molar weights";
 
   record dryair
-    constant Modelica.SIunits.SpecificHeatCapacityAtConstantPressure cp = 1005 "cp(p_ref, T_ref)";
-    constant Modelica.SIunits.MolarMass MM = Modelica.Media.IdealGases.Common.SingleGasesData.Air;
+    constant Modelica.Units.SI.SpecificHeatCapacityAtConstantPressure cp = 1005 "cp(p_ref, T_ref)";
+    constant Modelica.Units.SI.MolarMass MM = Modelica.Media.IdealGases.Common.SingleGasesData.Air;
     constant Real R(final unit="J/(kg.K)") = Modelica.Constants.R / MM;
-    constant Modelica.SIunits.DynamicViscosity eta = 1.8e-5 "eta(p_ref, T_ref)";
+    constant Modelica.Units.SI.DynamicViscosity eta = 1.8e-5 "eta(p_ref, T_ref)";
   end dryair;
 
   record dihydrogen
-    constant Modelica.SIunits.SpecificHeatCapacityAtConstantPressure cp = 14287 "cp(p_ref, T_ref)";
-    constant Modelica.SIunits.MolarMass MM = Modelica.Media.IdealGases.Common.SingleGasesData.H2; 
+    constant Modelica.Units.SI.SpecificHeatCapacityAtConstantPressure cp = 14287 "cp(p_ref, T_ref)";
+    constant Modelica.Units.SI.MolarMass MM = Modelica.Media.IdealGases.Common.SingleGasesData.H2; 
     constant Real R(final unit="J/(kg.K)") = Modelica.Constants.R / MM;
-    constant Modelica.SIunits.DynamicViscosity eta = 8.8e-5 "eta(p_ref, T_ref)";
-    constant Modelica.SIunits.ThermalConductivity lambda = 1.8248 "lambda(p_ref, T_ref)";
+    constant Modelica.Units.SI.DynamicViscosity eta = 8.8e-5 "eta(p_ref, T_ref)";
+    constant Modelica.Units.SI.ThermalConductivity lambda = 1.8248 "lambda(p_ref, T_ref)";
   end dihydrogen;
   
   redeclare replaceable model extends BaseProperties(
@@ -52,10 +52,10 @@
       p,
       T,
       X);
-    u = h - R*T;
-    R = H2.R*Xi[H2] + dryair.R*(1-Xi[H2]);
-    d = p/(R*T);
-    MM = Modelica.Constants.R/R;
+  u = h - R_s * T;
+  R_s = H2.R * Xi[H2] + dryair.R * (1 - Xi[H2]);
+  d = p / (R_s * T);
+  MM = Modelica.Constants.R / R_s;
     state.p = p;
     state.T = T;
     state.X = X;
@@ -63,12 +63,12 @@
   
   redeclare function extends gasConstant
   algorithm
-    R := dihydrogen.R*state.X[H2] + dryair.R*(1-state.X[H2]);
+    R_s := dihydrogen.R*state.X[H2] + dryair.R*(1-state.X[H2]);
   end gasConstant ;
   
   function gasConstant_X
     extends Modelica.Icons.Function;
-    input Modelica.SIunits.MassFraction X[:];
+    input Modelica.Units.SI.MassFraction X[:];
     output Real R(final unit="J/(kg.K)");
   algorithm
     R := dihydrogen.R*X[H2] + dryair.R*(1-state.X[H2]);
@@ -109,7 +109,8 @@
   
   redeclare function extends dynamicViscosity
   protected
-    Modelica.SIunits.MoleFraction Y[nX];
+    Modelica.Units.SI.MoleFraction Y[nX];
+
   algorithm
     Y := massToMoleFractions(X=state.X, MMX={dihydrogen.MM, dryair.MM});
     eta := dihydrogen.eta * Y[H2] + dryair.eta * (1-Y[H2]);
@@ -117,7 +118,8 @@
 
   redeclare function extends thermalConductivity
   protected
-    Modelica.SIunits.MoleFraction Y[nX];
+    Modelica.Units.SI.MoleFraction Y[nX];
+
   algorithm
     Y := massToMoleFractions(X=state.X, MMX={dihydrogen.MM, dryair.MM});
     lambda := dihydrogen.lambda * Y[H2] + dryair.lambda * (1-Y[H2]);
@@ -202,27 +204,27 @@
   end MolarMass;
   
   function temperature_hX
-    input Modelica.SIunits.SpecificEnthalpy h;
-    input Modelica.SIunits.MassFraction X[:];
-    output Modelica.SIunits.Temperature T;
+    input Modelica.Units.SI.SpecificEnthalpy h;
+    input Modelica.Units.SI.MassFraction X[:];
+    output Modelica.Units.SI.Temperature T;
   algorithm
     T := h / (X[H2] * dihydrogen.cp + (1-X[H2])*dryair.cp) + reference_T ;
   end temperature_hX;
   
   function pressure_dTX
-    input Modelica.SIunits.Density d;
-    input Modelica.SIunits.Temperature T;
-    input Modelica.SIunits.MassFraction X[:];
-    output Modelica.SIunits.Pressure p;
+    input Modelica.Units.SI.Density d;
+    input Modelica.Units.SI.Temperature T;
+    input Modelica.Units.SI.MassFraction X[:];
+    output Modelica.Units.SI.Pressure p;
   algorithm
     p := d * gasConstant_X(X) * T ;
   end pressure_dTX;
   
   redeclare function extends specificEnthalpy_pTX
-    input Modelica.SIunits.Pressure p = reference_p;
-    input Modelica.SIunits.Temperature T;
-    input Modelica.SIunits.MassFraction X[:];
-    output Modelica.SIunits.SpecificEnthalpy h;
+    input Modelica.Units.SI.Pressure p = reference_p;
+    input Modelica.Units.SI.Temperature T;
+    input Modelica.Units.SI.MassFraction X[:];
+    output Modelica.Units.SI.SpecificEnthalpy h;
   algorithm
     h := (dihydrogen.cp*X[H2] + dryair.cp*(1-X[H2]))*(T-reference_T);
   end specificEnthalpy_pTX;  
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/Media/Air/MoistAir.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/Media/Air/MoistAir.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/Media/Air/MoistAir.mo"	2022-03-10 09:57:44.124144902 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/Media/Air/MoistAir.mo"	2022-03-10 09:58:13.960148682 +0000
@@ -1,4 +1,4 @@
-﻿within TAeZoSysPro.Media.Air;
+within TAeZoSysPro.Media.Air;
 
 package MoistAir
 
@@ -9,13 +9,13 @@
   constant Real k_mair = steam.MM / dryair.MM "Ratio of molar weights";
 
   record dryair
-    constant SI.SpecificHeatCapacity R = Modelica.Media.IdealGases.Common.SingleGasesData.Air.R;
+    constant SI.SpecificHeatCapacity R = Modelica.Media.IdealGases.Common.SingleGasesData.Air.R_s;
     constant SI.MolarMass MM = Modelica.Media.IdealGases.Common.SingleGasesData.Air.MM;
     constant SI.SpecificHeatCapacityAtConstantPressure cp = 1006.4 "Specific heat capacity of dry air at 293.15K (20°C)";
   end dryair;
 
   record steam
-    constant SI.SpecificHeatCapacity R = Modelica.Media.IdealGases.Common.SingleGasesData.H2O.R;
+    constant SI.SpecificHeatCapacity R = Modelica.Media.IdealGases.Common.SingleGasesData.H2O.R_s;
     constant SI.MolarMass MM = Modelica.Media.IdealGases.Common.SingleGasesData.H2O.MM;
     constant SI.SpecificEnergy h_lv = 2453.55e3 "Enthalpy of vaporization of water at 293.15K (20°C)";
     constant SI.SpecificHeatCapacityAtConstantPressure cp = 1886.0 "Specific heat capacity of steam at 293.15K (20°C)";
@@ -27,8 +27,7 @@
 
   constant SI.MolarMass[2] MMX = {steam.MM, dryair.MM} "Molar masses of components";
   constant FluidConstants[nS] fluidConstants = {Modelica.Media.IdealGases.Common.FluidData.H2O, Modelica.Media.IdealGases.Common.FluidData.N2} "Constant data for the fluid";
-  import SI = Modelica.SIunits;
-  import Modelica.SIunits;
+  import Modelica.Units.SI;
 
   redeclare record extends ThermodynamicState "Thermodynamic state variables of moist air"
       Density d "density of medium";
@@ -60,12 +59,12 @@
       X_air = 1 - Xi[Water];
       h = h_dTX(d, T, Xi);
 //      R = dryair.R * (X_air / (1 - X_liquid)) + steam.R * X_steam / (1 - X_liquid);
-      R = r_dTX(d, T, Xi);
+      R_s = r_dTX(d, T, Xi);
 //
-      u = h - R * T;
+      u = h - R_s * T;
 //    u = X_air*720*(T-reference_T) + X_steam*(1000*(T-reference_T)+steam.h_lv) + X_liquid*4185*(T-reference_T);
 //    u = h - p/d;
-      p = d * (1 - X_liquid) * R * T;
+      p = d * (1 - X_liquid) * R_s * T;
 /* Note, is computed under the assumption that the volume of the liquid
          water is negligible with respect to the volume of air and of steam
       */
@@ -596,8 +595,8 @@
 
   function enthalpyOfWater "Computes specific enthalpy of water (solid/liquid) near atmospheric pressure from temperature T"
     extends Modelica.Icons.Function;
-    input SIunits.Temperature T "Temperature";
-    output SIunits.SpecificEnthalpy h "Specific enthalpy of water";
+    input SI.Temperature T "Temperature";
+    output SI.SpecificEnthalpy h "Specific enthalpy of water";
   protected
     constant SI.SpecificHeatCapacity cp_ice = 2050 "Specific heat capacity of ice";
   algorithm
@@ -620,7 +619,7 @@
 
   function enthalpyOfWater_der "Derivative function of enthalpyOfWater"
     extends Modelica.Icons.Function;
-    input SIunits.Temperature T "Temperature";
+    input SI.Temperature T "Temperature";
     input Real dT(unit = "K/s") "Time derivative of temperature";
     output Real dh(unit = "J/(kg.s)") "Time derivative of specific enthalpy";
   protected
@@ -1136,7 +1135,7 @@
   end specificHeatCapacityCv;
 
   redeclare function extends dynamicViscosity "Return dynamic viscosity as a function of the thermodynamic state record, valid from 123.15 K to 1273.15 K"
-      import Modelica.Media.Incompressible.TableBased.Polynomials_Temp;
+      import Modelica.Math.Polynomials;
 
     algorithm
       eta := 1.81063e-5;
@@ -1148,8 +1147,8 @@
   end dynamicViscosity;
 
   redeclare function extends thermalConductivity "Return thermal conductivity as a function of the thermodynamic state record, valid from 123.15 K to 1273.15 K"
-      import Modelica.Media.Incompressible.TableBased.Polynomials_Temp;
-      import Cv = Modelica.SIunits.Conversions;
+      import Modelica.Math.Polynomials;
+      import Cv = Modelica.Units.Conversions;
 
     algorithm
       lambda := 0.0258738;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Examples/AdvectionGaussian.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Examples/AdvectionGaussian.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Examples/AdvectionGaussian.mo"	2022-03-10 09:57:44.124144902 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Examples/AdvectionGaussian.mo"	2022-03-10 09:58:13.452148619 +0000
@@ -6,12 +6,12 @@
   constant Integer N = 30 "number of discrete node";
   constant Real std_dev = 0.05;
   
-  parameter Modelica.SIunits.Length L = 1 "length of the domain";
+  parameter Modelica.Units.SI.Length L = 1 "length of the domain";
   parameter Real dx = L / (N + 1 - 1);
   parameter Real x[N] = linspace(dx/2, L - dx/2, N);
   parameter Real x_bis[N] = linspace(dx/2, L - dx/2, N);
   
-  Modelica.SIunits.Velocity Vel "Displacemement velocity";
+  Modelica.Units.SI.Velocity Vel "Displacemement velocity";
   Real[N] u_1order;
   Real[N] u_analytic;
   Real positionMean;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Examples/BoundaryStepDiffusion.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Examples/BoundaryStepDiffusion.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Examples/BoundaryStepDiffusion.mo"	2022-03-10 09:57:44.124144902 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Examples/BoundaryStepDiffusion.mo"	2022-03-10 09:58:13.440148616 +0000
@@ -1,7 +1,7 @@
 within TAeZoSysPro.PDE.Examples;
 
 model BoundaryStepDiffusion
-  import pi = Modelica.Constants.pi ;
+  import  Modelica.Constants.pi ;
 
   extends Modelica.Icons.Example ;
   
@@ -10,11 +10,11 @@
   constant Real u_left = 20 ;
   
   parameter Integer N(quantity ="number of discrete layer", min=11) = 11 "Number of layer" ;  
-  parameter Modelica.SIunits.Length L = 1 "length of the domain";
+  parameter Modelica.Units.SI.Length L = 1 "length of the domain";
   parameter Real dx = L / N ;
   parameter Real x[N+2] = cat(1, {0.0}, linspace(dx/2,L-dx/2,N), {L} ) ;
   parameter Real xbis[N+2] = cat(1, {0.0}, linspace(dx/2,L-dx/2,N), {L} ) ;
-  parameter Modelica.SIunits.DiffusionCoefficient Dth = 0.001  ;
+  parameter Modelica.Units.SI.DiffusionCoefficient Dth = 0.001  ;
   Real[N+2] u_1order ;
   Real[N+2] u_analytic ;
   
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Examples/DiffusionGaussian.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Examples/DiffusionGaussian.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Examples/DiffusionGaussian.mo"	2022-03-10 09:57:44.124144902 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Examples/DiffusionGaussian.mo"	2022-03-10 09:58:13.404148612 +0000
@@ -1,17 +1,17 @@
 within TAeZoSysPro.PDE.Examples;
 
 model DiffusionGaussian
-  import pi = Modelica.Constants.pi ;
+  import  Modelica.Constants.pi ;
 
   extends Modelica.Icons.Example ;
   
   parameter Integer N(quantity ="number of discrete layer", min=11) = 22 "Number of layer" ;  
-  parameter Modelica.SIunits.Length L = 2 "length of the domain";
+  parameter Modelica.Units.SI.Length L = 2 "length of the domain";
   parameter Real dx = L / N ;
   parameter Real x[N+2] = cat(1, {0.0}, linspace(dx/2,L-dx/2,N), {L} ) ;
   parameter Real xbis[N+2] = cat(1, {0.0}, linspace(dx/2,L-dx/2,N), {L} ) ;
-  parameter Modelica.SIunits.DiffusionCoefficient Dth = 1  ;
-  parameter Modelica.SIunits.Time t_0 = 1e-3 " Initial time to avoid divisions by zero";
+  parameter Modelica.Units.SI.DiffusionCoefficient Dth = 1  ;
+  parameter Modelica.Units.SI.Time t_0 = 1e-3 " Initial time to avoid divisions by zero";
   Real[N+2] u_1order ;
   Real[N+2] u_analytic ;
   
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/ThermalDiffusion/CentralSecondOrder.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/ThermalDiffusion/CentralSecondOrder.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/ThermalDiffusion/CentralSecondOrder.mo"	2022-03-10 09:57:44.124144902 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/ThermalDiffusion/CentralSecondOrder.mo"	2022-03-10 09:58:13.380148608 +0000
@@ -3,7 +3,7 @@
 model CentralSecondOrder
   // user defined parameters
   parameter Integer N = 3 "Number of discrete layers";
-  parameter Modelica.SIunits.Position x[N+1] "Position array" ;
+  parameter Modelica.Units.SI.Position x[N+1] "Position array" ;
     
   // inputs
   input Real CoeffTimeDer=1 "Coefficient for time derivative";
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Transport/UpwindFirstOrder.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Transport/UpwindFirstOrder.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Transport/UpwindFirstOrder.mo"	2022-03-10 09:57:44.124144902 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/PDE/Transport/UpwindFirstOrder.mo"	2022-03-10 09:58:13.356148607 +0000
@@ -9,7 +9,7 @@
   input Real CoeffTimeDer=1 "Coefficient for time derivative" ;
   input Real CoeffSpaceDer "Coefficient for space derivative" ;
   input Real SourceTerm[N] "Source term in the right hand side" ;
-  input Modelica.SIunits.Position x[N+1] "Position array" ;
+  input Modelica.Units.SI.Position x[N+1] "Position array" ;
 //  input Boolean SteadyState = false "Steady state mode" ;
   
   // internal variable
@@ -24,7 +24,7 @@
     CoeffTimeDer * der(u[1, n_quantity]) = (CoeffSpaceDer+abs(CoeffSpaceDer))/2 * (u_ghost_left[n_quantity] - u[1, n_quantity]) / (x[2] - x[1]) - (CoeffSpaceDer-abs(CoeffSpaceDer))/2 * (u[2, n_quantity] - u[1, n_quantity]) / (x[2] - x[1]) + SourceTerm[1] "PDE domain";
     //right boundary
     CoeffTimeDer * der(u[N, n_quantity]) = (CoeffSpaceDer+abs(CoeffSpaceDer))/2 * (u[N-1, n_quantity] - u[N, n_quantity]) / (x[N+1] - x[N]) - (CoeffSpaceDer-abs(CoeffSpaceDer))/2 * (u_ghost_right[n_quantity] - u[N, n_quantity]) / (x[N+1] - x[N]) + SourceTerm[N] "PDE domain";
-    //domain  
+//domain
     for i in 2:N-1 loop /* loop on discrete node */
       CoeffTimeDer * der(u[i, n_quantity]) + (CoeffSpaceDer+abs(CoeffSpaceDer))/2 * (u[i, n_quantity] - u[i-1, n_quantity]) / (x[i] - x[i-1]) + (CoeffSpaceDer-abs(CoeffSpaceDer))/2 * (u[i+1, n_quantity] - u[i, n_quantity]) / (x[i+1] - x[i]) = SourceTerm[i] "PDE domain";    
     end for ;
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/openmodelica.metadata.json" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/openmodelica.metadata.json"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/openmodelica.metadata.json"	2022-03-10 09:57:44.124144902 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/openmodelica.metadata.json"	2022-03-10 09:58:17.164149088 +0000
@@ -1 +1 @@
-{"path":"", "sha":"2c409784af6252128e0c9568a44198cb08e091a5", "support":"experimental", "uses":{"Modelica":"3.2.3"}, "version":"3.1.0", "zipfile":"https://gitlab.pam-retd.fr/TAeZoSysPro/taezosyspro/-/archive/2c409784af6252128e0c9568a44198cb08e091a5/taezosyspro-2c409784af6252128e0c9568a44198cb08e091a5.zip"}
+{"path": "", "sha": "2c409784af6252128e0c9568a44198cb08e091a5", "support": "experimental", "uses": {"Modelica": "4.0.0"}, "version": "3.1.0", "zipfile": "https://gitlab.pam-retd.fr/TAeZoSysPro/taezosyspro/-/archive/2c409784af6252128e0c9568a44198cb08e091a5/taezosyspro-2c409784af6252128e0c9568a44198cb08e091a5.zip", "extraInfo": "Conversion script /home/hudson/saved_omc/libraries/.openmodelica/libraries/Modelica 4.0.0+maint.om//Resources/Scripts/Conversion/ConvertModelica_from_3.2.3_to_4.0.0.mos was applied"}
\ No newline at end of file
diff -ur "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/package.mo" "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/package.mo"
--- "/home/hudson/saved_omc/libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/package.mo"	2022-03-10 09:57:44.124144902 +0000
+++ "converted-libraries/.openmodelica/libraries/TAeZoSysPro 3.1.0/package.mo"	2022-03-10 09:58:17.160149088 +0000
@@ -95,6 +95,6 @@
 	
 
     </body></html>"),
-    uses(Modelica(version = "3.2.3")));
+    uses(Modelica(version = "4.0.0")));
 
 end TAeZoSysPro;
\ No newline at end of file
