0% found this document useful (0 votes)
20 views

SDS Laboratory Manual1

system design and simulation practical file

Uploaded by

hardiknasa.hn
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
0% found this document useful (0 votes)
20 views

SDS Laboratory Manual1

system design and simulation practical file

Uploaded by

hardiknasa.hn
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
You are on page 1/ 29

BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

Subject: Systems Design and Simulation Lab


Subject Code : EEE-435P
Semester : VII

COURSE OUTCOMES (COs)


CO-1 Understand the basic principles of
MATLAB/Simulink.

CO-2 To determine the load flow analysis on power


system.

CO-3 To perform fault analysis on Transmission line


models and Generators.

CO-4 Formation of Buses using direct inspection method.

Submitted To:

Submitted By:
Enrolment No.:
Academic Session:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 1


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

INDEX

S. Name of Experiment P.No.


No.
1 To learn basic operations and matrix manipulations in MATLAB and write
simple scripts for performing given tasks.
2 Generate various signals and sequences (Periodic and aperiodic), such as
Unit Impulse, Unit Step, Square, Saw tooth, Triangular, Sinusoidal, Ramp,
Sinc.
3 To obtain the Ybus matrix for the given power system using Direct
inspection method and to verify the same using MATLAB
4 To obtain the Zbus matrix for the given power system using Zbus building
algorithm and to verify the same using MATLAB.

5 To find load flow solution of the given power system using Gauss-Seidel
method theoretically for one iteration and obtain full solution using
MATLAB.

6 To find dynamic response of the given single area load frequency control
problem theoretically and to plot and verify the results in SIMULINK.

7 To find the parameters of the given transmission line using short-


line and

nominal-pi methods and verify using MATLAB.

8 To find Ferranti effect of a 5000 kM transmission line and to plot the locus
of voltage for the given problem and verify results in MATLAB.
9 SIMULINK model for evaluating transient stability of single machine
connected to infinite bus
10 To find dynamic response of the given two - area load frequency control
problem theoretically and to plot and verify the results in SIMULINK.

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 2


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

EXPERIMENT NO. 1
AIM:- To learn basic operations and matrix manipulations in MATLAB and write
simple scripts for performing given tasks.

Objective: introduction to MATLAB and its basic commands.

Theory of Experiment:

MATLAB is a widely used numerical computation package. It serves both as a simple


calculator and as a sophisticated tool for making long complicated calculations and plot
graphs of different functions depending upon requirement. Models of dynamic systems can
be built easily using SIMULINK.
Some Benefits of MATLAB are:
Simple to use
Fast computations are possible
Wide working range
Solution of matrix of any order
Desired operations are performed in matrices
Different Programming languages can be used
Simulation is possible

To start using MATLAB/SIMULINK, open editor to create an m-file or an .mdl Simulink


model in Simulink window. Always save using file names without breaks in words.
Some very important functions performed by MATLAB are:
Matrix computations
Vector Analysis
Differential Equations computations
Integration
Computer language programming
Simulation
2-D & 3-D Plotting

Basic Commands:
Some basic MATLAB commands are given as follows. Type these at the command
prompt to verify.

Addition: A+B Division: A/B Range : A: B


Subtraction:A-B Multiplication:A*B Power: A^B
Power of individual element: A. ^B, Square-Root: A=sqrt (B) where A & B are any
arbitrary integers

3. Basic Matrix Operations:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 3


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

This is a demonstration of some aspects of the MATLAB language.


Execute the commands in MATLAB and print out the results.
Creating a Vector:
Let’s create a simple vector with 9 elements called a.

a=[1 2 3 4 6 4 3 4 5]
a= 1 2 3 4 6 4 3 4 5

Now let's add 2 to each element of our vector, a, and store the result in a new vector.
Notice how MATLAB requires no special handling of vector or matrix math.
Adding an element to a Vector:

b=a+2
b= 3 4 5 6 8 6 5 6 7

Plots and Graphs:


