Comparison Summary

Modelica with alias name: Modelica 3.0.1 Modelica_3_1 with alias name: Modelica 3.1
Version: 3.0.1 Version: 3.1
Version date: $Date:: 2009-01-27 23:19:09 +0100 #$ Version date: 2009-08-14


model Blocks.Examples.PID_Controller

Component
Modelica 3.0.1
Modelica 3.1
PI

Td=0.1
inertia1

J=1



model Blocks.Examples.BusUsage

Component
Modelica 3.0.1
Modelica 3.1
sine

freqHz=1
gain

k=1



block Blocks.Continuous.PID

Component
Modelica 3.0.1
Modelica 3.1
P

k=1



block Blocks.Continuous.LimPID

Component
Modelica 3.0.1
Modelica 3.1
P

k=1



model Electrical.Analog.Examples.HeatingMOSInverter

Component
Modelica 3.0.1
Modelica 3.1
H_PMOS

useHeatPort=true
H_NMOS

useHeatPort=true



model Electrical.Analog.Examples.HeatingNPN_OrGate

Component
Modelica 3.0.1
Modelica 3.1
T1

useHeatPort=true
T2

useHeatPort=true



model Electrical.Analog.Examples.HeatingRectifier

Component
Modelica 3.0.1
Modelica 3.1
HeatingDiode1

useHeatPort=true
SineVoltage1

V=1

freqHz=1
Capacitor1

C=1



model Electrical.Analog.Basic.Resistor

Component
Modelica 3.0.1
Modelica 3.1
T_ref

Present
alpha

Present
R_actual

Present


Equations in Modelica 3.0.1 Equations in Modelica 3.1
R*i = v; assert((1 + alpha*(T_heatPort - T_ref)) >= Modelica_3_1.Constants.eps, "Temperature outside scope of model!");

R_actual = R*(1 + alpha*(T_heatPort - T_ref));
v = R_actual*i;
LossPower = v*i;



model Electrical.Analog.Basic.HeatingResistor

Component
Modelica 3.0.1
Modelica 3.1
T_ref
start=300


=300.15
alpha
start=0


=0
heatPort
Present





Equations in Modelica 3.0.1 Equations in Modelica 3.1
assert(cardinality(heatPort) > 0, "Connector heatPort of HeatingResistor must be connected"); assert((1 + alpha*(T_heatPort - T_ref)) >= Modelica_3_1.Constants.eps, "Temperature outside scope of model!");
R = R_ref*(1 + alpha*(heatPort.T - T_ref)); R = R_ref*(1 + alpha*(T_heatPort - T_ref));
v = R*i;
heatPort.Q_flow = -v*i; LossPower = v*i;



model Electrical.Analog.Basic.Conductor

Component
Modelica 3.0.1
Modelica 3.1
T_ref

Present
alpha

Present
G_actual

Present


Equations in Modelica 3.0.1 Equations in Modelica 3.1
i = G*v; assert((1 + alpha*(T_heatPort - T_ref)) >= Modelica_3_1.Constants.eps, "Temperature outside scope of model!");

G_actual = G/(1 + alpha*(T_heatPort - T_ref));
i = G_actual*v;
LossPower = v*i;



model Electrical.Analog.Basic.SaturatingInductor



Equations in Modelica 3.0.1 Equations in Modelica 3.1
initial equation
(Lnom - Linf) = (Lzer - Linf)*Ipar/Inom*(Modelica.Constants.pi/2-atan(Ipar/Inom)); (Lnom - Linf) = (Lzer - Linf)*Ipar/Inom*(Modelica_3_1.Constants.pi/2-Modelica_3_1.Math.atan(Ipar/Inom));

...
assert(Linf < Lnom-Modelica.Constants.eps,
         "Linf (= " + String(Linf) + ") has to be < Lnom (= " + String(Lnom) + ")");
(Lact - Linf)*i/Ipar = (Lzer - Linf)*noEvent(atan(i/Ipar)); (Lact - Linf)*i/Ipar = (Lzer - Linf)*noEvent(Modelica_3_1.Math.atan(i/Ipar));
Psi = Lact*i;
...



model Electrical.Analog.Basic.M_Transformer

Component
Modelica 3.0.1
Modelica 3.1
L
Real
SIunits.Inductance
v
Real
SIunits.Voltage
i
Real
SIunits.Current
Lm
Real
SIunits.Inductance



model Electrical.Analog.Basic.VariableResistor

Component
Modelica 3.0.1
Modelica 3.1
T_ref

Present
alpha

Present
R_actual

Present


