Modelica.Electrical.Machines.Utilities

Library with auxiliary models for testing

Information


This package contains utility components for testing examples.

Extends from Modelica.Icons.Package (Icon for standard packages).

Package Content

NameDescription
Modelica.Electrical.Machines.Utilities.VfController VfController Voltage-Frequency-Controller
Modelica.Electrical.Machines.Utilities.CurrentController CurrentController Current controller
Modelica.Electrical.Machines.Utilities.SwitchYD SwitchYD Y-D-switch
Modelica.Electrical.Machines.Utilities.TerminalBox TerminalBox Terminal box Y/D-connection
Modelica.Electrical.Machines.Utilities.SwitchedRheostat SwitchedRheostat Rheostat which is shortened after a given time
Modelica.Electrical.Machines.Utilities.RampedRheostat RampedRheostat Rheostat with linearly decreasing resistance
Modelica.Electrical.Machines.Utilities.TransformerData TransformerData Calculates Impedances from nominal values
Modelica.Electrical.Machines.Utilities.SynchronousMachineData SynchronousMachineData Computes machine parameter from usual datasheet


Modelica.Electrical.Machines.Utilities.VfController Modelica.Electrical.Machines.Utilities.VfController

Voltage-Frequency-Controller

Modelica.Electrical.Machines.Utilities.VfController

Information


Simple Voltage-Frequency-Controller.
Amplitude of voltage is linear dependent (VNominal/fNominal) on frequency (input signal "u"), but limited by VNominal (nominal RMS voltage per phase).
m sine-waves with amplitudes as described above are provided as output signal "y".
The sine-waves are intended to feed a m-phase SignalVoltage.
Phase shifts between sine-waves may be choosen by the user; default values are (k-1)/m*pi for k in 1:m.

Extends from Modelica.Blocks.Interfaces.SIMO (Single Input Multiple Output continuous control block).

Parameters

TypeNameDefaultDescription
IntegernoutmNumber of outputs
Integerm3Number of phases
VoltageVNominal Nominal RMS voltage per phase [V]
FrequencyfNominal Nominal frequency [Hz]
AngleBasePhase0Common phase shift [rad]

Connectors

TypeNameDescription
input RealInputuConnector of Real input signal
output RealOutputy[nout]Connector of Real output signals

Modelica definition

block VfController "Voltage-Frequency-Controller"
  extends Modelica.Blocks.Interfaces.SIMO(final nout=m);
  constant Modelica.SIunits.Angle pi=Modelica.Constants.pi;
  parameter Integer m=3 "Number of phases";
  parameter Modelica.SIunits.Voltage VNominal "Nominal RMS voltage per phase";
  parameter Modelica.SIunits.Frequency fNominal "Nominal frequency";
  parameter Modelica.SIunits.Angle BasePhase=0 "Common phase shift";
  output Modelica.SIunits.Angle x(start=0, fixed=true) "Integrator state";
  output Modelica.SIunits.Voltage amplitude;
equation 
//amplitude = sqrt(2)*VNominal*min(abs(u)/fNominal, 1);
  amplitude = sqrt(2)*VNominal*(if abs(u)<fNominal then abs(u)/fNominal else 1);
  der(x) = 2*pi*u;
  y = {amplitude*sin(x + BasePhase - (k - 1)*2/m*pi) for k in 1:m};
end VfController;

Modelica.Electrical.Machines.Utilities.CurrentController Modelica.Electrical.Machines.Utilities.CurrentController

Current controller

Modelica.Electrical.Machines.Utilities.CurrentController

Information


Simple Current-Controller.
The desired rms values of d- and q-component of the space phasor in rotor fixed coordinate system are given by inputs "id_rms" and "iq_rms". Using the given rotor position (input "phi"), the correct threephase currents (output "i[3]")are calculated. They can be used to feed a current source which in turn feeds an induction machine.

Extends from Modelica.Blocks.Interfaces.MO (Multiple Output continuous control block).

Parameters

TypeNameDefaultDescription
Integerp Number of poles pairs
IntegernoutmNumber of outputs