Creating graphs in MATLAB is as easy as one command. Let's plot the result of our vector
addition with grid lines.
plot (b)
grid on
MATLAB can make other graph types as well, with axis labels.
bar(b)
xlabel('Sample #')
ylabel('Pounds')

MATLAB can use symbols in plots as well. Here is an example using stars to mark the
points. MATLAB offers a variety of other symbols and line types.
plot(b,'*')
axis([0 10 0 10])

Creating a matrix:
One area in which MATLAB excels is matrix computation. Creating a matrix is as easy as
making a vector, using semicolons (;) to separate the rows of a matrix.
A = [1 2 0; 2 5 -1; 4 10 -1]
A=
1 2 0
2 5 -1
4 10 -1
Adding a new Row:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 4


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

A(4,:)=[7 8 9]
ans=
1 2 0
2 5 -1 4
10 -1 789
Adding a new Column:

A(:,4)=[7 8 9]
ans=
1 2 0 7
2 5 -1 8
4 10 -1 9
Transpose:
We can easily find the transpose of the matrix A.
A = [1 2 0; 2 5 -1; 4 10 -1]
A' =
1 2 4
2 5 10
0 -1 -1
Matrix Multiplication:
Now let's multiply these two matrices together. Note again that MATLAB doesn't require
you to deal with matrices as a collection of numbers. MATLAB knows when you are
dealing with matrices and adjusts your calculations accordingly.
A = [1 1 1; 2 2 2; 3 3 3]
B = [4 4 4; 5 5 5; 6 6 6]
C =A*B
C=
15 15 15
30 30 30
45 45 45
Instead of doing a matrix multiply, we can multiply the corresponding elements of two
matrices or vectors using the’.* ‘operator.
C =A.*B
C=
4 4 4
10 10 10
18 18 18
Inverse:
Let's find the inverse of a matrix

A = [1 2 0; 2 5 -1; 4 10 -1]
X=inv(A)
X=
5 2 -2
-2 -1 1
0 -2 1
... and then illustrate the fact that a matrix times its inverse is the identity matrix.
I=inv(A)*A
I=
1 0 0
0 1 0
0 0 1

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 5


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

VIVA QUESTIONS:-

1.Expand MATLAB? And importance of MATLAB?


2.What is clear all and close all will do?
3.What is disp() and input()?
4. What is the syntax to find the Eigen values and eigenvectors of the matrix? 5.
Define scalar and vector?

EXPERIMENT NO. 2

AIM: Generate various signals and sequences (Periodic and aperiodic), such as Unit
Impulse, Unit Step, Square, Saw tooth, Triangular, Sinusoidal, Ramp, Sinc.

Software Required: Matlab software

Theory: If the amplitude of the signal is defined at every instant of time, then it is called
continuous time signal. If the amplitude of the signal is defined at only at some instants of
time, then it is called discrete time signal. If the signal repeats itself at regular intervals, then
it is called periodic signal. Otherwise, they are called aperiodic signals.

EX: ramp, Impulse, unit step, sinc- Aperiodic signals square, sawtooth, triangular sinusoidal
– periodic signals.

Ramp sinal: The ramp function is a unitary real function, easily computable as the mean
of the independent variable and its absolute value. This function is applied in engineering.
The name ramp function is derived from the appearance of its graph.

r(t)= t when t>0

0 else

Unit impulse signal: One of the more useful functions in the study of linear systems is the
"unit impulse function. "An ideal impulse function is a function that is zero everywhere but
at the origin, where it Is infinitely high. However, the area of the impulse is finite

Y(t)= 1 when t=0

=0 other wise

Unit step signal: The unit step function and the impulse function are fundamental functions
in engineering, and it is strongly recommended that the reader becomes very familiar with
both functions.

u(t)= 0 if t<0

1 if t>0

½ if t=0

Sinc signal: There is a particular form that appears so frequently in communications


engineering, that we give it its own name. This function is called the "Sinc function”.
The Sinc function is defined in the following manner:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 6


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

if and sinc(0) =1

The value of sinc(x) is defined as 1 at x = 0, since

PROCEDURE:-