Equations in Modelica 3.0.1 Equations in Modelica 3.1
v = R*i; assert((1 + alpha*(T_heatPort - T_ref)) >= Modelica_3_1.Constants.eps, "Temperature outside scope of model!");

R_actual = R*(1 + alpha*(T_heatPort - T_ref));
v = R_actual*i;
LossPower = v*i;



model Electrical.Analog.Basic.VariableConductor

Component
Modelica 3.0.1
Modelica 3.1
T_ref

Present
alpha

Present
G_actual

Present


Equations in Modelica 3.0.1 Equations in Modelica 3.1
i = G*v; assert((1 + alpha*(T_heatPort - T_ref)) >= Modelica_3_1.Constants.eps, "Temperature outside scope of model!");

G_actual = G/(1 + alpha*(T_heatPort - T_ref));
i = G_actual*v;
LossPower = v*i;



model Electrical.Analog.Ideal.IdealThyristor



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
i = (s*unitVoltage)*(if off then Goff else 1) + Goff*Vknee;

LossPower = v*i;



model Electrical.Analog.Ideal.IdealGTOThyristor



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
i = (s*unitVoltage)*(if off then Goff else 1) + Goff*Vknee;

LossPower = v*i;



model Electrical.Analog.Ideal.IdealCommutingSwitch



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
n2.i = -(s2*unitVoltage)*(if (control) then 1 else Goff);

LossPower = p.i * p.v + n1.i *n1.v + n2.i * n2.v;



model Electrical.Analog.Ideal.IdealIntermediateSwitch



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
n2.i = if control then -s2*unitVoltage*Goff - s3*unitCurrent else -s2*unitCurrent - s3*unitVoltage*Goff;

LossPower = p1.i * p1.v + p2.i * p2.v + n1.i *n1.v + n2.i * n2.v;



model Electrical.Analog.Ideal.ControlledIdealCommutingSwitch



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
n2.i = -(s2*unitVoltage)*(if (control.v > level) then 1 else Goff);

LossPower = p.i * p.v + n1.i *n1.v + n2.i * n2.v;



model Electrical.Analog.Ideal.ControlledIdealIntermediateSwitch



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
n2.i = if control.v > level then -s2*unitVoltage*Goff - s3*unitCurrent else -s2*unitCurrent - s3*unitVoltage*Goff;

LossPower = p1.i * p1.v + p2.i * p2.v + n1.i *n1.v + n2.i * n2.v;



model Electrical.Analog.Ideal.IdealDiode



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
i = (s*unitVoltage)*(if off then Goff else 1) + Goff*Vknee;

LossPower = v*i;



model Electrical.Analog.Ideal.IdealTransformer

Component
Modelica 3.0.1
Modelica 3.1
considerMagnetization

Present
Lm1

Present
im1

Present
psim1

Present


Equations in Modelica 3.0.1 Equations in Modelica 3.1
v1 = n*v2; im1 = i1 + i2/n;
i2 = -n*i1; if considerMagnetization then

psim1 = Lm1*im1;
v1 = der(psim1);
else
psim1= 0;
im1 = 0;
end if;
v1 = n*v2;



model Electrical.Analog.Ideal.IdealOpeningSwitch



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
i = (s*unitVoltage)*(if control then Goff else 1);

LossPower = v*i;



model Electrical.Analog.Ideal.IdealClosingSwitch



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
i = (s*unitVoltage)*(if control then 1 else Goff);

LossPower = v*i;



model Electrical.Analog.Ideal.ControlledIdealOpeningSwitch



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
p.i = (s*unitVoltage)*(if (control.v > level) then Goff else 1);

LossPower = (p.v - n.v)*p.i;



model Electrical.Analog.Ideal.ControlledIdealClosingSwitch



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
p.i = (s*unitVoltage)*(if (control.v > level) then 1 else Goff);

LossPower = (p.v - n.v)*p.i;



model Electrical.Analog.Semiconductors.Diode



Equations in Modelica 3.0.1 Equations in Modelica 3.1
i = smooth(1,(if (v/Vt > Maxexp) then Ids*(exp(Maxexp)*(1 + v/Vt - Maxexp) - 1) +
    v/R else Ids*(exp(v/Vt) - 1) + v/R));

LossPower = v*i;



model Electrical.Analog.Semiconductors.PMOS



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
B.i = 0;

LossPower = D.i * (D.v - S.v);



model Electrical.Analog.Semiconductors.NMOS



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
B.i = 0;

LossPower = D.i * (D.v - S.v);



model Electrical.Analog.Semiconductors.NPN



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
E.i = -B.i - C.i + Ccs*der(C.v);

LossPower = C.i * C.v + B.i * B.v + E.i * E.v;