Connectors

TypeNameDescription
output RealOutputy[nout]Connector of Real output signals
input RealInputid_rms 
input RealInputiq_rms 
input RealInputphi 

Modelica definition

model CurrentController "Current controller"
  constant Integer m=3 "Number of phases";
  parameter Integer p "Number of poles pairs";
  extends Modelica.Blocks.Interfaces.MO(final nout=m);
  Modelica.Blocks.Interfaces.RealInput id_rms;
  Modelica.Blocks.Interfaces.RealInput iq_rms;
  Modelica.Blocks.Interfaces.RealInput phi;
  Modelica.Blocks.Math.Gain toPeak_d(k=sqrt(2));
  Modelica.Blocks.Math.Gain toPeak_q(k=sqrt(2));
  Modelica.Blocks.Math.Gain toGamma(k=-p);
  Modelica.Electrical.Machines.SpacePhasors.Blocks.Rotator rotator;
  Modelica.Blocks.Sources.Constant i0(k=0);
  Modelica.Electrical.Machines.SpacePhasors.Blocks.FromSpacePhasor fromSpacePhasor;
equation 
  connect(iq_rms, toPeak_q.u);
  connect(phi, toGamma.u);
  connect(rotator.angle, toGamma.y);
  connect(rotator.y, fromSpacePhasor.u);
  connect(toPeak_d.u, id_rms);
  connect(toPeak_d.y, rotator.u[1]);
  connect(toPeak_q.y, rotator.u[2]);
  connect(i0.y, fromSpacePhasor.zero);
  connect(fromSpacePhasor.y, y);
end CurrentController;

Modelica.Electrical.Machines.Utilities.SwitchYD Modelica.Electrical.Machines.Utilities.SwitchYD

Y-D-switch

Modelica.Electrical.Machines.Utilities.SwitchYD

Information


Simple Star-Delta-switch.
If control is false, plug_sp and plug_sn are star connected and plug_sp connected to the supply plug.
If control is true, plug_sp and plug_sn are delta connected and they are connected to the supply plug.

Parameters

TypeNameDefaultDescription
Integerm3Number of phases

Connectors

TypeNameDescription
PositivePlugplugSupplyTo grid
PositivePlugplug_spTo positive stator plug
NegativePlugplug_snTo negative stator plug
input BooleanInputcontrol[m] 

Modelica definition

model SwitchYD "Y-D-switch"
  parameter Integer m=3 "Number of phases";
  Modelica.Electrical.MultiPhase.Interfaces.PositivePlug plugSupply(final m=m) 
    "To grid";
  Modelica.Electrical.MultiPhase.Interfaces.PositivePlug plug_sp(final m=m) 
    "To positive stator plug";
  Modelica.Electrical.MultiPhase.Interfaces.NegativePlug plug_sn(final m=m) 
    "To negative stator plug";
  Modelica.Electrical.MultiPhase.Basic.Star star(final m=m);
  Modelica.Electrical.MultiPhase.Basic.Delta delta(final m=m);
  Modelica.Electrical.MultiPhase.Ideal.IdealCommutingSwitch
    idealCommutingSwitch(                                                        final m=m);
  Modelica.Blocks.Interfaces.BooleanInput control[m];
equation 
  connect(delta.plug_p, plugSupply);
  connect(delta.plug_p, plug_sp);
  connect(idealCommutingSwitch.plug_n2, delta.plug_n);
  connect(idealCommutingSwitch.plug_n1, star.plug_p);
  connect(idealCommutingSwitch.plug_p,plug_sn);
  connect(control, idealCommutingSwitch.control);
end SwitchYD;

Modelica.Electrical.Machines.Utilities.TerminalBox Modelica.Electrical.Machines.Utilities.TerminalBox

Terminal box Y/D-connection

Modelica.Electrical.Machines.Utilities.TerminalBox

Information


TerminalBox: at the bottom connected to both machine plugs, connect at the top to the grid as usual,
choosing Y-connection (StarDelta=Y) or D-connection (StarDelta=D).

