diff --git a/IBPSA/Airflow/Multizone/BaseClasses/Door.mo b/IBPSA/Airflow/Multizone/BaseClasses/Door.mo
new file mode 100644
index 0000000000..ff629a94be
--- /dev/null
+++ b/IBPSA/Airflow/Multizone/BaseClasses/Door.mo
@@ -0,0 +1,125 @@
+within IBPSA.Airflow.Multizone.BaseClasses;
+partial model Door
+ "Partial door model for bi-directional flow"
+ extends IBPSA.Fluid.Interfaces.PartialFourPortInterface(
+ redeclare final package Medium1 = Medium,
+ redeclare final package Medium2 = Medium,
+ final allowFlowReversal1=true,
+ final allowFlowReversal2=true,
+ final m1_flow_nominal=10/3600*1.2,
+ final m2_flow_nominal=m1_flow_nominal,
+ final m1_flow_small=1E-4*abs(m1_flow_nominal),
+ final m2_flow_small=1E-4*abs(m2_flow_nominal));
+
+ replaceable package Medium =
+ Modelica.Media.Interfaces.PartialMedium "Medium in the component"
+ annotation (choices(
+ choice(redeclare package Medium = IBPSA.Media.Air "Moist air")));
+
+ parameter Modelica.SIunits.Length wOpe=0.9 "Width of opening"
+ annotation (Dialog(group="Geometry"));
+ parameter Modelica.SIunits.Length hOpe=2.1 "Height of opening"
+ annotation (Dialog(group="Geometry"));
+
+ parameter Modelica.SIunits.PressureDifference dp_turbulent(
+ min=0,
+ displayUnit="Pa") = 0.01
+ "Pressure difference where laminar and turbulent flow relation coincide"
+ annotation(Dialog(tab="Advanced"));
+
+ Modelica.SIunits.VolumeFlowRate VAB_flow(nominal=0.001)
+ "Volume flow rate from A to B if positive";
+ Modelica.SIunits.VolumeFlowRate VBA_flow(nominal=0.001)
+ "Volume flow rate from B to A if positive";
+
+ input Modelica.SIunits.Velocity vAB(nominal=0.01) "Average velocity from A to B";
+ input Modelica.SIunits.Velocity vBA(nominal=0.01) "Average velocity from B to A";
+
+protected
+ final parameter Modelica.SIunits.Area AOpe = wOpe*hOpe "Open aperture area";
+
+ constant Real conTP = IBPSA.Media.Air.dStp*Modelica.Media.IdealGases.Common.SingleGasesData.Air.R
+ "Conversion factor for converting temperature difference to pressure difference";
+
+ parameter Medium.ThermodynamicState sta_default=Medium.setState_pTX(
+ T=Medium.T_default,
+ p=Medium.p_default,
+ X=Medium.X_default);
+
+ parameter Modelica.SIunits.Density rho_default=Medium.density(sta_default)
+ "Density";
+
+ Modelica.SIunits.VolumeFlowRate VABp_flow(nominal=0.001)
+ "Volume flow rate from A to B if positive due to static pressure difference";
+ Modelica.SIunits.MassFlowRate mABt_flow(nominal=0.001)
+ "Mass flow rate from A to B if positive due to buoyancy";
+
+equation
+ // Net flow rate
+ port_a1.m_flow = (rho_default * VABp_flow/2 + mABt_flow);
+ port_b2.m_flow = (rho_default * VABp_flow/2 - mABt_flow);
+
+ // Average velocity (using the whole orifice area)
+ VAB_flow = (max(port_a1.m_flow, 0) + max(port_b2.m_flow, 0))/rho_default;
+ VBA_flow = (max(port_a2.m_flow, 0) + max(port_b1.m_flow, 0))/rho_default;
+
+ // Energy balance (no storage, no heat loss/gain)
+ port_a1.h_outflow = inStream(port_b1.h_outflow);
+ port_b1.h_outflow = inStream(port_a1.h_outflow);
+ port_a2.h_outflow = inStream(port_b2.h_outflow);
+ port_b2.h_outflow = inStream(port_a2.h_outflow);
+
+ // Mass balance (no storage)
+ port_a1.m_flow = -port_b1.m_flow;
+ port_a2.m_flow = -port_b2.m_flow;
+
+ port_a1.Xi_outflow = inStream(port_b1.Xi_outflow);
+ port_b1.Xi_outflow = inStream(port_a1.Xi_outflow);
+ port_a2.Xi_outflow = inStream(port_b2.Xi_outflow);
+ port_b2.Xi_outflow = inStream(port_a2.Xi_outflow);
+
+ // Transport of trace substances
+ port_a1.C_outflow = inStream(port_b1.C_outflow);
+ port_b1.C_outflow = inStream(port_a1.C_outflow);
+ port_a2.C_outflow = inStream(port_b2.C_outflow);
+ port_b2.C_outflow = inStream(port_a2.C_outflow);
+
+ annotation (
+ Icon(graphics={
+ Rectangle(
+ extent={{-60,80},{60,-84}},
+ lineColor={0,0,255},
+ pattern=LinePattern.None,
+ fillColor={85,75,55},
+ fillPattern=FillPattern.Solid),
+ Rectangle(
+ extent={{-54,72},{56,-84}},
+ lineColor={0,0,0},
+ fillColor={215,215,215},
+ fillPattern=FillPattern.Solid),
+ Polygon(
+ points={{56,72},{-36,66},{-36,-90},{56,-84},{56,72}},
+ lineColor={0,0,0},
+ fillColor={95,95,95},
+ fillPattern=FillPattern.Solid),
+ Polygon(
+ points={{-30,-10},{-16,-8},{-16,-14},{-30,-16},{-30,-10}},
+ lineColor={0,0,255},
+ pattern=LinePattern.None,
+ fillColor={0,0,0},
+ fillPattern=FillPattern.Solid)}),
+ Documentation(info="
+
+This is a partial model for the bi-directional air flow through a door.
+
+",
+revisions="
+
+-
+October 6, 2020, by Michael Wetter:
+First implementation for
+#1353.
+
+
+"));
+end Door;
diff --git a/IBPSA/Airflow/Multizone/BaseClasses/DoorDiscretized.mo b/IBPSA/Airflow/Multizone/BaseClasses/DoorDiscretized.mo
index d6ffc0eb59..087a534f30 100644
--- a/IBPSA/Airflow/Multizone/BaseClasses/DoorDiscretized.mo
+++ b/IBPSA/Airflow/Multizone/BaseClasses/DoorDiscretized.mo
@@ -5,7 +5,9 @@ partial model DoorDiscretized
parameter Integer nCom=10 "Number of compartments for the discretization";
- parameter Modelica.SIunits.PressureDifference dp_turbulent(min=0) = 0.01
+ parameter Modelica.SIunits.PressureDifference dp_turbulent(
+ min=0,
+ displayUnit="Pa") = 0.01
"Pressure difference where laminar and turbulent flow relation coincide. Recommended: 0.01";
Modelica.SIunits.PressureDifference dpAB[nCom](each nominal=1)
@@ -93,7 +95,12 @@ equation
lineColor={0,0,255},
pattern=LinePattern.None,
fillColor={0,0,0},
- fillPattern=FillPattern.Solid)}),
+ fillPattern=FillPattern.Solid),
+ Line(points={{-54,48},{-36,48}}, color={0,0,0}),
+ Line(points={{-54,20},{-36,20}}, color={0,0,0}),
+ Line(points={{-54,-6},{-36,-6}}, color={0,0,0}),
+ Line(points={{-54,-58},{-36,-58}}, color={0,0,0}),
+ Line(points={{-54,-32},{-36,-32}}, color={0,0,0})}),
Documentation(info="
This is a partial model for the bi-directional air flow through a door.
diff --git a/IBPSA/Airflow/Multizone/BaseClasses/package.order b/IBPSA/Airflow/Multizone/BaseClasses/package.order
index eff4802baa..b5aba95f32 100644
--- a/IBPSA/Airflow/Multizone/BaseClasses/package.order
+++ b/IBPSA/Airflow/Multizone/BaseClasses/package.order
@@ -1,3 +1,4 @@
+Door
DoorDiscretized
ErrorControl
PowerLawResistance
diff --git a/IBPSA/Airflow/Multizone/DoorOpen.mo b/IBPSA/Airflow/Multizone/DoorOpen.mo
new file mode 100644
index 0000000000..f03486160e
--- /dev/null
+++ b/IBPSA/Airflow/Multizone/DoorOpen.mo
@@ -0,0 +1,212 @@
+within IBPSA.Airflow.Multizone;
+model DoorOpen
+ "Door model for bi-directional air flow between rooms"
+ extends IBPSA.Airflow.Multizone.BaseClasses.Door(
+ final vAB = VAB_flow/AOpe,
+ final vBA = VBA_flow/AOpe);
+
+ parameter Real CD=0.65 "Discharge coefficient"
+ annotation (Dialog(group="Orifice characteristics"));
+
+ parameter Real m = 0.5 "Flow coefficient"
+ annotation (Dialog(group="Orifice characteristics"));
+
+
+protected
+ constant Real gamma(min=1) = 1.5
+ "Normalized flow rate where dphi(0)/dpi intersects phi(1)";
+ constant Real a = gamma
+ "Polynomial coefficient for regularized implementation of flow resistance";
+ parameter Real b = 1/8*m^2 - 3*gamma - 3/2*m + 35.0/8
+ "Polynomial coefficient for regularized implementation of flow resistance";
+ parameter Real c = -1/4*m^2 + 3*gamma + 5/2*m - 21.0/4
+ "Polynomial coefficient for regularized implementation of flow resistance";
+ parameter Real d = 1/8*m^2 - gamma - m + 15.0/8
+ "Polynomial coefficient for regularized implementation of flow resistance";
+
+ parameter Real kVal=CD*AOpe*sqrt(2/rho_default) "Flow coefficient, k = V_flow/ dp^m";
+ parameter Real kT = rho_default * CD * AOpe/3 *
+ sqrt(Modelica.Constants.g_n /(Medium.T_default*conTP) * hOpe)
+ "Constant coefficient for buoyancy driven air flow rate";
+
+ parameter Modelica.SIunits.MassFlowRate m_flow_turbulent=
+ kVal * rho_default * sqrt(dp_turbulent)
+ "Mass flow rate where regularization to laminar flow occurs for temperature-driven flow";
+
+equation
+ // Air flow rate due to static pressure difference
+ VABp_flow = IBPSA.Airflow.Multizone.BaseClasses.powerLawFixedM(
+ k=kVal,
+ dp=port_a1.p-port_a2.p,
+ m=m,
+ a=a,
+ b=b,
+ c=c,
+ d=d,
+ dp_turbulent=dp_turbulent);
+ // Air flow rate due to buoyancy
+ // Because powerLawFixedM requires as an input a pressure difference pa-pb,
+ // we convert Ta-Tb by multiplying it with rho*R, and we divide
+ // above the constant expression by (rho*R)^m on the right hand-side of kT.
+ // Note that here, k is for mass flow rate, whereas in powerLawFixedM, it is for volume flow rate.
+ // We can use m=0.5 as this is from Bernoulli.
+ mABt_flow = IBPSA.Fluid.BaseClasses.FlowModels.basicFlowFunction_dp(
+ k=kT,
+ dp=conTP*(Medium.temperature(state_a1_inflow)-Medium.temperature(state_a2_inflow)),
+ m_flow_turbulent=m_flow_turbulent);
+
+ annotation (defaultComponentName="doo",
+Documentation(info="
+
+Model for bi-directional air flow through a large opening such as a door.
+
+
+In this model, the air flow is composed of two components,
+a one-directional bulk air flow
+due to static pressure difference in the adjoining two thermal zones, and
+a two-directional airflow due to temperature-induced differences in density
+of the air in the two thermal zones.
+Although turbulent air flow is a nonlinear phenomenon,
+the model is based on the simplifying assumption that these two
+air flow rates can be superposed.
+(Superposition is only exact for laminar flow.)
+This assumption is made because
+it leads to a simple model and because there is significant uncertainty
+and assumptions anyway in such simplified a model for bidirectional flow through a door.
+
+Main equations
+
+The air flow rate due to static pressure difference is
+
+
+ V̇ab,p = CD w h (2/ρ0)0.5 Δpm,
+
+
+where
+V̇ is the volumetric air flow rate,
+CD is the discharge coefficient,
+w and h are the width and height of the opening,
+ρ0 is the mass density at the medium default pressure, temperature and humidity,
+m is the flow exponent and
+Δp = pa - pb is the static pressure difference between
+the thermal zones.
+For this model explanation, we will assume pa > pb.
+For turbulent flow, m=1/2 and for laminar flow m=1.
+
+
+The air flow rate due to temperature difference in the thermal zones is
+V̇ab,t for flow from thermal zone a to b,
+and
+V̇ba,t for air flow rate from thermal zone b to a.
+The model has two air flow paths to allow bi-directional air flow.
+The mass flow rates at these two air flow paths are
+
+
+ ṁa1 = ρ0 (+V̇ab,p/2 + V̇ab,t),
+
+
+and, similarly,
+
+
+ V̇ba = ρ0 (-V̇ab,p/2 + V̇ba,t),
+
+
+where we simplified the calculation by using the density ρ0.
+To calculate V̇ba,t, we again use the density ρ0
+and because of this simplification, we can write
+
+
+ ṁab,t = -ṁba,t = ρ0 V̇ab,t
+ = -ρ0 V̇ba,t,
+
+
+from which follows that the neutral height, e.g., the height where the air flow rate due to flow
+induced by temperature difference is zero, is at h/2.
+Hence,
+
+
+V̇ab,t = CD ∫0h/2 w v(z) dz,
+
+
+where v(z) is the velocity at height z. From the Bernoulli equation, we obtain
+
+
+v(z) = (2 g z Δρ ⁄ ρ0)1/2.
+
+
+The density difference can be written as
+
+
+ Δρ = ρa-ρb
+ ≈ ρ0 (Tb - Ta) ⁄ T0,
+
+
+where we used
+ρa = p0 /(R Ta) and
+Ta Tb ≈ T02.
+Substituting this expression into the integral and integrating from 0 to z yields
+
+
+V̇ab,t = 1⁄3 CD w h
+(g h ⁄ (R T0 ρ0))1/2 Δp1/2.
+
+
+The above equation is equivalent to (6) in Brown and Solvason (1962).
+
Main assumptions
+
+The main assumptions are as follows:
+
+
+-
+
+The air flow rates due to static pressure difference and due to temperature-difference can be superposed.
+
+
+-
+
+For buoyancy-driven air flow, a constant density can be used to convert air volume flow rate to air mass flow rate.
+
+
+
+
+From these assumptions follows that the neutral height for buoyancy-driven air flow is at half of the height
+of the opening.
+
+Notes
+
+For a more detailed model, use
+
+IBPSA.Airflow.Multizone.DoorDiscretizedOpen.
+
+References
+
+",
+revisions="
+
+-
+January 22, 2020, by Michael Wetter:
+Revised buoyancy-driven flow based on Brown and Solvason (1962).
+
+-
+January 19, 2020, by Klaas De Jonge:
+Revised influence of stack effect.
+
+-
+October 6, 2020, by Michael Wetter:
+First implementation for
+#1353.
+
+
+"));
+end DoorOpen;
diff --git a/IBPSA/Airflow/Multizone/DoorOperable.mo b/IBPSA/Airflow/Multizone/DoorOperable.mo
new file mode 100644
index 0000000000..c67781e56c
--- /dev/null
+++ b/IBPSA/Airflow/Multizone/DoorOperable.mo
@@ -0,0 +1,187 @@
+within IBPSA.Airflow.Multizone;
+model DoorOperable
+ "Door model for bi-directional air flow between rooms that can be open or closed"
+ extends IBPSA.Airflow.Multizone.BaseClasses.Door(
+ final vAB = VAB_flow/A,
+ final vBA = VBA_flow/A);
+
+ parameter Real CDOpe=0.65 "Discharge coefficient of open door"
+ annotation (Dialog(group="Open door"));
+
+ parameter Real mOpe = 0.5 "Flow exponent for door of open door"
+ annotation (Dialog(group="Open door"));
+
+ parameter Modelica.SIunits.Area LClo(min=0)
+ "Effective leakage area of closed door"
+ annotation (Dialog(group="Closed door"));
+
+ parameter Real mClo= 0.65 "Flow exponent for crack of closed door"
+ annotation (Dialog(group="Closed door"));
+
+ parameter Modelica.SIunits.PressureDifference dpCloRat(min=0,
+ displayUnit="Pa") = 4
+ "Pressure drop at rating condition of closed door"
+ annotation (Dialog(group="Closed door rating conditions"));
+
+ parameter Real CDCloRat(min=0, max=1)=1
+ "Discharge coefficient at rating conditions of closed door"
+ annotation (Dialog(group="Closed door rating conditions"));
+
+ Modelica.Blocks.Interfaces.RealInput y(min=0, max=1, unit="1")
+ "Opening signal, 0=closed, 1=open"
+ annotation (Placement(transformation(extent={{-120,-10},{-100,10}}), iconTransformation(extent={{-120,-10},{-100,10}})));
+
+protected
+ parameter Real gamma(min=1) = 1.5
+ "Normalized flow rate where dphi(0)/dpi intersects phi(1)";
+ parameter Real[2] a = {gamma, gamma}
+ "Polynomial coefficient for regularized implementation of flow resistance";
+ parameter Real b[2] = {1/8*m^2 - 3*gamma - 3/2*m + 35.0/8 for m in {mOpe, mClo}}
+ "Polynomial coefficient for regularized implementation of flow resistance";
+ parameter Real c[2] = {-1/4*m^2 + 3*gamma + 5/2*m - 21.0/4 for m in {mOpe, mClo}}
+ "Polynomial coefficient for regularized implementation of flow resistance";
+ parameter Real d[2] = {1/8*m^2 - gamma - m + 15.0/8 for m in {mOpe, mClo}}
+ "Polynomial coefficient for regularized implementation of flow resistance";
+
+ parameter Modelica.SIunits.Area AClo = LClo * dpCloRat^(0.5-mClo) "Closed area";
+ parameter Real kVal[2]={
+ CDOpe *AOpe*sqrt(2/rho_default),
+ CDCloRat*AClo*sqrt(2/rho_default)}
+ "Flow coefficient, k = V_flow/ dp^m";
+
+ parameter Real kT = rho_default * CDOpe * AOpe/3 *
+ sqrt(Modelica.Constants.g_n /(Medium.T_default*conTP) * hOpe)
+ "Constant coefficient for buoyancy driven air flow rate";
+
+ parameter Modelica.SIunits.MassFlowRate m_flow_turbulent=
+ kVal[1] * rho_default * sqrt(dp_turbulent)
+ "Mass flow rate where regularization to laminar flow occurs for temperature-driven flow";
+
+ Modelica.SIunits.VolumeFlowRate VABpOpeClo_flow[2](each nominal=0.001)
+ "Volume flow rate from A to B if positive due to static pressure difference";
+ Modelica.SIunits.VolumeFlowRate VABp_flow(nominal=0.001)
+ "Volume flow rate from A to B if positive due to static pressure difference";
+
+ Modelica.SIunits.Area A "Current opening area";
+equation
+ // Air flow rate due to static pressure difference
+ VABpOpeClo_flow = IBPSA.Airflow.Multizone.BaseClasses.powerLawFixedM(
+ k=kVal,
+ dp=port_a1.p-port_a2.p,
+ m={mOpe, mClo},
+ a=a,
+ b=b,
+ c=c,
+ d=d,
+ dp_turbulent=dp_turbulent);
+ VABp_flow = y*VABpOpeClo_flow[1] + (1-y)*VABpOpeClo_flow[2];
+ A = y*AOpe + (1-y)*AClo;
+ // Air flow rate due to buoyancy
+ // Because powerLawFixedM requires as an input a pressure difference pa-pb,
+ // we convert Ta-Tb by multiplying it with rho*R, and we divide
+ // above the constant expression by (rho*R)^m on the right hand-side of kT.
+ mABt_flow = y*IBPSA.Fluid.BaseClasses.FlowModels.basicFlowFunction_dp(
+ k=kT,
+ dp=conTP*(Medium.temperature(state_a1_inflow)-Medium.temperature(state_a2_inflow)),
+ m_flow_turbulent=m_flow_turbulent);
+
+ annotation (defaultComponentName="doo",
+Documentation(info="
+
+Model for bi-directional air flow through a large opening such as a door which can be opened or closed
+based on the control input signal y.
+
+
+For the control input signal y=1, this model is identical to
+
+IBPSA.Airflow.Multizone.DoorOpen, and for
+y=0, the door is assumed to be closed and the air flow rate is
+set to the air flow rate through the crack posed by the open door, V̇clo.
+
+The air flow rate for the closed door is computed as
+
+
+ V̇clo = kclo ΔpmClo,
+
+
+where
+V̇clo is the volume flow rate,
+kclo is a flow coefficient and
+mClo is the flow exponent.
+The flow coefficient is
+
+
+kclo = Lclo CDCloRat ΔpRat(0.5-mClo) (2/ρ0)0.5,
+
+
+where
+Lclo is the effective air leakage area,
+CDCloRat is the discharge coefficient at the reference condition,
+ΔpRat is the pressure drop at the rating condition, and
+ρ0 is the mass density at the medium default pressure, temperature and humidity.
+
+
+The effective air leakage area Lclo can be obtained, for example,
+from the ASHRAE fundamentals (ASHRAE, 1997, p. 25.18). In
+the ASHRAE fundamentals, the effective air leakage area is
+based on a reference pressure difference of ΔpRat = 4 Pa and a discharge
+coefficient of CDCloRat = 1.
+A similar model is also used in the CONTAM software (Dols and Walton, 2002).
+Dols and Walton (2002) recommend to use for the flow exponent
+mClo=0.6 to mClo=0.7 if the flow exponent is not
+reported with the test results.
+
+
+For the open door, the air flow rate
+V̇ope is computed as described in
+
+IBPSA.Airflow.Multizone.DoorOpen
+with the parameters CDOpe
and mOpe
.
+
+
+The actual air flow rate is computed as
+
+
+V̇clo = (y-1) V̇clo + y V̇ope,
+
+
+where y ∈ [0, 1] is the control signal.
+Note that for values of y that are different from 0 and
+1, the model simply interpolates the air flow rate between a fully open
+and a fully closed door. In practice, the air flow rate would likely increase quickly if the
+door is slightly opened, and hence we do not claim that the model is accurate for
+values other than y = 0 and y = 1.
+
+References
+
+-
+ASHRAE.
+ASHRAE Fundamentals,
+American Society of Heating, Refrigeration and Air-Conditioning
+Engineers, 1997.
+
+-
+Dols and Walton.
+W. Stuart Dols and George N. Walton, CONTAMW 2.0 User Manual,
+Multizone Airflow and Contaminant Transport Analysis Software,
+Building and Fire Research Laboratory,
+National Institute of Standards and Technology,
+Tech. Report NISTIR 6921,
+November, 2002.
+
+
+",
+revisions="
+
+-
+January 22, 2020, by Michael Wetter:
+Revised buoyancy-driven flow.
+
+-
+October 6, 2020, by Michael Wetter:
+First implementation for
+#1353.
+
+
+"));
+end DoorOperable;
diff --git a/IBPSA/Airflow/Multizone/Examples/OneOpenDoor.mo b/IBPSA/Airflow/Multizone/Examples/OneOpenDoor.mo
index e724b684e0..68e349f1c6 100644
--- a/IBPSA/Airflow/Multizone/Examples/OneOpenDoor.mo
+++ b/IBPSA/Airflow/Multizone/Examples/OneOpenDoor.mo
@@ -4,8 +4,8 @@ model OneOpenDoor "Model with one open and one closed door"
package Medium = Modelica.Media.Air.SimpleAir;
- IBPSA.Airflow.Multizone.DoorDiscretizedOpen dooOpe(redeclare package Medium
- = Medium) "Discretized door"
+ IBPSA.Airflow.Multizone.DoorDiscretizedOpen dooOpe(
+ redeclare package Medium = Medium) "Discretized door"
annotation (Placement(transformation(extent={{10,-8},{30,12}})));
IBPSA.Fluid.MixingVolumes.MixingVolume volA(
diff --git a/IBPSA/Airflow/Multizone/Validation/DoorOpenClosed.mo b/IBPSA/Airflow/Multizone/Validation/DoorOpenClosed.mo
new file mode 100644
index 0000000000..09a7f704bb
--- /dev/null
+++ b/IBPSA/Airflow/Multizone/Validation/DoorOpenClosed.mo
@@ -0,0 +1,125 @@
+within IBPSA.Airflow.Multizone.Validation;
+model DoorOpenClosed
+ "Validation model for the operable door and the door that is always open"
+ extends Modelica.Icons.Example;
+
+ package Medium = IBPSA.Media.Air "Medium model";
+
+ Fluid.Sources.Boundary_pT bouA(
+ redeclare package Medium = Medium,
+ p(displayUnit="Pa") = 101330,
+ T=294.15,
+ nPorts=5) "Boundary condition at side a" annotation (Placement(
+ transformation(
+ extent={{-10,-10},{10,10}},
+ rotation=0,
+ origin={-70,0})));
+
+ Fluid.Sources.Boundary_pT bouB(
+ redeclare package Medium = Medium,
+ p(displayUnit="Pa") = 101325,
+ T=293.15,
+ nPorts=5) "Boundary condition at side b"
+ annotation (Placement(transformation(extent={{10,-10},{-10,10}},
+ rotation=0,
+ origin={80,0})));
+
+ IBPSA.Airflow.Multizone.DoorOpen doo(
+ redeclare package Medium = Medium)
+ "Open door that is always open"
+ annotation (Placement(transformation(extent={{-20,40},{0,60}})));
+
+ EffectiveAirLeakageArea lea(
+ redeclare package Medium = Medium,
+ m=0.65,
+ dp_turbulent=0.01,
+ L=20*1E-4) "Leakage flow element"
+ annotation (Placement(transformation(extent={{-20,10},{0,30}})));
+ DoorOperable dooOpeClo(
+ redeclare package Medium = Medium,
+ LClo=20*1E-4)
+ "Operable door"
+ annotation (Placement(transformation(extent={{-20,-40},{0,-20}})));
+ Modelica.Blocks.Sources.Step yDoo(startTime=0.5) "Door opening signal"
+ annotation (Placement(transformation(extent={{-80,-40},{-60,-20}})));
+ Fluid.Sensors.MassFlowRate senMasFlo1(redeclare package Medium = Medium)
+ "Mass flow rate sensor"
+ annotation (Placement(transformation(extent={{10,-12},{30,8}})));
+ Fluid.Sensors.MassFlowRate senMasFlo2(
+ redeclare package Medium = Medium)
+ "Mass flow rate sensor"
+ annotation (Placement(transformation(extent={{30,-46},{50,-26}})));
+ Modelica.Blocks.Math.Add mNet_flow(y(final unit="kg/s"))
+ "Net air flow rate from A to B through the operable door"
+ annotation (Placement(transformation(extent={{60,32},{80,52}})));
+ Modelica.Blocks.Sources.Step yDooCom(
+ height=-1,
+ offset=1,
+ startTime=0.5) "Outputs 1 if door is closed"
+ annotation (Placement(transformation(extent={{-80,-90},{-60,-70}})));
+ Modelica.Blocks.Math.Product mNetClo_flow(y(final unit="kg/s"))
+ "Mass flow rate if door is closed"
+ annotation (Placement(transformation(extent={{0,-90},{20,-70}})));
+equation
+ connect(bouA.ports[1], doo.port_a1) annotation (Line(points={{-60,3.2},{-40,3.2},
+ {-40,56},{-20,56}}, color={0,127,255}));
+ connect(bouA.ports[2], doo.port_b2) annotation (Line(points={{-60,1.6},{-38,1.6},
+ {-38,44},{-20,44}}, color={0,127,255}));
+ connect(bouA.ports[3], lea.port_a) annotation (Line(points={{-60,0},{-36,0},{-36,
+ 20},{-20,20}}, color={0,127,255}));
+ connect(bouA.ports[4], dooOpeClo.port_a1) annotation (Line(points={{-60,-1.6},
+ {-36,-1.6},{-36,-24},{-20,-24}}, color={0,127,255}));
+ connect(bouA.ports[5], dooOpeClo.port_b2) annotation (Line(points={{-60,-3.2},
+ {-40,-3.2},{-40,-36},{-20,-36}}, color={0,127,255}));
+ connect(doo.port_b1, bouB.ports[1]) annotation (Line(points={{0,56},{50,56},{50,
+ 3.2},{70,3.2}}, color={0,127,255}));
+ connect(doo.port_a2, bouB.ports[2]) annotation (Line(points={{0,44},{48,44},{48,
+ 1.6},{70,1.6}}, color={0,127,255}));
+ connect(lea.port_b, bouB.ports[3]) annotation (Line(points={{0,20},{46,20},{46,
+ 0},{70,0}}, color={0,127,255}));
+ connect(yDoo.y, dooOpeClo.y)
+ annotation (Line(points={{-59,-30},{-21,-30}}, color={0,0,127}));
+ connect(dooOpeClo.port_b1, senMasFlo1.port_a) annotation (Line(points={{0,-24},
+ {6,-24},{6,-2},{10,-2}}, color={0,127,255}));
+ connect(senMasFlo1.port_b, bouB.ports[4])
+ annotation (Line(points={{30,-2},{70,-2},{70,-1.6}}, color={0,127,255}));
+ connect(dooOpeClo.port_a2,senMasFlo2. port_a)
+ annotation (Line(points={{0,-36},{30,-36}}, color={0,127,255}));
+ connect(senMasFlo2.port_b, bouB.ports[5]) annotation (Line(points={{50,-36},{62,
+ -36},{62,-3.2},{70,-3.2}}, color={0,127,255}));
+ connect(senMasFlo1.m_flow, mNet_flow.u1)
+ annotation (Line(points={{20,9},{20,48},{58,48}}, color={0,0,127}));
+ connect(senMasFlo2.m_flow, mNet_flow.u2)
+ annotation (Line(points={{40,-25},{40,36},{58,36}}, color={0,0,127}));
+ connect(yDooCom.y, mNetClo_flow.u2) annotation (Line(points={{-59,-80},{-32,
+ -80},{-32,-86},{-2,-86}}, color={0,0,127}));
+ connect(mNet_flow.y, mNetClo_flow.u1) annotation (Line(points={{81,42},{94,42},
+ {94,-60},{-12,-60},{-12,-74},{-2,-74}}, color={0,0,127}));
+ annotation (
+ __Dymola_Commands(file="modelica://IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/DoorOpenClosed.mos"
+ "Simulate and plot"),
+ experiment(
+ StopTime=1,
+ Tolerance=1e-06),
+ Documentation(info="
+
+This model validates the door model that takes as an input a signal
+that determines whether the door is open or closed.
+In this validation, the instance dooOpeClo
is either open or closed,
+depending on its input signal y
.
+If the door is open, its air flow rate is identical to the air flow rate of the
+instance doo
.
+If the door is closed, its air flow rate is identical to the air flow rate of the
+instance lea
.
+
+", revisions="
+
+-
+October 12, 2020 by Michael Wetter:
+First implementation.
+
+
+"),
+ Diagram(coordinateSystem(extent={{-100,-100},{100,100}})),
+ Icon(coordinateSystem(extent={{-100,-100},{80,100}})));
+end DoorOpenClosed;
diff --git a/IBPSA/Airflow/Multizone/Validation/OpenDoorBuoyancyDynamic.mo b/IBPSA/Airflow/Multizone/Validation/OpenDoorBuoyancyDynamic.mo
new file mode 100644
index 0000000000..e30ce7a2d2
--- /dev/null
+++ b/IBPSA/Airflow/Multizone/Validation/OpenDoorBuoyancyDynamic.mo
@@ -0,0 +1,115 @@
+within IBPSA.Airflow.Multizone.Validation;
+model OpenDoorBuoyancyDynamic
+ "Model with open door and buoyancy driven flow only"
+ extends Modelica.Icons.Example;
+
+ package Medium = IBPSA.Media.Air "Medium model";
+
+ IBPSA.Airflow.Multizone.DoorOpen doo(
+ redeclare package Medium = Medium)
+ "Door" annotation (Placement(transformation(extent={{-10,-10},{10,10}})));
+
+ IBPSA.Fluid.Sources.Boundary_pT bou(
+ redeclare package Medium = Medium,
+ nPorts=1) "Pressure boundary"
+ annotation (Placement(transformation(extent={{-50,18},{-30,38}})));
+
+ Fluid.MixingVolumes.MixingVolume bouA(
+ redeclare package Medium = Medium,
+ T_start=292.15,
+ V=2.5*5*5,
+ energyDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ massDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ m_flow_nominal=0.01,
+ nPorts=3) "Boundary condition at side a" annotation (Placement(
+ transformation(
+ extent={{10,-10},{-10,10}},
+ rotation=90,
+ origin={-40,0})));
+
+ IBPSA.Fluid.MixingVolumes.MixingVolume bouB(
+ redeclare package Medium = Medium,
+ T_start=294.15,
+ V=2.5*5*5,
+ energyDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ massDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ m_flow_nominal=0.01,
+ nPorts=2) "Boundary condition at side b"
+ annotation (Placement(transformation(extent={{-10,-10},{10,10}},
+ rotation=270,
+ origin={40,0})));
+ DoorDiscretizedOpen dooDis(
+ forceErrorControlOnFlow=false,
+ redeclare package Medium = Medium,
+ vZer=0.000001) "Door"
+ annotation (Placement(transformation(extent={{-10,-80},{10,-60}})));
+ Fluid.Sources.Boundary_pT bou1(
+ redeclare package Medium = Medium,
+ nPorts=1) "Pressure boundary"
+ annotation (Placement(transformation(extent={{-50,-50},{-30,-30}})));
+ Fluid.MixingVolumes.MixingVolume bouADis(
+ redeclare package Medium = Medium,
+ T_start=292.15,
+ V=2.5*5*5,
+ energyDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ massDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ m_flow_nominal=0.01,
+ nPorts=3) "Boundary condition at side a" annotation (Placement(
+ transformation(
+ extent={{10,-10},{-10,10}},
+ rotation=90,
+ origin={-40,-70})));
+ Fluid.MixingVolumes.MixingVolume bouBDis(
+ redeclare package Medium = Medium,
+ T_start=294.15,
+ V=2.5*5*5,
+ energyDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ massDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ m_flow_nominal=0.01,
+ nPorts=2) "Boundary condition at side b" annotation (Placement(
+ transformation(
+ extent={{-10,-10},{10,10}},
+ rotation=270,
+ origin={40,-70})));
+equation
+ connect(doo.port_b1, bouB.ports[1])
+ annotation (Line(points={{10,6},{20,6},{20,2},{30,2}}, color={0,127,255}));
+ connect(doo.port_a2, bouB.ports[2]) annotation (Line(points={{10,-6},{20,-6},
+ {20,-2},{30,-2}},color={0,127,255}));
+ connect(doo.port_a1, bouA.ports[1]) annotation (Line(points={{-10,6},{-20,6},
+ {-20,2.66667},{-30,2.66667}},
+ color={0,127,255}));
+ connect(doo.port_b2, bouA.ports[2]) annotation (Line(points={{-10,-6},{-18,-6},
+ {-18,-8.88178e-16},{-30,-8.88178e-16}}, color={0,127,255}));
+ connect(bou.ports[1], bouA.ports[3])
+ annotation (Line(points={{-30,28},{-30,-2.66667}}, color={0,127,255}));
+ connect(bou1.ports[1], bouADis.ports[1])
+ annotation (Line(points={{-30,-40},{-30,-67.3333}}, color={0,127,255}));
+ connect(dooDis.port_a1, bouADis.ports[2]) annotation (Line(points={{-10,-64},
+ {-20,-64},{-20,-70},{-30,-70}}, color={0,127,255}));
+ connect(dooDis.port_b2, bouADis.ports[3]) annotation (Line(points={{-10,-76},
+ {-20,-76},{-20,-72.6667},{-30,-72.6667}}, color={0,127,255}));
+ connect(dooDis.port_b1, bouBDis.ports[1]) annotation (Line(points={{10,-64},{
+ 20,-64},{20,-68},{30,-68}}, color={0,127,255}));
+ connect(dooDis.port_a2, bouBDis.ports[2]) annotation (Line(points={{10,-76},{
+ 22,-76},{22,-72},{30,-72}}, color={0,127,255}));
+ annotation (
+ __Dymola_Commands(file="modelica://IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorBuoyancyDynamic.mos"
+ "Simulate and plot"),
+ experiment(
+ StopTime=14400,
+ Tolerance=1e-08),
+ Documentation(info="
+
+This model validates the door model for the situation where there is only buoyancy-driven air flow.
+Initially the volume is at a different temperature than the pressure source, leading to an airflow that eventually decays to zero.
+
+", revisions="
+
+-
+October 9, 2020 by Michael Wetter:
+First implementation.
+
+
+"));
+end OpenDoorBuoyancyDynamic;
diff --git a/IBPSA/Airflow/Multizone/Validation/OpenDoorBuoyancyPressureDynamic.mo b/IBPSA/Airflow/Multizone/Validation/OpenDoorBuoyancyPressureDynamic.mo
new file mode 100644
index 0000000000..a1d863a913
--- /dev/null
+++ b/IBPSA/Airflow/Multizone/Validation/OpenDoorBuoyancyPressureDynamic.mo
@@ -0,0 +1,114 @@
+within IBPSA.Airflow.Multizone.Validation;
+model OpenDoorBuoyancyPressureDynamic
+ "Model with open door and buoyancy and pressure driven flow"
+ extends Modelica.Icons.Example;
+
+ package Medium = IBPSA.Media.Air "Medium model";
+
+ IBPSA.Airflow.Multizone.DoorOpen doo(redeclare package Medium = Medium)
+ "Door" annotation (Placement(transformation(extent={{-10,-10},{10,10}})));
+
+ IBPSA.Fluid.Sources.Boundary_pT bou(
+ redeclare package Medium = Medium,
+ nPorts=1) "Pressure boundary"
+ annotation (Placement(transformation(extent={{-50,-46},{-30,-26}})));
+
+ Fluid.MixingVolumes.MixingVolume bouA(
+ redeclare package Medium = Medium,
+ T_start=292.15,
+ V=2.5*5*5,
+ energyDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ massDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ m_flow_nominal=0.01,
+ nPorts=3) "Boundary condition at side a" annotation (Placement(
+ transformation(
+ extent={{-10,-10},{10,10}},
+ rotation=90,
+ origin={-40,0})));
+
+ IBPSA.Fluid.MixingVolumes.MixingVolume bouB(
+ redeclare package Medium = Medium,
+ T_start=294.15,
+ p_start=101320,
+ V=2.5*5*5,
+ energyDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ massDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ m_flow_nominal=0.01,
+ nPorts=2) "Boundary condition at side b"
+ annotation (Placement(transformation(extent={{-10,-10},{10,10}},
+ rotation=270,
+ origin={40,0})));
+ DoorDiscretizedOpen dooDis(redeclare package Medium = Medium) "Door"
+ annotation (Placement(transformation(extent={{-10,66},{10,86}})));
+ Fluid.Sources.Boundary_pT bouDis(redeclare package Medium = Medium, nPorts=1)
+ "Pressure boundary"
+ annotation (Placement(transformation(extent={{-50,30},{-30,50}})));
+ Fluid.MixingVolumes.MixingVolume bouADis(
+ redeclare package Medium = Medium,
+ T_start=292.15,
+ V=2.5*5*5,
+ energyDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ massDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ m_flow_nominal=0.01,
+ nPorts=3) "Boundary condition at side a" annotation (Placement(
+ transformation(
+ extent={{-10,-10},{10,10}},
+ rotation=90,
+ origin={-40,76})));
+ Fluid.MixingVolumes.MixingVolume bouBDis(
+ redeclare package Medium = Medium,
+ T_start=294.15,
+ p_start=101320,
+ V=2.5*5*5,
+ energyDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ massDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial,
+ m_flow_nominal=0.01,
+ nPorts=2) "Boundary condition at side b" annotation (Placement(
+ transformation(
+ extent={{-10,-10},{10,10}},
+ rotation=270,
+ origin={40,76})));
+equation
+ connect(doo.port_b1, bouB.ports[1])
+ annotation (Line(points={{10,6},{20,6},{20,2},{30,2}}, color={0,127,255}));
+ connect(doo.port_a2, bouB.ports[2]) annotation (Line(points={{10,-6},{20,-6},
+ {20,-2},{30,-2}},color={0,127,255}));
+ connect(doo.port_a1, bouA.ports[1]) annotation (Line(points={{-10,6},{-20,6},{
+ -20,-2.66667},{-30,-2.66667}},
+ color={0,127,255}));
+ connect(doo.port_b2, bouA.ports[2]) annotation (Line(points={{-10,-6},{-20,-6},
+ {-20,-4.44089e-16},{-30,-4.44089e-16}}, color={0,127,255}));
+ connect(bou.ports[1], bouA.ports[3])
+ annotation (Line(points={{-30,-36},{-30,2.66667}}, color={0,127,255}));
+
+
+ connect(dooDis.port_b1, bouBDis.ports[1]) annotation (Line(points={{10,82},{
+ 20,82},{20,78},{30,78}}, color={0,127,255}));
+ connect(dooDis.port_a2, bouBDis.ports[2]) annotation (Line(points={{10,70},{
+ 20,70},{20,74},{30,74}}, color={0,127,255}));
+ connect(dooDis.port_a1, bouADis.ports[1]) annotation (Line(points={{-10,82},{
+ -20,82},{-20,73.3333},{-30,73.3333}}, color={0,127,255}));
+ connect(dooDis.port_b2, bouADis.ports[2]) annotation (Line(points={{-10,70},{
+ -20,70},{-20,76},{-30,76}}, color={0,127,255}));
+ connect(bouDis.ports[1], bouADis.ports[3])
+ annotation (Line(points={{-30,40},{-30,78.6667}}, color={0,127,255}));
+ annotation (
+ __Dymola_Commands(file="modelica://IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorBuoyancyPressureDynamic.mos"
+ "Simulate and plot"),
+ experiment(
+ StopTime=14400,
+ Tolerance=1e-08),
+ Documentation(info="
+
+This model validates the door model for the situation where there is air flow due to buoyancy and static pressure difference.
+Initially the volumes are at a different temperatures and pressure, leading to an airflow that eventually decays to zero.
+
+", revisions="
+
+-
+October 9, 2020 by Michael Wetter:
+First implementation.
+
+
+"));
+end OpenDoorBuoyancyPressureDynamic;
diff --git a/IBPSA/Airflow/Multizone/Validation/OpenDoorPressure.mo b/IBPSA/Airflow/Multizone/Validation/OpenDoorPressure.mo
new file mode 100644
index 0000000000..84c4560f4a
--- /dev/null
+++ b/IBPSA/Airflow/Multizone/Validation/OpenDoorPressure.mo
@@ -0,0 +1,96 @@
+within IBPSA.Airflow.Multizone.Validation;
+model OpenDoorPressure
+ "Model with one open door and only pressure-driven flow"
+ extends Modelica.Icons.Example;
+
+ package Medium = IBPSA.Media.Air "Medium model";
+
+ IBPSA.Airflow.Multizone.DoorOpen doo(
+ redeclare package Medium = Medium)
+ "Door" annotation (Placement(transformation(extent={{-10,-10},{10,10}})));
+
+ Fluid.Sources.Boundary_pT bouA(
+ redeclare package Medium = Medium,
+ p(displayUnit="Pa") = 101325,
+ nPorts=4) "Boundary condition at side a" annotation (Placement(
+ transformation(
+ extent={{-10,-10},{10,10}},
+ rotation=0,
+ origin={-40,0})));
+
+ Fluid.Sources.Boundary_pT bouB(
+ redeclare package Medium = Medium,
+ use_p_in=true,
+ p(displayUnit="Pa"),
+ nPorts=4) "Boundary condition at side b"
+ annotation (Placement(transformation(extent={{10,-10},{-10,10}},
+ rotation=0,
+ origin={40,0})));
+
+ DoorDiscretizedOpen dooDis(
+ redeclare package Medium = Medium,
+ hA=2.1/2,
+ hB=2.1/2) "Door"
+ annotation (Placement(transformation(extent={{-10,-40},{10,-20}})));
+ Modelica.Blocks.Sources.TimeTable bouPre(
+ table=[
+ 0.0,0;
+ 1,0;
+ 1,5;
+ 2,5;
+ 2,10;
+ 3,10;
+ 3,15;
+ 4,15;
+ 4,20;
+ 5,20;
+ 5,25;
+ 6,25;
+ 6,30;
+ 7,30;
+ 7,35;
+ 8,35;
+ 8,40;
+ 24,40],
+ timeScale=3600,
+ offset=101325-20) "Pressure boundary condition"
+ annotation (Placement(transformation(extent={{86,-2},{66,18}})));
+equation
+ connect(doo.port_b1, bouB.ports[1])
+ annotation (Line(points={{10,6},{20,6},{20,3},{30,3}}, color={0,127,255}));
+ connect(doo.port_a2, bouB.ports[2]) annotation (Line(points={{10,-6},{20,-6},
+ {20,1},{30,1}}, color={0,127,255}));
+ connect(doo.port_a1, bouA.ports[1]) annotation (Line(points={{-10,6},{-20,6},
+ {-20,3},{-30,3}}, color={0,127,255}));
+ connect(doo.port_b2, bouA.ports[2]) annotation (Line(points={{-10,-6},{-20,-6},
+ {-20,1},{-30,1}}, color={0,127,255}));
+ connect(bouA.ports[3], dooDis.port_a1) annotation (Line(points={{-30,-1},{-22,
+ -1},{-22,-24},{-10,-24}}, color={0,127,255}));
+ connect(bouA.ports[4], dooDis.port_b2) annotation (Line(points={{-30,-3},{-24,
+ -3},{-24,-36},{-10,-36}}, color={0,127,255}));
+ connect(dooDis.port_b1, bouB.ports[3]) annotation (Line(points={{10,-24},{22,
+ -24},{22,-1},{30,-1}}, color={0,127,255}));
+ connect(dooDis.port_a2, bouB.ports[4]) annotation (Line(points={{10,-36},{24,
+ -36},{24,-3},{30,-3}}, color={0,127,255}));
+ connect(bouPre.y, bouB.p_in)
+ annotation (Line(points={{65,8},{52,8}}, color={0,0,127}));
+ annotation (
+ __Dymola_Commands(file="modelica://IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorPressure.mos"
+ "Simulate and plot"),
+ experiment(
+ StopTime=28800,
+ Interval=600,
+ Tolerance=1e-06),
+ Documentation(info="
+
+This model validates the door model for the situation where there is only pressure-driven air flow.
+
+", revisions="
+
+-
+October 9, 2020 by Michael Wetter:
+First implementation.
+
+
+"));
+end OpenDoorPressure;
diff --git a/IBPSA/Airflow/Multizone/Validation/OpenDoorTemperature.mo b/IBPSA/Airflow/Multizone/Validation/OpenDoorTemperature.mo
new file mode 100644
index 0000000000..dbf8e453b4
--- /dev/null
+++ b/IBPSA/Airflow/Multizone/Validation/OpenDoorTemperature.mo
@@ -0,0 +1,94 @@
+within IBPSA.Airflow.Multizone.Validation;
+model OpenDoorTemperature
+ "Model with one open door and only temperature-driven flow"
+ extends Modelica.Icons.Example;
+
+ package Medium = IBPSA.Media.Air "Medium model";
+
+ IBPSA.Airflow.Multizone.DoorOpen doo(
+ redeclare package Medium = Medium)
+ "Door" annotation (Placement(transformation(extent={{-10,-10},{10,10}})));
+
+ Fluid.Sources.Boundary_pT bouA(
+ redeclare package Medium = Medium,
+ nPorts=4) "Boundary condition at side a" annotation (Placement(
+ transformation(
+ extent={{-10,-10},{10,10}},
+ rotation=0,
+ origin={-40,0})));
+
+ Fluid.Sources.Boundary_pT bouB(
+ redeclare package Medium = Medium,
+ use_T_in=true,
+ nPorts=4) "Boundary condition at side b"
+ annotation (Placement(transformation(extent={{10,-10},{-10,10}},
+ rotation=0,
+ origin={40,0})));
+
+ DoorDiscretizedOpen dooDis(
+ redeclare package Medium = Medium,
+ hA=2.1/2,
+ hB=2.1/2) "Door"
+ annotation (Placement(transformation(extent={{-10,-40},{10,-20}})));
+ Modelica.Blocks.Sources.TimeTable bouTem(
+ table=[
+ 0.0,0;
+ 1,0;
+ 1,5;
+ 2,5;
+ 2,10;
+ 3,10;
+ 3,15;
+ 4,15;
+ 4,20;
+ 5,20;
+ 5,25;
+ 6,25;
+ 6,30;
+ 7,30;
+ 7,35;
+ 8,35;
+ 8,40;
+ 24,40],
+ timeScale=3600,
+ offset=273.15) "Temperature boundary condition"
+ annotation (Placement(transformation(extent={{86,-6},{66,14}})));
+equation
+ connect(doo.port_b1, bouB.ports[1])
+ annotation (Line(points={{10,6},{20,6},{20,3},{30,3}}, color={0,127,255}));
+ connect(doo.port_a2, bouB.ports[2]) annotation (Line(points={{10,-6},{20,-6},
+ {20,1},{30,1}}, color={0,127,255}));
+ connect(doo.port_a1, bouA.ports[1]) annotation (Line(points={{-10,6},{-20,6},
+ {-20,3},{-30,3}}, color={0,127,255}));
+ connect(doo.port_b2, bouA.ports[2]) annotation (Line(points={{-10,-6},{-20,-6},
+ {-20,1},{-30,1}}, color={0,127,255}));
+ connect(bouA.ports[3], dooDis.port_a1) annotation (Line(points={{-30,-1},{-22,
+ -1},{-22,-24},{-10,-24}}, color={0,127,255}));
+ connect(bouA.ports[4], dooDis.port_b2) annotation (Line(points={{-30,-3},{-24,
+ -3},{-24,-36},{-10,-36}}, color={0,127,255}));
+ connect(dooDis.port_b1, bouB.ports[3]) annotation (Line(points={{10,-24},{22,
+ -24},{22,-1},{30,-1}}, color={0,127,255}));
+ connect(dooDis.port_a2, bouB.ports[4]) annotation (Line(points={{10,-36},{24,
+ -36},{24,-3},{30,-3}}, color={0,127,255}));
+ connect(bouTem.y, bouB.T_in)
+ annotation (Line(points={{65,4},{52,4}}, color={0,0,127}));
+ annotation (
+ __Dymola_Commands(file="modelica://IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorTemperature.mos"
+ "Simulate and plot"),
+ experiment(
+ StopTime=28800,
+ Interval=600,
+ Tolerance=1e-06),
+ Documentation(info="
+
+This model validates the door model for the situation where there is only temperature-driven air flow.
+
+", revisions="
+
+-
+October 9, 2020 by Michael Wetter:
+First implementation.
+
+
+"));
+end OpenDoorTemperature;
diff --git a/IBPSA/Airflow/Multizone/Validation/ThreeRoomsContam.mo b/IBPSA/Airflow/Multizone/Validation/ThreeRoomsContam.mo
index 6685073d89..90aee916cd 100644
--- a/IBPSA/Airflow/Multizone/Validation/ThreeRoomsContam.mo
+++ b/IBPSA/Airflow/Multizone/Validation/ThreeRoomsContam.mo
@@ -12,25 +12,30 @@ model ThreeRoomsContam
nPorts=5,
m_flow_nominal=0.001,
energyDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial)
+ "Air volume east room"
annotation (Placement(transformation(extent={{80,-20},{100,0}})));
IBPSA.Airflow.Multizone.Orifice oriOutBot(
redeclare package Medium = Medium,
A=0.01,
- m=0.5) annotation (Placement(transformation(extent={{142,-90},{162,-70}})));
+ m=0.5) "Orifice at bottom of facade"
+ annotation (Placement(transformation(extent={{142,-90},{162,-70}})));
IBPSA.Airflow.Multizone.MediumColumn colOutTop(
redeclare package Medium = Medium,
h=1.5,
densitySelection=IBPSA.Airflow.Multizone.Types.densitySelection.fromBottom)
+ "Medium column for bottom floor outside air"
annotation (Placement(transformation(extent={{191,-8},{211,12}})));
IBPSA.Airflow.Multizone.Orifice oriOutTop(
redeclare package Medium = Medium,
A=0.01,
- m=0.5) annotation (Placement(transformation(extent={{141,10},{161,30}})));
+ m=0.5) "Orifice at top of facade"
+ annotation (Placement(transformation(extent={{141,10},{161,30}})));
IBPSA.Airflow.Multizone.MediumColumn colEasInTop(
redeclare package Medium = Medium,
h=1.5,
densitySelection=IBPSA.Airflow.Multizone.Types.densitySelection.fromBottom)
+ "Medium column for bottom floor"
annotation (Placement(transformation(extent={{121,-10},{141,10}})));
IBPSA.Fluid.Sources.Boundary_pT volOut(
redeclare package Medium = Medium,
@@ -43,21 +48,25 @@ model ThreeRoomsContam
redeclare package Medium = Medium,
h=1.5,
densitySelection=IBPSA.Airflow.Multizone.Types.densitySelection.fromTop)
+ "Medium column for bottom floor"
annotation (Placement(transformation(extent={{122,-70},{142,-50}})));
IBPSA.Airflow.Multizone.MediumColumn colOutBot(
redeclare package Medium = Medium,
h=1.5,
densitySelection=IBPSA.Airflow.Multizone.Types.densitySelection.fromTop)
+ "Medium column for bottom floor outside air"
annotation (Placement(transformation(extent={{190,-68},{210,-48}})));
IBPSA.Airflow.Multizone.MediumColumn colWesBot(
redeclare package Medium = Medium,
h=1.5,
densitySelection=IBPSA.Airflow.Multizone.Types.densitySelection.fromBottom)
+ "Medium column for bottom floor"
annotation (Placement(transformation(extent={{-70,9},{-50,29}})));
IBPSA.Airflow.Multizone.Orifice oriWesTop(
redeclare package Medium = Medium,
m=0.5,
- A=0.01) annotation (Placement(transformation(
+ A=0.01) "Orifice between top and bottom west floor"
+ annotation (Placement(transformation(
origin={-60,49},
extent={{-10,-10},{10,10}},
rotation=270)));
@@ -66,18 +75,17 @@ model ThreeRoomsContam
redeclare package Medium = Medium,
h=1.5,
densitySelection=IBPSA.Airflow.Multizone.Types.densitySelection.fromTop)
+ "Medium column for top floor"
annotation (Placement(transformation(extent={{-70,71},{-50,91}})));
- IBPSA.Airflow.Multizone.DoorDiscretizedOperable dooOpeClo(
+
+ replaceable DoorOpen dooOpeClo(
redeclare package Medium = Medium,
- LClo=20*1E-4,
wOpe=1,
hOpe=2.2,
- CDOpe=0.78,
- CDClo=0.78,
- nCom=10,
- hA=3/2,
- hB=3/2,
- dp_turbulent(displayUnit="Pa") = 0.01) "Discretized door"
+ dp_turbulent(displayUnit="Pa") = 0.01,
+ CD=0.78,
+ m=0.5) constrainedby Fluid.Interfaces.PartialFourPortInterface
+ "Door"
annotation (Placement(transformation(extent={{-1,-55},{19,-35}})));
IBPSA.Fluid.MixingVolumes.MixingVolume volWes(
redeclare package Medium = Medium,
@@ -86,18 +94,19 @@ model ThreeRoomsContam
V=2.5*5*5,
m_flow_nominal=0.001,
energyDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial)
+ "Air volume west floor"
annotation (Placement(transformation(extent={{-90,-30},{-70,-10}})));
- Modelica.Blocks.Sources.Constant open(k=1) annotation (Placement(
- transformation(extent={{-40,-21},{-20,-1}})));
IBPSA.Airflow.Multizone.MediumColumn col1EasBot(
redeclare package Medium = Medium,
h=1.5,
densitySelection=IBPSA.Airflow.Multizone.Types.densitySelection.fromBottom)
+ "Medium column for bottom floor"
annotation (Placement(transformation(extent={{100,9},{120,29}})));
IBPSA.Airflow.Multizone.Orifice oriEasTop(
redeclare package Medium = Medium,
m=0.5,
- A=0.01) annotation (Placement(transformation(
+ A=0.01) "Orifice between top and bottom east floor"
+ annotation (Placement(transformation(
origin={110,49},
extent={{-10,-10},{10,10}},
rotation=90)));
@@ -105,6 +114,7 @@ model ThreeRoomsContam
redeclare package Medium = Medium,
h=1.5,
densitySelection=IBPSA.Airflow.Multizone.Types.densitySelection.fromTop)
+ "Medium column for top floor"
annotation (Placement(transformation(extent={{100,71},{120,91}})));
IBPSA.Fluid.MixingVolumes.MixingVolume volTop(
redeclare package Medium = Medium,
@@ -113,6 +123,7 @@ model ThreeRoomsContam
nPorts=2,
m_flow_nominal=0.001,
energyDynamics=Modelica.Fluid.Types.Dynamics.FixedInitial)
+ "Air volume top floor"
annotation (Placement(transformation(extent={{-20,120},{0,140}})));
Modelica.Thermal.HeatTransfer.Sources.FixedTemperature TTop(T=293.15)
@@ -134,8 +145,6 @@ model ThreeRoomsContam
"Thermal conductor"
annotation (Placement(transformation(extent={{50,-20},{70,0}})));
equation
- connect(open.y, dooOpeClo.y) annotation (Line(points={{-19,-11},{-14,-11},{
- -14,-45},{-2,-45}}, color={0,0,255}));
connect(volWes.ports[1], dooOpeClo.port_b2) annotation (Line(
points={{-82.6667,-30},{-82.6667,-51},{-1,-51}},
color={0,127,255}));
@@ -242,9 +251,10 @@ The model implements the configuration shown below.
-This model has been used for a comparative model validation between CONTAM and
-the Buildings
library.
-See Wetter (2006) for details of the validation.
+For the model that has been used for a comparative model validation between CONTAM and
+the Buildings
library in Wetter (2006), see
+
+IBPSA.Airflow.Multizone.Validation.ThreeRoomsContamDiscretizedDoor.
References
@@ -256,6 +266,10 @@ Proc. of the 5th International Modelica Conference, p. 431-440. Vienna, Austria,
", revisions="
-
+October 9, 2020, by Michael Wetter:
+Refactored model to use the new door model.
+
+-
May 15, 2019, by Jianjun Hu:
Replaced fluid source. This is for
#1072.
diff --git a/IBPSA/Airflow/Multizone/Validation/ThreeRoomsContamDiscretizedDoor.mo b/IBPSA/Airflow/Multizone/Validation/ThreeRoomsContamDiscretizedDoor.mo
new file mode 100644
index 0000000000..53ba748806
--- /dev/null
+++ b/IBPSA/Airflow/Multizone/Validation/ThreeRoomsContamDiscretizedDoor.mo
@@ -0,0 +1,90 @@
+within IBPSA.Airflow.Multizone.Validation;
+model ThreeRoomsContamDiscretizedDoor
+ "Model with three rooms for the validation of the multizone air exchange models"
+ extends IBPSA.Airflow.Multizone.Validation.ThreeRoomsContam(
+ redeclare IBPSA.Airflow.Multizone.DoorDiscretizedOperable dooOpeClo(
+ redeclare package Medium = Medium,
+ LClo=20*1E-4,
+ wOpe=1,
+ hOpe=2.2,
+ CDOpe=0.78,
+ CDClo=0.78,
+ nCom=10,
+ hA=3/2,
+ hB=3/2,
+ dp_turbulent(displayUnit="Pa") = 0.01));
+ Modelica.Blocks.Sources.Constant open1(k=1)
+ annotation (Placement(
+ transformation(extent={{-40,-30},{-20,-10}})));
+equation
+ connect(open1.y, dooOpeClo.y) annotation (Line(points={{-19,-20},{-12,-20},{-12,
+ -44},{-2,-44},{-2,-45}}, color={0,0,127}));
+ annotation (
+ Diagram(coordinateSystem(preserveAspectRatio=false,extent={{-200,-150},{260,
+ 200}}), graphics={
+ Rectangle(
+ extent={{8,48},{152,-100}},
+ lineColor={135,135,135},
+ lineThickness=1),
+ Rectangle(
+ extent={{-160,48},{8,-100}},
+ lineColor={135,135,135},
+ lineThickness=1),
+ Rectangle(
+ extent={{-160,160},{152,49}},
+ lineColor={135,135,135},
+ lineThickness=1)}),
+experiment(Tolerance=1e-06, StopTime=3600),
+ __Dymola_Commands(file="modelica://IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/ThreeRoomsContamDiscretizedDoor.mos"
+ "Simulate and plot"),
+ Documentation(info="
+
+This model is identical to
+
+IBPSA.Airflow.Multizone.Validation.ThreeRoomsContam
+except that it uses a different door model.
+
+
+This model has been used for a comparative model validation between CONTAM and
+the Buildings
library.
+See Wetter (2006) for details of the validation.
+
+References
+
+Michael Wetter.
+
+Multizone Airflow Model in Modelica.
+Proc. of the 5th International Modelica Conference, p. 431-440. Vienna, Austria, September 2006.
+
+", revisions="
+
+-
+October 9, 2020, by Michael Wetter:
+Refactored model to use the base class
+
+IBPSA.Airflow.Multizone.Validation.ThreeRoomsContam.
+
+-
+May 15, 2019, by Jianjun Hu:
+Replaced fluid source. This is for
+ #1072.
+
+-
+December 22, 2014 by Michael Wetter:
+Removed Modelica.Fluid.System
+to address issue
+#311.
+
+-
+June 26, 2014, by Michael Wetter:
+Set the initial conditions to be fixed to avoid a translation warning.
+This required adding a heat conductor between each volume and its prescribed
+temperature in order to avoid an overdetermined system of equations.
+
+-
+November 10, 2011, by Michael Wetter:
+Added documentation.
+
+
+"));
+end ThreeRoomsContamDiscretizedDoor;
diff --git a/IBPSA/Airflow/Multizone/Validation/package.order b/IBPSA/Airflow/Multizone/Validation/package.order
index 9a60080fba..12c9ea277c 100644
--- a/IBPSA/Airflow/Multizone/Validation/package.order
+++ b/IBPSA/Airflow/Multizone/Validation/package.order
@@ -1 +1,7 @@
+DoorOpenClosed
+OpenDoorBuoyancyDynamic
+OpenDoorBuoyancyPressureDynamic
+OpenDoorPressure
+OpenDoorTemperature
ThreeRoomsContam
+ThreeRoomsContamDiscretizedDoor
diff --git a/IBPSA/Airflow/Multizone/package.order b/IBPSA/Airflow/Multizone/package.order
index 7c3794b580..10d5c5dac9 100644
--- a/IBPSA/Airflow/Multizone/package.order
+++ b/IBPSA/Airflow/Multizone/package.order
@@ -1,6 +1,8 @@
UsersGuide
DoorDiscretizedOpen
DoorDiscretizedOperable
+DoorOpen
+DoorOperable
EffectiveAirLeakageArea
MediumColumn
MediumColumnDynamic
diff --git a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_CO2TransportStep.txt b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_CO2TransportStep.txt
index 89747a2169..1601d450ea 100644
--- a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_CO2TransportStep.txt
+++ b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_CO2TransportStep.txt
@@ -1,6 +1,12 @@
-last-generated=2015-05-08
-statistics-simulation={'numerical Jacobians': '0', 'nonlinear': ' ', 'number of continuous time states': '18', 'linear': ' '}
-CO2SenWes.C=[0., 0., 0., 0., 0., 0.0000001444770703074, 0.00000018205216179012, 0.00000016622587395432, 0.0000001496235029208, 0.00000014355917699049, 0.0000001328426009195, 0.00000012406749760885, 0.00000011630327634293, 0.0000001092343850928, 0.00000010254525051323, 0.00000009626726438228, 0.00000009050607729932, 0.00000008516595073615, 0.00000008022059461155, 0.0000000756437259497, 0.00000007140906177483, 0.00000006749031911113, 0.00000006386120787738, 0.00000006049543799236, 0.0000000573667335857, 0.00000005449427575854, 0.00000005183231266415, 0.00000004933377439897, 0.00000004699163724808, 0.00000004479887749653, 0.0000000427484785348, 0.00000004083341309524, 0.0000000390466574629, 0.00000003738119147556, 0.00000003582999497098, 0.0000000343860371288, 0.00000003304230489221, 0.00000003179176744084, 0.00000003062740816517, 0.00000002954219979756, 0.00000002852912217577, 0.00000002758115158485, 0.00000002669126608623, 0.00000002585244374131, 0.00000002505766083516, 0.00000002431717405216, 0.00000002364483187023, 0.00000002299804435779, 0.00000002237614715739, 0.00000002177847591156, 0.00000002120436803921, 0.00000002065315918287, 0.00000002012418320874, 0.0000000196167775357, 0.00000001913027780631, 0.00000001866402143946, 0.00000001821734052498, 0.00000001778957425813, 0.00000001738005650509, 0.00000001698812468476, 0.00000001661311266332, 0.00000001625435963604, 0.00000001591119769273, 0.00000001558296602866, 0.00000001526899851001, 0.00000001496863077932, 0.00000001468119936732, 0.00000001440604080472, 0.00000001414248984588, 0.00000001388988302153, 0.00000001364755597422, 0.00000001341484523465, 0.0000000131910855572, 0.00000001297561347258, 0.00000001276776462333, 0.00000001256687465201, 0.00000001237228008932, 0.00000001218331657782, 0.00000001199931976004, 0.00000001181962527852, 0.00000001164356966399, 0.00000001147048855898, 0.00000001129971760605, 0.00000001113059333591, 0.00000001096245050292, 0.0000000107946256378, 0.00000001062797849727, 0.00000001046477482447, 0.00000001030494178877, 0.00000001014838257873, 0.00000000999500127108, 0.00000000984470194254, 0.00000000969738866985, 0.0000000095529628652, 0.00000000941133038168, 0.00000000927239351967, 0.00000000913605635589, 0.00000000900222296707, 0.00000000887079565359, 0.00000000874167938036, 0.00000000861477644776]
-CO2SenEas.C=[0., 0., 0., 0., 0., 0.00000022682017686293, 0.00000016401649816089, 0.00000015675853148878, 0.00000015204204828478, 0.00000013836893231201, 0.00000013087203853956, 0.00000012279699035389, 0.00000011497983365416, 0.00000010764377833539, 0.00000010101203429258, 0.00000009499635211796, 0.000000089357286015, 0.00000008411805652031, 0.00000007925596889891, 0.00000007474833552124, 0.00000007057247586317, 0.00000006670570229517, 0.00000006312533429309, 0.00000005980867712196, 0.00000005673304670495, 0.00000005391029489488, 0.00000005128936564347, 0.00000004882903681391, 0.00000004652240903624, 0.00000004436259359863, 0.00000004234269468384, 0.0000000404558164746, 0.00000003869507025911, 0.0000000370535602201, 0.00000003552439409304, 0.0000000341006796134, 0.00000003277552096392, 0.00000003154202232736, 0.0000000303932985446, 0.00000002932244669296, 0.00000002832258161334, 0.00000002738680393577, 0.00000002650822317207, 0.00000002567994705771, 0.00000002489507977543, 0.0000000241636488596, 0.00000002349913685862, 0.00000002285979405769, 0.00000002224496498116, 0.00000002165399770604, 0.00000002108624030939, 0.00000002054103553917, 0.00000002001773324878, 0.0000000195156797389, 0.00000001903422131022, 0.00000001857270426342, 0.00000001813047489918, 0.00000001770688129454, 0.00000001730126975019, 0.00000001691298479045, 0.00000001654137626872, 0.00000001618578870932, 0.0000000158455701893, 0.00000001552006700933, 0.00000001520862547011, 0.00000001491059187231, 0.00000001462531340479, 0.00000001435213636825, 0.00000001409040795153, 0.0000000138394753435, 0.00000001359868395667, 0.0000000133673809799, 0.00000001314491271387, 0.00000001293062723562, 0.00000001272386995765, 0.00000001252398718066, 0.00000001233032698167, 0.00000001214223477319, 0.00000001195905774409, 0.00000001178014219505, 0.00000001160483620311, 0.00000001143248518076, 0.0000000112624354287, 0.00000001109403413579, 0.00000001092662849089, 0.00000001075956479468, 0.00000001059368681666, 0.00000001043122122013, 0.00000001027209783899, 0.00000001011622074998, 0.000000009963494918, 0.00000000981382530796, 0.00000000966711777295, 0.00000000952327550152, 0.00000000938220434676, 0.00000000924380927358, 0.00000000910799524689, 0.00000000897466634342, 0.00000000884372841625, 0.0000000087150864303, 0.00000000858864357411]
-CO2SenTop.C=[0., 0., 0., 0., 0., 0.00000000458930005109, 0.00000000882905659694, 0.00000001280101979972, 0.00000001640133362457, 0.00000001963020324069, 0.0000000225542571286, 0.0000000251853649047, 0.00000002754755712431, 0.0000000296622033602, 0.00000003155067318517, 0.0000000332252518831, 0.00000003471496157204, 0.00000003603599552093, 0.00000003719910424138, 0.00000003821503824497, 0.00000003909454093787, 0.00000003984836283166, 0.00000004048725443795, 0.0000000410219627156, 0.00000004146323462351, 0.00000004180408552656, 0.00000004206582104871, 0.00000004226787098105, 0.00000004241318407594, 0.00000004250472329659, 0.00000004254543028992, 0.00000004253826801914, 0.0000000424861816839, 0.00000004239213069468, 0.00000004225906735655, 0.00000004208994042187, 0.00000004188770574842, 0.00000004165531919398, 0.0000000413957295109, 0.00000004111189255696, 0.00000004080676418994, 0.00000004048328960948, 0.00000004014442822609, 0.00000003979313234481, 0.00000003943235071802, 0.00000003905785916913, 0.00000003866378861517, 0.00000003826772854154, 0.00000003786987434751, 0.00000003747042143232, 0.00000003706956164251, 0.00000003666749748277, 0.00000003626441724691, 0.00000003586051988691, 0.0000000354559972493, 0.00000003505104828605, 0.00000003464586839641, 0.00000003424064942692, 0.00000003383559032955, 0.00000003343088650354, 0.00000003302672624272, 0.0000000326233156045, 0.00000003222084288268, 0.00000003181950347653, 0.000000031419496338, 0.00000003102101331365, 0.00000003062424980271, 0.00000003022940475716, 0.00000002983667002354, 0.00000002944624277745, 0.00000002905831664179, 0.00000002867308879217, 0.00000002829075285149, 0.00000002791150599535, 0.00000002753554007029, 0.00000002716305402828, 0.00000002679424149221, 0.00000002642929786134, 0.00000002606842031128, 0.00000002571180068855, 0.00000002535963616879, 0.00000002501212392758, 0.00000002466945581148, 0.00000002433182899608, 0.00000002399943710429, 0.00000002367247731172, 0.00000002335053927993, 0.00000002303256252389, 0.0000000227185061874, 0.00000002240834007239, 0.00000002210203930986, 0.00000002179957725446, 0.00000002150092726083, 0.00000002120606445999, 0.00000002091496220658, 0.00000002062759207888, 0.00000002034393098427, 0.00000002006395050103, 0.00000001978762576016, 0.00000001951493011632, 0.00000001924583692414]
-time=[0., 86400.]
+last-generated=2020-10-09
+statistics-simulation=
+{
+ "linear": " ",
+ "nonlinear": " ",
+ "number of continuous time states": "16",
+ "numerical Jacobians": "0"
+}
+time=[0e+00, 8.64e+04]
+CO2SenWes.C=[0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 1.857115705661272e-07, 1.75567166138535e-07, 1.648390366426611e-07, 1.560445213044659e-07, 1.472500059662707e-07, 1.384554906280755e-07, 1.309360015966377e-07, 1.239335318814483e-07, 1.169310550608316e-07, 1.102396041119391e-07, 1.043514146203961e-07, 9.871609307765539e-08, 9.333363237828961e-08, 8.82040325222988e-08, 8.332730061511029e-08, 7.870342955129672e-08, 7.432556969888537e-08, 7.016139136339916e-08, 6.623924519999491e-08, 6.255913831409998e-08, 5.912106360028702e-08, 5.592502105855601e-08, 5.297101424162065e-08, 5.023889571020844e-08, 4.651976581726558e-08, 4.295612754390277e-08, 3.954798444283369e-08, 3.629533651405836e-08, 3.319818020486309e-08, 3.025651906796155e-08, 2.747035310335378e-08, 2.483968053468288e-08, 2.23645013619489e-08, 2.004481736150865e-08, 1.788062498064846e-08, 1.587192954843886e-08, 1.401872573580931e-08, 1.232101709547351e-08, 1.077880273925302e-08, 9.392081778969441e-09, 8.160855102801179e-09, 7.085122266659027e-09, 6.164883270542987e-09, 5.400138558542267e-09, 4.790887686567658e-09, 4.337131098708369e-09, 4.038868350875191e-09, 3.896099443068124e-09, 3.908824819376377e-09, 4.077044035710742e-09, 4.40075753616043e-09, 4.621408145055731e-09, 3.762788747252451e-09, 2.957371236789186e-09, 2.205155391621361e-09, 1.506141433793573e-09, 8.603292522835204e-10, 2.677188470912029e-10, -2.71689754027804e-10, -7.578965788290759e-10, -1.190901599557037e-09, -1.570704788456112e-09, -1.897306312059754e-09, -2.170705837301059e-09, -2.390903697246925e-09, -2.557899891897363e-09, -2.671693977163159e-09, -2.732286619178126e-09, -2.739677151808451e-09, -2.693866019143343e-09, -2.594853221182802e-09, -2.44263831383762e-09, -2.237221963241609e-09, -1.978603503260956e-09, -1.666783489007173e-09, -1.301761587413353e-09, -8.83537909501797e-10, -4.121124275169308e-10, 1.125148585412461e-10, 4.695462352266588e-10, 4.28417440412332e-10, 3.949582050299938e-10, 3.691686123463711e-10, 3.510486068503127e-10, 3.405982440529698e-10, 3.378174684431912e-10, 3.427062800209768e-10, 3.55264734297478e-10, 3.754927757615434e-10, 4.033904321687487e-10, 4.389577035190939e-10, 4.821945620570034e-10, 5.331010632936284e-10, 5.916771517178177e-10, 6.579228273295712e-10, 7.318381456400402e-10]
+CO2SenEas.C=[0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 1.863530485479714e-07, 1.731955308059696e-07, 1.62502914236029e-07, 1.538541880563571e-07, 1.452054618766851e-07, 1.365567214861585e-07, 1.291195133035217e-07, 1.221735743683894e-07, 1.152276212224024e-07, 1.0859142918207e-07, 1.027552087862205e-07, 9.717081894677904e-08, 9.183825255831833e-08, 8.675751672626575e-08, 8.192861145062125e-08, 7.735152962595748e-08, 7.302533333586325e-08, 6.894551063396648e-08, 6.511601213787799e-08, 6.153684495302514e-08, 5.820799131583954e-08, 5.51294654371759e-08, 5.230126376432054e-08, 4.970130973447338e-08, 4.600502023777153e-08, 4.246423301879076e-08, 3.907894807753109e-08, 3.584916186127884e-08, 3.277488147546137e-08, 2.985610336736498e-08, 2.709282398427605e-08, 2.448504865526502e-08, 2.203277382761826e-08, 1.973600127769259e-08, 1.759473100548803e-08, 1.560896301100456e-08, 1.377869551788535e-08, 1.210393119066566e-08, 1.058466825298865e-08, 9.220907593032734e-09, 8.012648322619498e-09, 6.959891329927359e-09, 6.062636170867108e-09, 5.320882845438746e-09, 4.734631797731481e-09, 4.303882139566895e-09, 4.028634759123406e-09, 3.908889212311806e-09, 3.944645055042884e-09, 4.135903619584269e-09, 4.482663573668336e-09, 4.724300062264312e-09, 3.876793996937529e-09, 3.081679134098181e-09, 2.338955473746296e-09, 1.648622904859565e-09, 1.01068153846029e-09, 4.251314023040464e-10, -1.080275868758918e-10, -5.887954013239494e-10, -1.017172013284551e-09, -1.39315758929115e-09, -1.71675185178799e-09, -1.987954911797376e-09, -2.206766991363905e-09, -2.373187646398377e-09, -2.487217320989998e-09, -2.548855793094162e-09, -2.55810306271087e-09, -2.514959129840122e-09, -2.419424216526522e-09, -2.271497878680862e-09, -2.071180560392349e-09, -1.818471928594079e-09, -1.513372094308352e-09, -1.155881168557471e-09, -7.459990958302853e-10, -2.837258206156434e-10, 2.309386154530912e-10, 5.874007946715665e-10, 5.657520008028882e-10, 5.5306653701237e-10, 5.493442922777092e-10, 5.545853776212084e-10, 5.687896820205651e-10, 5.919572609869306e-10, 6.24088170031456e-10, 6.651822981318389e-10, 7.152397007992306e-10, 7.742604335447822e-10, 8.422443853461914e-10, 9.191916117146093e-10, 1.005102112650036e-09, 1.099975999174774e-09, 1.203813049244218e-09, 1.316613373880671e-09]
+CO2SenTop.C=[0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 3.997768782681987e-09, 7.730635687153153e-09, 1.109886937911142e-08, 1.368996649375731e-08, 1.62810636084032e-08, 1.887216072304909e-08, 2.098460782917755e-08, 2.290296308160578e-08, 2.482132011039084e-08, 2.662219245053166e-08, 2.811964705529135e-08, 2.952158872915334e-08, 3.082801214304709e-08, 3.203892617875681e-08, 3.31543219544983e-08, 3.417420302298524e-08, 3.510094970238242e-08, 3.594578856791486e-08, 3.669887860269228e-08, 3.736021270128731e-08, 3.792979441641364e-08, 3.840762374807127e-08, 3.87937006962602e-08, 3.909660861722841e-08, 3.983157981224394e-08, 4.05116793444904e-08, 4.113691076668147e-08, 4.170727052610346e-08, 4.222275862275637e-08, 4.268337860935389e-08, 4.308912693318234e-08, 4.34400071469554e-08, 4.373601569795937e-08, 4.397715613890796e-08, 4.416342491708747e-08, 4.429482558521158e-08, 4.437135459056663e-08, 4.439301193315259e-08, 4.435980116568317e-08, 4.427171873544467e-08, 4.412876819515077e-08, 4.39309459920878e-08, 4.367825567896944e-08, 4.3370693703082e-08, 4.300826006442549e-08, 4.259095831571358e-08, 4.21187849042326e-08, 4.159174338269622e-08, 4.100983019839077e-08, 4.037304890402993e-08, 3.96813959469e-08, 3.90367667080227e-08, 3.882387034082058e-08, 3.859641850567641e-08, 3.835440409716284e-08, 3.809783422070723e-08, 3.782670532359589e-08, 3.754101740582882e-08, 3.724077402011972e-08, 3.692597161375488e-08, 3.659661018673432e-08, 3.625268973905804e-08, 3.589421382343971e-08, 3.552117533445198e-08, 3.513358137752221e-08, 3.473143195265039e-08, 3.431471995440916e-08, 3.388345248822588e-08, 3.343762600138689e-08, 3.297724049389217e-08, 3.25022995184554e-08, 3.201279596964923e-08, 3.150873695290102e-08, 3.099011891549708e-08, 3.045694541015109e-08, 2.99092093314357e-08, 2.934691956113511e-08, 2.877006899382195e-08, 2.817865940585307e-08, 2.765051299036259e-08, 2.726688563825519e-08, 2.688474864953605e-08, 2.650410024784833e-08, 2.612494220954886e-08, 2.574727275828081e-08, 2.537109189404418e-08, 2.499640139319581e-08, 2.462320125573569e-08, 2.425148792895016e-08, 2.388126496555287e-08, 2.351253236554385e-08, 2.314528835256624e-08, 2.277953470297689e-08, 2.241526786406212e-08, 2.205249316489244e-08, 2.169120527639734e-08]
diff --git a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_OneOpenDoor.txt b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_OneOpenDoor.txt
index e37250dce0..d2eea05eeb 100644
--- a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_OneOpenDoor.txt
+++ b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_OneOpenDoor.txt
@@ -11,7 +11,7 @@ dooOpe.vAB=[-1.828544399229415e-10, 7.744489703327417e-04, 3.120638197287917e-03
dooOpe.vBA=[1.82854689723122e-10, 7.83746421802789e-04, 3.149702912196517e-03, 6.859173532575369e-03, 1.149625424295664e-02, 1.638871617615223e-02, 2.093742974102497e-02, 2.488339319825173e-02, 2.801888436079025e-02, 3.071469254791737e-02, 3.296883404254913e-02, 3.479285910725594e-02, 3.625937178730965e-02, 3.73937152326107e-02, 3.820809349417686e-02, 3.790324926376343e-02, 3.58145497739315e-02, 3.391088172793388e-02, 3.237584605813026e-02, 3.100461699068546e-02, 2.965953014791012e-02, 2.823882363736629e-02, 2.667451091110706e-02, 2.488125860691071e-02, 2.278635092079639e-02, 2.025625109672546e-02, 1.723581738770008e-02, 1.353335473686455e-02, 9.007898159325107e-03, 3.451112192124128e-03, 3.226996399462223e-03, 1.016592606902122e-02, 1.662694662809372e-02, 2.129698544740677e-02, 2.4571742862463e-02, 2.686300873756409e-02, 2.851203642785549e-02, 2.965476736426353e-02, 3.042300045490265e-02, 3.088059835135937e-02, 3.106354922056198e-02, 3.101322427392006e-02, 3.074470907449722e-02, 3.026657178997993e-02, 2.958239614963531e-02, 2.868657186627388e-02, 2.756011672317982e-02, 2.618258818984032e-02, 2.503139153122902e-02, 2.249842323362827e-02, 2.00509075075388e-02, 1.698556169867516e-02, 1.357492990791798e-02, 9.214967489242554e-03, 3.336021676659545e-03, 3.359148977324415e-03, 1.075231563299898e-02, 1.686312258243561e-02, 2.14648824185133e-02, 2.431734092533588e-02, 2.693993225693703e-02, 2.861898392438889e-02, 2.973535656929016e-02, 3.052528947591782e-02, 3.096076473593712e-02, 3.113003075122833e-02, 3.118841163814068e-02, 3.078893199563026e-02, 3.034090809524059e-02, 2.951950207352638e-02, 2.871350198984146e-02, 2.756510116159916e-02, 2.615204080939293e-02, 2.445583790540695e-02, 2.247136458754539e-02, 2.002259716391563e-02, 1.701848767697811e-02, 1.343587879091501e-02, 8.303899317979813e-03, 3.086143406108022e-03, 3.382438793778419e-03, 1.052721496671438e-02, 1.681743189692497e-02, 2.140798047184944e-02, 2.446058765053749e-02, 2.686451748013496e-02, 2.849728055298328e-02, 2.965690195560455e-02, 3.041950426995754e-02, 3.087067045271397e-02, 3.106571361422539e-02, 3.101162426173687e-02, 3.074277006089687e-02, 3.025645948946476e-02, 2.957308664917946e-02, 2.867946587502956e-02, 2.754545398056507e-02, 2.618557587265968e-02, 2.470811456441879e-02, 2.25211288779974e-02, 1.96418184787035e-02]
dooOpeClo.vAB=[-9.1644337951724e-11, 3.714342310559005e-04, 1.5570706455037e-03, 3.413593862205744e-03, 5.700282752513885e-03, 8.074872195720673e-03, 1.023960672318935e-02, 1.210264675319195e-02, 1.383906416594982e-02, 1.532804593443871e-02, 1.660740002989769e-02, 1.769467070698738e-02, 1.858022436499596e-02, 1.927342638373375e-02, 2.066400088369848e-02, 3.039553575217724e-02, 3.57811227440834e-02, 3.387891501188278e-02, 3.234804794192314e-02, 3.097936511039734e-02, 2.963798679411411e-02, 2.822473831474781e-02, 2.665600925683975e-02, 2.487590722739697e-02, 2.278347499668598e-02, 2.030643075704575e-02, 1.72595176845789e-02, 1.355490274727343e-02, 9.027298539876922e-03, 3.509134752675891e-03, 3.276306902989745e-03, 1.080624479800463e-02, 1.68143343180418e-02, 2.138751931488514e-02, 2.461155876517296e-02, 2.691951207816601e-02, 2.854683063924313e-02, 2.969101816415787e-02, 3.047664649784565e-02, 3.092434629797935e-02, 3.110743127763271e-02, 3.105247393250465e-02, 3.077681548893452e-02, 3.029567375779152e-02, 2.960921823978424e-02, 2.870707400143147e-02, 2.758162096142769e-02, 2.620630525052547e-02, 2.403721213340759e-02, 2.254626899957657e-02, 2.009090967476368e-02, 1.715373434126377e-02, 1.323695294559002e-02, 8.5343848913908e-03, 3.320445539429744e-03, 3.479309612885162e-03, 1.052942685782914e-02, 1.681605540215969e-02, 2.138819918036461e-02, 2.499713562428951e-02, 2.694580517709255e-02, 2.851816080510616e-02, 2.968760393559933e-02, 3.045925311744213e-02, 3.091711737215519e-02, 3.106844611465931e-02, 3.086912631988525e-02, 3.075956366956234e-02, 3.022648766636848e-02, 2.965895086526871e-02, 2.867006883025169e-02, 2.755626104772091e-02, 2.614875696599483e-02, 2.444218099117279e-02, 2.242965623736382e-02, 1.999888382852077e-02, 1.701958850026131e-02, 1.325665973126888e-02, 9.379577822983265e-03, 3.548952518031001e-03, 3.434372367337346e-03, 1.070229988545179e-02, 1.680628396570683e-02, 2.138950116932392e-02, 2.478140778839588e-02, 2.691375836730003e-02, 2.855760045349598e-02, 2.969254180788994e-02, 3.045953623950481e-02, 3.091422095894814e-02, 3.108858689665794e-02, 3.104471787810326e-02, 3.077805414795876e-02, 3.028850443661213e-02, 2.960635535418987e-02, 2.870535291731358e-02, 2.758941240608692e-02, 2.619574964046478e-02, 2.436224929988384e-02, 2.24694050848484e-02, 2.042261138558388e-02]
dooOpeClo.vBA=[9.164440040176913e-11, 3.760936087928712e-04, 1.571618136949837e-03, 3.426991170272231e-03, 5.712668877094984e-03, 8.082190528512001e-03, 1.026582717895508e-02, 1.221683248877526e-02, 1.387111749500036e-02, 1.536433026194572e-02, 1.66592076420784e-02, 1.773467846214771e-02, 1.861876808106899e-02, 1.931435987353325e-02, 2.070466056466104e-02, 3.043271414935589e-02, 3.58145497739315e-02, 3.391088172793388e-02, 3.237584605813026e-02, 3.100461699068546e-02, 2.965953014791012e-02, 2.823882363736629e-02, 2.667451091110706e-02, 2.488125860691071e-02, 2.278635092079639e-02, 2.025625109672546e-02, 1.723581738770008e-02, 1.353335473686455e-02, 9.007898159325107e-03, 3.451112192124128e-03, 3.226996399462223e-03, 1.016592606902122e-02, 1.662694662809372e-02, 2.129698544740677e-02, 2.4571742862463e-02, 2.686300873756409e-02, 2.851203642785549e-02, 2.965476736426353e-02, 3.042300045490265e-02, 3.088059835135937e-02, 3.106354922056198e-02, 3.101322427392006e-02, 3.074470907449722e-02, 3.026657178997993e-02, 2.958239614963531e-02, 2.868657186627388e-02, 2.756011672317982e-02, 2.618258818984032e-02, 2.503139153122902e-02, 2.249842323362827e-02, 2.00509075075388e-02, 1.698556169867516e-02, 1.357492990791798e-02, 9.214967489242554e-03, 3.336021676659545e-03, 3.359148977324415e-03, 1.075231563299898e-02, 1.686312258243561e-02, 2.14648824185133e-02, 2.431734092533588e-02, 2.693993225693703e-02, 2.861898392438889e-02, 2.973535656929016e-02, 3.052528947591782e-02, 3.096076473593712e-02, 3.113003075122833e-02, 3.118841163814068e-02, 3.078893199563026e-02, 3.034090809524059e-02, 2.951950207352638e-02, 2.871350198984146e-02, 2.756510116159916e-02, 2.615204080939293e-02, 2.445583790540695e-02, 2.247136458754539e-02, 2.002259716391563e-02, 1.701848767697811e-02, 1.343587879091501e-02, 8.303899317979813e-03, 3.086143406108022e-03, 3.382438793778419e-03, 1.052721496671438e-02, 1.681743189692497e-02, 2.140798047184944e-02, 2.446058765053749e-02, 2.686451748013496e-02, 2.849728055298328e-02, 2.965690195560455e-02, 3.041950426995754e-02, 3.087067045271397e-02, 3.106571361422539e-02, 3.101162426173687e-02, 3.074277006089687e-02, 3.025645948946476e-02, 2.957308664917946e-02, 2.867946587502956e-02, 2.754545398056507e-02, 2.618557587265968e-02, 2.470811456441879e-02, 2.25211288779974e-02, 1.96418184787035e-02]
-dooOpe.mAB_flow=[-4.161353484022356e-10, 1.762488624081016e-03, 7.102153729647398e-03, 1.555009838193655e-02, 2.610969915986061e-02, 3.727133572101593e-02, 4.754110425710678e-02, 5.613024160265923e-02, 6.365261971950531e-02, 6.978099048137665e-02, 7.485508173704147e-02, 7.906641066074371e-02, 8.241861313581467e-02, 8.499711751937866e-02, 8.686283230781555e-02, 8.622457832098007e-02, 8.148808777332306e-02, 7.715097814798355e-02, 7.366114854812622e-02, 7.054147869348526e-02, 6.748443096876144e-02, 6.426398456096649e-02, 6.068969517946243e-02, 5.66343180835247e-02, 5.186809226870537e-02, 4.622659459710121e-02, 3.928830102086067e-02, 3.08535601943731e-02, 2.054652571678158e-02, 7.986355572938919e-03, 7.455821614712477e-03, 2.458915114402771e-02, 3.825666755437851e-02, 4.865766689181328e-02, 5.598857626318932e-02, 6.1235461384058e-02, 6.49343878030777e-02, 6.753486394882202e-02, 6.932026892900467e-02, 7.033763080835342e-02, 7.075367122888565e-02, 7.062878459692001e-02, 7.000236958265305e-02, 6.890898197889328e-02, 6.734894961118698e-02, 6.529858708381653e-02, 6.274048984050751e-02, 5.96141405403614e-02, 5.468207225203514e-02, 5.129263177514076e-02, 4.570894688367844e-02, 3.902865573763847e-02, 3.011884354054928e-02, 1.942006684839725e-02, 7.556259632110505e-03, 7.918470539152723e-03, 2.396597713232051e-02, 3.827857226133347e-02, 4.869028180837631e-02, 5.691002309322357e-02, 6.134993210434914e-02, 6.493266671895981e-02, 6.759753078222275e-02, 6.935612857341766e-02, 7.039962708950043e-02, 7.074455171823502e-02, 7.029053568840027e-02, 7.004052400588989e-02, 6.882569193840027e-02, 6.753205507993698e-02, 6.527876853942871e-02, 6.274081766605377e-02, 5.953402072191238e-02, 5.564630776643753e-02, 5.106223747134209e-02, 4.552624374628067e-02, 3.874199464917183e-02, 3.017461113631725e-02, 2.134827710688114e-02, 8.076958358287811e-03, 7.815511897206306e-03, 2.435258589684963e-02, 3.82382944226265e-02, 4.866211861371994e-02, 5.63749261200428e-02, 6.12223744392395e-02, 6.495889276266098e-02, 6.753832101821899e-02, 6.928137689828873e-02, 7.031462341547012e-02, 7.071082293987274e-02, 7.061114907264709e-02, 7.000518590211868e-02, 6.88926950097084e-02, 6.734244525432587e-02, 6.529468297958374e-02, 6.275821477174759e-02, 5.959013476967812e-02, 5.542149767279625e-02, 5.111779272556305e-02, 4.646363854408264e-02]
-dooOpe.mBA_flow=[4.161359312693236e-10, 1.783611485734582e-03, 7.167722098529339e-03, 1.56085379421711e-02, 2.615886740386486e-02, 3.728849440813065e-02, 4.763409867882729e-02, 5.66067397594452e-02, 6.373443454504013e-02, 6.986124068498611e-02, 7.498312741518021e-02, 7.912681251764297e-02, 8.24577584862709e-02, 8.503387868404388e-02, 8.688313513994217e-02, 8.619088679552078e-02, 8.144741505384445e-02, 7.712323218584061e-02, 7.36357644200325e-02, 7.052002102136612e-02, 6.746328622102737e-02, 6.423430144786835e-02, 6.067849695682526e-02, 5.660173296928406e-02, 5.183852463960648e-02, 4.60849329829216e-02, 3.921529650688171e-02, 3.079319931566712e-02, 2.049751020967957e-02, 7.853599265217781e-03, 7.344221696257591e-03, 2.313856407999992e-02, 3.784802928566933e-02, 4.848254844546318e-02, 5.594146251678467e-02, 6.11613392829895e-02, 6.491865217685699e-02, 6.752268970012665e-02, 6.927348673343658e-02, 7.031639665365219e-02, 7.073336839675903e-02, 7.061865925788879e-02, 7.000666856765747e-02, 6.891696155071259e-02, 6.735775619745255e-02, 6.531634926795959e-02, 6.274961680173874e-02, 5.961111187934875e-02, 5.698785185813904e-02, 5.121886730194092e-02, 4.564472660422325e-02, 3.86645719408989e-02, 3.089907951653004e-02, 2.097362652420998e-02, 7.59235629811874e-03, 7.644326891750207e-03, 2.446638420224198e-02, 3.836759552359581e-02, 4.883358627557755e-02, 5.53191751241684e-02, 6.128183007240295e-02, 6.509844213724136e-02, 6.763564050197601e-02, 6.943082809448242e-02, 7.042039185762405e-02, 7.080504298210144e-02, 7.093797624111176e-02, 7.002989947795868e-02, 6.90118670463562e-02, 6.714489310979843e-02, 6.531322002410889e-02, 6.270292401313782e-02, 5.949076637625694e-02, 5.56345172226429e-02, 5.112230032682419e-02, 4.555358365178108e-02, 3.872097283601761e-02, 3.057149797677994e-02, 1.889560371637344e-02, 7.02306441962719e-03, 7.698004133999348e-03, 2.396093495190144e-02, 3.828169032931328e-02, 4.873528704047203e-02, 5.568844079971313e-02, 6.116477027535439e-02, 6.488505005836487e-02, 6.752755492925644e-02, 6.926550716161728e-02, 7.029376924037933e-02, 7.073827832937241e-02, 7.06150159239769e-02, 7.000225037336349e-02, 6.88939169049263e-02, 6.73365443944931e-02, 6.530015915632248e-02, 6.271623075008392e-02, 5.961790680885315e-02, 5.625185742974281e-02, 5.127052962779999e-02, 4.471342638134956e-02]
-dooOpeClo.mAB_flow=[-1.165218366672854e-13, 4.722674589174858e-07, 1.979828311959864e-06, 4.340623945608968e-06, 7.248775091284188e-06, 1.026919744617771e-05, 1.302325199503684e-05, 1.539403820061125e-05, 1.760411214490887e-05, 1.949967372638639e-05, 2.112867514370009e-05, 2.251331898150966e-05, 2.364123974984977e-05, 2.452426815580111e-05, 3.162165870890072e-03, 4.616500437259674e-02, 8.148808777332306e-02, 7.715097814798355e-02, 7.366114854812622e-02, 7.054147869348526e-02, 6.748443096876144e-02, 6.426398456096649e-02, 6.068969517946243e-02, 5.66343180835247e-02, 5.186809226870537e-02, 4.622659459710121e-02, 3.928830102086067e-02, 3.08535601943731e-02, 2.054652571678158e-02, 7.986355572938919e-03, 7.455821614712477e-03, 2.458915114402771e-02, 3.825666755437851e-02, 4.865766689181328e-02, 5.598857626318932e-02, 6.1235461384058e-02, 6.49343878030777e-02, 6.753486394882202e-02, 6.932026892900467e-02, 7.033763080835342e-02, 7.075367122888565e-02, 7.062878459692001e-02, 7.000236958265305e-02, 6.890898197889328e-02, 6.734894961118698e-02, 6.529858708381653e-02, 6.274048984050751e-02, 5.96141405403614e-02, 5.468207225203514e-02, 5.129263177514076e-02, 4.570894688367844e-02, 3.902865573763847e-02, 3.011884354054928e-02, 1.942006684839725e-02, 7.556259632110505e-03, 7.918470539152723e-03, 2.396597713232051e-02, 3.827857226133347e-02, 4.869028180837631e-02, 5.691002309322357e-02, 6.134993210434914e-02, 6.493266671895981e-02, 6.759753078222275e-02, 6.935612857341766e-02, 7.039962708950043e-02, 7.074455171823502e-02, 7.029053568840027e-02, 7.004052400588989e-02, 6.882569193840027e-02, 6.753205507993698e-02, 6.527876853942871e-02, 6.274081766605377e-02, 5.953402072191238e-02, 5.564630776643753e-02, 5.106223747134209e-02, 4.552624374628067e-02, 3.874199464917183e-02, 3.017461113631725e-02, 2.134827710688114e-02, 8.076958358287811e-03, 7.815511897206306e-03, 2.435258589684963e-02, 3.82382944226265e-02, 4.866211861371994e-02, 5.63749261200428e-02, 6.12223744392395e-02, 6.495889276266098e-02, 6.753832101821899e-02, 6.928137689828873e-02, 7.031462341547012e-02, 7.071082293987274e-02, 7.061114907264709e-02, 7.000518590211868e-02, 6.88926950097084e-02, 6.734244525432587e-02, 6.529468297958374e-02, 6.275821477174759e-02, 5.959013476967812e-02, 5.542149767279625e-02, 5.111779272556305e-02, 4.646363854408264e-02]
-dooOpeClo.mBA_flow=[1.165219179824484e-13, 4.78181959806534e-07, 1.998164179894957e-06, 4.356883891887264e-06, 7.262299277499551e-06, 1.027381040330511e-05, 1.304851411987329e-05, 1.552707544760779e-05, 1.762817191774957e-05, 1.952433740370907e-05, 2.116834366461262e-05, 2.253353886771947e-05, 2.365564250794705e-05, 2.453839988447726e-05, 3.16330255009239e-03, 4.614829272031784e-02, 8.144741505384445e-02, 7.712323218584061e-02, 7.36357644200325e-02, 7.052002102136612e-02, 6.746328622102737e-02, 6.423430144786835e-02, 6.067849695682526e-02, 5.660173296928406e-02, 5.183852463960648e-02, 4.60849329829216e-02, 3.921529650688171e-02, 3.079319931566712e-02, 2.049751020967957e-02, 7.853599265217781e-03, 7.344221696257591e-03, 2.313856407999992e-02, 3.784802928566933e-02, 4.848254844546318e-02, 5.594146251678467e-02, 6.11613392829895e-02, 6.491865217685699e-02, 6.752268970012665e-02, 6.927348673343658e-02, 7.031639665365219e-02, 7.073336839675903e-02, 7.061865925788879e-02, 7.000666856765747e-02, 6.891696155071259e-02, 6.735775619745255e-02, 6.531634926795959e-02, 6.274961680173874e-02, 5.961111187934875e-02, 5.698785185813904e-02, 5.121886730194092e-02, 4.564472660422325e-02, 3.86645719408989e-02, 3.089907951653004e-02, 2.097362652420998e-02, 7.59235629811874e-03, 7.644326891750207e-03, 2.446638420224198e-02, 3.836759552359581e-02, 4.883358627557755e-02, 5.53191751241684e-02, 6.128183007240295e-02, 6.509844213724136e-02, 6.763564050197601e-02, 6.943082809448242e-02, 7.042039185762405e-02, 7.080504298210144e-02, 7.093797624111176e-02, 7.002989947795868e-02, 6.90118670463562e-02, 6.714489310979843e-02, 6.531322002410889e-02, 6.270292401313782e-02, 5.949076637625694e-02, 5.56345172226429e-02, 5.112230032682419e-02, 4.555358365178108e-02, 3.872097283601761e-02, 3.057149797677994e-02, 1.889560371637344e-02, 7.02306441962719e-03, 7.698004133999348e-03, 2.396093495190144e-02, 3.828169032931328e-02, 4.873528704047203e-02, 5.568844079971313e-02, 6.116477027535439e-02, 6.488505005836487e-02, 6.752755492925644e-02, 6.926550716161728e-02, 7.029376924037933e-02, 7.073827832937241e-02, 7.06150159239769e-02, 7.000225037336349e-02, 6.88939169049263e-02, 6.73365443944931e-02, 6.530015915632248e-02, 6.271623075008392e-02, 5.961790680885315e-02, 5.625185742974281e-02, 5.127052962779999e-02, 4.471342638134956e-02]
+dooOpe.port_a1.m_flow=[-4.161353484022356e-10, 1.762488624081016e-03, 7.102153729647398e-03, 1.555009838193655e-02, 2.610969915986061e-02, 3.727133572101593e-02, 4.754110425710678e-02, 5.613024160265923e-02, 6.365261971950531e-02, 6.978099048137665e-02, 7.485508173704147e-02, 7.906641066074371e-02, 8.241861313581467e-02, 8.499711751937866e-02, 8.686283230781555e-02, 8.622457832098007e-02, 8.148808777332306e-02, 7.715097814798355e-02, 7.366114854812622e-02, 7.054147869348526e-02, 6.748443096876144e-02, 6.426398456096649e-02, 6.068969517946243e-02, 5.66343180835247e-02, 5.186809226870537e-02, 4.622659459710121e-02, 3.928830102086067e-02, 3.08535601943731e-02, 2.054652571678158e-02, 7.986355572938919e-03, 7.455821614712477e-03, 2.458915114402771e-02, 3.825666755437851e-02, 4.865766689181328e-02, 5.598857626318932e-02, 6.1235461384058e-02, 6.49343878030777e-02, 6.753486394882202e-02, 6.932026892900467e-02, 7.033763080835342e-02, 7.075367122888565e-02, 7.062878459692001e-02, 7.000236958265305e-02, 6.890898197889328e-02, 6.734894961118698e-02, 6.529858708381653e-02, 6.274048984050751e-02, 5.96141405403614e-02, 5.468207225203514e-02, 5.129263177514076e-02, 4.570894688367844e-02, 3.902865573763847e-02, 3.011884354054928e-02, 1.942006684839725e-02, 7.556259632110505e-03, 7.918470539152723e-03, 2.396597713232051e-02, 3.827857226133347e-02, 4.869028180837631e-02, 5.691002309322357e-02, 6.134993210434914e-02, 6.493266671895981e-02, 6.759753078222275e-02, 6.935612857341766e-02, 7.039962708950043e-02, 7.074455171823502e-02, 7.029053568840027e-02, 7.004052400588989e-02, 6.882569193840027e-02, 6.753205507993698e-02, 6.527876853942871e-02, 6.274081766605377e-02, 5.953402072191238e-02, 5.564630776643753e-02, 5.106223747134209e-02, 4.552624374628067e-02, 3.874199464917183e-02, 3.017461113631725e-02, 2.134827710688114e-02, 8.076958358287811e-03, 7.815511897206306e-03, 2.435258589684963e-02, 3.82382944226265e-02, 4.866211861371994e-02, 5.63749261200428e-02, 6.12223744392395e-02, 6.495889276266098e-02, 6.753832101821899e-02, 6.928137689828873e-02, 7.031462341547012e-02, 7.071082293987274e-02, 7.061114907264709e-02, 7.000518590211868e-02, 6.88926950097084e-02, 6.734244525432587e-02, 6.529468297958374e-02, 6.275821477174759e-02, 5.959013476967812e-02, 5.542149767279625e-02, 5.111779272556305e-02, 4.646363854408264e-02]
+dooOpe.port_a2.m_flow=[4.161359312693236e-10, 1.783611485734582e-03, 7.167722098529339e-03, 1.56085379421711e-02, 2.615886740386486e-02, 3.728849440813065e-02, 4.763409867882729e-02, 5.66067397594452e-02, 6.373443454504013e-02, 6.986124068498611e-02, 7.498312741518021e-02, 7.912681251764297e-02, 8.24577584862709e-02, 8.503387868404388e-02, 8.688313513994217e-02, 8.619088679552078e-02, 8.144741505384445e-02, 7.712323218584061e-02, 7.36357644200325e-02, 7.052002102136612e-02, 6.746328622102737e-02, 6.423430144786835e-02, 6.067849695682526e-02, 5.660173296928406e-02, 5.183852463960648e-02, 4.60849329829216e-02, 3.921529650688171e-02, 3.079319931566712e-02, 2.049751020967957e-02, 7.853599265217781e-03, 7.344221696257591e-03, 2.313856407999992e-02, 3.784802928566933e-02, 4.848254844546318e-02, 5.594146251678467e-02, 6.11613392829895e-02, 6.491865217685699e-02, 6.752268970012665e-02, 6.927348673343658e-02, 7.031639665365219e-02, 7.073336839675903e-02, 7.061865925788879e-02, 7.000666856765747e-02, 6.891696155071259e-02, 6.735775619745255e-02, 6.531634926795959e-02, 6.274961680173874e-02, 5.961111187934875e-02, 5.698785185813904e-02, 5.121886730194092e-02, 4.564472660422325e-02, 3.86645719408989e-02, 3.089907951653004e-02, 2.097362652420998e-02, 7.59235629811874e-03, 7.644326891750207e-03, 2.446638420224198e-02, 3.836759552359581e-02, 4.883358627557755e-02, 5.53191751241684e-02, 6.128183007240295e-02, 6.509844213724136e-02, 6.763564050197601e-02, 6.943082809448242e-02, 7.042039185762405e-02, 7.080504298210144e-02, 7.093797624111176e-02, 7.002989947795868e-02, 6.90118670463562e-02, 6.714489310979843e-02, 6.531322002410889e-02, 6.270292401313782e-02, 5.949076637625694e-02, 5.56345172226429e-02, 5.112230032682419e-02, 4.555358365178108e-02, 3.872097283601761e-02, 3.057149797677994e-02, 1.889560371637344e-02, 7.02306441962719e-03, 7.698004133999348e-03, 2.396093495190144e-02, 3.828169032931328e-02, 4.873528704047203e-02, 5.568844079971313e-02, 6.116477027535439e-02, 6.488505005836487e-02, 6.752755492925644e-02, 6.926550716161728e-02, 7.029376924037933e-02, 7.073827832937241e-02, 7.06150159239769e-02, 7.000225037336349e-02, 6.88939169049263e-02, 6.73365443944931e-02, 6.530015915632248e-02, 6.271623075008392e-02, 5.961790680885315e-02, 5.625185742974281e-02, 5.127052962779999e-02, 4.471342638134956e-02]
+dooOpeClo.port_a1.m_flow=[-1.165218366672854e-13, 4.722674589174858e-07, 1.979828311959864e-06, 4.340623945608968e-06, 7.248775091284188e-06, 1.026919744617771e-05, 1.302325199503684e-05, 1.539403820061125e-05, 1.760411214490887e-05, 1.949967372638639e-05, 2.112867514370009e-05, 2.251331898150966e-05, 2.364123974984977e-05, 2.452426815580111e-05, 3.162165870890072e-03, 4.616500437259674e-02, 8.148808777332306e-02, 7.715097814798355e-02, 7.366114854812622e-02, 7.054147869348526e-02, 6.748443096876144e-02, 6.426398456096649e-02, 6.068969517946243e-02, 5.66343180835247e-02, 5.186809226870537e-02, 4.622659459710121e-02, 3.928830102086067e-02, 3.08535601943731e-02, 2.054652571678158e-02, 7.986355572938919e-03, 7.455821614712477e-03, 2.458915114402771e-02, 3.825666755437851e-02, 4.865766689181328e-02, 5.598857626318932e-02, 6.1235461384058e-02, 6.49343878030777e-02, 6.753486394882202e-02, 6.932026892900467e-02, 7.033763080835342e-02, 7.075367122888565e-02, 7.062878459692001e-02, 7.000236958265305e-02, 6.890898197889328e-02, 6.734894961118698e-02, 6.529858708381653e-02, 6.274048984050751e-02, 5.96141405403614e-02, 5.468207225203514e-02, 5.129263177514076e-02, 4.570894688367844e-02, 3.902865573763847e-02, 3.011884354054928e-02, 1.942006684839725e-02, 7.556259632110505e-03, 7.918470539152723e-03, 2.396597713232051e-02, 3.827857226133347e-02, 4.869028180837631e-02, 5.691002309322357e-02, 6.134993210434914e-02, 6.493266671895981e-02, 6.759753078222275e-02, 6.935612857341766e-02, 7.039962708950043e-02, 7.074455171823502e-02, 7.029053568840027e-02, 7.004052400588989e-02, 6.882569193840027e-02, 6.753205507993698e-02, 6.527876853942871e-02, 6.274081766605377e-02, 5.953402072191238e-02, 5.564630776643753e-02, 5.106223747134209e-02, 4.552624374628067e-02, 3.874199464917183e-02, 3.017461113631725e-02, 2.134827710688114e-02, 8.076958358287811e-03, 7.815511897206306e-03, 2.435258589684963e-02, 3.82382944226265e-02, 4.866211861371994e-02, 5.63749261200428e-02, 6.12223744392395e-02, 6.495889276266098e-02, 6.753832101821899e-02, 6.928137689828873e-02, 7.031462341547012e-02, 7.071082293987274e-02, 7.061114907264709e-02, 7.000518590211868e-02, 6.88926950097084e-02, 6.734244525432587e-02, 6.529468297958374e-02, 6.275821477174759e-02, 5.959013476967812e-02, 5.542149767279625e-02, 5.111779272556305e-02, 4.646363854408264e-02]
+dooOpeClo.port_a2.m_flow=[1.165219179824484e-13, 4.78181959806534e-07, 1.998164179894957e-06, 4.356883891887264e-06, 7.262299277499551e-06, 1.027381040330511e-05, 1.304851411987329e-05, 1.552707544760779e-05, 1.762817191774957e-05, 1.952433740370907e-05, 2.116834366461262e-05, 2.253353886771947e-05, 2.365564250794705e-05, 2.453839988447726e-05, 3.16330255009239e-03, 4.614829272031784e-02, 8.144741505384445e-02, 7.712323218584061e-02, 7.36357644200325e-02, 7.052002102136612e-02, 6.746328622102737e-02, 6.423430144786835e-02, 6.067849695682526e-02, 5.660173296928406e-02, 5.183852463960648e-02, 4.60849329829216e-02, 3.921529650688171e-02, 3.079319931566712e-02, 2.049751020967957e-02, 7.853599265217781e-03, 7.344221696257591e-03, 2.313856407999992e-02, 3.784802928566933e-02, 4.848254844546318e-02, 5.594146251678467e-02, 6.11613392829895e-02, 6.491865217685699e-02, 6.752268970012665e-02, 6.927348673343658e-02, 7.031639665365219e-02, 7.073336839675903e-02, 7.061865925788879e-02, 7.000666856765747e-02, 6.891696155071259e-02, 6.735775619745255e-02, 6.531634926795959e-02, 6.274961680173874e-02, 5.961111187934875e-02, 5.698785185813904e-02, 5.121886730194092e-02, 4.564472660422325e-02, 3.86645719408989e-02, 3.089907951653004e-02, 2.097362652420998e-02, 7.59235629811874e-03, 7.644326891750207e-03, 2.446638420224198e-02, 3.836759552359581e-02, 4.883358627557755e-02, 5.53191751241684e-02, 6.128183007240295e-02, 6.509844213724136e-02, 6.763564050197601e-02, 6.943082809448242e-02, 7.042039185762405e-02, 7.080504298210144e-02, 7.093797624111176e-02, 7.002989947795868e-02, 6.90118670463562e-02, 6.714489310979843e-02, 6.531322002410889e-02, 6.270292401313782e-02, 5.949076637625694e-02, 5.56345172226429e-02, 5.112230032682419e-02, 4.555358365178108e-02, 3.872097283601761e-02, 3.057149797677994e-02, 1.889560371637344e-02, 7.02306441962719e-03, 7.698004133999348e-03, 2.396093495190144e-02, 3.828169032931328e-02, 4.873528704047203e-02, 5.568844079971313e-02, 6.116477027535439e-02, 6.488505005836487e-02, 6.752755492925644e-02, 6.926550716161728e-02, 7.029376924037933e-02, 7.073827832937241e-02, 7.06150159239769e-02, 7.000225037336349e-02, 6.88939169049263e-02, 6.73365443944931e-02, 6.530015915632248e-02, 6.271623075008392e-02, 5.961790680885315e-02, 5.625185742974281e-02, 5.127052962779999e-02, 4.471342638134956e-02]
diff --git a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_ReverseBuoyancy.txt b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_ReverseBuoyancy.txt
index e6d3216a23..19ea05c3a2 100644
--- a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_ReverseBuoyancy.txt
+++ b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_ReverseBuoyancy.txt
@@ -7,9 +7,9 @@ statistics-simulation=
"numerical Jacobians": "0"
}
oriWesTop.port_a.m_flow=[5.965141952037811e-02, 3.259154036641121e-03, 2.942090621218085e-03, 2.671305788680911e-03, 2.42581544443965e-03, 2.201464027166367e-03, 1.999294152483344e-03, 1.816506497561931e-03, 1.649399171583354e-03, 1.496979268267751e-03, 1.356916269287467e-03, 1.226408639922738e-03, 1.104065566323698e-03, 9.885167237371206e-04, 8.782477816566823e-04, 7.719525601714849e-04, 6.686746492050588e-04, 5.674550193361938e-04, 4.670993948820978e-04, 3.675664192996919e-04, 2.699048782233149e-04, 1.752431271597743e-04, 8.450375753454864e-05, -1.629166149541561e-06, -8.226019417634234e-05, -1.571743632666767e-04, -2.262566704303026e-04, -2.894194622058423e-04, -3.467686765361579e-04, -3.984780632890761e-04, -4.449390689842403e-04, -4.865453229285777e-04, -5.236900178715587e-04, -5.567641346715391e-04, -5.86151028983295e-04, -6.122456397861242e-04, -6.353901117108762e-04, -6.559038884006441e-04, -6.740412209182978e-04, -6.901841843500733e-04, -7.04567355569452e-04, -7.17357499524951e-04, -7.287198677659035e-04, -7.388184894807637e-04, -7.478162297047675e-04, -7.55875080358237e-04, -7.630256004631519e-04, -7.695259409956634e-04, -7.75434251409024e-04, -7.807941292412579e-04, -7.856491138227284e-04, -7.900423952378333e-04, -7.940171635709703e-04, -7.976163760758936e-04, -8.008829317986965e-04, -8.038596133701503e-04, -8.065890287980437e-04, -8.091139607131481e-04, -8.113846415653825e-04, -8.135061361826956e-04, -8.154941024258733e-04, -8.173537789843976e-04, -8.190904045477509e-04, -8.207092760130763e-04, -8.22215573862195e-04, -8.236145367845893e-04, -8.249113452620804e-04, -8.261111797764897e-04, -8.272193372249603e-04, -8.282409398816526e-04, -8.291811682283878e-04, -8.300452609546483e-04, -8.308383985422552e-04, -8.31565645057708e-04, -8.3223229739815e-04, -8.328435360454023e-04, -8.334044250659645e-04, -8.339202031493187e-04, -8.343959925696254e-04, -8.348370320163667e-04, -8.352352306246758e-04, -8.355952450074255e-04, -8.359180064871907e-04, -8.362045045942068e-04, -8.364557288587093e-04, -8.366726106032729e-04, -8.368560229428113e-04, -8.370069554075599e-04, -8.371263393200934e-04, -8.372151060029864e-04, -8.372741867788136e-04, -8.373045711778104e-04, -8.373071323148906e-04, -8.372828015126288e-04, -8.372325683012605e-04, -8.371573640033603e-04, -8.37058003526181e-04, -8.3693559281528e-04, -8.3679094677791e-04, -8.366250549443066e-04, -8.364387904293835e-04]
-dooOpeClo.mBA_flow=[1.375604569911957e-01, 2.393880188465118e-01, 2.010592818260193e-01, 1.694754064083099e-01, 1.436794102191925e-01, 1.223648339509964e-01, 1.047639474272728e-01, 8.989661186933516e-02, 7.705046981573105e-02, 6.586703658103943e-02, 5.590169504284859e-02, 4.680290445685387e-02, 3.845109790563583e-02, 3.073403611779213e-02, 2.351729571819304e-02, 1.658848859369755e-02, 9.693924337625504e-03, 2.333670854568481e-03, 4.554246552288532e-04, 7.349834777414799e-03, 1.404928043484688e-02, 2.034010179340839e-02, 2.61865109205246e-02, 3.17499078810215e-02, 3.695468604564667e-02, 4.177527129650116e-02, 4.619521647691727e-02, 5.020184069871904e-02, 5.3799144923687e-02, 5.699734762310982e-02, 5.98248690366745e-02, 6.231094524264336e-02, 6.448607891798019e-02, 6.638333946466446e-02, 6.803250312805176e-02, 6.946127861738205e-02, 7.06934928894043e-02, 7.175134867429733e-02, 7.265238463878632e-02, 7.342338562011719e-02, 7.408055663108826e-02, 7.463530451059341e-02, 7.509895414113998e-02, 7.54828006029129e-02, 7.579810172319412e-02, 7.60561004281044e-02, 7.625868171453476e-02, 7.64237716794014e-02, 7.655521482229233e-02, 7.66558051109314e-02, 7.672836631536484e-02, 7.67756924033165e-02, 7.680059224367142e-02, 7.680588215589523e-02, 7.679436355829239e-02, 7.676886022090912e-02, 7.673217356204987e-02, 7.668714225292206e-02, 7.663066685199738e-02, 7.65690803527832e-02, 7.650326192378998e-02, 7.64334574341774e-02, 7.635990530252457e-02, 7.628284394741058e-02, 7.620251923799515e-02, 7.611917704343796e-02, 7.603304833173752e-02, 7.594438642263412e-02, 7.585342973470688e-02, 7.576041668653488e-02, 7.566560059785843e-02, 7.556921988725662e-02, 7.547152787446976e-02, 7.537276297807693e-02, 7.527317106723785e-02, 7.517299801111221e-02, 7.507249712944031e-02, 7.497190684080124e-02, 7.487147301435471e-02, 7.47714564204216e-02, 7.46714174747467e-02, 7.457133382558823e-02, 7.447120547294617e-02, 7.437104731798172e-02, 7.427088171243668e-02, 7.417071610689163e-02, 7.407055795192719e-02, 7.397042959928513e-02, 7.387033104896545e-02, 7.377028465270996e-02, 7.367029786109924e-02, 7.357038557529449e-02, 7.347055524587631e-02, 7.337082922458649e-02, 7.327121496200562e-02, 7.317171990871429e-02, 7.307235896587372e-02, 7.297315448522568e-02, 7.287410646677017e-02, 7.27752298116684e-02, 7.267654687166214e-02]
+dooOpeClo.port_a2.m_flow=[1.375604569911957e-01, 2.393880188465118e-01, 2.010592818260193e-01, 1.694754064083099e-01, 1.436794102191925e-01, 1.223648339509964e-01, 1.047639474272728e-01, 8.989661186933516e-02, 7.705046981573105e-02, 6.586703658103943e-02, 5.590169504284859e-02, 4.680290445685387e-02, 3.845109790563583e-02, 3.073403611779213e-02, 2.351729571819304e-02, 1.658848859369755e-02, 9.693924337625504e-03, 2.333670854568481e-03, 4.554246552288532e-04, 7.349834777414799e-03, 1.404928043484688e-02, 2.034010179340839e-02, 2.61865109205246e-02, 3.17499078810215e-02, 3.695468604564667e-02, 4.177527129650116e-02, 4.619521647691727e-02, 5.020184069871904e-02, 5.3799144923687e-02, 5.699734762310982e-02, 5.98248690366745e-02, 6.231094524264336e-02, 6.448607891798019e-02, 6.638333946466446e-02, 6.803250312805176e-02, 6.946127861738205e-02, 7.06934928894043e-02, 7.175134867429733e-02, 7.265238463878632e-02, 7.342338562011719e-02, 7.408055663108826e-02, 7.463530451059341e-02, 7.509895414113998e-02, 7.54828006029129e-02, 7.579810172319412e-02, 7.60561004281044e-02, 7.625868171453476e-02, 7.64237716794014e-02, 7.655521482229233e-02, 7.66558051109314e-02, 7.672836631536484e-02, 7.67756924033165e-02, 7.680059224367142e-02, 7.680588215589523e-02, 7.679436355829239e-02, 7.676886022090912e-02, 7.673217356204987e-02, 7.668714225292206e-02, 7.663066685199738e-02, 7.65690803527832e-02, 7.650326192378998e-02, 7.64334574341774e-02, 7.635990530252457e-02, 7.628284394741058e-02, 7.620251923799515e-02, 7.611917704343796e-02, 7.603304833173752e-02, 7.594438642263412e-02, 7.585342973470688e-02, 7.576041668653488e-02, 7.566560059785843e-02, 7.556921988725662e-02, 7.547152787446976e-02, 7.537276297807693e-02, 7.527317106723785e-02, 7.517299801111221e-02, 7.507249712944031e-02, 7.497190684080124e-02, 7.487147301435471e-02, 7.47714564204216e-02, 7.46714174747467e-02, 7.457133382558823e-02, 7.447120547294617e-02, 7.437104731798172e-02, 7.427088171243668e-02, 7.417071610689163e-02, 7.407055795192719e-02, 7.397042959928513e-02, 7.387033104896545e-02, 7.377028465270996e-02, 7.367029786109924e-02, 7.357038557529449e-02, 7.347055524587631e-02, 7.337082922458649e-02, 7.327121496200562e-02, 7.317171990871429e-02, 7.307235896587372e-02, 7.297315448522568e-02, 7.287410646677017e-02, 7.27752298116684e-02, 7.267654687166214e-02]
oriOutBot.port_a.m_flow=[3.664178252220154e-01, -9.132619015872478e-03, -9.042366407811642e-03, -8.975396864116192e-03, -8.923434652388096e-03, -8.881124667823315e-03, -8.845748379826546e-03, -8.815106935799122e-03, -8.787799626588821e-03, -8.763118647038937e-03, -8.740398101508617e-03, -8.719123899936676e-03, -8.698997087776661e-03, -8.679775521159172e-03, -8.661234751343727e-03, -8.643199689686298e-03, -8.625545538961887e-03, -8.60814843326807e-03, -8.590877056121826e-03, -8.573713712394238e-03, -8.55675246566534e-03, -8.540092036128044e-03, -8.52381344884634e-03, -8.507982827723026e-03, -8.492650464177132e-03, -8.477830328047276e-03, -8.463535457849503e-03, -8.449779823422432e-03, -8.436555974185467e-03, -8.423854596912861e-03, -8.411642163991928e-03, -8.399885147809982e-03, -8.388550952076912e-03, -8.377604186534882e-03, -8.367011323571205e-03, -8.356736972928047e-03, -8.346749469637871e-03, -8.337019011378288e-03, -8.327523246407509e-03, -8.318224921822548e-03, -8.309101685881615e-03, -8.300138637423515e-03, -8.291319943964481e-03, -8.282629773020744e-03, -8.274052292108536e-03, -8.265572600066662e-03, -8.257186971604824e-03, -8.248870261013508e-03, -8.240616880357265e-03, -8.232424035668373e-03, -8.224286139011383e-03, -8.216200396418571e-03, -8.208162151277065e-03, -8.200168609619141e-03, -8.19221418350935e-03, -8.184295147657394e-03, -8.176407776772976e-03, -8.168548345565796e-03, -8.160720579326153e-03, -8.1529151648283e-03, -8.145132102072239e-03, -8.137369528412819e-03, -8.12962744385004e-03, -8.121906779706478e-03, -8.114205673336983e-03, -8.106524124741554e-03, -8.098861202597618e-03, -8.091217838227749e-03, -8.083593100309372e-03, -8.075986988842487e-03, -8.068397641181946e-03, -8.060825988650322e-03, -8.053272031247616e-03, -8.045733906328678e-03, -8.038212545216084e-03, -8.030706085264683e-03, -8.023216389119625e-03, -8.015740662813187e-03, -8.008279837667942e-03, -8.000833913683891e-03, -7.99340195953846e-03, -7.985985837876797e-03, -7.978583686053753e-03, -7.971196435391903e-03, -7.963824085891247e-03, -7.956466637551785e-03, -7.949124090373516e-03, -7.941795513033867e-03, -7.934481836855412e-03, -7.927182130515575e-03, -7.919897325336933e-03, -7.91262648999691e-03, -7.905370555818081e-03, -7.898128591477871e-03, -7.89090059697628e-03, -7.883687503635883e-03, -7.876487448811531e-03, -7.869302295148373e-03, -7.862131111323833e-03, -7.854973897337914e-03, -7.847829721868038e-03]
-dooOpeClo.mAB_flow=[4.811525940895081e-01, 2.426469922065735e-01, 2.04001173377037e-01, 1.721466481685638e-01, 1.461052149534225e-01, 1.245664060115814e-01, 1.067629754543304e-01, 9.171310067176817e-02, 7.869993150234222e-02, 6.736385077238083e-02, 5.725857987999916e-02, 4.802931845188141e-02, 3.955515474081039e-02, 3.17225269973278e-02, 2.439552918076514e-02, 1.736043393611908e-02, 1.036258321255445e-02, 2.901113824918866e-03, 9.225088870152831e-04, 7.71738588809967e-03, 1.4319172129035e-02, 2.05153189599514e-02, 2.627100422978401e-02, 3.174826502799988e-02, 3.687241300940514e-02, 4.161808639764786e-02, 4.596894979476929e-02, 4.991241171956064e-02, 5.345236510038377e-02, 5.659881979227066e-02, 5.937986448407173e-02, 6.182438135147095e-02, 6.396243721246719e-02, 6.582663208246231e-02, 6.744635105133057e-02, 6.884902715682983e-02, 7.005809992551804e-02, 7.109544426202774e-02, 7.197835296392441e-02, 7.273319363594055e-02, 7.337596267461777e-02, 7.391791790723801e-02, 7.437022030353546e-02, 7.474400103092194e-02, 7.505031675100327e-02, 7.530023157596588e-02, 7.549566030502319e-02, 7.565424591302872e-02, 7.577976584434509e-02, 7.587498426437378e-02, 7.594268023967743e-02, 7.59856179356575e-02, 7.600656151771545e-02, 7.600826770067215e-02, 7.599350810050964e-02, 7.59650394320488e-02, 7.592562586069107e-02, 7.587803155183792e-02, 7.581928372383118e-02, 7.575558125972748e-02, 7.568777352571487e-02, 7.561609894037247e-02, 7.554080337285995e-02, 7.546211779117584e-02, 7.538028061389923e-02, 7.529553025960922e-02, 7.520810514688492e-02, 7.511824369430542e-02, 7.502618432044983e-02, 7.493215799331665e-02, 7.483641058206558e-02, 7.473917305469513e-02, 7.464069873094559e-02, 7.454121857881546e-02, 7.444096356630325e-02, 7.434018701314926e-02, 7.423912733793259e-02, 7.413801550865173e-02, 7.40370973944664e-02, 7.393661886453629e-02, 7.383618503808975e-02, 7.373573631048203e-02, 7.36352875828743e-02, 7.353484630584717e-02, 7.343442738056183e-02, 7.333404570817947e-02, 7.32337012887001e-02, 7.313341647386551e-02, 7.303320616483688e-02, 7.293307036161423e-02, 7.283302396535873e-02, 7.27330818772316e-02, 7.263325154781342e-02, 7.253354787826538e-02, 7.243397831916809e-02, 7.233456522226334e-02, 7.223530858755112e-02, 7.213621586561203e-02, 7.203731685876846e-02, 7.193861156702042e-02, 7.184010744094849e-02]
+dooOpeClo.port_a1.m_flow=[4.811525940895081e-01, 2.426469922065735e-01, 2.04001173377037e-01, 1.721466481685638e-01, 1.461052149534225e-01, 1.245664060115814e-01, 1.067629754543304e-01, 9.171310067176817e-02, 7.869993150234222e-02, 6.736385077238083e-02, 5.725857987999916e-02, 4.802931845188141e-02, 3.955515474081039e-02, 3.17225269973278e-02, 2.439552918076514e-02, 1.736043393611908e-02, 1.036258321255445e-02, 2.901113824918866e-03, 9.225088870152831e-04, 7.71738588809967e-03, 1.4319172129035e-02, 2.05153189599514e-02, 2.627100422978401e-02, 3.174826502799988e-02, 3.687241300940514e-02, 4.161808639764786e-02, 4.596894979476929e-02, 4.991241171956064e-02, 5.345236510038377e-02, 5.659881979227066e-02, 5.937986448407173e-02, 6.182438135147095e-02, 6.396243721246719e-02, 6.582663208246231e-02, 6.744635105133057e-02, 6.884902715682983e-02, 7.005809992551804e-02, 7.109544426202774e-02, 7.197835296392441e-02, 7.273319363594055e-02, 7.337596267461777e-02, 7.391791790723801e-02, 7.437022030353546e-02, 7.474400103092194e-02, 7.505031675100327e-02, 7.530023157596588e-02, 7.549566030502319e-02, 7.565424591302872e-02, 7.577976584434509e-02, 7.587498426437378e-02, 7.594268023967743e-02, 7.59856179356575e-02, 7.600656151771545e-02, 7.600826770067215e-02, 7.599350810050964e-02, 7.59650394320488e-02, 7.592562586069107e-02, 7.587803155183792e-02, 7.581928372383118e-02, 7.575558125972748e-02, 7.568777352571487e-02, 7.561609894037247e-02, 7.554080337285995e-02, 7.546211779117584e-02, 7.538028061389923e-02, 7.529553025960922e-02, 7.520810514688492e-02, 7.511824369430542e-02, 7.502618432044983e-02, 7.493215799331665e-02, 7.483641058206558e-02, 7.473917305469513e-02, 7.464069873094559e-02, 7.454121857881546e-02, 7.444096356630325e-02, 7.434018701314926e-02, 7.423912733793259e-02, 7.413801550865173e-02, 7.40370973944664e-02, 7.393661886453629e-02, 7.383618503808975e-02, 7.373573631048203e-02, 7.36352875828743e-02, 7.353484630584717e-02, 7.343442738056183e-02, 7.333404570817947e-02, 7.32337012887001e-02, 7.313341647386551e-02, 7.303320616483688e-02, 7.293307036161423e-02, 7.283302396535873e-02, 7.27330818772316e-02, 7.263325154781342e-02, 7.253354787826538e-02, 7.243397831916809e-02, 7.233456522226334e-02, 7.223530858755112e-02, 7.213621586561203e-02, 7.203731685876846e-02, 7.193861156702042e-02, 7.184010744094849e-02]
oriOutTop.port_a.m_flow=[3.666715025901794e-01, 9.132188744843006e-03, 9.042119607329369e-03, 8.975256234407425e-03, 8.923365734517574e-03, 8.881098590791225e-03, 8.845752105116844e-03, 8.815129287540913e-03, 8.787837810814381e-03, 8.763168938457966e-03, 8.740455843508244e-03, 8.719188161194324e-03, 8.699065074324608e-03, 8.679847232997417e-03, 8.661307394504547e-03, 8.643274195492268e-03, 8.625620044767857e-03, 8.608223870396614e-03, 8.590951561927795e-03, 8.573788218200207e-03, 8.55682697147131e-03, 8.540167473256588e-03, 8.523889817297459e-03, 8.508061058819294e-03, 8.492730557918549e-03, 8.477913215756416e-03, 8.463621139526367e-03, 8.449867367744446e-03, 8.43664538115263e-03, 8.423946797847748e-03, 8.411736227571964e-03, 8.399981074035168e-03, 8.388648740947247e-03, 8.377702906727791e-03, 8.367111906409264e-03, 8.35683848708868e-03, 8.346851915121078e-03, 8.337122388184071e-03, 8.327627554535866e-03, 8.318330161273479e-03, 8.309206925332546e-03, 8.300244808197021e-03, 8.291426114737988e-03, 8.28273594379425e-03, 8.274158462882042e-03, 8.265678770840168e-03, 8.25729314237833e-03, 8.248976431787014e-03, 8.240723051130772e-03, 8.232530206441879e-03, 8.224392309784889e-03, 8.216306567192078e-03, 8.208268322050571e-03, 8.200273849070072e-03, 8.192319422960281e-03, 8.184400387108326e-03, 8.176513016223907e-03, 8.168652653694153e-03, 8.16082488745451e-03, 8.153019472956657e-03, 8.145235478878021e-03, 8.137472905218601e-03, 8.129730820655823e-03, 8.122009225189686e-03, 8.11430811882019e-03, 8.106626570224762e-03, 8.098963648080826e-03, 8.091320283710957e-03, 8.08369554579258e-03, 8.07608850300312e-03, 8.068499155342579e-03, 8.060927502810955e-03, 8.053372614085674e-03, 8.045834489166737e-03, 8.038312196731567e-03, 8.030806668102741e-03, 8.023316040635109e-03, 8.015840314328671e-03, 8.008379489183426e-03, 8.000932633876801e-03, 7.993500679731369e-03, 7.986083626747131e-03, 7.978681474924088e-03, 7.971294224262238e-03, 7.963921874761581e-03, 7.956563495099545e-03, 7.949220947921276e-03, 7.941892370581627e-03, 7.934577763080597e-03, 7.927278056740761e-03, 7.919993251562119e-03, 7.912722416222095e-03, 7.905465550720692e-03, 7.898223586380482e-03, 7.890995591878891e-03, 7.883781567215919e-03, 7.876581512391567e-03, 7.869396358728409e-03, 7.86222517490387e-03, 7.855067029595375e-03, 7.847923785448074e-03]
time=[0e+00, 3.6e+03]
oriEasTop.port_a.m_flow=[-5.94506673514843e-02, 3.259395947679877e-03, 2.942183054983616e-03, 2.671063877642155e-03, 2.425972139462829e-03, 2.201500814408064e-03, 1.99948949739337e-03, 1.81632034946233e-03, 1.649205922149122e-03, 1.497006393037736e-03, 1.356824301183224e-03, 1.2263348326087e-03, 1.103991642594337e-03, 9.884641040116549e-04, 8.78149061463773e-04, 7.718466222286224e-04, 6.685940898023546e-04, 5.673644482158124e-04, 4.670095513574779e-04, 3.674770414363593e-04, 2.698155585676432e-04, 1.751535455696285e-04, 8.441357203992084e-05, -1.72018314970046e-06, -8.23524605948478e-05, -1.572680193930864e-04, -2.263517089886591e-04, -2.895159705076368e-04, -3.468665527179839e-04, -3.985775692854077e-04, -4.45039855549112e-04, -4.866469535045326e-04, -5.237922305241227e-04, -5.568671622313559e-04, -5.862552206963301e-04, -6.123504717834294e-04, -6.354954093694687e-04, -6.560097099281847e-04, -6.741473916918039e-04, -6.902906461618841e-04, -7.046740502119064e-04, -7.174643105827272e-04, -7.288267370313406e-04, -7.389253005385399e-04, -7.479230407625437e-04, -7.559818914160132e-04, -7.631323533132672e-04, -7.69632519222796e-04, -7.755407132208347e-04, -7.809004746377468e-04, -7.857552845962346e-04, -7.901483913883567e-04, -7.941229268908501e-04, -7.977219065651298e-04, -8.009881712496281e-04, -8.039645617827773e-04, -8.06693802587688e-04, -8.092185016721487e-04, -8.114888332784176e-04, -8.136100950650871e-04, -8.155977702699602e-04, -8.174572722055018e-04, -8.191936649382114e-04, -8.208123035728931e-04, -8.223183685913682e-04, -8.237170404754579e-04, -8.250136161223054e-04, -8.262131595984101e-04, -8.273210260085762e-04, -8.283423376269639e-04, -8.292822167277336e-04, -8.301460184156895e-04, -8.3093874854967e-04, -8.316657040268183e-04, -8.323320071212947e-04, -8.329428965225816e-04, -8.335034945048392e-04, -8.340190397575498e-04, -8.344946545548737e-04, -8.349355193786323e-04, -8.353334269486368e-04, -8.35693150293082e-04, -8.360156789422035e-04, -8.36301944218576e-04, -8.365529356524348e-04, -8.367695263586938e-04, -8.369527058675885e-04, -8.371034055016935e-04, -8.372224983759224e-04, -8.373109740205109e-04, -8.373698219656944e-04, -8.373998571187258e-04, -8.374021272175014e-04, -8.37377505376935e-04, -8.373269811272621e-04, -8.372514275833964e-04, -8.371518342755735e-04, -8.370291325263679e-04, -8.368842536583543e-04, -8.367181289941072e-04, -8.365316898562014e-04]
diff --git a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_ReverseBuoyancy3Zones.txt b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_ReverseBuoyancy3Zones.txt
index 0cdf75c944..9f474bb368 100644
--- a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_ReverseBuoyancy3Zones.txt
+++ b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Examples_ReverseBuoyancy3Zones.txt
@@ -7,9 +7,9 @@ statistics-simulation=
"numerical Jacobians": "0"
}
oriWesTop.port_a.m_flow=[5.965141952037811e-02, 2.931245602667332e-03, 2.567382529377937e-03, 2.240111818537116e-03, 1.954184146597981e-03, 1.710532349534333e-03, 1.502707833424211e-03, 1.329283230006695e-03, 1.17757951375097e-03, 1.047018216922879e-03, 9.322953992523253e-04, 8.301943889819086e-04, 7.388624362647533e-04, 6.562225753441453e-04, 5.805068649351596e-04, 5.105379968881607e-04, 4.454260924831033e-04, 3.842797596007586e-04, 3.262839454691857e-04, 2.70880525931716e-04, 2.176276902901009e-04, 1.660728885326535e-04, 1.157745864475146e-04, 6.638222839683294e-05, 1.749969851516653e-05, -3.120374822174199e-05, -7.964127144077793e-05, -1.274086098419504e-04, -1.741587184369565e-04, -2.195846027461812e-04, -2.634135307744145e-04, -3.054220578633249e-04, -3.454618854448199e-04, -3.833598748315126e-04, -4.189885803498328e-04, -4.523451498243958e-04, -4.834282153751701e-04, -5.12237660586834e-04, -5.388206336647272e-04, -5.632059182971716e-04, -5.85498521104455e-04, -6.0581712750718e-04, -6.242792587727308e-04, -6.410015048459172e-04, -6.560992915183306e-04, -6.696869386360049e-04, -6.81860139593482e-04, -6.927790818735957e-04, -7.02541321516037e-04, -7.112356834113598e-04, -7.189505849964917e-04, -7.257736870087683e-04, -7.317923009395599e-04, -7.370932726189494e-04, -7.417153101414442e-04, -7.457860046997666e-04, -7.493516313843429e-04, -7.524501997977495e-04, -7.551196031272411e-04, -7.573975017294288e-04, -7.593216141685843e-04, -7.60929542593658e-04, -7.622588309459388e-04, -7.633470231667161e-04, -7.642010459676385e-04, -7.648655446246266e-04, -7.653788779862225e-04, -7.65750533901155e-04, -7.659899420104921e-04, -7.661064155399799e-04, -7.661093259230256e-04, -7.660081028006971e-04, -7.658121758140624e-04, -7.655307999812067e-04, -7.651734631508589e-04, -7.647494785487652e-04, -7.642682758159935e-04, -7.63739226385951e-04, -7.631717598997056e-04, -7.625631405971944e-04, -7.61919014621526e-04, -7.612523040734231e-04, -7.605643477290869e-04, -7.598561933264136e-04, -7.591291796416044e-04, -7.583843544125557e-04, -7.576230564154685e-04, -7.568463915959001e-04, -7.560555823147297e-04, -7.552517927251756e-04, -7.544363033957779e-04, -7.536102784797549e-04, -7.527748821303248e-04, -7.519313367083669e-04, -7.510808645747602e-04, -7.502246298827231e-04, -7.493639132007957e-04, -7.484998204745352e-04, -7.47633574064821e-04, -7.467664545401931e-04, -7.458996260538697e-04]
-dooOpeClo.mBA_flow=[1.375604569911957e-01, 2.452837824821472e-01, 2.078186422586441e-01, 1.771714836359024e-01, 1.522329449653625e-01, 1.319006532430649e-01, 1.151738986372948e-01, 1.012287512421608e-01, 8.940209448337555e-02, 7.92749896645546e-02, 7.044700533151627e-02, 6.263040751218796e-02, 5.562004074454308e-02, 4.925509542226791e-02, 4.342551529407501e-02, 3.805464878678322e-02, 3.30788716673851e-02, 2.843117341399193e-02, 2.4049898609519e-02, 1.988012529909611e-02, 1.57626923173666e-02, 1.17552550509572e-02, 7.693749852478504e-03, 3.345707664266229e-03, 2.541472786106169e-04, 8.402476669289172e-04, 4.629223141819239e-03, 8.778126910328877e-03, 1.256574317812921e-02, 1.614537835121155e-02, 1.958683133125305e-02, 2.280339226126671e-02, 2.5861956179142e-02, 2.876986563205719e-02, 3.151437267661095e-02, 3.409255295991898e-02, 3.65019366145134e-02, 3.874047473073006e-02, 4.081014171242714e-02, 4.271180182695389e-02, 4.445253685116768e-02, 4.604076594114304e-02, 4.748504608869553e-02, 4.879404976963997e-02, 4.997649416327477e-02, 5.1041129976511e-02, 5.199526250362396e-02, 5.28513491153717e-02, 5.36169707775116e-02, 5.429905652999878e-02, 5.4904505610466e-02, 5.544019117951393e-02, 5.591294914484024e-02, 5.632958933711052e-02, 5.669313296675682e-02, 5.701357871294022e-02, 5.729454010725021e-02, 5.753900110721588e-02, 5.77499195933342e-02, 5.793024972081184e-02, 5.80829419195652e-02, 5.821093916893005e-02, 5.831717699766159e-02, 5.84045872092247e-02, 5.847371369600296e-02, 5.852802842855453e-02, 5.857054144144058e-02, 5.86019903421402e-02, 5.862310156226158e-02, 5.863460898399353e-02, 5.863724648952484e-02, 5.863174051046371e-02, 5.861882492899895e-02, 5.859923362731934e-02, 5.857369676232338e-02, 5.854294821619987e-02, 5.850772187113762e-02, 5.846874788403511e-02, 5.842676758766174e-02, 5.838155746459961e-02, 5.833355709910393e-02, 5.828378349542618e-02, 5.823233351111412e-02, 5.817930027842522e-02, 5.812477320432663e-02, 5.806884914636612e-02, 5.801162123680115e-02, 5.795317888259888e-02, 5.789361894130707e-02, 5.783303454518318e-02, 5.777151882648468e-02, 5.770916119217873e-02, 5.764606595039368e-02, 5.75823150575161e-02, 5.751800909638405e-02, 5.745324492454529e-02, 5.738810822367668e-02, 5.732270330190659e-02, 5.725711584091187e-02, 5.719144642353058e-02, 5.712578445672989e-02]
+dooOpeClo.port_a2.m_flow=[1.375604569911957e-01, 2.452837824821472e-01, 2.078186422586441e-01, 1.771714836359024e-01, 1.522329449653625e-01, 1.319006532430649e-01, 1.151738986372948e-01, 1.012287512421608e-01, 8.940209448337555e-02, 7.92749896645546e-02, 7.044700533151627e-02, 6.263040751218796e-02, 5.562004074454308e-02, 4.925509542226791e-02, 4.342551529407501e-02, 3.805464878678322e-02, 3.30788716673851e-02, 2.843117341399193e-02, 2.4049898609519e-02, 1.988012529909611e-02, 1.57626923173666e-02, 1.17552550509572e-02, 7.693749852478504e-03, 3.345707664266229e-03, 2.541472786106169e-04, 8.402476669289172e-04, 4.629223141819239e-03, 8.778126910328877e-03, 1.256574317812921e-02, 1.614537835121155e-02, 1.958683133125305e-02, 2.280339226126671e-02, 2.5861956179142e-02, 2.876986563205719e-02, 3.151437267661095e-02, 3.409255295991898e-02, 3.65019366145134e-02, 3.874047473073006e-02, 4.081014171242714e-02, 4.271180182695389e-02, 4.445253685116768e-02, 4.604076594114304e-02, 4.748504608869553e-02, 4.879404976963997e-02, 4.997649416327477e-02, 5.1041129976511e-02, 5.199526250362396e-02, 5.28513491153717e-02, 5.36169707775116e-02, 5.429905652999878e-02, 5.4904505610466e-02, 5.544019117951393e-02, 5.591294914484024e-02, 5.632958933711052e-02, 5.669313296675682e-02, 5.701357871294022e-02, 5.729454010725021e-02, 5.753900110721588e-02, 5.77499195933342e-02, 5.793024972081184e-02, 5.80829419195652e-02, 5.821093916893005e-02, 5.831717699766159e-02, 5.84045872092247e-02, 5.847371369600296e-02, 5.852802842855453e-02, 5.857054144144058e-02, 5.86019903421402e-02, 5.862310156226158e-02, 5.863460898399353e-02, 5.863724648952484e-02, 5.863174051046371e-02, 5.861882492899895e-02, 5.859923362731934e-02, 5.857369676232338e-02, 5.854294821619987e-02, 5.850772187113762e-02, 5.846874788403511e-02, 5.842676758766174e-02, 5.838155746459961e-02, 5.833355709910393e-02, 5.828378349542618e-02, 5.823233351111412e-02, 5.817930027842522e-02, 5.812477320432663e-02, 5.806884914636612e-02, 5.801162123680115e-02, 5.795317888259888e-02, 5.789361894130707e-02, 5.783303454518318e-02, 5.777151882648468e-02, 5.770916119217873e-02, 5.764606595039368e-02, 5.75823150575161e-02, 5.751800909638405e-02, 5.745324492454529e-02, 5.738810822367668e-02, 5.732270330190659e-02, 5.725711584091187e-02, 5.719144642353058e-02, 5.712578445672989e-02]
oriOutBot.port_a.m_flow=[-7.80478585511446e-03, -7.660315837711096e-03, -7.559817284345627e-03, -7.486475631594658e-03, -7.430643774569035e-03, -7.386470679193735e-03, -7.35032930970192e-03, -7.31989648193121e-03, -7.293570786714554e-03, -7.270417641848326e-03, -7.249622605741024e-03, -7.230646442621946e-03, -7.213175296783447e-03, -7.196897175163031e-03, -7.181561551988125e-03, -7.167004514485598e-03, -7.15310126543045e-03, -7.139730732887983e-03, -7.126788143068552e-03, -7.114199921488762e-03, -7.1019078604877e-03, -7.089854683727026e-03, -7.077984046190977e-03, -7.066251244395971e-03, -7.054606452584267e-03, -7.04300170764327e-03, -7.031423505395651e-03, -7.019915618002415e-03, -7.008518557995558e-03, -6.997268181294203e-03, -6.986197084188461e-03, -6.975332740694284e-03, -6.964694242924452e-03, -6.954303942620754e-03, -6.944179069250822e-03, -6.934322416782379e-03, -6.924735847860575e-03, -6.91542262211442e-03, -6.906379014253616e-03, -6.897604092955589e-03, -6.889087148010731e-03, -6.880815606564283e-03, -6.872776430100203e-03, -6.864957977086306e-03, -6.857346277683973e-03, -6.849928759038448e-03, -6.842694710940123e-03, -6.835625041276217e-03, -6.828708108514547e-03, -6.821933668106794e-03, -6.815291009843349e-03, -6.808769889175892e-03, -6.802359595894814e-03, -6.796048954129219e-03, -6.789833772927523e-03, -6.783697754144669e-03, -6.777635775506496e-03, -6.771642249077559e-03, -6.765713449567556e-03, -6.759843789041042e-03, -6.754029076546431e-03, -6.748264655470848e-03, -6.742544937878847e-03, -6.736866198480129e-03, -6.731226574629545e-03, -6.725621409714222e-03, -6.720044650137424e-03, -6.714495830237865e-03, -6.708973087370396e-03, -6.703475955873728e-03, -6.698003038764e-03, -6.692552473396063e-03, -6.687123794108629e-03, -6.681715603917837e-03, -6.676326505839825e-03, -6.670955568552017e-03, -6.665600929409266e-03, -6.660262122750282e-03, -6.654937285929918e-03, -6.649626884609461e-03, -6.644330453127623e-03, -6.639046128839254e-03, -6.633773911744356e-03, -6.628512870520353e-03, -6.62326393648982e-03, -6.618025712668896e-03, -6.612799130380154e-03, -6.607583723962307e-03, -6.602378562092781e-03, -6.597184576094151e-03, -6.592000834643841e-03, -6.586827337741852e-03, -6.581664085388184e-03, -6.576511077582836e-03, -6.571367383003235e-03, -6.566233467310667e-03, -6.561108864843845e-03, -6.55599357560277e-03, -6.550887133926153e-03, -6.545790005475283e-03, -6.540701258927584e-03]
-dooOpeClo.mAB_flow=[4.811525940895081e-01, 2.482147812843323e-01, 2.103851288557053e-01, 1.794112026691437e-01, 1.541871428489685e-01, 1.336115598678589e-01, 1.166782379150391e-01, 1.025573164224624e-01, 9.057971090078354e-02, 8.032197505235672e-02, 7.137931138277054e-02, 6.346061825752258e-02, 5.635883659124374e-02, 4.991130530834198e-02, 4.400601238012313e-02, 3.856517747044563e-02, 3.35242822766304e-02, 2.881544083356857e-02, 2.437617816030979e-02, 2.015101537108421e-02, 1.598029769957066e-02, 1.192131172865629e-02, 7.809523027390242e-03, 3.41207766905427e-03, 2.716383023653179e-04, 8.090345654636621e-04, 4.549573175609112e-03, 8.650716394186032e-03, 1.239157747477294e-02, 1.592578552663326e-02, 1.932340674102306e-02, 2.249796316027641e-02, 2.551648765802383e-02, 2.838649973273277e-02, 3.109537810087204e-02, 3.364020213484764e-02, 3.60185019671917e-02, 3.822823241353035e-02, 4.027131944894791e-02, 4.214858263731003e-02, 4.386701062321663e-02, 4.543492197990417e-02, 4.686075821518898e-02, 4.815306141972542e-02, 4.932041838765144e-02, 5.03714494407177e-02, 5.131340399384499e-02, 5.215856432914734e-02, 5.291441828012466e-02, 5.358780920505524e-02, 5.418555065989494e-02, 5.471442267298698e-02, 5.518116801977158e-02, 5.559249594807625e-02, 5.595142021775246e-02, 5.626779049634933e-02, 5.654518306255341e-02, 5.678653717041016e-02, 5.699478834867477e-02, 5.717284604907036e-02, 5.732362344861031e-02, 5.745001882314682e-02, 5.75549304485321e-02, 5.764124542474747e-02, 5.770951509475708e-02, 5.776316300034523e-02, 5.780516192317009e-02, 5.783623456954956e-02, 5.785710364580154e-02, 5.786849185824394e-02, 5.787112563848495e-02, 5.786572396755219e-02, 5.785300582647324e-02, 5.783370137214661e-02, 5.78085295855999e-02, 5.777820572257042e-02, 5.774346366524696e-02, 5.770501866936684e-02, 5.766359344124794e-02, 5.761898681521416e-02, 5.757163465023041e-02, 5.752253159880638e-02, 5.747177079319954e-02, 5.741944536566734e-02, 5.736564472317696e-02, 5.731046572327614e-02, 5.725399777293205e-02, 5.719633027911186e-02, 5.713756009936333e-02, 5.707778036594391e-02, 5.701708048582077e-02, 5.695554986596107e-02, 5.689328908920288e-02, 5.683038383722305e-02, 5.676693096756935e-02, 5.670302361249924e-02, 5.663875117897987e-02, 5.657420679926872e-02, 5.650948733091354e-02, 5.64446821808815e-02, 5.637988820672035e-02]
+dooOpeClo.port_a1.m_flow=[4.811525940895081e-01, 2.482147812843323e-01, 2.103851288557053e-01, 1.794112026691437e-01, 1.541871428489685e-01, 1.336115598678589e-01, 1.166782379150391e-01, 1.025573164224624e-01, 9.057971090078354e-02, 8.032197505235672e-02, 7.137931138277054e-02, 6.346061825752258e-02, 5.635883659124374e-02, 4.991130530834198e-02, 4.400601238012313e-02, 3.856517747044563e-02, 3.35242822766304e-02, 2.881544083356857e-02, 2.437617816030979e-02, 2.015101537108421e-02, 1.598029769957066e-02, 1.192131172865629e-02, 7.809523027390242e-03, 3.41207766905427e-03, 2.716383023653179e-04, 8.090345654636621e-04, 4.549573175609112e-03, 8.650716394186032e-03, 1.239157747477294e-02, 1.592578552663326e-02, 1.932340674102306e-02, 2.249796316027641e-02, 2.551648765802383e-02, 2.838649973273277e-02, 3.109537810087204e-02, 3.364020213484764e-02, 3.60185019671917e-02, 3.822823241353035e-02, 4.027131944894791e-02, 4.214858263731003e-02, 4.386701062321663e-02, 4.543492197990417e-02, 4.686075821518898e-02, 4.815306141972542e-02, 4.932041838765144e-02, 5.03714494407177e-02, 5.131340399384499e-02, 5.215856432914734e-02, 5.291441828012466e-02, 5.358780920505524e-02, 5.418555065989494e-02, 5.471442267298698e-02, 5.518116801977158e-02, 5.559249594807625e-02, 5.595142021775246e-02, 5.626779049634933e-02, 5.654518306255341e-02, 5.678653717041016e-02, 5.699478834867477e-02, 5.717284604907036e-02, 5.732362344861031e-02, 5.745001882314682e-02, 5.75549304485321e-02, 5.764124542474747e-02, 5.770951509475708e-02, 5.776316300034523e-02, 5.780516192317009e-02, 5.783623456954956e-02, 5.785710364580154e-02, 5.786849185824394e-02, 5.787112563848495e-02, 5.786572396755219e-02, 5.785300582647324e-02, 5.783370137214661e-02, 5.78085295855999e-02, 5.777820572257042e-02, 5.774346366524696e-02, 5.770501866936684e-02, 5.766359344124794e-02, 5.761898681521416e-02, 5.757163465023041e-02, 5.752253159880638e-02, 5.747177079319954e-02, 5.741944536566734e-02, 5.736564472317696e-02, 5.731046572327614e-02, 5.725399777293205e-02, 5.719633027911186e-02, 5.713756009936333e-02, 5.707778036594391e-02, 5.701708048582077e-02, 5.695554986596107e-02, 5.689328908920288e-02, 5.683038383722305e-02, 5.676693096756935e-02, 5.670302361249924e-02, 5.663875117897987e-02, 5.657420679926872e-02, 5.650948733091354e-02, 5.64446821808815e-02, 5.637988820672035e-02]
oriOutTop.port_a.m_flow=[7.80478585511446e-03, 7.65983946621418e-03, 7.559518795460463e-03, 7.486284710466862e-03, 7.430522702634335e-03, 7.386392913758755e-03, 7.3502860032022e-03, 7.319866213947535e-03, 7.293563801795244e-03, 7.270417176187038e-03, 7.249635178595781e-03, 7.230665534734726e-03, 7.213198114186525e-03, 7.196924649178982e-03, 7.181592751294374e-03, 7.167038042098284e-03, 7.153136655688286e-03, 7.139767985790968e-03, 7.126826792955399e-03, 7.114239037036896e-03, 7.101947907358408e-03, 7.089895196259022e-03, 7.078024558722973e-03, 7.06629129126668e-03, 7.054646499454975e-03, 7.043041754513979e-03, 7.031463552266359e-03, 7.019955664873123e-03, 7.008559070527554e-03, 6.997309159487486e-03, 6.986238528043032e-03, 6.975375581532717e-03, 6.964737549424171e-03, 6.954348180443048e-03, 6.944224238395691e-03, 6.934368517249823e-03, 6.92478334531188e-03, 6.9154710508883e-03, 6.906428374350071e-03, 6.897654384374619e-03, 6.889138370752335e-03, 6.880867294967175e-03, 6.872829515486956e-03, 6.865011528134346e-03, 6.857400294393301e-03, 6.849983707070351e-03, 6.842750124633312e-03, 6.835680920630693e-03, 6.828764453530312e-03, 6.821990478783846e-03, 6.815348286181688e-03, 6.808827631175518e-03, 6.80241733789444e-03, 6.796106696128845e-03, 6.789891980588436e-03, 6.783756427466869e-03, 6.77769398316741e-03, 6.771700922399759e-03, 6.765772122889757e-03, 6.759902462363243e-03, 6.754087749868631e-03, 6.748323328793049e-03, 6.742603611201048e-03, 6.73692487180233e-03, 6.731285247951746e-03, 6.725679617375135e-03, 6.720102857798338e-03, 6.714554037898779e-03, 6.709031760692596e-03, 6.703534163534641e-03, 6.698061246424913e-03, 6.692610681056976e-03, 6.687182001769543e-03, 6.681773811578751e-03, 6.676384247839451e-03, 6.671013310551643e-03, 6.665658671408892e-03, 6.660319399088621e-03, 6.654994562268257e-03, 6.6496841609478e-03, 6.644387729465961e-03, 6.639103405177593e-03, 6.633830722421408e-03, 6.628569681197405e-03, 6.623320281505585e-03, 6.618082523345947e-03, 6.612855475395918e-03, 6.607640068978071e-03, 6.602434907108545e-03, 6.597240455448627e-03, 6.592056713998318e-03, 6.586883217096329e-03, 6.581719964742661e-03, 6.576566491276026e-03, 6.571422796696424e-03, 6.566288881003857e-03, 6.561164278537035e-03, 6.556048523634672e-03, 6.550942081958055e-03, 6.545844487845898e-03, 6.540755741298199e-03]
time=[0e+00, 3.6e+03]
oriEasTop.port_a.m_flow=[-5.950168892741203e-02, 2.931503113359213e-03, 2.567752962931991e-03, 2.240234753116965e-03, 1.954734092578292e-03, 1.710978918708861e-03, 1.505830092355609e-03, 1.328034675680101e-03, 1.17769162170589e-03, 1.046992023475468e-03, 9.322630357928574e-04, 8.30159813631326e-04, 7.388318190351129e-04, 6.561892805621028e-04, 5.804561660625039e-04, 5.104900919832289e-04, 4.453832807485014e-04, 3.842321457341313e-04, 3.262350510340184e-04, 2.708312531467527e-04, 2.175785630242899e-04, 1.660237176110968e-04, 1.157251899712719e-04, 6.633298471570015e-05, 1.745074041537009e-05, -3.125245711999014e-05, -7.96898893895559e-05, -1.274573005503045e-04, -1.742075837682934e-04, -2.196337300119922e-04, -2.634630363900214e-04, -3.054720000363886e-04, -3.455123223830014e-04, -3.834108938463032e-04, -4.190401814412326e-04, -4.523973329924047e-04, -4.834809806197882e-04, -5.122910370118916e-04, -5.38874592166394e-04, -5.632605170831084e-04, -5.855537601746619e-04, -6.058728322386742e-04, -6.243353709578514e-04, -6.410579080693424e-04, -6.561560439877212e-04, -6.697441567666829e-04, -6.819177069701254e-04, -6.928369402885437e-04, -7.025994127616286e-04, -7.11294065695256e-04, -7.190090836957097e-04, -7.258323021233082e-04, -7.318510324694216e-04, -7.371521205641329e-04, -7.417742162942886e-04, -7.45844969060272e-04, -7.494106539525092e-04, -7.525092805735767e-04, -7.551786256954074e-04, -7.574564660899341e-04, -7.593805785290897e-04, -7.609884487465024e-04, -7.623176788911223e-04, -7.634058129042387e-04, -7.642598357051611e-04, -7.649241597391665e-04, -7.654374931007624e-04, -7.65809032600373e-04, -7.660483242943883e-04, -7.661646814085543e-04, -7.661675335839391e-04, -7.660661940462887e-04, -7.658701506443322e-04, -7.655886583961546e-04, -7.65231205150485e-04, -7.648071041330695e-04, -7.643257849849761e-04, -7.637966191396117e-04, -7.632290362380445e-04, -7.626203005202115e-04, -7.619759999215603e-04, -7.613092311657965e-04, -7.606211001984775e-04, -7.599128293804824e-04, -7.591856992803514e-04, -7.584407576359808e-04, -7.576793432235718e-04, -7.569025037810206e-04, -7.561115780845284e-04, -7.553077302873135e-04, -7.54492066334933e-04, -7.536658667959273e-04, -7.528303540311754e-04, -7.519866921938956e-04, -7.511360454373062e-04, -7.502796943299472e-04, -7.494188030250371e-04, -7.485545938834548e-04, -7.476882892660797e-04, -7.46820995118469e-04, -7.459540502168238e-04]
diff --git a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_DoorOpenClosed.txt b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_DoorOpenClosed.txt
new file mode 100644
index 0000000000..7d0569c7a4
--- /dev/null
+++ b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_DoorOpenClosed.txt
@@ -0,0 +1,15 @@
+last-generated=2021-01-22
+statistics-simulation=
+{
+ "linear": " ",
+ "nonlinear": " ",
+ "number of continuous time states": "1",
+ "numerical Jacobians": "0"
+}
+time=[0e+00, 1e+00]
+doo.port_a1.m_flow=[2.242841005325317e+00, 2.242841005325317e+00]
+doo.port_b2.m_flow=[2.012807846069336e+00, 2.012807846069336e+00]
+dooOpeClo.port_a1.m_flow=[3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00, 2.242841005325317e+00]
+dooOpeClo.port_b2.m_flow=[3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 3.582012839615345e-03, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00, 2.012807846069336e+00]
+lea.port_a.m_flow=[7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03]
+mNetClo_flow.y=[7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 7.16402567923069e-03, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00]
diff --git a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_OpenDoorBuoyancyDynamic.txt b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_OpenDoorBuoyancyDynamic.txt
new file mode 100644
index 0000000000..c1f4e22323
--- /dev/null
+++ b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_OpenDoorBuoyancyDynamic.txt
@@ -0,0 +1,17 @@
+last-generated=2021-01-22
+statistics-simulation=
+{
+ "linear": " ",
+ "nonlinear": " ",
+ "number of continuous time states": "12",
+ "numerical Jacobians": "0"
+}
+time=[0e+00, 1.44e+04]
+doo.vAB=[8.119534701108932e-02, 5.520493909716606e-02, 3.903370723128319e-02, 2.966813743114471e-02, 2.378417365252972e-02, 1.979839242994785e-02, 1.693606004118919e-02, 1.478709559887647e-02, 1.311744470149279e-02, 1.178545132279396e-02, 1.069753430783749e-02, 9.79198794811964e-03, 9.026696905493736e-03, 8.371828123927116e-03, 7.805232424288987e-03, 7.310621906071901e-03, 6.875031627714634e-03, 6.488111801445484e-03, 6.142404861748219e-03, 5.831553135067225e-03, 5.55051863193512e-03, 5.295119248330593e-03, 5.062179174274206e-03, 4.848851822316647e-03, 4.652758128941059e-03, 4.471847787499428e-03, 4.304449539631605e-03, 4.149131011217832e-03, 4.004620946943759e-03, 3.869816428050399e-03, 3.743765410035849e-03, 3.625671146437526e-03, 3.514795564115047e-03, 3.410493489354849e-03, 3.312187502160668e-03, 3.219390520825982e-03, 3.131650388240814e-03, 3.048563841730356e-03, 2.969770459458232e-03, 2.89494008757174e-03, 2.823784481734037e-03, 2.756043570116162e-03, 2.691475674510002e-03, 2.62986239977181e-03, 2.571004675701261e-03, 2.514720195904374e-03, 2.460847841575742e-03, 2.409234875813127e-03, 2.359741600230336e-03, 2.312238793820143e-03, 2.266610506922007e-03, 2.222748240455985e-03, 2.180551178753376e-03, 2.139925956726074e-03, 2.100785495713353e-03, 2.063050167635083e-03, 2.026646863669157e-03, 1.991505734622478e-03, 1.957562286406755e-03, 1.924756215885282e-03, 1.893031410872936e-03, 1.862335251644254e-03, 1.832620589993894e-03, 1.803838997147977e-03, 1.775947865098715e-03, 1.748797134496272e-03, 1.722416607663035e-03, 1.696834806352854e-03, 1.672051846981049e-03, 1.647782861255109e-03, 1.623973716050386e-03, 1.600833609700203e-03, 1.578362309373915e-03, 1.556560164317489e-03, 1.53542694170028e-03, 1.514962641522288e-03, 1.495152828283608e-03, 1.475424622185528e-03, 1.456225174479187e-03, 1.437554135918617e-03, 1.419411855749786e-03, 1.401798101142049e-03, 1.384712988510728e-03, 1.368156517855823e-03, 1.351871993392706e-03, 1.33577617816627e-03, 1.320083974860609e-03, 1.304795383475721e-03, 1.289910287596285e-03, 1.275428687222302e-03, 1.261350815184414e-03, 1.247676438651979e-03, 1.234008697792888e-03, 1.220648875460029e-03, 1.207598834298551e-03, 1.194858574308455e-03, 1.182428211905062e-03, 1.170307630673051e-03, 1.158496947027743e-03, 1.146866241469979e-03, 1.135353464633226e-03]
+doo.vBA=[8.119534701108932e-02, 5.520493909716606e-02, 3.903370723128319e-02, 2.966813743114471e-02, 2.378417365252972e-02, 1.979839242994785e-02, 1.693606004118919e-02, 1.478709559887647e-02, 1.311744470149279e-02, 1.178545132279396e-02, 1.069753430783749e-02, 9.79198794811964e-03, 9.026696905493736e-03, 8.371828123927116e-03, 7.805232424288987e-03, 7.310621906071901e-03, 6.875031627714634e-03, 6.488111801445484e-03, 6.142404861748219e-03, 5.831553135067225e-03, 5.55051863193512e-03, 5.295119248330593e-03, 5.062179174274206e-03, 4.848851822316647e-03, 4.652758128941059e-03, 4.471847787499428e-03, 4.304449539631605e-03, 4.149131011217832e-03, 4.004620946943759e-03, 3.869816428050399e-03, 3.743765410035849e-03, 3.625671146437526e-03, 3.514795564115047e-03, 3.410493489354849e-03, 3.312187502160668e-03, 3.219390520825982e-03, 3.131650388240814e-03, 3.048563841730356e-03, 2.969770459458232e-03, 2.89494008757174e-03, 2.823784481734037e-03, 2.756043570116162e-03, 2.691475674510002e-03, 2.62986239977181e-03, 2.571004675701261e-03, 2.514720195904374e-03, 2.460847841575742e-03, 2.409234875813127e-03, 2.359741600230336e-03, 2.312238793820143e-03, 2.266610506922007e-03, 2.222748240455985e-03, 2.180551178753376e-03, 2.139925956726074e-03, 2.100785495713353e-03, 2.063050167635083e-03, 2.026646863669157e-03, 1.991505734622478e-03, 1.957562286406755e-03, 1.924756215885282e-03, 1.893031410872936e-03, 1.862335251644254e-03, 1.832620589993894e-03, 1.803838997147977e-03, 1.775947865098715e-03, 1.748797134496272e-03, 1.722416607663035e-03, 1.696834806352854e-03, 1.672051846981049e-03, 1.647782861255109e-03, 1.623973716050386e-03, 1.600833609700203e-03, 1.578362309373915e-03, 1.556560164317489e-03, 1.53542694170028e-03, 1.514962641522288e-03, 1.495152828283608e-03, 1.475424622185528e-03, 1.456225174479187e-03, 1.437554135918617e-03, 1.419411855749786e-03, 1.401798101142049e-03, 1.384712988510728e-03, 1.368156517855823e-03, 1.351871993392706e-03, 1.33577617816627e-03, 1.320083974860609e-03, 1.304795383475721e-03, 1.289910287596285e-03, 1.275428687222302e-03, 1.261350815184414e-03, 1.247676438651979e-03, 1.234008697792888e-03, 1.220648875460029e-03, 1.207598834298551e-03, 1.194858574308455e-03, 1.182428211905062e-03, 1.170307630673051e-03, 1.158496947027743e-03, 1.146866241469979e-03, 1.135353464633226e-03]
+dooDis.vAB=[1.164413839578629e-01, 5.968387797474861e-02, 4.684257507324219e-02, 3.835171088576317e-02, 3.224297240376472e-02, 2.741414681077003e-02, 2.359866909682751e-02, 2.071449905633926e-02, 1.806275174021721e-02, 1.585057191550732e-02, 1.425776816904545e-02, 1.284204609692097e-02, 1.158089656382799e-02, 1.050782948732376e-02, 9.757678955793381e-03, 9.076362475752831e-03, 8.389487862586975e-03, 7.974592968821526e-03, 7.324646692723036e-03, 6.980249658226967e-03, 6.556612905114889e-03, 6.368167698383331e-03, 5.895545706152916e-03, 5.673220381140709e-03, 5.370703991502523e-03, 5.261399317532778e-03, 5.005098413676023e-03, 4.730355460196733e-03, 4.59613837301731e-03, 4.439406096935272e-03, 4.398589953780174e-03, 4.063236061483622e-03, 4.024782683700323e-03, 3.842563601210713e-03, 3.933290019631386e-03, 3.597211092710495e-03, 3.582742530852556e-03, 3.407027572393417e-03, 3.33857792429626e-03, 3.138144034892321e-03, 3.044532146304846e-03, 3.069647587835789e-03, 2.915049670264125e-03, 2.904233988374472e-03, 2.815964631736279e-03, 2.886753994971514e-03, 2.655010903254151e-03, 2.68202368170023e-03, 2.567047020420432e-03, 2.711344044655561e-03, 2.481817733496428e-03, 2.470946870744228e-03, 2.414105692878366e-03, 2.344382926821709e-03, 2.25134822539985e-03, 2.124833641573788e-03, 2.237983979284762e-03, 2.097827149555087e-03, 2.138545271009207e-03, 2.057649428024888e-03, 2.036209916695952e-03, 1.994818449020386e-03, 1.963377464562654e-03, 1.931154867634177e-03, 1.899926923215389e-03, 1.870920765213668e-03, 1.842956757172942e-03, 1.814490766264498e-03, 1.785522908903658e-03, 1.758010475896299e-03, 1.732325181365013e-03, 1.707031158730388e-03, 1.682128058746457e-03, 1.657616579905152e-03, 1.633496605791152e-03, 1.609768252819777e-03, 1.58645783085376e-03, 1.564588048495352e-03, 1.543361111544073e-03, 1.522777252830565e-03, 1.502836588770151e-03, 1.483539002947509e-03, 1.464884844608605e-03, 1.446874113753438e-03, 1.429091673344374e-03, 1.411403063684702e-03, 1.394155900925398e-03, 1.377349952235818e-03, 1.360985450446606e-03, 1.345062628388405e-03, 1.32958113681525e-03, 1.314541324973106e-03, 1.299560070037842e-03, 1.28492817748338e-03, 1.270647277124226e-03, 1.256717834621668e-03, 1.243139384314418e-03, 1.229912508279085e-03, 1.217036857269704e-03, 1.204356085509062e-03, 1.191794988699257e-03]
+dooDis.vBA=[4.749564453959465e-02, 5.990498512983322e-02, 4.694976285099983e-02, 3.840827569365501e-02, 3.220124542713165e-02, 2.759085595607758e-02, 2.390220947563648e-02, 2.059530839323997e-02, 1.81407630443573e-02, 1.607844978570938e-02, 1.422037463635206e-02, 1.281538605690002e-02, 1.166222710162401e-02, 1.065531745553017e-02, 9.700608439743517e-03, 8.960271254181862e-03, 8.408299647271633e-03, 7.754968944936991e-03, 7.434388156980276e-03, 6.918889936059713e-03, 6.570843048393726e-03, 6.104995496571064e-03, 5.961773451417685e-03, 5.623039789497852e-03, 5.402896087616682e-03, 5.067681428045034e-03, 4.912242759019136e-03, 4.790075123310088e-03, 4.553210455924273e-03, 4.376804921776056e-03, 4.139650147408247e-03, 4.180979914963245e-03, 3.944966476410627e-03, 3.863802645355463e-03, 3.579841693863273e-03, 3.696293337270617e-03, 3.501861821860075e-03, 3.462576540187001e-03, 3.331364365294576e-03, 3.308042185381055e-03, 3.186007728800178e-03, 2.985333791002631e-03, 2.977491822093725e-03, 2.845598617568612e-03, 2.802335657179356e-03, 2.640249906107783e-03, 2.752406988292933e-03, 2.610975876450539e-03, 2.6056042406708e-03, 2.397250849753618e-03, 2.535609062761068e-03, 2.45367456227541e-03, 2.407297026365995e-03, 2.374268136918545e-03, 2.347771776840092e-03, 2.336967270821331e-03, 2.12784274481237e-03, 2.176653360947967e-03, 2.063610590994358e-03, 2.072939649224281e-03, 2.02759588137269e-03, 1.997738843783736e-03, 1.962000504136086e-03, 1.929172081872821e-03, 1.897827605716884e-03, 1.866249949671328e-03, 1.835622126236558e-03, 1.807461259886622e-03, 1.781767583452165e-03, 1.755510573275387e-03, 1.728114555589855e-03, 1.70180422719568e-03, 1.676580170169473e-03, 1.652442151680589e-03, 1.629390520974994e-03, 1.607425510883331e-03, 1.586497528478503e-03, 1.564662554301322e-03, 1.543437479995191e-03, 1.522822771221399e-03, 1.502818195149302e-03, 1.483424217440188e-03, 1.464640605263412e-03, 1.446467824280262e-03, 1.428594812750816e-03, 1.410920755006373e-03, 1.393705955706537e-03, 1.37695053126663e-03, 1.360654598101974e-03, 1.344817923381925e-03, 1.32944097276777e-03, 1.314523629844189e-03, 1.299569034017622e-03, 1.284954370930791e-03, 1.270682201720774e-03, 1.256752293556929e-03, 1.243164879269898e-03, 1.229919726029038e-03, 1.217017183080316e-03, 1.204319181852043e-03, 1.191760296933353e-03]
+bouA.T=[2.921499938964844e+02, 2.925950927734375e+02, 2.927796325683594e+02, 2.928743896484375e+02, 2.929311828613281e+02, 2.929688110351562e+02, 2.929954833984375e+02, 2.93015380859375e+02, 2.930307312011719e+02, 2.930429382324219e+02, 2.930528869628906e+02, 2.930611572265625e+02, 2.930681457519531e+02, 2.930740966796875e+02, 2.930792541503906e+02, 2.930837707519531e+02, 2.930877075195312e+02, 2.930912170410156e+02, 2.930943603515625e+02, 2.930971984863281e+02, 2.930997314453125e+02, 2.9310205078125e+02, 2.931041564941406e+02, 2.931061096191406e+02, 2.931078796386719e+02, 2.931095275878906e+02, 2.931110229492188e+02, 2.931124572753906e+02, 2.931137390136719e+02, 2.931149597167969e+02, 2.931161193847656e+02, 2.931171875e+02, 2.931181945800781e+02, 2.93119140625e+02, 2.931200256347656e+02, 2.931208801269531e+02, 2.931216735839844e+02, 2.931224060058594e+02, 2.931231384277344e+02, 2.931238098144531e+02, 2.931244506835938e+02, 2.931250610351562e+02, 2.931256408691406e+02, 2.931261901855469e+02, 2.931267395019531e+02, 2.931272583007812e+02, 2.931277465820312e+02, 2.931282043457031e+02, 2.93128662109375e+02, 2.931290893554688e+02, 2.931294860839844e+02, 2.931298828125e+02, 2.931302795410156e+02, 2.931306457519531e+02, 2.931309814453125e+02, 2.9313134765625e+02, 2.931316528320312e+02, 2.931319885253906e+02, 2.931322937011719e+02, 2.931325988769531e+02, 2.931328735351562e+02, 2.931331481933594e+02, 2.931334228515625e+02, 2.931336669921875e+02, 2.931339416503906e+02, 2.931341857910156e+02, 2.931344299316406e+02, 2.931346435546875e+02, 2.931348571777344e+02, 2.931351013183594e+02, 2.931353149414062e+02, 2.931355285644531e+02, 2.931357116699219e+02, 2.931359252929688e+02, 2.931361083984375e+02, 2.931362915039062e+02, 2.93136474609375e+02, 2.931366577148438e+02, 2.931368103027344e+02, 2.931369934082031e+02, 2.931371459960938e+02, 2.931373291015625e+02, 2.931374816894531e+02, 2.931376342773438e+02, 2.931377563476562e+02, 2.931379089355469e+02, 2.931380615234375e+02, 2.9313818359375e+02, 2.931383361816406e+02, 2.931384582519531e+02, 2.931385803222656e+02, 2.931387023925781e+02, 2.931388244628906e+02, 2.931389465332031e+02, 2.931390686035156e+02, 2.931391906738281e+02, 2.931393127441406e+02, 2.93139404296875e+02, 2.931395263671875e+02, 2.931396179199219e+02, 2.931397399902344e+02]
+bouB.T=[2.941499938964844e+02, 2.937049255371094e+02, 2.935203857421875e+02, 2.934256286621094e+02, 2.933688049316406e+02, 2.933311767578125e+02, 2.933045043945312e+02, 2.932846374511719e+02, 2.932692565917969e+02, 2.932570495605469e+02, 2.932471008300781e+02, 2.932388305664062e+02, 2.932318725585938e+02, 2.932258911132812e+02, 2.932207336425781e+02, 2.932162475585938e+02, 2.932122802734375e+02, 2.932087707519531e+02, 2.932056274414062e+02, 2.932028198242188e+02, 2.932002563476562e+02, 2.931979370117188e+02, 2.931958312988281e+02, 2.931939086914062e+02, 2.931921081542969e+02, 2.931904907226562e+02, 2.9318896484375e+02, 2.931875610351562e+02, 2.931862487792969e+02, 2.931850280761719e+02, 2.931838989257812e+02, 2.931828002929688e+02, 2.931818237304688e+02, 2.931808776855469e+02, 2.931799621582031e+02, 2.931791381835938e+02, 2.931783447265625e+02, 2.931775817871094e+02, 2.931768798828125e+02, 2.931762084960938e+02, 2.931755676269531e+02, 2.931749267578125e+02, 2.931743469238281e+02, 2.931737976074219e+02, 2.931732788085938e+02, 2.931727600097656e+02, 2.931722717285156e+02, 2.931718139648438e+02, 2.931713562011719e+02, 2.931709289550781e+02, 2.931705017089844e+02, 2.931701049804688e+02, 2.931697387695312e+02, 2.931693725585938e+02, 2.931690063476562e+02, 2.931686706542969e+02, 2.931683349609375e+02, 2.931680297851562e+02, 2.93167724609375e+02, 2.931674194335938e+02, 2.931671142578125e+02, 2.931668395996094e+02, 2.931665954589844e+02, 2.931663208007812e+02, 2.931660766601562e+02, 2.931658325195312e+02, 2.931655883789062e+02, 2.931653442382812e+02, 2.931651306152344e+02, 2.931649169921875e+02, 2.931647033691406e+02, 2.931644897460938e+02, 2.931642761230469e+02, 2.931640930175781e+02, 2.931638793945312e+02, 2.931636962890625e+02, 2.931635131835938e+02, 2.931633605957031e+02, 2.931631774902344e+02, 2.931629943847656e+02, 2.93162841796875e+02, 2.931626892089844e+02, 2.931625366210938e+02, 2.931623840332031e+02, 2.931622314453125e+02, 2.931620788574219e+02, 2.931619567871094e+02, 2.931618041992188e+02, 2.931616821289062e+02, 2.931615295410156e+02, 2.931614074707031e+02, 2.931612854003906e+02, 2.931611633300781e+02, 2.931610412597656e+02, 2.931609191894531e+02, 2.931607971191406e+02, 2.931607055664062e+02, 2.931605834960938e+02, 2.931604919433594e+02, 2.931603698730469e+02, 2.931602783203125e+02]
+doo.port_a1.p=[1.01325e+05, 1.01325e+05]
+doo.port_a2.p=[1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05]
diff --git a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_OpenDoorBuoyancyPressureDynamic.txt b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_OpenDoorBuoyancyPressureDynamic.txt
new file mode 100644
index 0000000000..e16873df82
--- /dev/null
+++ b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_OpenDoorBuoyancyPressureDynamic.txt
@@ -0,0 +1,19 @@
+last-generated=2021-01-25
+statistics-simulation=
+{
+ "linear": " ",
+ "nonlinear": " ",
+ "number of continuous time states": "12",
+ "numerical Jacobians": "0"
+}
+time=[0e+00, 1.44e+04]
+doo.vAB=[1.876388430595398e+00, 5.529473721981049e-02, 3.910126909613609e-02, 2.970257960259914e-02, 2.380389720201492e-02, 1.981072872877121e-02, 1.694450527429581e-02, 1.479324884712696e-02, 1.312171947211027e-02, 1.178676262497902e-02, 1.06967194005847e-02, 9.790188632905483e-03, 9.024634957313538e-03, 8.369671180844307e-03, 7.80302658677101e-03, 7.308023981750011e-03, 6.871913094073534e-03, 6.484804209321737e-03, 6.138890516012907e-03, 5.827941931784153e-03, 5.546926520764828e-03, 5.291721317917109e-03, 5.058933049440384e-03, 4.845737013965845e-03, 4.649761598557234e-03, 4.469003994017839e-03, 4.301760345697403e-03, 4.146569874137639e-03, 4.002177622169255e-03, 3.867494175210595e-03, 3.741573542356491e-03, 3.623588010668755e-03, 3.512810915708542e-03, 3.408601740375161e-03, 3.310393309220672e-03, 3.217682475224137e-03, 3.13002010807395e-03, 3.047005040571094e-03, 2.968278015032411e-03, 2.893515629693866e-03, 2.822424983605742e-03, 2.754742512479424e-03, 2.690228167921305e-03, 2.62866448611021e-03, 2.569854725152254e-03, 2.513617509976029e-03, 2.459788462147117e-03, 2.40821554325521e-03, 2.358759986236691e-03, 2.311293967068195e-03, 2.26570013910532e-03, 2.221870003268123e-03, 2.179703209549189e-03, 2.1391068585217e-03, 2.099994802847504e-03, 2.062286948785185e-03, 2.025908790528774e-03, 1.990791643038392e-03, 1.956871012225747e-03, 1.924086711369455e-03, 1.892382279038429e-03, 1.861706026829779e-03, 1.832008012570441e-03, 1.803242485038936e-03, 1.775366021320224e-03, 1.74833822529763e-03, 1.722121029160917e-03, 1.696678227744997e-03, 1.671976293437183e-03, 1.647982746362686e-03, 1.624668249860406e-03, 1.602003583684564e-03, 1.579962903633714e-03, 1.558520132675767e-03, 1.537651405669749e-03, 1.517334138043225e-03, 1.497547025792301e-03, 1.478269230574369e-03, 1.459481427446008e-03, 1.441164989955723e-03, 1.423302805051208e-03, 1.405877876095474e-03, 1.388874254189432e-03, 1.372276921756566e-03, 1.356071792542934e-03, 1.340244896709919e-03, 1.324782962910831e-03, 1.309673767536879e-03, 1.294905319809914e-03, 1.280466211028397e-03, 1.266345498152077e-03, 1.252532820217311e-03, 1.239018165506423e-03, 1.225791987963021e-03, 1.212845207192004e-03, 1.200169092044234e-03, 1.187755144201219e-03, 1.175595331005752e-03, 1.163682085461915e-03, 1.152007724158466e-03, 1.140565262176096e-03]
+doo.vBA=[0e+00, 5.529473721981049e-02, 3.910126909613609e-02, 2.970257960259914e-02, 2.380389720201492e-02, 1.981072872877121e-02, 1.694450527429581e-02, 1.479324884712696e-02, 1.312172040343285e-02, 1.178676262497902e-02, 1.06967194005847e-02, 9.790188632905483e-03, 9.024634957313538e-03, 8.369671180844307e-03, 7.80302658677101e-03, 7.308024447411299e-03, 6.871913094073534e-03, 6.484804209321737e-03, 6.138891912996769e-03, 5.827941931784153e-03, 5.54692605510354e-03, 5.291721317917109e-03, 5.058933049440384e-03, 4.845737013965845e-03, 4.649761598557234e-03, 4.469003994017839e-03, 4.301759880036116e-03, 4.146569874137639e-03, 4.002177622169255e-03, 3.867494175210595e-03, 3.741573542356491e-03, 3.623588010668755e-03, 3.512810915708542e-03, 3.408601507544518e-03, 3.310393309220672e-03, 3.217682475224137e-03, 3.13002010807395e-03, 3.047005040571094e-03, 2.968278015032411e-03, 2.893515396863222e-03, 2.822425216436386e-03, 2.754742512479424e-03, 2.690227935090661e-03, 2.62866448611021e-03, 2.56985449232161e-03, 2.513617509976029e-03, 2.459788462147117e-03, 2.40821554325521e-03, 2.358759986236691e-03, 2.311293967068195e-03, 2.26570013910532e-03, 2.221870003268123e-03, 2.179703209549189e-03, 2.1391068585217e-03, 2.099994802847504e-03, 2.062286948785185e-03, 2.025908790528774e-03, 1.990791643038392e-03, 1.956871012225747e-03, 1.924086711369455e-03, 1.892382628284395e-03, 1.861706026829779e-03, 1.832008012570441e-03, 1.803242252208292e-03, 1.775366021320224e-03, 1.74833822529763e-03, 1.722120912745595e-03, 1.696678111329675e-03, 1.671976060606539e-03, 1.647982746362686e-03, 1.624668249860406e-03, 1.602003932930529e-03, 1.579962903633714e-03, 1.558519899845123e-03, 1.537651405669749e-03, 1.51733448728919e-03, 1.497547025792301e-03, 1.478269230574369e-03, 1.459481427446008e-03, 1.441165339201689e-03, 1.423302805051208e-03, 1.405877876095474e-03, 1.388874254189432e-03, 1.372277271002531e-03, 1.356071792542934e-03, 1.340244896709919e-03, 1.324782962910831e-03, 1.309673767536879e-03, 1.294905319809914e-03, 1.280466211028397e-03, 1.266345498152077e-03, 1.252532820217311e-03, 1.239018165506423e-03, 1.225791987963021e-03, 1.212845207192004e-03, 1.200169092044234e-03, 1.187755144201219e-03, 1.175595331005752e-03, 1.163681969046593e-03, 1.152007607743144e-03, 1.140564912930131e-03]
+dooDis.vAB=[1.880900979042053e+00, 5.975151807069778e-02, 4.68953475356102e-02, 3.838159143924713e-02, 3.223228082060814e-02, 2.752139233052731e-02, 2.375267259776592e-02, 2.065540850162506e-02, 1.809901744127274e-02, 1.600105129182339e-02, 1.427508611232042e-02, 1.284789945930243e-02, 1.165811810642481e-02, 1.065468974411488e-02, 9.801148436963556e-03, 9.067862294614315e-03, 8.432281203567982e-03, 7.876892574131489e-03, 7.387927267700434e-03, 6.954491604119539e-03, 6.567902863025665e-03, 6.221112795174122e-03, 5.908406805247068e-03, 5.625088233500719e-03, 5.36726787686348e-03, 5.131704732775688e-03, 4.915674682706594e-03, 4.716875031590461e-03, 4.533357452601194e-03, 4.363429266959429e-03, 4.205668345093727e-03, 4.058857448399067e-03, 3.921851515769958e-03, 3.793579991906881e-03, 3.673521336168051e-03, 3.560716984793544e-03, 3.454592544585466e-03, 3.354579443112016e-03, 3.260163124650717e-03, 3.170887706801295e-03, 3.086346434429288e-03, 3.006173530593514e-03, 2.930039772763848e-03, 2.857649233192205e-03, 2.788734156638384e-03, 2.723051235079765e-03, 2.660379279404879e-03, 2.60051665827632e-03, 2.543278504163027e-03, 2.488496713340282e-03, 2.436014590784907e-03, 2.385680098086596e-03, 2.337356563657522e-03, 2.290919655933976e-03, 2.246255753561854e-03, 2.203263808041811e-03, 2.161849057301878e-03, 2.121926052495837e-03, 2.083415631204844e-03, 2.046243287622929e-03, 2.010342199355364e-03, 1.975647872313857e-03, 1.94210116751492e-03, 1.909648301079869e-03, 1.878235954791307e-03, 1.847816864028573e-03, 1.818345859646797e-03, 1.789778936654329e-03, 1.762077561579645e-03, 1.735202618874609e-03, 1.709119300357997e-03, 1.683793030679226e-03, 1.659193309023976e-03, 1.635289285331964e-03, 1.612052787095308e-03, 1.589456922374666e-03, 1.567476545460522e-03, 1.546086859889328e-03, 1.525265164673328e-03, 1.504989340901375e-03, 1.485238899476826e-03, 1.465994166210294e-03, 1.447235816158354e-03, 1.428946736268699e-03, 1.411108998581767e-03, 1.393707236275077e-03, 1.376725500449538e-03, 1.360149006359279e-03, 1.343964016996324e-03, 1.328156795352697e-03, 1.312714535742998e-03, 1.297625014558434e-03, 1.28287635743618e-03, 1.268457272090018e-03, 1.254357048310339e-03, 1.240565325133502e-03, 1.227072207257152e-03, 1.213868497870862e-03, 1.200944767333567e-03, 1.188292517326772e-03, 1.175903016701341e-03]
+dooDis.vBA=[-0e+00, 5.997490510344505e-02, 4.700437188148499e-02, 3.844550251960754e-02, 3.227068483829498e-02, 2.754724584519863e-02, 2.377376332879066e-02, 2.066727541387081e-02, 1.810834184288979e-02, 1.600653119385242e-02, 1.428088638931513e-02, 1.285345107316971e-02, 1.166158448904753e-02, 1.065774727612734e-02, 9.803696535527704e-03, 9.070034138858318e-03, 8.434153161942959e-03, 7.878521457314491e-03, 7.389356382191181e-03, 6.955756805837154e-03, 6.56902976334095e-03, 6.222122814506292e-03, 5.909316707402468e-03, 5.625913385301828e-03, 5.368019919842482e-03, 5.132395308464766e-03, 4.916313104331493e-03, 4.71747014671564e-03, 4.533896688371896e-03, 4.363927058875561e-03, 4.206139128655195e-03, 4.059180617332458e-03, 3.922068513929844e-03, 3.79397114738822e-03, 3.673818428069353e-03, 3.561022458598018e-03, 3.454896854236722e-03, 3.35487094707787e-03, 3.260438097640872e-03, 3.171147778630257e-03, 3.08659253641963e-03, 3.006407292559743e-03, 2.930261893197894e-03, 2.857860177755356e-03, 2.788935089483857e-03, 2.723242854699492e-03, 2.660562284290791e-03, 2.600691048428416e-03, 2.54344567656517e-03, 2.48865713365376e-03, 2.436168026179075e-03, 2.385827712714672e-03, 2.337497659027576e-03, 2.291054930537939e-03, 2.246386371552944e-03, 2.203389070928096e-03, 2.161969896405935e-03, 2.122042700648308e-03, 2.083527389913797e-03, 2.046351786702871e-03, 2.010446274653077e-03, 1.975748222321272e-03, 1.942198956385255e-03, 1.90974201541394e-03, 1.87832722440362e-03, 1.847905456088483e-03, 1.818430959247053e-03, 1.789862173609436e-03, 1.762157888151705e-03, 1.735280733555555e-03, 1.709194970317185e-03, 1.683866954408586e-03, 1.659264671616256e-03, 1.635358552448452e-03, 1.612120191566646e-03, 1.589522464200854e-03, 1.56754010822624e-03, 1.546148676425219e-03, 1.525325351394713e-03, 1.505048130638897e-03, 1.485296175815165e-03, 1.466049696318805e-03, 1.447290182113647e-03, 1.428999355994165e-03, 1.411160686984658e-03, 1.393757527694106e-03, 1.376774627715349e-03, 1.360197318717837e-03, 1.344011048786342e-03, 1.328202779404819e-03, 1.312759472057223e-03, 1.297668903134763e-03, 1.282919081859291e-03, 1.268499065190554e-03, 1.254397910088301e-03, 1.240605372004211e-03, 1.227111555635929e-03, 1.213906914927065e-03, 1.200982369482517e-03, 1.188329188153148e-03, 1.175938989035785e-03]
+bouA.T=[2.921499938964844e+02, 2.925960083007812e+02, 2.927809753417969e+02, 2.928760986328125e+02, 2.929330444335938e+02, 2.929707336425781e+02, 2.929974670410156e+02, 2.930173645019531e+02, 2.930327453613281e+02, 2.930449829101562e+02, 2.930549621582031e+02, 2.93063232421875e+02, 2.930702209472656e+02, 2.93076171875e+02, 2.930813293457031e+02, 2.930858459472656e+02, 2.930897827148438e+02, 2.930933227539062e+02, 2.930964660644531e+02, 2.930992736816406e+02, 2.931018371582031e+02, 2.931041259765625e+02, 2.931062622070312e+02, 2.931081848144531e+02, 2.931099548339844e+02, 2.931116027832031e+02, 2.931130981445312e+02, 2.931145324707031e+02, 2.931158142089844e+02, 2.931170349121094e+02, 2.931181945800781e+02, 2.931192626953125e+02, 2.931202697753906e+02, 2.931212158203125e+02, 2.931221008300781e+02, 2.931229248046875e+02, 2.931237182617188e+02, 2.931244812011719e+02, 2.931251831054688e+02, 2.931258544921875e+02, 2.931264953613281e+02, 2.931271362304688e+02, 2.931277160644531e+02, 2.931282653808594e+02, 2.931287841796875e+02, 2.931293029785156e+02, 2.931297912597656e+02, 2.931302490234375e+02, 2.931307067871094e+02, 2.931311340332031e+02, 2.931315612792969e+02, 2.931319580078125e+02, 2.9313232421875e+02, 2.931326904296875e+02, 2.93133056640625e+02, 2.931333923339844e+02, 2.931337280273438e+02, 2.93134033203125e+02, 2.931343383789062e+02, 2.931346435546875e+02, 2.931349182128906e+02, 2.931351928710938e+02, 2.931354675292969e+02, 2.931357421875e+02, 2.93135986328125e+02, 2.9313623046875e+02, 2.93136474609375e+02, 2.931366882324219e+02, 2.931369323730469e+02, 2.931371459960938e+02, 2.931373596191406e+02, 2.931375427246094e+02, 2.931377563476562e+02, 2.93137939453125e+02, 2.931381530761719e+02, 2.931383361816406e+02, 2.931384887695312e+02, 2.93138671875e+02, 2.931388549804688e+02, 2.931390075683594e+02, 2.9313916015625e+02, 2.931393432617188e+02, 2.931394958496094e+02, 2.931396484375e+02, 2.931397705078125e+02, 2.931399230957031e+02, 2.931400756835938e+02, 2.931401977539062e+02, 2.931403503417969e+02, 2.931404724121094e+02, 2.931405944824219e+02, 2.931407165527344e+02, 2.931408386230469e+02, 2.931409606933594e+02, 2.931410827636719e+02, 2.931412048339844e+02, 2.931412963867188e+02, 2.931414184570312e+02, 2.931415100097656e+02, 2.931416320800781e+02, 2.931417236328125e+02]
+bouB.T=[2.941499938964844e+02, 2.937080993652344e+02, 2.935231323242188e+02, 2.934280090332031e+02, 2.933710632324219e+02, 2.933333435058594e+02, 2.93306640625e+02, 2.932867431640625e+02, 2.932713623046875e+02, 2.932591247558594e+02, 2.932491455078125e+02, 2.932408752441406e+02, 2.9323388671875e+02, 2.932279357910156e+02, 2.932227783203125e+02, 2.9321826171875e+02, 2.932142944335938e+02, 2.932107849121094e+02, 2.932076416015625e+02, 2.93204833984375e+02, 2.932022705078125e+02, 2.93199951171875e+02, 2.931978454589844e+02, 2.931959228515625e+02, 2.931941528320312e+02, 2.931925048828125e+02, 2.931909790039062e+02, 2.931895751953125e+02, 2.931882629394531e+02, 2.931870422363281e+02, 2.931859130859375e+02, 2.931848449707031e+02, 2.93183837890625e+02, 2.931828918457031e+02, 2.931820068359375e+02, 2.931811828613281e+02, 2.931803894042969e+02, 2.931796264648438e+02, 2.931789245605469e+02, 2.9317822265625e+02, 2.931775817871094e+02, 2.931769714355469e+02, 2.931763916015625e+02, 2.931758422851562e+02, 2.9317529296875e+02, 2.931748046875e+02, 2.9317431640625e+02, 2.93173828125e+02, 2.931734008789062e+02, 2.931729736328125e+02, 2.931725463867188e+02, 2.931721496582031e+02, 2.931717834472656e+02, 2.931714172363281e+02, 2.931710510253906e+02, 2.931707153320312e+02, 2.931703796386719e+02, 2.931700744628906e+02, 2.931697692871094e+02, 2.931694641113281e+02, 2.931691589355469e+02, 2.931688842773438e+02, 2.931686401367188e+02, 2.931683654785156e+02, 2.931681213378906e+02, 2.931678771972656e+02, 2.931676330566406e+02, 2.931673889160156e+02, 2.931671752929688e+02, 2.931669616699219e+02, 2.93166748046875e+02, 2.931665344238281e+02, 2.931663513183594e+02, 2.931661376953125e+02, 2.931659545898438e+02, 2.93165771484375e+02, 2.931655883789062e+02, 2.931654357910156e+02, 2.931652526855469e+02, 2.931651000976562e+02, 2.931649169921875e+02, 2.931647644042969e+02, 2.931646118164062e+02, 2.931644592285156e+02, 2.93164306640625e+02, 2.931641845703125e+02, 2.931640319824219e+02, 2.931639099121094e+02, 2.931637573242188e+02, 2.931636352539062e+02, 2.931635131835938e+02, 2.931633911132812e+02, 2.931632690429688e+02, 2.931631469726562e+02, 2.931630249023438e+02, 2.931629028320312e+02, 2.931628112792969e+02, 2.931626892089844e+02, 2.931625671386719e+02, 2.931624755859375e+02, 2.931623840332031e+02]
+bouADis.T=[2.921499938964844e+02, 2.926053466796875e+02, 2.928067321777344e+02, 2.929131774902344e+02, 2.9297607421875e+02, 2.930162048339844e+02, 2.930432739257812e+02, 2.930623168945312e+02, 2.930762023925781e+02, 2.930866088867188e+02, 2.930946655273438e+02, 2.931010437011719e+02, 2.931061706542969e+02, 2.931104125976562e+02, 2.931139526367188e+02, 2.93116943359375e+02, 2.931195068359375e+02, 2.931217346191406e+02, 2.931236877441406e+02, 2.931253967285156e+02, 2.931268920898438e+02, 2.931282653808594e+02, 2.931294860839844e+02, 2.931305847167969e+02, 2.93131591796875e+02, 2.931325073242188e+02, 2.931333312988281e+02, 2.931340942382812e+02, 2.931347961425781e+02, 2.931354675292969e+02, 2.931360473632812e+02, 2.931366271972656e+02, 2.931371459960938e+02, 2.931376342773438e+02, 2.931380920410156e+02, 2.931385192871094e+02, 2.931389465332031e+02, 2.931393127441406e+02, 2.931396789550781e+02, 2.931400146484375e+02, 2.931403503417969e+02, 2.931406555175781e+02, 2.931409301757812e+02, 2.931412048339844e+02, 2.931414794921875e+02, 2.931417236328125e+02, 2.931419677734375e+02, 2.931421813964844e+02, 2.931423950195312e+02, 2.931426086425781e+02, 2.93142822265625e+02, 2.931430053710938e+02, 2.931431884765625e+02, 2.931433715820312e+02, 2.931435241699219e+02, 2.931437072753906e+02, 2.931438598632812e+02, 2.931440124511719e+02, 2.931441345214844e+02, 2.93144287109375e+02, 2.931444396972656e+02, 2.931445617675781e+02, 2.931446838378906e+02, 2.931448059082031e+02, 2.931449279785156e+02, 2.931450500488281e+02, 2.931451416015625e+02, 2.93145263671875e+02, 2.931453552246094e+02, 2.931454467773438e+02, 2.931455688476562e+02, 2.931456604003906e+02, 2.93145751953125e+02, 2.931458435058594e+02, 2.931459045410156e+02, 2.9314599609375e+02, 2.931460876464844e+02, 2.931461791992188e+02, 2.93146240234375e+02, 2.931463317871094e+02, 2.931463928222656e+02, 2.931464538574219e+02, 2.931465454101562e+02, 2.931466064453125e+02, 2.931466674804688e+02, 2.93146728515625e+02, 2.931467895507812e+02, 2.931468505859375e+02, 2.931469116210938e+02, 2.9314697265625e+02, 2.931470336914062e+02, 2.931470947265625e+02, 2.931471557617188e+02, 2.93147216796875e+02, 2.931472473144531e+02, 2.931473083496094e+02, 2.931473693847656e+02, 2.931473999023438e+02, 2.931474609375e+02, 2.931474914550781e+02, 2.931475524902344e+02]
+bouBDis.T=[2.941499938964844e+02, 2.9369873046875e+02, 2.93497314453125e+02, 2.93390869140625e+02, 2.933280029296875e+02, 2.932878723144531e+02, 2.932608032226562e+02, 2.932417602539062e+02, 2.932278747558594e+02, 2.932174682617188e+02, 2.932094116210938e+02, 2.932030334472656e+02, 2.931979064941406e+02, 2.931936645507812e+02, 2.931901245117188e+02, 2.931871337890625e+02, 2.931845703125e+02, 2.931823425292969e+02, 2.931803894042969e+02, 2.931786804199219e+02, 2.931771545410156e+02, 2.931758117675781e+02, 2.931745910644531e+02, 2.931734924316406e+02, 2.931724853515625e+02, 2.931715698242188e+02, 2.931707458496094e+02, 2.931699829101562e+02, 2.931692810058594e+02, 2.931686096191406e+02, 2.931679992675781e+02, 2.931674499511719e+02, 2.931669311523438e+02, 2.931664428710938e+02, 2.931659851074219e+02, 2.931655578613281e+02, 2.931651306152344e+02, 2.931647644042969e+02, 2.931643981933594e+02, 2.931640625e+02, 2.931637268066406e+02, 2.931634216308594e+02, 2.931631469726562e+02, 2.931628723144531e+02, 2.9316259765625e+02, 2.93162353515625e+02, 2.93162109375e+02, 2.931618957519531e+02, 2.931616821289062e+02, 2.931614685058594e+02, 2.931612548828125e+02, 2.931610717773438e+02, 2.93160888671875e+02, 2.931607055664062e+02, 2.931605529785156e+02, 2.931603698730469e+02, 2.931602172851562e+02, 2.931600646972656e+02, 2.93159912109375e+02, 2.931597900390625e+02, 2.931596374511719e+02, 2.931595153808594e+02, 2.931593933105469e+02, 2.931592712402344e+02, 2.931591491699219e+02, 2.931590270996094e+02, 2.93158935546875e+02, 2.931588134765625e+02, 2.931587219238281e+02, 2.931586303710938e+02, 2.931585083007812e+02, 2.931584167480469e+02, 2.931583251953125e+02, 2.931582336425781e+02, 2.931581420898438e+02, 2.931580810546875e+02, 2.931579895019531e+02, 2.931578979492188e+02, 2.931578369140625e+02, 2.931577453613281e+02, 2.931576843261719e+02, 2.931576232910156e+02, 2.931575317382812e+02, 2.93157470703125e+02, 2.931574096679688e+02, 2.931573486328125e+02, 2.931572875976562e+02, 2.931572265625e+02, 2.931571655273438e+02, 2.931571044921875e+02, 2.931570434570312e+02, 2.93156982421875e+02, 2.931569213867188e+02, 2.931568603515625e+02, 2.931568298339844e+02, 2.931567687988281e+02, 2.931567077636719e+02, 2.931566772460938e+02, 2.931566162109375e+02, 2.931565856933594e+02, 2.931565246582031e+02]
+doo.port_a1.p=[1.01325e+05, 1.01325e+05]
+doo.port_a2.p=[1.0132e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05]
diff --git a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_OpenDoorPressure.txt b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_OpenDoorPressure.txt
new file mode 100644
index 0000000000..7d9f0e0102
--- /dev/null
+++ b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_OpenDoorPressure.txt
@@ -0,0 +1,17 @@
+last-generated=2021-01-22
+statistics-simulation=
+{
+ "linear": " ",
+ "nonlinear": " ",
+ "number of continuous time states": "2",
+ "numerical Jacobians": "0"
+}
+time=[0e+00, 2.88e+04]
+doo.vAB=[3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00]
+doo.vBA=[0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00]
+dooDis.vAB=[3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.752776861190796e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00]
+dooDis.vBA=[-0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, 0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, 0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, 0e+00, 0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, 0e+00, 0e+00, 0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 1.876388430595398e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 2.653613805770874e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00, 3.25e+00]
+bouA.T=[2.931499938964844e+02, 2.931499938964844e+02]
+bouB.T=[2.931499938964844e+02, 2.931499938964844e+02]
+doo.port_a1.p=[1.01325e+05, 1.01325e+05]
+doo.port_a2.p=[1.01305e+05, 1.01305e+05, 1.01305e+05, 1.01305e+05, 1.01305e+05, 1.01305e+05, 1.01305e+05, 1.01305e+05, 1.01305e+05, 1.01305e+05, 1.01305e+05, 1.01305e+05, 1.01305e+05, 1.0131e+05, 1.0131e+05, 1.0131e+05, 1.0131e+05, 1.0131e+05, 1.0131e+05, 1.0131e+05, 1.0131e+05, 1.0131e+05, 1.0131e+05, 1.0131e+05, 1.0131e+05, 1.0131e+05, 1.01315e+05, 1.01315e+05, 1.01315e+05, 1.01315e+05, 1.01315e+05, 1.01315e+05, 1.01315e+05, 1.01315e+05, 1.01315e+05, 1.01315e+05, 1.01315e+05, 1.01315e+05, 1.0132e+05, 1.0132e+05, 1.0132e+05, 1.0132e+05, 1.0132e+05, 1.0132e+05, 1.0132e+05, 1.0132e+05, 1.0132e+05, 1.0132e+05, 1.0132e+05, 1.0132e+05, 1.0132e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.01325e+05, 1.0133e+05, 1.0133e+05, 1.0133e+05, 1.0133e+05, 1.0133e+05, 1.0133e+05, 1.0133e+05, 1.0133e+05, 1.0133e+05, 1.0133e+05, 1.0133e+05, 1.0133e+05, 1.0133e+05, 1.01335e+05, 1.01335e+05, 1.01335e+05, 1.01335e+05, 1.01335e+05, 1.01335e+05, 1.01335e+05, 1.01335e+05, 1.01335e+05, 1.01335e+05, 1.01335e+05, 1.01335e+05, 1.0134e+05, 1.0134e+05, 1.0134e+05, 1.0134e+05, 1.0134e+05, 1.0134e+05, 1.0134e+05, 1.0134e+05, 1.0134e+05, 1.0134e+05, 1.0134e+05, 1.0134e+05, 1.0134e+05]
diff --git a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_OpenDoorTemperature.txt b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_OpenDoorTemperature.txt
new file mode 100644
index 0000000000..c46aa68ead
--- /dev/null
+++ b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_OpenDoorTemperature.txt
@@ -0,0 +1,17 @@
+last-generated=2021-01-22
+statistics-simulation=
+{
+ "linear": " ",
+ "nonlinear": " ",
+ "number of continuous time states": "2",
+ "numerical Jacobians": "0"
+}
+time=[0e+00, 2.88e+04]
+doo.vAB=[2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01]
+doo.vBA=[2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.568219602108002e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.284109801054001e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 1.816005408763885e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01, 2.224143296480179e-01]
+dooDis.vAB=[2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 0e+00, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01]
+dooDis.vBA=[2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.67546147108078e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 2.296097874641418e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.858129650354385e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, 1.302446722984314e-01, -0e+00, -0e+00, -0e+00, 0e+00, 0e+00, 0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, -0e+00, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.280418336391449e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 1.795789897441864e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01, 2.18146800994873e-01]
+bouA.T=[2.931499938964844e+02, 2.931499938964844e+02]
+bouB.T_in=[2.731499938964844e+02, 2.731499938964844e+02, 2.731499938964844e+02, 2.731499938964844e+02, 2.731499938964844e+02, 2.731499938964844e+02, 2.731499938964844e+02, 2.731499938964844e+02, 2.731499938964844e+02, 2.731499938964844e+02, 2.731499938964844e+02, 2.731499938964844e+02, 2.731499938964844e+02, 2.781499938964844e+02, 2.781499938964844e+02, 2.781499938964844e+02, 2.781499938964844e+02, 2.781499938964844e+02, 2.781499938964844e+02, 2.781499938964844e+02, 2.781499938964844e+02, 2.781499938964844e+02, 2.781499938964844e+02, 2.781499938964844e+02, 2.781499938964844e+02, 2.781499938964844e+02, 2.831499938964844e+02, 2.831499938964844e+02, 2.831499938964844e+02, 2.831499938964844e+02, 2.831499938964844e+02, 2.831499938964844e+02, 2.831499938964844e+02, 2.831499938964844e+02, 2.831499938964844e+02, 2.831499938964844e+02, 2.831499938964844e+02, 2.831499938964844e+02, 2.881499938964844e+02, 2.881499938964844e+02, 2.881499938964844e+02, 2.881499938964844e+02, 2.881499938964844e+02, 2.881499938964844e+02, 2.881499938964844e+02, 2.881499938964844e+02, 2.881499938964844e+02, 2.881499938964844e+02, 2.881499938964844e+02, 2.881499938964844e+02, 2.881499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 3.031499938964844e+02, 3.031499938964844e+02, 3.031499938964844e+02, 3.031499938964844e+02, 3.031499938964844e+02, 3.031499938964844e+02, 3.031499938964844e+02, 3.031499938964844e+02, 3.031499938964844e+02, 3.031499938964844e+02, 3.031499938964844e+02, 3.031499938964844e+02, 3.081499938964844e+02, 3.081499938964844e+02, 3.081499938964844e+02, 3.081499938964844e+02, 3.081499938964844e+02, 3.081499938964844e+02, 3.081499938964844e+02, 3.081499938964844e+02, 3.081499938964844e+02, 3.081499938964844e+02, 3.081499938964844e+02, 3.081499938964844e+02, 3.081499938964844e+02]
+doo.port_a1.p=[1.01325e+05, 1.01325e+05]
+doo.port_a2.p=[1.01325e+05, 1.01325e+05]
diff --git a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_ThreeRoomsContam.txt b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_ThreeRoomsContam.txt
index f99ef671db..3b58c91013 100644
--- a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_ThreeRoomsContam.txt
+++ b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_ThreeRoomsContam.txt
@@ -1,24 +1,24 @@
-last-generated=2018-06-06
+last-generated=2021-01-25
statistics-simulation=
{
"linear": " ",
"nonlinear": " ",
- "number of continuous time states": "18",
+ "number of continuous time states": "16",
"numerical Jacobians": "0"
}
-oriWesTop.port_a.m_flow=[5.950168892741203e-02, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03]
-dooOpeClo.mBA_flow=[6.595544815063477e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01]
-oriOutBot.port_a.m_flow=[-7.940255105495453e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03]
-dooOpeClo.mAB_flow=[2.039858996868134e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01]
-oriOutTop.port_a.m_flow=[7.940255105495453e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03]
time=[0e+00, 3.6e+03]
-oriEasTop.port_a.m_flow=[-5.975272879004478e-02, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03]
+oriWesTop.port_a.m_flow=[5.950168892741203e-02, -3.868332132697105e-03, -3.868332132697105e-03, -3.868332365527749e-03, -3.868332365527749e-03, -3.868332365527749e-03, -3.868332365527749e-03, -3.868332365527749e-03, -3.868332365527749e-03, -3.868332365527749e-03, -3.868332365527749e-03, -3.868332365527749e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03]
+oriEasTop.port_a.m_flow=[-5.975272879004478e-02, -3.868332365527749e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03, -3.868332598358393e-03]
+oriOutTop.port_a.m_flow=[7.940255105495453e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03]
+oriOutBot.port_a.m_flow=[-7.940255105495453e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03]
+dooOpeClo.port_a1.m_flow=[4.163791835308075e-01, 4.144438803195953e-01, 4.144441187381744e-01, 4.144443869590759e-01, 4.144445955753326e-01, 4.14444625377655e-01, 4.14444625377655e-01, 4.14444625377655e-01, 4.144446551799774e-01, 4.144446551799774e-01, 4.144446849822998e-01, 4.144446849822998e-01, 4.144446849822998e-01, 4.144447147846222e-01, 4.144447147846222e-01, 4.144447445869446e-01, 4.144447445869446e-01, 4.144447445869446e-01, 4.14444774389267e-01, 4.14444774389267e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448041915894e-01, 4.144448339939117e-01]
+dooOpeClo.port_a2.m_flow=[4.163791835308075e-01, 4.183141589164734e-01, 4.183138906955719e-01, 4.183136224746704e-01, 4.183134138584137e-01, 4.183134138584137e-01, 4.183133840560913e-01, 4.183133840560913e-01, 4.183133542537689e-01, 4.183133542537689e-01, 4.183133542537689e-01, 4.183133244514465e-01, 4.183133244514465e-01, 4.183132946491241e-01, 4.183132946491241e-01, 4.183132946491241e-01, 4.183132648468018e-01, 4.183132648468018e-01, 4.183132350444794e-01, 4.183132350444794e-01, 4.183132350444794e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01, 4.18313205242157e-01]
volWes.T=[2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02]
volEas.T=[2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02]
-volOut.T=[2.831499938964844e+02, 2.831499938964844e+02]
volTop.T=[2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02]
-dooOpeClo.dpAB[1]=[-2.735938131809235e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01]
-oriOutBot.dp=[-6.217717528343201e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01]
-oriWesTop.dp=[3.491568756103516e+01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01]
-oriEasTop.dp=[-3.521093368530273e+01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01]
+volOut.T=[2.831499938964844e+02, 2.831499938964844e+02]
+oriWesTop.dp=[3.491568756103516e+01, -1.475739032030106e-01, -1.475739032030106e-01, -1.475739181041718e-01, -1.475739181041718e-01, -1.475739181041718e-01, -1.475739181041718e-01, -1.475739181041718e-01, -1.475739181041718e-01, -1.475739181041718e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01]
+oriEasTop.dp=[-3.521093368530273e+01, -1.475739181041718e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739479064941e-01, -1.475739479064941e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01, -1.475739330053329e-01]
oriOutTop.dp=[6.217717528343201e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01]
+oriOutBot.dp=[-6.217717528343201e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01]
+dooOpeClo.dp1=[0e+00, -9.706254058983177e-05, -9.704944386612624e-05, -9.70362889347598e-05, -9.702557872515172e-05, -9.702499664854258e-05, -9.702444367576391e-05, -9.702384704723954e-05, -9.702325041871518e-05, -9.702265379019082e-05, -9.702208626549691e-05, -9.702148963697255e-05, -9.702090756036341e-05, -9.702031093183905e-05, -9.701972885522991e-05, -9.701914677862078e-05, -9.701855015009642e-05, -9.701795352157205e-05, -9.701738599687815e-05, -9.701678936835378e-05, -9.701619273982942e-05, -9.701574163045734e-05, -9.701574163045734e-05, -9.701571252662688e-05, -9.701569797471166e-05, -9.701569797471166e-05, -9.701568342279643e-05, -9.701565431896597e-05, -9.701565431896597e-05, -9.701563976705074e-05, -9.701562521513551e-05, -9.701562521513551e-05, -9.701559611130506e-05, -9.701558155938983e-05, -9.70155670074746e-05, -9.70155670074746e-05, -9.701553790364414e-05, -9.701552335172892e-05, -9.701552335172892e-05, -9.701550879981369e-05, -9.701549424789846e-05, -9.701549424789846e-05, -9.7015465144068e-05, -9.701545059215277e-05, -9.701545059215277e-05, -9.701543604023755e-05, -9.701540693640709e-05, -9.701540693640709e-05, -9.701539238449186e-05, -9.701537783257663e-05, -9.701537783257663e-05, -9.701534872874618e-05, -9.701533417683095e-05, -9.701533417683095e-05, -9.701531962491572e-05, -9.701529052108526e-05, -9.701529052108526e-05, -9.701527596917003e-05, -9.701526141725481e-05, -9.701526141725481e-05, -9.701523231342435e-05, -9.701521776150912e-05, -9.701521776150912e-05, -9.701520320959389e-05, -9.701517410576344e-05, -9.701517410576344e-05, -9.701515955384821e-05, -9.701514500193298e-05, -9.701514500193298e-05, -9.701511589810252e-05, -9.701510134618729e-05, -9.701510134618729e-05, -9.701508679427207e-05, -9.701505769044161e-05, -9.701504313852638e-05, -9.701504313852638e-05, -9.701502858661115e-05, -9.701501403469592e-05, -9.701501403469592e-05, -9.701498493086547e-05, -9.701497037895024e-05, -9.701497037895024e-05, -9.701495582703501e-05, -9.701492672320455e-05, -9.701492672320455e-05, -9.701491217128932e-05, -9.70148976193741e-05, -9.70148976193741e-05, -9.701486851554364e-05, -9.701485396362841e-05, -9.701485396362841e-05, -9.701483941171318e-05, -9.701481030788273e-05, -9.701481030788273e-05, -9.70147957559675e-05, -9.701478120405227e-05, -9.701478120405227e-05, -9.701475210022181e-05, -9.701473754830658e-05, -9.701473754830658e-05, -9.701472299639136e-05]
diff --git a/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_ThreeRoomsContamDiscretizedDoor.txt b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_ThreeRoomsContamDiscretizedDoor.txt
new file mode 100644
index 0000000000..e258ef3789
--- /dev/null
+++ b/IBPSA/Resources/ReferenceResults/Dymola/IBPSA_Airflow_Multizone_Validation_ThreeRoomsContamDiscretizedDoor.txt
@@ -0,0 +1,24 @@
+last-generated=2018-06-06
+statistics-simulation=
+{
+ "linear": " ",
+ "nonlinear": " ",
+ "number of continuous time states": "18",
+ "numerical Jacobians": "0"
+}
+oriWesTop.port_a.m_flow=[5.950168892741203e-02, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03]
+dooOpeClo.port_a2.m_flow=[6.595544815063477e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01, 4.127706587314606e-01]
+oriOutBot.port_a.m_flow=[-7.940255105495453e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03, -7.940256036818027e-03]
+dooOpeClo.port_a1.m_flow=[2.039858996868134e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01, 4.084133207798004e-01]
+oriOutTop.port_a.m_flow=[7.940255105495453e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03, 7.940256036818027e-03]
+time=[0e+00, 3.6e+03]
+oriEasTop.port_a.m_flow=[-5.975272879004478e-02, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03, -4.357359372079372e-03]
+volWes.T=[2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02, 2.981499938964844e+02]
+volEas.T=[2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02]
+volOut.T=[2.831499938964844e+02, 2.831499938964844e+02]
+volTop.T=[2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02, 2.931499938964844e+02]
+dooOpeClo.dpAB[1]=[-2.735938131809235e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01, -1.943236440420151e-01]
+oriOutBot.dp=[-6.217717528343201e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01, -6.217718720436096e-01]
+oriWesTop.dp=[3.491568756103516e+01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01]
+oriEasTop.dp=[-3.521093368530273e+01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01, -1.872443854808807e-01]
+oriOutTop.dp=[6.217717528343201e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01, 6.217718720436096e-01]
diff --git a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Examples/OneOpenDoor.mos b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Examples/OneOpenDoor.mos
index e2538260a1..997354e77d 100644
--- a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Examples/OneOpenDoor.mos
+++ b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Examples/OneOpenDoor.mos
@@ -10,7 +10,7 @@ createPlot(id = 4,
color = true,
filename = "OneOpenDoor.mat");
createPlot(id = 5,
- y = {"dooOpe.mAB_flow", "dooOpe.mBA_flow", "dooOpeClo.mAB_flow", "dooOpeClo.mBA_flow"},
+ y = {"dooOpe.port_a1.m_flow", "dooOpe.port_a2.m_flow", "dooOpeClo.port_a1.m_flow", "dooOpeClo.port_a2.m_flow"},
autoscale = true,
autoerase = true,
autoreplot = true,
diff --git a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Examples/ReverseBuoyancy.mos b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Examples/ReverseBuoyancy.mos
index 033cb7131b..86eef8ba19 100644
--- a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Examples/ReverseBuoyancy.mos
+++ b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Examples/ReverseBuoyancy.mos
@@ -1,7 +1,7 @@
simulateModel("IBPSA.Airflow.Multizone.Examples.ReverseBuoyancy", stopTime=3600, method="CVode", tolerance=1e-06, resultFile="ReverseBuoyancy");
createPlot(id = 1,
position = {35, 30, 825, 625},
- y = {"oriWesTop.port_a.m_flow", "oriEasTop.port_a.m_flow", "oriOutTop.port_a.m_flow","oriOutBot.port_a.m_flow", "dooOpeClo.mAB_flow", "dooOpeClo.mBA_flow"},
+ y = {"oriWesTop.port_a.m_flow", "oriEasTop.port_a.m_flow", "oriOutTop.port_a.m_flow","oriOutBot.port_a.m_flow", "dooOpeClo.port_a1.m_flow", "dooOpeClo.port_a2.m_flow"},
range = {0, 3600.0, 3.5, (-1.5)},
autoscale = true,
autoerase = true,
diff --git a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Examples/ReverseBuoyancy3Zones.mos b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Examples/ReverseBuoyancy3Zones.mos
index 2070483a04..bbb7917b31 100644
--- a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Examples/ReverseBuoyancy3Zones.mos
+++ b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Examples/ReverseBuoyancy3Zones.mos
@@ -2,7 +2,7 @@ simulateModel("IBPSA.Airflow.Multizone.Examples.ReverseBuoyancy3Zones", stopTime
method="CVode", tolerance=1e-06, resultFile="ReverseBuoyancy3Zones");
createPlot(id = 1,
position = {35, 30, 825, 625},
- y = {"oriWesTop.port_a.m_flow", "oriEasTop.port_a.m_flow", "oriOutTop.port_a.m_flow","oriOutBot.port_a.m_flow", "dooOpeClo.mAB_flow", "dooOpeClo.mBA_flow"},
+ y = {"oriWesTop.port_a.m_flow", "oriEasTop.port_a.m_flow", "oriOutTop.port_a.m_flow","oriOutBot.port_a.m_flow", "dooOpeClo.port_a1.m_flow", "dooOpeClo.port_a2.m_flow"},
range = {0, 3600.0, 3.5, (-1.5)},
autoscale = true,
autoerase = true,
diff --git a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/DoorOpenClosed.mos b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/DoorOpenClosed.mos
new file mode 100644
index 0000000000..9b17169dfc
--- /dev/null
+++ b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/DoorOpenClosed.mos
@@ -0,0 +1,3 @@
+simulateModel("IBPSA.Airflow.Multizone.Validation.DoorOpenClosed", method="CVode", stopTime=1, tolerance=1e-06, resultFile="DoorOpenClosed");
+createPlot(id=1, position={15, 15, 799, 543}, y={"doo.port_a1.m_flow", "doo.port_b2.m_flow", "dooOpeClo.port_a1.m_flow", "dooOpeClo.port_b2.m_flow"}, range={0.0, 1.0, -1.0, 3.0}, grid=true, colors={{28,108,200}, {238,46,47}, {0,140,72}, {217,67,180}});
+createPlot(id=1, position={15, 15, 799, 543}, y={"lea.port_a.m_flow", "mNetClo_flow.y"}, range={0.0, 1.0, -0.005, 0.009999999999999998}, grid=true, subPlot=2, colors={{28,108,200}, {238,46,47}});
diff --git a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorBuoyancyDynamic.mos b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorBuoyancyDynamic.mos
new file mode 100644
index 0000000000..91a0904dd1
--- /dev/null
+++ b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorBuoyancyDynamic.mos
@@ -0,0 +1,4 @@
+simulateModel("IBPSA.Airflow.Multizone.Validation.OpenDoorBuoyancyDynamic", stopTime=14400, method="Cvode", tolerance=1e-08, resultFile="OpenDoorBuoyancyDynamic");
+createPlot(id=1, position={35, 35, 1110, 830}, y={"doo.vAB", "doo.vBA", "dooDis.vAB", "dooDis.vBA"}, range={0.0, 15000.0, -1.0, 2.0}, grid=true, colors={{28,108,200}, {238,46,47}, {0,140,72}, {217,67,180}}, displayUnits={"m/s", "m/s", "m/s", "m/s"});
+createPlot(id=1, position={35, 35, 1110, 830}, y={"bouA.T", "bouB.T"}, range={0.0, 15000.0, 17.0, 23.0}, grid=true, subPlot=2, colors={{28,108,200}, {238,46,47}}, displayUnits={"degC", "degC"});
+createPlot(id=1, position={35, 35, 1110, 830}, y={"doo.port_a1.p", "doo.port_a2.p"}, range={0.0, 15000.0, 1.0132400000000001, 1.0133200000000002}, grid=true, subPlot=3, colors={{28,108,200}, {238,46,47}}, displayUnits={"bar", "bar"});
diff --git a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorBuoyancyPressureDynamic.mos b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorBuoyancyPressureDynamic.mos
new file mode 100644
index 0000000000..16f594bec4
--- /dev/null
+++ b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorBuoyancyPressureDynamic.mos
@@ -0,0 +1,4 @@
+simulateModel("IBPSA.Airflow.Multizone.Validation.OpenDoorBuoyancyPressureDynamic", stopTime=14400, method="Cvode", tolerance=1e-08, resultFile="OpenDoorBuoyancyPressureDynamic");
+createPlot(id=1, position={35, 35, 1110, 830}, y={"doo.vAB", "doo.vBA", "dooDis.vAB", "dooDis.vBA"}, range={0.0, 1500.0, -0.05, 0.15000000000000002}, autoscale=false, grid=true, colors={{28,108,200}, {238,46,47}, {0,140,72}, {217,67,180}}, displayUnits={"m/s", "m/s", "m/s", "m/s"});
+createPlot(id=1, position={35, 35, 1110, 830}, y={"bouA.T", "bouB.T", "bouADis.T", "bouBDis.T"}, range={0.0, 1500.0, 18.0, 22.0}, autoscale=false, grid=true, subPlot=2, colors={{28,108,200}, {238,46,47}, {0,140,72}, {217,67,180}}, displayUnits={"degC", "degC", "degC", "degC"});
+createPlot(id=1, position={35, 35, 1110, 830}, y={"doo.port_a1.p", "doo.port_a2.p"}, range={0.0, 1500.0, 0.9, 1.2000000000000002}, autoscale=false, grid=true, subPlot=3, colors={{28,108,200}, {238,46,47}}, displayUnits={"bar", "bar"});
diff --git a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorPressure.mos b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorPressure.mos
new file mode 100644
index 0000000000..f07707ecba
--- /dev/null
+++ b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorPressure.mos
@@ -0,0 +1,4 @@
+simulateModel("IBPSA.Airflow.Multizone.Validation.OpenDoorPressure", stopTime=28800, method="Cvode", tolerance=1e-06, resultFile="OpenDoorPressure");
+createPlot(id=1, position={35, 35, 1110, 830}, y={"doo.vAB", "doo.vBA", "dooDis.vAB", "dooDis.vBA"}, range={0.0, 15000.0, -1.0, 2.0}, grid=true, colors={{28,108,200}, {238,46,47}, {0,140,72}, {217,67,180}}, displayUnits={"m/s", "m/s", "m/s", "m/s"});
+createPlot(id=1, position={35, 35, 1110, 830}, y={"bouA.T", "bouB.T"}, range={0.0, 15000.0, 17.0, 23.0}, grid=true, subPlot=2, colors={{28,108,200}, {238,46,47}}, displayUnits={"degC", "degC"});
+createPlot(id=1, position={35, 35, 1110, 830}, y={"doo.port_a1.p", "doo.port_a2.p"}, range={0.0, 15000.0, 1.01324, 1.01332}, grid=true, subPlot=3, colors={{28,108,200}, {238,46,47}}, displayUnits={"bar", "bar"});
diff --git a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorTemperature.mos b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorTemperature.mos
new file mode 100644
index 0000000000..311cf86f6c
--- /dev/null
+++ b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/OpenDoorTemperature.mos
@@ -0,0 +1,4 @@
+simulateModel("IBPSA.Airflow.Multizone.Validation.OpenDoorTemperature", stopTime=28800, method="Cvode", tolerance=1e-06, resultFile="OpenDoorTemperature");
+createPlot(id=1, position={35, 35, 1110, 830}, y={"doo.vAB", "doo.vBA", "dooDis.vAB", "dooDis.vBA"}, range={0.0, 15000.0, -1.0, 2.0}, grid=true, colors={{28,108,200}, {238,46,47}, {0,140,72}, {217,67,180}}, displayUnits={"m/s", "m/s", "m/s", "m/s"});
+createPlot(id=1, position={35, 35, 1110, 830}, y={"bouA.T", "bouB.T_in"}, range={0.0, 15000.0, 17.0, 23.0}, grid=true, subPlot=2, colors={{28,108,200}, {238,46,47}}, displayUnits={"degC", "degC"});
+createPlot(id=1, position={35, 35, 1110, 830}, y={"doo.port_a1.p", "doo.port_a2.p"}, range={0.0, 15000.0, 1.01324, 1.01332}, grid=true, subPlot=3, colors={{28,108,200}, {238,46,47}}, displayUnits={"bar", "bar"});
diff --git a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/ThreeRoomsContam.mos b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/ThreeRoomsContam.mos
index 8c6dde0528..5ea8788a24 100644
--- a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/ThreeRoomsContam.mos
+++ b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/ThreeRoomsContam.mos
@@ -1,11 +1,8 @@
-translateModel("IBPSA.Airflow.Multizone.Validation.ThreeRoomsContam");
-simulateModel("IBPSA.Airflow.Multizone.Validation.ThreeRoomsContam", stopTime=3600,
- method="CVode", tolerance=1e-06, resultFile="ThreeRoomsContam");
+simulateModel("IBPSA.Airflow.Multizone.Validation.ThreeRoomsContam", stopTime=3600, method="CVode", tolerance=1e-06, resultFile="ThreeRoomsContam");
createPlot(id = 1,
position = {35, 30, 825, 625},
- y = {"oriWesTop.port_a.m_flow", "oriEasTop.port_a.m_flow", "oriOutTop.port_a.m_flow","oriOutBot.port_a.m_flow", "dooOpeClo.mAB_flow", "dooOpeClo.mBA_flow"},
+ y = {"oriWesTop.port_a.m_flow", "oriEasTop.port_a.m_flow", "oriOutTop.port_a.m_flow","oriOutBot.port_a.m_flow", "dooOpeClo.port_a1.m_flow", "dooOpeClo.port_a2.m_flow"},
range = {0, 3600.0, 3.5, (-1.5)},
- filename = "ThreeRoomsContam.mat",
autoscale = true,
autoerase = true,
autoreplot = true,
@@ -26,7 +23,7 @@ createPlot(id = 2,
bottomTitleType = 1);
createPlot(id = 3,
position = {30, 30, 800, 625},
- y = {"oriWesTop.dp", "oriEasTop.dp", "oriOutTop.dp","oriOutBot.dp", "dooOpeClo.dpAB[1]"},
+ y = {"oriWesTop.dp", "oriEasTop.dp", "oriOutTop.dp","oriOutBot.dp", "dooOpeClo.dp1"},
range = {0, 3600.0, 3.5, (-1.5)},
autoscale = true,
autoerase = true,
diff --git a/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/ThreeRoomsContamDiscretizedDoor.mos b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/ThreeRoomsContamDiscretizedDoor.mos
new file mode 100644
index 0000000000..606cb7ffc9
--- /dev/null
+++ b/IBPSA/Resources/Scripts/Dymola/Airflow/Multizone/Validation/ThreeRoomsContamDiscretizedDoor.mos
@@ -0,0 +1,34 @@
+simulateModel("IBPSA.Airflow.Multizone.Validation.ThreeRoomsContamDiscretizedDoor", stopTime=3600, method="CVode", tolerance=1e-06, resultFile="ThreeRoomsContamDiscretizedDoor");
+createPlot(id = 1,
+ position = {35, 30, 825, 625},
+ y = {"oriWesTop.port_a.m_flow", "oriEasTop.port_a.m_flow", "oriOutTop.port_a.m_flow","oriOutBot.port_a.m_flow", "dooOpeClo.port_a1.m_flow", "dooOpeClo.port_a2.m_flow"},
+ range = {0, 3600.0, 3.5, (-1.5)},
+ autoscale = true,
+ autoerase = true,
+ autoreplot = true,
+ grid = true,
+ color = true,
+ leftTitleType = 1,
+ bottomTitleType = 1);
+createPlot(id = 2,
+ position = {55, 50, 881, 504},
+ y = {"volWes.T", "volEas.T", "volTop.T", "volOut.T"},
+ range = {0, 360000.0, 33.0, 19.0},
+ autoscale = true,
+ autoerase = true,
+ autoreplot = true,
+ grid = true,
+ color = true,
+ leftTitleType = 1,
+ bottomTitleType = 1);
+createPlot(id = 3,
+ position = {30, 30, 800, 625},
+ y = {"oriWesTop.dp", "oriEasTop.dp", "oriOutTop.dp","oriOutBot.dp", "dooOpeClo.dpAB[1]"},
+ range = {0, 3600.0, 3.5, (-1.5)},
+ autoscale = true,
+ autoerase = true,
+ autoreplot = true,
+ grid = true,
+ color = true,
+ leftTitleType = 1,
+ bottomTitleType = 1);
diff --git a/IBPSA/Resources/Scripts/Dymola/Utilities/IO/SignalExchange/Examples/WeatherStation.mos b/IBPSA/Resources/Scripts/Dymola/Utilities/IO/SignalExchange/Examples/WeatherStation.mos
index 80e6093860..508173c79c 100644
--- a/IBPSA/Resources/Scripts/Dymola/Utilities/IO/SignalExchange/Examples/WeatherStation.mos
+++ b/IBPSA/Resources/Scripts/Dymola/Utilities/IO/SignalExchange/Examples/WeatherStation.mos
@@ -1,3 +1,3 @@
simulateModel("IBPSA.Utilities.IO.SignalExchange.Examples.WeatherStation", stopTime=864000, tolerance=1e-6, method="CVode", resultFile="WeatherStation");
createPlot(id=1, position={89, 26, 792, 511}, y={"weaSta.reaWeaTDryBul.y", "weaSta.reaWeaTDewPoi.y", "weaSta.reaWeaTBlaSky.y"}, range={0.0, 10.0, 220.0, 280.0}, grid=true, colors={{28,108,200}, {238,46,47}, {0,140,72}}, timeUnit="d", displayUnits={"K", "K", "K"});
-createPlot(id=1, position={89, 26, 792, 511}, y={"weaSta.reaWeaHGloHor.y", "weaSta.reaWeaHDifHor.y", "weaSta.reaWeaHDirNor.y"}, range={0.0, 10.0, -200.0, 1000.0}, grid=true, subPlot=102, colors={{28,108,200}, {238,46,47}, {0,140,72}}, timeUnit="d", displayUnits={"W/m2", "W/m2", "W/m2"});
+createPlot(id=1, position={89, 26, 792, 511}, y={"weaSta.reaWeaHGloHor.y", "weaSta.reaWeaHDifHor.y", "weaSta.reaWeaHDirNor.y"}, range={0.0, 10.0, -200.0, 1000.0}, grid=true, subPlot=2, colors={{28,108,200}, {238,46,47}, {0,140,72}}, timeUnit="d", displayUnits={"W/m2", "W/m2", "W/m2"});