model Electrical.Analog.Semiconductors.PNP



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
E.i = -B.i - C.i + Ccs*der(C.v);

LossPower = C.i * C.v + B.i * B.v + E.i * E.v;



model Electrical.Analog.Semiconductors.HeatingDiode

Component
Modelica 3.0.1
Modelica 3.1
heatPort
Present





Equations in Modelica 3.0.1 Equations in Modelica 3.1
assert( heatPort.T > 0,"temperature must be positive"); assert( T_heatPort > 0,"temperature must be positive");
htemp = heatPort.T; htemp = T_heatPort;
vt_t = k*htemp/q;
...
i = Ids*id*pow(htemp/TNOM, XTI/N)*auxp + v/R;
heatPort.Q_flow = -i*v; LossPower = i*v;



model Electrical.Analog.Semiconductors.HeatingNMOS

Component
Modelica 3.0.1
Modelica 3.1
heatPort
Present





Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
assert(W + dW > 0, "Effective width must be positive");
assert( heatPort.T > 0,"temperature must be positive"); assert( T_heatPort > 0,"temperature must be positive");
gds = if (RDS < 1.e-20 and RDS > -1.e-20) then 1.e20 else 1/RDS;
...
id = smooth(0,if (ugst <= 0) then uds*gds else if (ugst > uds) then v*uds*(
    ugst - uds/2) + uds*gds else v*ugst*ugst/2 + uds*gds);
beta_t = Beta*pow((heatPort.T/Tnom), -1.5); beta_t = Beta*pow((T_heatPort/Tnom), -1.5);
vt_t = Vt*(1 + (heatPort.T - Tnom)*kvt); vt_t = Vt*(1 + (T_heatPort - Tnom)*kvt);
k2_t = K2*(1 + (heatPort.T - Tnom)*kk2); k2_t = K2*(1 + (T_heatPort - Tnom)*kk2);
G.i = 0;
...
B.i = 0;
heatPort.Q_flow = -D.i*(D.v - S.v); LossPower = D.i*(D.v - S.v);



model Electrical.Analog.Semiconductors.HeatingPMOS

Component
Modelica 3.0.1
Modelica 3.1
heatPort
Present





Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
assert(W + dW > 0, "Effective width must be positive");
assert( heatPort.T > 0,"temperature must be positive"); assert( T_heatPort > 0,"temperature must be positive");
gds = if (RDS < 1.e-20 and RDS > -1.e-20) then 1.e20 else 1/RDS;
...
id = smooth(0,if (ugst >= 0) then uds*gds else if (ugst < uds) then -v*uds*(
    ugst - uds/2) + uds*gds else -v*ugst*ugst/2 + uds*gds);
beta_t = Beta*pow((heatPort.T/Tnom), -1.5); beta_t = Beta*pow((T_heatPort/Tnom), -1.5);
vt_t = Vt*(1 + (heatPort.T - Tnom)*kvt); vt_t = Vt*(1 + (T_heatPort - Tnom)*kvt);
k2_t = K2*(1 + (heatPort.T - Tnom)*kk2); k2_t = K2*(1 + (T_heatPort - Tnom)*kk2);
G.i = 0;
...
B.i = 0;
heatPort.Q_flow = -D.i*(D.v - S.v); LossPower = D.i*(D.v - S.v);



model Electrical.Analog.Semiconductors.HeatingNPN

Component
Modelica 3.0.1
Modelica 3.1
heatPort
Present





Equations in Modelica 3.0.1 Equations in Modelica 3.1
assert( heatPort.T > 0,"temperature must be positive"); assert( T_heatPort > 0,"temperature must be positive");
ExMin = exp(EMin);
...
qbk = 1 - vbc*Vak;
hexp = (heatPort.T/Tnom - 1)*EG/vt_t; hexp = (T_heatPort/Tnom - 1)*EG/vt_t;
htempexp = smooth(1,if (hexp < EMin) then ExMin*(hexp - EMin + 1) else if (
    hexp > EMax) then ExMax*(hexp - EMax + 1) else exp(hexp));
is_t = Is*pow((heatPort.T/Tnom), XTI)*htempexp; is_t = Is*pow((T_heatPort/Tnom), XTI)*htempexp;
br_t = Br*pow((heatPort.T/Tnom), XTB); br_t = Br*pow((T_heatPort/Tnom), XTB);
bf_t = Bf*pow((heatPort.T/Tnom), XTB); bf_t = Bf*pow((T_heatPort/Tnom), XTB);
vt_t = (K/q)*heatPort.T; vt_t = (K/q)*T_heatPort;
ibc = smooth(1,(if (vbc/(NR*vt_t) < EMin) then is_t*(ExMin*(vbc/(NR*vt_t) -
    EMin + 1) - 1) + vbc*Gbc else if (vbc/(NR*vt_t) > EMax) then is_t*(
    ExMax*(vbc/(NR*vt_t) - EMax + 1) - 1) + vbc*Gbc else is_t*(exp(vbc/
    (NR*vt_t)) - 1) + vbc*Gbc));