➢ Open MATLAB
➢ Open new M-file
➢ Type the program
➢ Save in current directory
➢ Compile and Run the program
➢ For the output see command window\ Figure window

PROGRAM:

% Generation of signals and sequences


clc;
clear all;
close all;

%~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~

%generation of unit impulse signal

t1=-1:0.01:1
y1=(t1==0);
subplot(2,2,1);
plot(t1,y1);
xlabel('time');

ylabel('amplitude');
title('unit impulse signal');

%generation of impulse sequence subplot(2,2,2);

stem(t1,y1);
xlabel('n');
ylabel('amplitude');
title('unit impulse sequence');

%~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~

%generation of unit step signal t2=-10:1:10;


y2=(t2>=0);
subplot(2,2,3);

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 7


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

plot(t2,y2);
xlabel('time');
ylabel('amplitude');
title('unit step signal');

%generation of unit step sequence subplot(2,2,4);

stem(t2,y2);
xlabel('n');
ylabel('amplitude');
title('unit step sequence');

%~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~

%generation of square wave signal

t=0:0.002:0.1;

y3=square(2*pi*50*t);
figure;

subplot(2,2,1);
plot(t,y3);
axis([0 0.1 -2 2]);
xlabel('time');
ylabel('amplitude');
title('square wave signal');

%generation of square wave sequence subplot(2,2,2);

stem(t,y3);
axis([0 0.1 -2 2]);
xlabel('n');
ylabel('amplitude');
title('square wave sequence');

%~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~

%generation of sawtooth signal

y4=sawtooth(2*pi*50*t);

subplot(2,2,3);
plot(t,y4);

axis([0 0.1 -2 2]);


xlabel('time');
ylabel('amplitude');
title('sawtooth wave signal');

%generation of sawtooth sequence subplot(2,2,4);

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 8


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

stem(t,y4);
axis([0 0.1 -2 2]);
xlabel('n');
ylabel('amplitude');
title('sawtooth wave sequence');

%~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~

%generation of triangular wave signal

y5=sawtooth(2*pi*50*t,.5);
figure;
subplot(2,2,1);

plot(t,y5);
axis([0 0.1 -2 2]);
xlabel('time');
ylabel('amplitude');
title(' triangular wave signal');

%generation of triangular wave sequence

subplot(2,2,2);
stem(t,y5);
axis([0 0.1 -2 2]);
xlabel('n');

ylabel('amplitude');
title('triangular wave sequence');
%generation of sinsoidal wave signal
y6=sin(2*pi*40*t);
subplot(2,2,3);
plot(t,y6);
axis([0 0.1 -2 2]);
xlabel('time');
ylabel('amplitude');
title(' sinsoidal wave signal');

%generation of sin wave sequence


subplot(2,2,4);
stem(t,y6);
axis([0 0.1 -2 2]);
xlabel('n');
ylabel('amplitude');
title('sin wave sequence');

%generation of ramp signal


y7=t;
figure;
subplot(2,2,1);
plot(t,y7);
xlabel('time');

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 9


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

ylabel('amplitude');
title('ramp signal');

%generation of ramp sequence


subplot(2,2,2);
stem(t,y7);
xlabel('n');
ylabel('amplitude');
title('ramp sequence');

%~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~

%generation of sinc signal


t3=linspace(-5,5);
y8=sinc(t3);
subplot(2,2,3);
plot(t3,y8);
xlabel('time');
ylabel('amplitude');
title(' sinc signal');
%generation of sinc sequence
subplot(2,2,4);
stem(y8);
xlabel('n');
ylabel('amplitude');
title('sinc sequence');

EXPECTED OUTPUT:

Various signals & sequences generated using MATLAB software.

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 10


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

VIVA QUESTIONS:-

1. Define Signal?
2. Define continuous and discrete Signals?
3. State the relation between step, ramp and Delta Functions?
4. Differentiate saw tooth and triangular signals?
5. Define Periodic and aperiodic Signal?

EXPERIMENT NO. 3
AIM: To obtain the Ybus matrix for the given power system using Direct inspection method
and to verify the same using MATLAB.