Parameters

TypeNameDefaultDescription
Integerm3Number of phases
StringterminalConnection Choose Y=star/D=delta

Connectors

TypeNameDescription
PositivePlugplug_spTo positive stator plug
NegativePlugplug_snTo negative stator plug
PositivePlugplugSupplyTo grid
NegativePinstarpoint 

Modelica definition

model TerminalBox "Terminal box Y/D-connection"
  parameter Integer m=3 "Number of phases";
  parameter String terminalConnection(start="Y") "Choose Y=star/D=delta";
  Modelica.Electrical.MultiPhase.Interfaces.PositivePlug plug_sp(final m=m) 
    "To positive stator plug";
  Modelica.Electrical.MultiPhase.Interfaces.NegativePlug plug_sn(final m=m) 
    "To negative stator plug";
  Modelica.Electrical.MultiPhase.Basic.Star star(final m=m) if (terminalConnection<>"D");
  Modelica.Electrical.MultiPhase.Basic.Delta delta(final m=m) if (terminalConnection=="D");
  Modelica.Electrical.MultiPhase.Interfaces.PositivePlug plugSupply(final m=m) 
    "To grid";
  Modelica.Electrical.Analog.Interfaces.NegativePin starpoint if (terminalConnection<>"D");
equation 
  connect(plug_sn, star.plug_p);
  connect(plug_sn, delta.plug_n);
  connect(delta.plug_p,plug_sp);
  connect(plug_sp, plugSupply);
  connect(star.pin_n, starpoint);
end TerminalBox;

Modelica.Electrical.Machines.Utilities.SwitchedRheostat Modelica.Electrical.Machines.Utilities.SwitchedRheostat

Rheostat which is shortened after a given time

Modelica.Electrical.Machines.Utilities.SwitchedRheostat

Information


Switched rheostat, used for starting asynchronous induction motors with slipring rotor:

The external rotor resistance RStart is shortened at time tStart.

Parameters

TypeNameDefaultDescription
Integerm3Number of phases
ResistanceRStart Starting resistance [Ohm]
TimetStart Duration of switching on the starting resistor [s]

Connectors

TypeNameDescription
PositivePlugplug_pTo positive rotor plug
NegativePlugplug_nTo negative rotor plug

Modelica definition

model SwitchedRheostat 
  "Rheostat which is shortened after a given time"
  parameter Integer m= 3 "Number of phases";
  Modelica.Electrical.MultiPhase.Interfaces.PositivePlug plug_p(final m=m) 
    "To positive rotor plug";
  Modelica.Electrical.MultiPhase.Interfaces.NegativePlug plug_n(final m=m) 
    "To negative rotor plug";
  parameter Modelica.SIunits.Resistance RStart "Starting resistance";
  parameter Modelica.SIunits.Time tStart 
    "Duration of switching on the starting resistor";
  Modelica.Electrical.MultiPhase.Basic.Star star(final m=m);
  Modelica.Electrical.Analog.Basic.Ground ground;
  Modelica.Electrical.MultiPhase.Ideal.IdealCommutingSwitch
    idealCommutingSwitch(final m=m);
  Modelica.Electrical.MultiPhase.Basic.Resistor rheostat(
    final m=m,
    final R=fill(RStart, m));
  Modelica.Electrical.MultiPhase.Basic.Star starRheostat(final m=m);
  Modelica.Blocks.Sources.BooleanStep booleanStep[m](
    final startTime=fill(tStart, m),
    final startValue=fill(false, m));
equation 

  connect(plug_p, idealCommutingSwitch.plug_p);
  connect(idealCommutingSwitch.plug_n2, plug_n);
  connect(rheostat.plug_p, idealCommutingSwitch.plug_n1);
  connect(idealCommutingSwitch.plug_n2, star.plug_p);
  connect(rheostat.plug_n, starRheostat.plug_p);
  connect(starRheostat.pin_n, star.pin_n);
  connect(star.pin_n, ground.p);
  connect(booleanStep.y, idealCommutingSwitch.control);