...
E.i = -B.i - C.i + Ccs*der(C.v);
heatPort.Q_flow = -(vbc*ibc/br_t + vbe*ibe/bf_t + (ibe - ibc)*qbk*(C.v
- E.v));
LossPower = (vbc*ibc/br_t + vbe*ibe/bf_t + (ibe - ibc)*qbk*(C.v - E.v));



model Electrical.Analog.Semiconductors.HeatingPNP

Component
Modelica 3.0.1
Modelica 3.1
heatPort
Present





Equations in Modelica 3.0.1 Equations in Modelica 3.1
assert( heatPort.T > 0,"temperature must be positive"); assert( T_heatPort > 0,"temperature must be positive");
ExMin = exp(EMin);
...
qbk = 1 - vcb*Vak;
hexp = (heatPort.T/Tnom - 1)*EG/vt_t; hexp = (T_heatPort/Tnom - 1)*EG/vt_t;
htempexp = smooth(1,if (hexp < EMin) then ExMin*(hexp - EMin + 1) else if (
    hexp > EMax) then ExMax*(hexp - EMax + 1) else exp(hexp));
is_t = Is*pow((heatPort.T/Tnom), XTI)*htempexp; is_t = Is*pow((T_heatPort/Tnom), XTI)*htempexp;
br_t = Br*pow((heatPort.T/Tnom), XTB); br_t = Br*pow((T_heatPort/Tnom), XTB);
bf_t = Bf*pow((heatPort.T/Tnom), XTB); bf_t = Bf*pow((T_heatPort/Tnom), XTB);
vt_t = (K/q)*heatPort.T; vt_t = (K/q)*T_heatPort;
icb = smooth(1,(if (vcb/(NR*vt_t) < EMin) then is_t*(ExMin*(vcb/(NR*vt_t) -
    EMin + 1) - 1) + vcb*Gbc else if (vcb/(NR*vt_t) > EMax) then is_t*(
    ExMax*(vcb/(NR*vt_t) - EMax + 1) - 1) + vcb*Gbc else is_t*(exp(vcb/
    (NR*vt_t)) - 1) + vcb*Gbc));
...
E.i = -B.i - C.i + Ccs*der(C.v);
heatPort.Q_flow = -(vcb*icb/br_t + veb*ieb/bf_t + (icb - ieb)*qbk*(E.v
- C.v));
LossPower = (vcb*icb/br_t + veb*ieb/bf_t + (icb - ieb)*qbk*(E.v- C.v));



model Mechanics.MultiBody.Examples.Elementary.PointGravity

Component
Modelica 3.0.1
Modelica 3.1
body1

r_CM={0,0,0}
body2

r_CM={0,0,0}



model Mechanics.MultiBody.Examples.Elementary.SpringDamperSystem

Component
Modelica 3.0.1
Modelica 3.1
body2

r_CM={0,0,0}



model Mechanics.MultiBody.Examples.Elementary.SpringMassSystem

Component
Modelica 3.0.1
Modelica 3.1
body1

r_CM={0,0,0}
body2

r_CM={0,0,0}



model Mechanics.MultiBody.Examples.Elementary.SpringWithMass

Component
Modelica 3.0.1
Modelica 3.1
body

r_CM={0,0,0}

m=1



model Mechanics.MultiBody.Examples.Loops.Engine1a

Component
Modelica 3.0.1
Modelica 3.1
Inertia

J=1



model Mechanics.MultiBody.Examples.Loops.EngineV6

Component
Modelica 3.0.1
Modelica 3.1
load

J=1



model Mechanics.MultiBody.Examples.Loops.EngineV6_analytic

Component
Modelica 3.0.1
Modelica 3.1
load

J=1



model Mechanics.MultiBody.Examples.Loops.PlanarLoops_analytic

Component
Modelica 3.0.1
Modelica 3.1
sine

freqHz=1



model Mechanics.MultiBody.Examples.Rotational3DEffects.ActuatedDrive

Component
Modelica 3.0.1
Modelica 3.1
bodyCylinder

r_CM={0,0,0}
sine

freqHz={1,1,1}



model Mechanics.MultiBody.Examples.Rotational3DEffects.MovingActuatedDrive