APPARATUS REQUIRED: MATLAB software.

PROBLEM ON FORMATION OF Ybus:

Find the Ybus matrix for the given power system data using Direct inspection method
Sending end

Sending end Receiving end Reactance values in ohms

1 2 j0.15
2 3 j0.10
1 3 j0.20
1 4 j0.10
4 3 j0.15

PROGRAM FOR YBUS FORMATION USING THE GIVEN DATA:

% ***** Matlab code for Y bus formation by direct inspection method********** %

clc;
close all;
clear all;
zdata=[1 2 0 0.15; 1 3 0 0.2;
1 4 0 0.1;

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 11


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

2 3 0 0.1;
3 4 0 0.15];
nl=zdata(:,1);
nr=zdata(:,2);
R=zdata(:,3);
X=zdata(:,4);
nbr=length(zdata(:,1));
nbus = max(max(nl), max(nr));
Z = R + j*X;
y= ones(nbr,1)./Z;
Ybus=zeros(nbus,nbus);
for k = 1:nbr; % formation of the off diagonal elements
% Sending end bus % Receiving end bus % Resistance
% Reactance
%branch impedance %branch admittance
% initialize Ybus to zero
if nl(k) > 0 & nr(k) > 0
Ybus(nl(k),nr(k)) = Ybus(nl(k),nr(k)) - y(k); Ybus(nr(k),nl(k)) = Ybus(nl(k),nr(k));
end
end
for n = 1:nbus % formation of the diagonal elements
for k = 1:nbr
if nl(k) == n | nr(k) == n Ybus(n,n) = Ybus(n,n) + y(k); else
end end
end Ybus

COMMANDS USED IN THE PROGRAM:

§ y bus is the command used to obtain the admittance matrix for the given system data
using direct inspection method.
§ z data matrix consists of four columns in which
§ 1st column represent sending end
§ 2nd column represents receiving end
§ 3rd column represents resistance between the sending and receiving end
§ 4th column represents reactance between the sending and receiving end

Expected Output:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 12


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

EXPERIMENT NO.4

AIM: To obtain the Zbus matrix for the given power system using Zbus building algorithm
and to verify the same using MATLAB.

OBJECTIVE: Z BUS FORMATION USING MATLAB

PROBLEM ON FORMATION OF Zbus: Find the bus impedance matrix using Zbus
building algorithm for the given power system whose reactance values are as follows.

Sending end Receiving end Reactance values in ohms


0 1 j0.05
1 2 j0.75
0 2 j0.075
2 3 j0.45
1 3 j0.3

COMMANDS USED IN THE PROGRAM:


§ zbuild is the command used to obtain the impedance matrix for the given system data
using Zbus building algorithm.
§ linedata matrix consists of four columns in which
§ 1st column represent sending end
§ 2nd column represents receiving end
§ 3rd column represents resistance between the sending and receiving end in ohms
§ 4th column represents reactance between the sending and receiving end in ohms

PROGRAM FOR FORMATION OF ZBUS USING THE GIVEN DATA:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 13


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

clc
clear all
close all
linedata=[0 1 0 0.05
0 2 0 0.075
1 2 0 0.75
1 3 0 0.30
2 3 0 0.45];
nl = linedata(:,1); nr = linedata(:,2); R = linedata(:,3);
X = linedata(:,4);
nbr=length(linedata(:,1)); nbus = max(max(nl), max(nr)); ZB = R + j*X;
Zbus = zeros(nbus, nbus);
tree=0; %%%%new

% Adding a branch from a new bus to reference bus 0


for I = 1:nbr ntree(I) = 1;
if nl(I) == 0 | nr(I) == 0 if nl(I) == 0
n = nr(I); elseif nr(I) == 0
n = nl(I); end
if abs(Zbus(n, n)) == 0 Zbus(n,n) = ZB(I); tree=tree+1;%%new
end ntree(I) = 2;
end end