end SwitchedRheostat;

Modelica.Electrical.Machines.Utilities.RampedRheostat Modelica.Electrical.Machines.Utilities.RampedRheostat

Rheostat with linearly decreasing resistance

Modelica.Electrical.Machines.Utilities.RampedRheostat

Information


Ramped rheostat, used for starting asynchronous induction motors with slipring rotor:

The external rotor resistance RStart is reduced to zero, starting at time tStart with a linear ramp tRamp.

Parameters

TypeNameDefaultDescription
Integerm3Number of phases
ResistanceRStart Starting resistance [Ohm]
TimetStart Time instance of reducing the rheostat [s]
TimetRamp Duration of ramp [s]

Connectors

TypeNameDescription
PositivePlugplug_pTo positive rotor plug
NegativePlugplug_nTo negative rotor plug

Modelica definition

model RampedRheostat "Rheostat with linearly decreasing resistance"
  parameter Integer m= 3 "Number of phases";
  Modelica.Electrical.MultiPhase.Interfaces.PositivePlug plug_p(final m=m) 
    "To positive rotor plug";
  Modelica.Electrical.MultiPhase.Interfaces.NegativePlug plug_n(final m=m) 
    "To negative rotor plug";
  parameter Modelica.SIunits.Resistance RStart "Starting resistance";
  parameter Modelica.SIunits.Time tStart 
    "Time instance of reducing the rheostat";
  parameter Modelica.SIunits.Time tRamp "Duration of ramp";
  Modelica.Electrical.MultiPhase.Basic.Star star(final m=m);
  Modelica.Electrical.Analog.Basic.Ground ground;
  Modelica.Electrical.MultiPhase.Basic.VariableResistor rheostat(final m=m);
  Modelica.Blocks.Sources.Ramp ramp[m](
    final height=fill(-RStart, m),
    final duration=fill(tRamp, m),
    final offset=fill(RStart, m),
    final startTime=fill(tStart, m));
equation 
  connect(plug_p, rheostat.plug_p);
  connect(rheostat.plug_n, plug_n);
  connect(rheostat.R, ramp.y);
  connect(rheostat.plug_n, star.plug_p);
  connect(star.pin_n, ground.p);
end RampedRheostat;

Modelica.Electrical.Machines.Utilities.TransformerData Modelica.Electrical.Machines.Utilities.TransformerData

Calculates Impedances from nominal values

Information


The parameters of the transformer models are calculated from parameters normally given in a technical description.

Extends from Modelica.Icons.Record (Icon for records).

Parameters