Component
Modelica 3.0.1
Modelica 3.1
bodyCylinder

r_CM={0,0,0}
sine1

freqHz={1,1,1}
sine2

freqHz=1



model Mechanics.MultiBody.Examples.Rotational3DEffects.GearConstraint

Component
Modelica 3.0.1
Modelica 3.1
sine

freqHz={1,1,1}



model Mechanics.MultiBody.Examples.Systems.RobotR3.Components.Motor

Component
Modelica 3.0.1
Modelica 3.1
convert1

k=1
convert2

k=1



model Mechanics.MultiBody.Examples.Systems.RobotR3.Components.MechanicalStructure

Component
Modelica 3.0.1
Modelica 3.1
b0

r_CM={0,0,0}

m=1
b1

r_CM={0,0,0}

m=1



model Mechanics.MultiBody.Visualizers.Advanced.Shape

Component
Modelica 3.0.1
Modelica 3.1
shapeType
Present

R
Present

r
Present

r_shape
Present

lengthDirection
Present

widthDirection
Present

length
Present

width
Present

height
Present

extra
Present

color
Present

specularCoefficient
Present

abs_n_x
Present

e_x
Present

n_z_aux
Present

e_y
Present

Form
Present

rxvisobj
Present

ryvisobj
Present

rvisobj
Present

size
Present

Material
Present

Extra
Present



Equations in Modelica 3.0.1 Equations in Modelica 3.1
Form = (987000 + PackShape(shapeType))*1E20;
rxvisobj = transpose(R.T)*e_x;
ryvisobj = transpose(R.T)*e_y;
rvisobj = r + T.resolve1(R.T, r_shape);
size = {length,width,height};
Material = PackMaterial(color[1]/255.0, color[2]/255.0, color[3]/255.0,
    specularCoefficient);
Extra = extra;




model Mechanics.Rotational.Examples.LossyGearDemo1

Component
Modelica 3.0.1
Modelica 3.1
Inertia1

J=1



model Mechanics.Rotational.Examples.LossyGearDemo2

Component
Modelica 3.0.1
Modelica 3.1
Inertia1

J=1



model Mechanics.Rotational.Examples.ElasticBearing

Component
Modelica 3.0.1
Modelica 3.1
shaft

J=1



model Mechanics.Rotational.Components.BearingFriction



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
free = false;
phi = flange_a.phi - internalSupport.phi; phi = flange_a.phi - phi_support;
flange_b.phi = flange_a.phi;
...



model Mechanics.Rotational.Components.Brake



Equations in Modelica 3.0.1 Equations in Modelica 3.1
mue0 = Modelica.Math.tempInterpol1(0, mue_pos, 2);
phi = flange_a.phi - internalSupport.phi; phi = flange_a.phi - phi_support;
flange_b.phi = flange_a.phi;
...



model Mechanics.Rotational.Components.IdealGear



Equations in Modelica 3.0.1 Equations in Modelica 3.1
phi_a = flange_a.phi - internalSupport.phi; phi_a = flange_a.phi - phi_support;
phi_b = flange_b.phi - internalSupport.phi; phi_b = flange_b.phi - phi_support;
phi_a = ratio*phi_b;
...



model Mechanics.Rotational.Components.LossyGear



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
tau_bf2 = noEvent(abs(interpolation_result[1, 4]));
phi_a = flange_a.phi - internalSupport.phi; phi_a = flange_a.phi - phi_support;
phi_b = flange_b.phi - internalSupport.phi; phi_b = flange_b.phi - phi_support;
phi_a = ratio*phi_b;
...



model Mechanics.Rotational.Components.Gearbox



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
connect(elastoBacklash.flange_b, flange_b);
connect(lossyGear.support, internalSupport); connect(lossyGear.support, support);



model Mechanics.Rotational.Sources.Position



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
equation
phi = flange.phi - internalSupport.phi;
equation
phi = flange.phi - phi_support;
if exact then
...



model Mechanics.Rotational.Sources.Speed



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
equation
phi = flange.phi - internalSupport.phi;
equation
phi = flange.phi - phi_support;
w = der(phi);
...



model Mechanics.Rotational.Sources.Accelerate



Equations in Modelica 3.0.1 Equations in Modelica 3.1
phi = flange.phi - internalSupport.phi; phi = flange.phi - phi_support;
w = der(phi);
...



model Mechanics.Rotational.Sources.Move



Equations in Modelica 3.0.1 Equations in Modelica 3.1
phi = flange.phi - internalSupport.phi; phi = flange.phi - phi_support;
phi = position(u,time);