% Adding a branch from new bus to an existing bus while tree < nbus %%% new
for n = 1:nbus
nadd = 1;
if abs(Zbus(n,n)) == 0
for I = 1:nbr
if nadd == 1;
if nl(I) == n | nr(I) == n if nl(I) == n
k = nr(I); elseif nr(I) == n
k = nl(I); end
if abs(Zbus(k,k)) ~= 0 for m = 1:nbus
if m ~= n
Zbus(m,n) = Zbus(m,k); Zbus(n,m) = Zbus(m,k);

else, end end


Zbus(n,n) = Zbus(k,k) + ZB(I); tree=tree+1; %%new
nadd = 2;
ntree(I) = 2;
else
end else
end else
end end
else
end end
end %%%%%%new
% Adding a link between two old buses for n = 1:nbus
for I = 1:nbr
if ntree(I) == 1
if nl(I) == n | nr(I) == n if nl(I) == n
k = nr(I);
elseif nr(I) == n

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 14


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

k = nl(I);
end
DM = Zbus(n,n) + Zbus(k,k) + ZB(I) - 2*Zbus(n,k); for jj = 1:nbus
AP = Zbus(jj,n) - Zbus(jj,k);
for kk = 1:nbus
AT = Zbus(n,kk) - Zbus(k, kk); DELZ(jj,kk) = AP*AT/DM; end
end
Zbus = Zbus - DELZ; ntree(I) = 2;
else, end
else, end
end end
Zbus
ACTUAL OUTPUT:

EXPERIMENT NO.5

Aim:- To find load flow solution of the given power system using Gauss-Seidel method
theoretically for one iteration and obtain full solution using MATLAB.

OBJECTIVE: MATLAB Program to Solve Load Flow Equations By Gauss-Seidel Method

PROBLEM

For the sample power system shown below, the generators are connected at all the four
buses, while loads are at buses 2 and 3. Values of real and reactive powers are listed in the
table. All buses other than the slack are PQ type. Assuming a flat voltage start, find the
voltages and bus angles at the three buses at the end of first GS iteration.
Input data:

MATLAB PROGRAM:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 15


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

% Load flow using gauss siedel method clc


clear
n=4;
V=[1.04 1 1 1];
Y=[3-j*9 -2+j*6 -1+j*3 0
-2+j*6 3.666-j*11 -0.666+j*2 -1+j*3 -1+j*3 -0.666+j*2 3.666-j*11 -2+j*6 0 -1+j*3 -
2+j*6 3-j*9];
type=ones(n,1);
typechanged=zeros(n,1);
Qlimitmax=zeros(n,1);
Qlimitmin=zeros(n,1);
Vmagfixed=zeros(n,1); type(2)=2;
Qlimitmax(2)=1.0;
Qlimitmin(2)=-0.2;
Vmagfixed(2)=1.04; diff=10;
noofiter=1;
Vprev=V;
while (diff>0.00001 | noofiter==1),
abs(V);
abs(Vprev);
Vprev=V;
P=[inf 0.5 -1 0.3];
Q=[inf -0.3 0.5 -0.1];
S=[inf 0.5-j*0.2 -1.0+j*0.5 0.3-j*0.1];
for i=2:n,
if type(i)==2 |typechanged(i)==1,
if (Q(i)>Qlimitmax(i)| Q(i)<Qlimitmin(i))
if (Q(i)<Qlimitmin(i)) Q(i)=Qlimitmin(i);
else Q(i)=Qlimitmax(i);
end
type(i)=1; typechanged(i)=1;
else type(i)=2;
typechanged(i)=0;
end
end sumyv=0;
for k=1:n,
if(i~=k)
sumyv=sumyv+Y(i,k)*V(k);
end
end V(i)=(1/Y(i,i))*((P(i)-j*Q(i))/conj(V(i))-sumyv) if type(i)==2 & typechanged(i)~=1,
V(i)=PolarTorect(Vmagfixed(i),angle(V(i)*180/pi))
end
end
diff=max(abs(abs(V(2:n))-abs(Vprev(2:n))));
noofiter=noofiter+1
end

EXPECTED OUTPUT:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 16


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