TypeNameDefaultDescription
Frequencyf Nominal frequency [Hz]
VoltageV1 Primary nominal line-to-line voltage (RMS) [V]
StringC1 Choose primary connection
VoltageV2 Secondary open circuit line-to-line voltage (RMS) @ primary nominal voltage [V]
StringC2 Choose secondary connection
ApparentPowerSNominal Nominal apparent power [VA]
Realv_sc Impedance voltage drop pu
PowerP_sc Short-circuit (copper) losses [W]
Result
RealnV1/V2Ratio primary voltage (line-to-line) / secondary voltage (line-to-line)
ResistanceR10.5*P_sc/(3*I1ph^2)Warm primary resistance per phase [Ohm]
InductanceL1sigmasqrt(Z1ph^2 - R1^2)/(2*Model...Primary stray inductance per phase [H]
ResistanceR20.5*P_sc/(3*I2ph^2)Warm secondary resistance per phase [Ohm]
InductanceL2sigmasqrt(Z2ph^2 - R2^2)/(2*Model...Secondary stray inductance per phase [H]

Modelica definition

record TransformerData "Calculates Impedances from nominal values"
  extends Modelica.Icons.Record;
  parameter Modelica.SIunits.Frequency f(start=50) "Nominal frequency";
  parameter Modelica.SIunits.Voltage V1(start=100) 
    "Primary nominal line-to-line voltage (RMS)";
  parameter String C1(start="Y") "Choose primary connection";
  parameter Modelica.SIunits.Voltage V2(start=100) 
    "Secondary open circuit line-to-line voltage (RMS) @ primary nominal voltage";
  parameter String C2(start="y") "Choose secondary connection";
  parameter Modelica.SIunits.ApparentPower SNominal(start=30E3) 
    "Nominal apparent power";
  parameter Real v_sc(final min=0, final max=1, start=0.05) 
    "Impedance voltage drop pu";
  parameter Modelica.SIunits.Power P_sc(start=300) 
    "Short-circuit (copper) losses";

  parameter Real n = V1/V2 
    "Ratio primary voltage (line-to-line) / secondary voltage (line-to-line)";
  final parameter Modelica.SIunits.Voltage V1ph = V1/(if C1=="D" then 1 else sqrt(3)) 
    "Primary phase voltage (RMS)";
  final parameter Modelica.SIunits.Current I1ph = SNominal/(3*V1ph) 
    "Primary phase current (RMS)";
  final parameter Modelica.SIunits.Voltage V2ph = V2/(if C2=="d" then 1 else sqrt(3)) 
    "Secondary phase voltage (RMS)";
  final parameter Modelica.SIunits.Current I2ph = SNominal/(3*V2ph) 
    "Secondary phase current (RMS)";
  final parameter Modelica.SIunits.Impedance Z1ph = 0.5*v_sc*V1ph/I1ph 
    "Primary impedance per phase";
  parameter Modelica.SIunits.Resistance R1= 0.5*P_sc/(3*I1ph^2) 
    "Warm primary resistance per phase";
  parameter Modelica.SIunits.Inductance L1sigma= sqrt(Z1ph^2-R1^2)/(2*Modelica.Constants.pi*f) 
    "Primary stray inductance per phase";
  final parameter Modelica.SIunits.Impedance Z2ph = 0.5*v_sc*V2ph/I2ph 
    "Secondary impedance per phase";
  parameter Modelica.SIunits.Resistance R2= 0.5*P_sc/(3*I2ph^2) 
    "Warm secondary resistance per phase";
  parameter Modelica.SIunits.Inductance L2sigma= sqrt(Z2ph^2-R2^2)/(2*Modelica.Constants.pi*f) 
    "Secondary stray inductance per phase";
end TransformerData;

Modelica.Electrical.Machines.Utilities.SynchronousMachineData Modelica.Electrical.Machines.Utilities.SynchronousMachineData

Computes machine parameter from usual datasheet

Information


The parameters of the synchronous machine model with electrical excitation (and damper) are calculated from parameters normally given in a technical description, according to the standard EN 60034-4:2008 Appendix C.

Extends from Modelica.Icons.Record (Icon for records).

Parameters

TypeNameDefaultDescription
ApparentPowerSNominal Nominal apparent power [VA]
VoltageVsNominal Nominal stator voltage per phase [V]
FrequencyfsNominal Nominal stator frequency [Hz]
CurrentIeOpenCircuit Open circuit excitation current @ nominal voltage and frequency [A]
Realx0 Stator stray inductance per phase (approximately zero impedance) [pu]
Realxd Synchronous reactance per phase, d-axis [pu]
Realxq Synchronous reactance per phase, q-axis [pu]
RealxdTransient Transient reactance per phase, d-axis [pu]
RealxdSubtransient Subtransient reactance per phase, d-axis [pu]
RealxqSubtransient Subtransient reactance per phase, q-axis [pu]
TimeTa Armature time constant [s]
TimeTd0Transient Open circuit field time constant Td0' [s]
TimeTd0Subtransient Open circuit subtransient time constant Td0'', d-axis [s]
TimeTq0Subtransient Open circuit subtransient time constant Tq0'', q-axis [s]
Material
TemperatureTsSpecification Specification temperature of stator resistance [K]
TemperatureTsRef Reference temperature of stator resistance [K]
LinearTemperatureCoefficient20alpha20s Temperature coefficient of stator resistance at 20 degC [1/K]
TemperatureTrSpecification Specification temperature of (optional) damper cage [K]
TemperatureTrRef Reference temperature of damper resistances in d- and q-axis [K]
LinearTemperatureCoefficient20alpha20r Temperature coefficient of damper resistances in d- and q-axis [1/K]
TemperatureTeSpecification Specification excitation temperature [K]
TemperatureTeRef Reference temperture of excitation resistance [K]
LinearTemperatureCoefficient20alpha20e Temperature coefficient of excitation resistance [1/K]
Result
ResistanceRsMachines.Thermal.convertResi...Stator resistance per phase at TRef [Ohm]
InductanceLssigmax0*ZReference/omegaStator stray inductance per phase [H]
InductanceLmdxmd*ZReference/omegaMain field inductance in d-axis [H]
InductanceLmqxmq*ZReference/omegaMain field inductance in q-axis [H]
InductanceLrsigmad(xrd - xmd)*ZReference/omegaDamper stray inductance in d-axis [H]
InductanceLrsigmaq(xrq - xmq)*ZReference/omegaDamper stray inductance in q-axis [H]
ResistanceRrdMachines.Thermal.convertResi...Damper resistance in d-axis at TRef [Ohm]
ResistanceRrqMachines.Thermal.convertResi...Damper resistance in q-axis at TRef [Ohm]
ResistanceRe3/2*turnsRatio^2*Machines.Th...Excitation resistance at TRef [Ohm]
Realsigmae1 - xmd/xeStray fraction of total excitation inductance

Modelica definition

record SynchronousMachineData 
  "Computes machine parameter from usual datasheet"
  extends Modelica.Icons.Record;
  import Modelica.Constants.pi;
  parameter Modelica.SIunits.ApparentPower SNominal(start=30E3) 
    "Nominal apparent power";
  parameter Modelica.SIunits.Voltage VsNominal(start=100) 
    "Nominal stator voltage per phase";
  final parameter Modelica.SIunits.Current IsNominal=SNominal/(3*VsNominal) 
    "Nominal stator current per phase";
  final parameter Modelica.SIunits.Impedance ZReference=VsNominal/IsNominal 
    "Reference impedance";
  parameter Modelica.SIunits.Frequency fsNominal(start=50) 
    "Nominal stator frequency";
  final parameter Modelica.SIunits.AngularVelocity omega=2*pi*fsNominal 
    "Nominal angular frequency";
  parameter Modelica.SIunits.Current IeOpenCircuit(start=10) 
    "Open circuit excitation current @ nominal voltage and frequency";
  final parameter Real turnsRatio = sqrt(2)*VsNominal/(omega*Lmd*IeOpenCircuit) 
    "Stator current / excitation current";
  parameter Real x0(start=0.1) 
    "Stator stray inductance per phase (approximately zero impedance) [pu]";
  parameter Real xd(start=1.6) "Synchronous reactance per phase, d-axis [pu]";
  parameter Real xq(start=1.6) "Synchronous reactance per phase, q-axis [pu]";
  parameter Real xdTransient(start=0.1375) 
    "Transient reactance per phase, d-axis [pu]";
  parameter Real xdSubtransient(start=0.121428571) 
    "Subtransient reactance per phase, d-axis [pu]";
  parameter Real xqSubtransient(start=0.148387097) 
    "Subtransient reactance per phase, q-axis [pu]";
  parameter Modelica.SIunits.Time Ta(start=0.014171268) 
    "Armature time constant";
  parameter Modelica.SIunits.Time Td0Transient(start=0.261177343) 
    "Open circuit field time constant Td0'";
  parameter Modelica.SIunits.Time Td0Subtransient(start=0.006963029) 
    "Open circuit subtransient time constant Td0'', d-axis";
  parameter Modelica.SIunits.Time Tq0Subtransient(start=0.123345081) 
    "Open circuit subtransient time constant Tq0'', q-axis";
  parameter Modelica.SIunits.Temperature TsSpecification(start=293.15) 
    "Specification temperature of stator resistance";
  parameter Modelica.SIunits.Temperature TsRef(start=293.15) 
    "Reference temperature of stator resistance";
  parameter Machines.Thermal.LinearTemperatureCoefficient20 alpha20s(start=0) 
    "Temperature coefficient of stator resistance at 20 degC";
  parameter Modelica.SIunits.Temperature TrSpecification(start=293.15) 
    "Specification temperature of (optional) damper cage";
  parameter Modelica.SIunits.Temperature TrRef(start=293.15) 
    "Reference temperature of damper resistances in d- and q-axis";
  parameter Machines.Thermal.LinearTemperatureCoefficient20 alpha20r(start=0) 
    "Temperature coefficient of damper resistances in d- and q-axis";
  parameter Modelica.SIunits.Temperature TeSpecification(start=293.15) 
    "Specification excitation temperature";
  parameter Modelica.SIunits.Temperature TeRef(start=293.15) 
    "Reference temperture of excitation resistance";
  parameter Machines.Thermal.LinearTemperatureCoefficient20 alpha20e(start=0) 
    "Temperature coefficient of excitation resistance";
  final parameter Real xmd = xd - x0 
    "Main field reactance per phase, d-axis [pu]";
  final parameter Real xmq = xq - x0 
    "Main field reactance per phase, q-axis [pu]";
  final parameter Real xe =  xmd^2/(xd - xdTransient) 
    "Excitation reactance [pu]";
  final parameter Real xrd = xmd^2/(xdTransient - xdSubtransient)*(1 - (xmd/xe))^2 + xmd^2/xe 
    "Damper reactance per phase, d-axis [pu]";
  final parameter Real xrq = xmq^2/(xq - xqSubtransient) 
    "Damper reactance per phase, d-axis [pu]";
  final parameter Real rs = 2/(1/xdSubtransient + 1/xqSubtransient)/(omega*Ta) 
    "Stator resistance per phase at specifaction temperature [pu]";
  final parameter Real rrd = (xrd - xmd^2/xe)/(omega*Td0Subtransient) 
    "Damper resistance per phase at specification temperature, d-axis [pu]";
  final parameter Real rrq = xrq/(omega*Tq0Subtransient) 
    "Damper resistance per phase at specification temperature, q-axis [pu]";
  final parameter Real re =  xe/(omega*Td0Transient) 
    "Excitation resistance per phase at specification temperature [pu]";
  parameter Modelica.SIunits.Resistance Rs=
   Machines.Thermal.convertResistance(rs*ZReference,TsSpecification,alpha20s,TsRef) 
    "Stator resistance per phase at TRef";
  parameter Modelica.SIunits.Inductance Lssigma=x0*ZReference/omega 
    "Stator stray inductance per phase";
  parameter Modelica.SIunits.Inductance Lmd=xmd*ZReference/omega 
    "Main field inductance in d-axis";
  parameter Modelica.SIunits.Inductance Lmq=xmq*ZReference/omega 
    "Main field inductance in q-axis";
  parameter Modelica.SIunits.Inductance Lrsigmad=(xrd - xmd)*ZReference/omega 
    "Damper stray inductance in d-axis";
  parameter Modelica.SIunits.Inductance Lrsigmaq=(xrq - xmq)*ZReference/omega 
    "Damper stray inductance in q-axis";
  parameter Modelica.SIunits.Resistance Rrd=
   Machines.Thermal.convertResistance(rrd*ZReference,TrSpecification,alpha20r,TrRef) 
    "Damper resistance in d-axis at TRef";
  parameter Modelica.SIunits.Resistance Rrq=
   Machines.Thermal.convertResistance(rrq*ZReference,TrSpecification,alpha20r,TrRef) 
    "Damper resistance in q-axis at TRef";
  parameter Modelica.SIunits.Resistance Re=3/2*turnsRatio^2*
   Machines.Thermal.convertResistance(re*ZReference,TeSpecification,alpha20e,TeRef) 
    "Excitation resistance at TRef";
  parameter Real sigmae=1 - xmd/xe 
    "Stray fraction of total excitation inductance";
end SynchronousMachineData;

Automatically generated Fri Nov 12 16:29:16 2010.