model Mechanics.Rotational.Interfaces.PartialTorque



Equations in Modelica 3.0.1 Equations in Modelica 3.1
phi = flange.phi - internalSupport.phi; phi = flange.phi - phi_support;



model Mechanics.Translational.Components.ElastoGap

Component
Modelica 3.0.1
Modelica 3.1
c
SIunits.TranslationalSpringConstant
Real
d
SIunits.TranslationalDampingConstant
Real
n

Present
contact

Present
f_d2

Present
v_rel

Present


Equations in Modelica 3.0.1 Equations in Modelica 3.1
if s_rel > s_rel0 then contact = s_rel < s_rel0;
f_c = 0; f_c = smooth(1, noEvent( if contact then -c*abs(s_rel - s_rel0)^n else 0));
f_d = 0; f_d2 = if contact then d*v_rel else 0;
f = 0; f_d = smooth(0, noEvent( if contact then (if f_d2 < f_c then f_c else
if f_d2 > -f_c then -f_c else f_d2) else 0));
else f = f_c + f_d;
f_c = c*(s_rel - s_rel0);
f_d = d*v_rel;
f = smooth(0, noEvent(if (f_c + f_d) >= 0 then 0 else f_c + max(f_c, f_d)));
end if;




model Mechanics.Translational.Components.SupportFriction



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
free = false;
s = s_a - internalSupport.s; s = s_a - s_support;
s_a = s_b;
...



model Mechanics.Translational.Interfaces.PartialElementaryTwoFlangesAndSupport

Component
Modelica 3.0.1
Modelica 3.1
s_a
SIunits.Distance
SIunits.Length
s_b
SIunits.Distance
SIunits.Length



function Media.Air.MoistAir.specificHeatCapacityCp

Component
Modelica 3.0.1
Modelica 3.1
dT

Present


Equations in Modelica 3.0.1 Equations in Modelica 3.1
algorithm
cp:= SingleGasNasa.cp_Tlow(dryair, state.T)*(1-state.X[Water])
+ SingleGasNasa.cp_Tlow(steam, state.T)*state.X[Water];
cp := h_pTX_der(state.p,state.T,state.X, 0.0, 1.0, zeros(size(state.X,1)))*dT
"Definition of cp: dh/dT @ constant p";



package Media.IdealGases.Common.MixtureGasNasa

Component
Modelica 3.0.1
Modelica 3.1
referenceChoice
=Choices.ReferenceEnthalpy.ZeroAt0K
=ReferenceEnthalpy.ZeroAt0K



model StateGraph.Examples.FirstExample

Component
Modelica 3.0.1
Modelica 3.1
stateGraphRoot

Present





model StateGraph.Examples.FirstExample_Variant2

Component
Modelica 3.0.1
Modelica 3.1
stateGraphRoot

Present





model StateGraph.Examples.FirstExample_Variant3

Component
Modelica 3.0.1
Modelica 3.1
stateGraphRoot

Present





model StateGraph.Examples.ExecutionPaths

Component
Modelica 3.0.1
Modelica 3.1
stateGraphRoot

Present





model StateGraph.Examples.ShowCompositeStep

Component
Modelica 3.0.1
Modelica 3.1
stateGraphRoot

Present





model StateGraph.Examples.ShowExceptions

Component
Modelica 3.0.1
Modelica 3.1
stateGraphRoot

Present





model StateGraph.Examples.ControlledTanks

Component
Modelica 3.0.1
Modelica 3.1
stateGraphRoot

Present





connector StateGraph.Interfaces.CompositeStepStatePort_in

Component
Modelica 3.0.1
Modelica 3.1
activeSteps
output

activeStepsDummy

Present



connector StateGraph.Interfaces.CompositeStepStatePort_out

Component
Modelica 3.0.1
Modelica 3.1
activeSteps
input

activeStepsDummy

Present



block StateGraph.Interfaces.PartialStep

Component
Modelica 3.0.1
Modelica 3.1
subgraphStatePort
Present

outerStatePort

Present


Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
equation
connect(subgraphStatePort, stateGraphRoot.subgraphStatePort);
equation
connect(outerStatePort.subgraphStatePort, stateGraphRoot.subgraphStatePort);
for i in 1:nIn loop
...
localActive = pre(newActive);
newActive = if subgraphStatePort.resume then
oldActive else
( StateGraph.Temporary.anyTrue(inPort.set) or
localActive
and not StateGraph.Temporary.anyTrue(outPort.reset))
and not subgraphStatePort.suspend;
newActive = if outerStatePort.subgraphStatePort.resume then
oldActive else
( StateGraph.Temporary.anyTrue(inPort.set) or
localActive
and not StateGraph.Temporary.anyTrue(outPort.reset))
and not outerStatePort.subgraphStatePort.suspend;
when subgraphStatePort.suspend then when outerStatePort.subgraphStatePort.suspend then
oldActive = localActive;
end when;
subgraphStatePort.activeSteps = if localActive then 1.0 else 0.0; outerStatePort.subgraphStatePort.activeSteps = if localActive then 1.0 else 0.0;
for i in 1:nIn loop
...