EXPERIMENT NO.6

AIM: To find dynamic response of the given single area load frequency control problem
theoretically and to plot and verify the results in SIMULINK.

OBJECTIVE: Simulink Model of Single Area Load frequency Control without and with
PI Controller

PROBLEM:

The parameters for load frequency control of a single area are:

Speed governor gain Kg=10


Time constant of speed governor Tg=0.4
Speed regulation of speed governor R=3
Gain of turbine Kt=0.1
Time constant of turbine Tt=0.5
Gain of power system Kp=100
Time constant of power system Tp=20
Changes in the load ΔPD=0.01 pu

An integral controller with gain Ki=0.09 is now used to reduce steady state error. What is
the dynamic response of the system with and without the controller? Obtain the dynamic
response of the system with and without the PI controller by developing a SIMULINK
model and verify the responses

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 17


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

SIMULINK MODEL WITHOUT & WITH PI CONTROLLER:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 18


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 19


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

EXPECTED OUTPUT:

EXPERIMENT NO. 7

AIM: To find the parameters of the given transmission line using short-line and

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 20


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

nominal-pi methods and verify using MATLAB.

OBJECTIVE: MATLAB Program to Model Transmission Lines

PROBLEM:

A 50 Hz transmission line 300km long has a total series impedance of 40+j 125
ohms and a total shunt admittance of 10-3 mho. The receiving-end load is 50 MW
at 220kV with 0.8 lagging power factor. Find the sending-end voltage, current,
power and power factor using (a) short line approximation, and (b) nominal-pi
method. Compare the results and comment.

Solve the problem theoretically and verify with MATLAB THEORY:

THEORETICAL SOLUTION: MATLAB PROGRAM:

clc
clear all
f=50;L=300;z=40+i*125;y=i*1e-3;
PR=50e6/3;VR=220e3/(sqrt(3));Pfload=0.8;IRR=PR/(VR*Pfload);IR=IRR*(0.8-
i*0.6);
z=z/L;y=y/L;k=1;
for i=10:10:600,
%short line aproximation
VS_shortline(k)=VR+((z*i*IR));
IS_shortline(k)=IR; spf_shortline(k)=cos(angle(VS_shortline(k))-
angle(IS_shortline(k)));
spower_shortline(k)=3*abs(VS_shortline(k))*abs(IS_shortline(k))*spf_shortline(k)
; %nominal pi method
A=1+(y*i)*(z*i)/2;
B=z*i;
C=y*i*(1+(y*i)*(z*i)/4);
D=A;
VS_nominalpi(k)=A*VR+B*IR;
IS_nominalpi(k)=C*VR+D*IR; spf_nominalpi(k)=cos(angle(VS_nominalpi(k))-
angle(IS_nominalpi(k)));
spower_nominalpi(k)=3*abs(VS_nominalpi(k))*abs(IS_nominalpi(k))*spf_nominal
pi( k);
point(k)=i;

k=k+1;
end
%plots of short line in red and nominal pi in red
figure(1); plot(point,abs(VS_shortline),'r',point,abs(VS_nominalpi),'g') figure(2);
plot(point,abs(IS_shortline),'r',point,abs(IS_nominalpi),'g') figure(3);
plot(point,abs(spf_shortline),'r',point,abs(spf_nominalpi),'g') figure(4);
plot(point,abs(spower_shortline),'r',point,abs(spower_nominalpi),'g')

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 21


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

EXPECTED OUTPUT:

EXPERIMENT NO. -8

AIM: To find Ferranti effect of a 5000 kM transmission line and to plot the locus of voltage
for the given problem and verify results in MATLAB.

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 22


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

OBJECTIVE: MATLAB Program to Simulate Ferranti Effect

PROBLEM:

A 3-Phase 50 Hz transmission line is 5000 kM long. The line parameters are R=


0.125Ω/km,X= 0.4 Ω/km and Y= 2.8*10-6 mho/km. If the line is open circuited with a
receiving end voltage of 220KV, find the rms value and phase angle of the following. Use
the receiving-end line to neutral voltage as reference.