package Utilities.Internal

Component
Modelica 3.0.1
Modelica 3.1
package
protected




function Utilities.Examples.expression

Component
Modelica 3.0.1
Modelica 3.1
operator
Present

opString

Present


Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
while scanning loop
(operator, nextIndex) = Strings.scanDelimiter(
string, nextIndex, {"+","-",""}, message);
(opString, nextIndex) = Strings.scanDelimiter(
string, nextIndex, {"+","-",""}, message);
if operator == "" then if opString == "" then
scanning = false;
...
(result2, nextIndex) = term(string, nextIndex, message);
result = if operator == "+" then result+result2 else result-result2; result = if opString == "+" then result+result2 else result-result2;
end if;
...



function Utilities.Files.list



Equations in Modelica 3.0.1 Equations in Modelica 3.1
algorithm
fileType := Internal.stat(name); fileType := Modelica_3_1.Utilities.Internal.FileSystem.stat(
name);
if fileType == Types.FileType.RegularFile then
...
elseif fileType == Types.FileType.Directory then
listDirectory(name, Internal.getNumberOfFiles(name)); listDirectory(name, Modelica_3_1.Utilities.Internal.FileSystem.getNumberOfFiles(
name));
elseif fileType == Types.FileType.SpecialFile then
...



function Utilities.Files.copy

Component
Modelica 3.0.1
Modelica 3.1
oldFileType
=Internal.stat(oldName2)
=Modelica_3_1.Utilities.Internal.FileSystem.stat(oldName2)


Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
elseif oldFileType == Types.FileType.Directory then
newFileType = Internal.stat(newName2); newFileType = Modelica_3_1.Utilities.Internal.FileSystem.stat(
newName2);
if newFileType == Types.FileType.NoFile then
...
end if;
Internal.copyFile(oldName2, newName2); Modelica_3_1.Utilities.Internal.FileSystem.copyFile(
oldName2, newName2);
end if;
...



function Utilities.Files.move



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
if Strings.find(oldName,"/") == 0 and Strings.find(newName,"/") == 0 then
Internal.rename(oldName, newName); Modelica_3_1.Utilities.Internal.FileSystem.rename(
oldName, newName);
else
...



function Utilities.Files.remove

Component
Modelica 3.0.1
Modelica 3.1
fileType
=Internal.stat(fullName)
=Modelica_3_1.Utilities.Internal.FileSystem.stat(fullName)


Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
if fileType == Types.FileType.RegularFile or
     fileType == Types.FileType.SpecialFile then
Internal.removeFile(fullName); Modelica_3_1.Utilities.Internal.FileSystem.removeFile(
fullName);
elseif fileType == Types.FileType.Directory then
...



function Utilities.Files.removeFile

Component
Modelica 3.0.1
Modelica 3.1
fileType
=Internal.stat(fileName)
=Modelica_3_1.Utilities.Internal.FileSystem.stat(fileName)


Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
if fileType == Types.FileType.RegularFile then
Internal.removeFile(fileName); Modelica_3_1.Utilities.Internal.FileSystem.removeFile(
fileName);
elseif fileType == Types.FileType.Directory then
...



function Utilities.Files.createDirectory



Equations in Modelica 3.0.1 Equations in Modelica 3.1

...
while not finished loop
Internal.mkdir(Strings.substring(fullName,1,index)); Modelica_3_1.Utilities.Internal.FileSystem.mkdir(
Strings.substring(fullName,1,index));
if index >= lastIndex then
...



function Utilities.Files.exist



Equations in Modelica 3.0.1 Equations in Modelica 3.1
algorithm
result := Internal.stat(name) > Types.FileType.NoFile; result := Modelica_3_1.Utilities.Internal.FileSystem.stat(
name) > Types.FileType.NoFile;



function Utilities.Files.assertNew

Component
Modelica 3.0.1
Modelica 3.1
fileType
=Internal.stat(name)
=Modelica_3_1.Utilities.Internal.FileSystem.stat(name)












Class Modelica 3.0.1Modelica 3.1
Modelica.StateGraph.Interfaces.CompositeStepState block model
Modelica.StateGraph.PartialCompositeStep block model
Modelica.StateGraph.StateGraphRoot block model
function Modelica.Media.Interfaces.PartialMixtureMedium.setSmoothState Present
function Modelica.Utilities.Internal.mkdir Present
function Modelica.Utilities.Internal.rmdir Present
function Modelica.Utilities.Internal.stat Present
function Modelica.Utilities.Internal.rename Present
function Modelica.Utilities.Internal.removeFile Present
function Modelica.Utilities.Internal.copyFile Present
function Modelica.Utilities.Internal.readDirectory Present
function Modelica.Utilities.Internal.getNumberOfFiles Present
class Modelica_3_1.UsersGuide.ReleaseNotes.VersionManagement
Present
class Modelica_3_1.UsersGuide.ReleaseNotes.Version_3_1
Present
block Modelica_3_1.Blocks.Math.RectangularToPolar
Present
block Modelica_3_1.Blocks.Math.PolarToRectangular
Present
block Modelica_3_1.Blocks.Routing.Replicator
Present
model Modelica_3_1.Electrical.Analog.Examples.HeatingResistor
Present
model Modelica_3_1.Electrical.Analog.Examples.OvervoltageProtection
Present
model Modelica_3_1.Electrical.Analog.Examples.SwitchWithArc
Present
model Modelica_3_1.Electrical.Analog.Examples.ThyristorBehaviourTest
Present
model Modelica_3_1.Electrical.Analog.Examples.AmplifierWithOpAmpDetailed
Present
model Modelica_3_1.Electrical.Analog.Examples.CompareTransformers
Present
model Modelica_3_1.Electrical.Analog.Examples.ControlledSwitchWithArc
Present
model Modelica_3_1.Electrical.Analog.Basic.TranslationalEMF
Present
model Modelica_3_1.Electrical.Analog.Basic.OpAmpDetailed
Present
model Modelica_3_1.Electrical.Analog.Ideal.OpenerWithArc
Present
model Modelica_3_1.Electrical.Analog.Ideal.CloserWithArc
Present
model Modelica_3_1.Electrical.Analog.Ideal.ControlledOpenerWithArc
Present
model Modelica_3_1.Electrical.Analog.Ideal.ControlledCloserWithArc
Present
model Modelica_3_1.Electrical.Analog.Interfaces.ConditionalHeatPort
Present
model Modelica_3_1.Electrical.Analog.Semiconductors.ZDiode
Present
model Modelica_3_1.Electrical.Analog.Semiconductors.Thyristor
Present
model Modelica_3_1.Icons.ObsoleteModel
Present
model Modelica_3_1.Mechanics.MultiBody.Examples.Elementary.RollingWheel
Present
model Modelica_3_1.Mechanics.MultiBody.Examples.Elementary.RollingWheelSetDriving
Present
model Modelica_3_1.Mechanics.MultiBody.Examples.Elementary.RollingWheelSetPulling
Present
model Modelica_3_1.Mechanics.MultiBody.Joints.Internal.RollingConstraintVerticalWheel
Present
model Modelica_3_1.Mechanics.MultiBody.Joints.RollingWheel
Present
model Modelica_3_1.Mechanics.MultiBody.Joints.RollingWheelSet
Present
model Modelica_3_1.Mechanics.MultiBody.Parts.RollingWheel
Present
model Modelica_3_1.Mechanics.MultiBody.Parts.RollingWheelSet
Present
model Modelica_3_1.Mechanics.MultiBody.Visualizers.Ground
Present
model Modelica_3_1.Mechanics.Rotational.Interfaces.PartialElementaryOneFlangeAndSupport2
Present
model Modelica_3_1.Mechanics.Rotational.Interfaces.PartialElementaryTwoFlangesAndSupport2
Present
model Modelica_3_1.Mechanics.Translational.Interfaces.PartialElementaryOneFlangeAndSupport2
Present
model Modelica_3_1.Mechanics.Translational.Interfaces.PartialElementaryTwoFlangesAndSupport2
Present
function Modelica_3_1.Media.Air.MoistAir.setSmoothState
Present
function Modelica_3_1.Media.IdealGases.Common.MixtureGasNasa.setSmoothState
Present
function Modelica_3_1.SIunits.Conversions.from_Hz
Present
function Modelica_3_1.SIunits.Conversions.to_Hz
Present
type Modelica_3_1.SIunits.ElectricalForceConstant
Present
package Modelica_3_1.Utilities.Internal.PartialModelicaServices
Present
package Modelica_3_1.Utilities.Internal.FileSystem
Present
package Modelica_3_1.Magnetic
Present
package Modelica_3_1.Fluid
Present