(a) The incident and reflected voltages to neutral at the receiving-end.


(b) The incident and reflected voltages to neutral at 200 km from the receiving- end.

The resultant voltage at 200 km from the receiving end. Solve the problem theoretically.
Vary the length of the long transmission line in steps of 10 KM from zero (receiving
end) to 5000KM (sending end), and plot the sending end voltage phasor using
MATLAB.

MATLAB PROGRAM:

%Program to illustrate Ferranti effect


%it simulates the effect by varying the length of transmission line from
%zero(receiving end) to 5000km in steps of 10km
%and plots the sending end voltage phasor
clc
clear all
VR=220e3/sqrt(3);
alpha=0.163e-3;
beta=1.0683e-3;
L=5000;
k=1;
fori=0:10:L, VS=(VR/2)*exp(alpha*i)*exp(j*beta*i)+(VR/2)*exp(-alpha*i)*exp(-
j*beta*i); X(k)=real(VS);
Y(k)=imag(VS);
k=k+1;
p(k)=VS;
q(k)=I;
end
figure(1);
plot(p,q)
figure(2);
plot(X,Y)

EXPECTED OUTPUT:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 23


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

EXPERIMENT NO. -9

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 24


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

AIM:-SIMULINK model for evaluating transient stability of single machine connected to


infinite bus

PROBLEM:

A 20 MVA, 50 Hz generator delivers 18 MW over a double circuit line to an infinite bus.


The generator has KE of 2.52 MJ/MVA at rated speed. The generator transient reactance is
X’d=0.35pu.
Each transmission circuit has R=0 and a reactance of 0.2 pu on a 20 MVA base .|E’|=1.1 p
u and infinite bus voltage V=1.0/_00.A three-phase short circuit occurs at the mid point of
one of the transmission lines. Plot swing curves with fault cleared by simultaneous opening
of breakers at both ends of the line at 2.5 cycles and 6.25 cycles after the occurrence of fault.
Also plot the swing curve over the period of 0.5 s if the fault is sustained.

Simulate the problem in SIMULINK and compare with theoretical results.


Note: Before running simulation, integrator 1 has to be initialized to pre fault value of δ, i.e.,
δ0. This can be done by double-clicking on integrator 1 block and changing the initial value
from 0 to δ0 (in radians). Also double click the switch block and change the threshold value
from 0 to the fault clearing time (in sec).

THEORETICAL SOLUTION:
This experiment is solution of swing equation of experiment 7 implemented in SIMULINK.

SIMULINK MODEL:

SUBSYSTEM DETAILS:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 25


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

SUBSYSTEM1 DETAILS:

EXPECTED OUTPUT:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 26


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

EXPERIMENT NO. -10

MODEL FOR TWO AREA LOAD FREQUENCY CONTROL

AIM: To find dynamic response of the given two - area load frequency control problem
theoretically and to plot and verify the results in SIMULINK
PROBLEM:
The parameters for load frequency control of a two area are:

Speed governor gain Ksg=1


Time constant of speed governor
Tsg=0.4

Speed regulation of speed governor R=3


Gain of turbine Kt=1

Time constant of turbine Tt=0.5

Gain of power system Kps=100

Time constant of power system Tps=10


Ki=0.07
Proportional plus integral gain

Synchronizing co-efficient Tr=0.05


Frequency bias 0.425s

SIMULINK MODEL:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 27


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 28


BHAGWAN PARSHURAM INSTITUTE OF TECHNOLOGY

EXPECTED OUTPUT:

DEPARTMENT OF ELECTRICAL & ELECTRONICS ENGINEERING Page 29

You might also like

pFad - Phonifier reborn

Pfad - The Proxy pFad of © 2024 Garber Painting. All rights reserved.

Note: This service is not intended for secure transactions such as banking, social media, email, or purchasing. Use at your own risk. We assume no liability whatsoever for broken pages.


Alternative Proxies:

Alternative Proxy

pFad Proxy

pFad v3 Proxy

pFad v4 Proxy