Вы находитесь на странице: 1из 66

1

TABLE OF CONTENTS
Ex. No Pag e No Marks Awarded Signature

Date

Title of the Experiment

1. 2. 3. 4. 5. 6. 7. 8. 9. 10 . 11 . 12 .
Total Marks Average Marks Lab Completed Date Signature

EX.NO:

DETERMINATION OF TRANSMISSION LINE PARAMETERS

DATE:

AIM:

To Determine the transmission line parameters and verify using MATLAB simulation.
SOFTWARE REQUIRED:

MATLAB
ALGORITHM: Find that given transmission line is single phase or three phases. If it is single phase get the distance between the conductors. Get the radius of the conductor. Using the appropriate formula find inductance and capacitance. If the given system is three phase classify whether it is symmetrical or unsymmetrical. If symmetrical get the distance between the conductors and radius of the conductors. Using the appropriate formula find inductance and capacitance. If unsymmetrical get the distance between the conductors and radius of the conductor.
Using the appropriate formula find inductance and capacitance.

FORMULA: Single phase Inductance=10-7[ 1+4log(d/r) ] Capacitance=3.14*8.854*10-12/log (d/r) Three phase Inductance=10-7[ 0.5+2log(d/r) ] Capacitance=2*3.14*8.854*10-12/log(d/r) D equivalent=[d1*d2*d3]1/3 Where d=spacing of conductors r=radius of conductor

THEORY: An AC transmission line has resistance ,inductance and capacitance uniformly distributed along its length. These are know as constants or parameters of the line.The performance of the transmission line depend to a considerable extent upon these constants.For instance, these constants determine whether the efficiency and voltage regulation of the line will be good or poor.Therefore,a sound concept of these constants is necessary in order to make the electrical design of a transmission line a technical success.constants of transmission line are resistance, inductance and capacitance uniformly distributed along the whole length of the line.

RESISTANCE: It is the opposition of the line conductors to current flow. The resistance is distributed uniformly along the whole length of the line. INDUCTANCE: An alternating current flow through a conductor ,a charging flux is setup which links the conductor . Due to this flux linkage ,the conductor possesses inductance. Inductance defined as the flux linkage per ampere. CAPACITANCE: The capacitance between the conductors is the charge per unit potential difference.

Flow chart

START

1 PHASE OR 3 PHASE

READ THE VALUE OF D&R SUCH READ THE VALUE OF D&R TRANSMIS SION L=10n(0.5+2ln(DR) C=(2*PIX*8.854+10X(-R2)ln(D/R) L=(16*(-7)*(1+4*ln(D/R))) C=((A+B.85 (-12))/ln D/R PRINT LC READ THE VALUE OF P11,P22.P33 D=(D12+D23+D31) n(1/3) READ THE VALUE OF R L=10n(-7)+(0.3)+2&ln(D/R) C=(2+Di&S4+10n)(-12)ln(D+F) PRINT L& C

PROGRAM
clear all clc

STOP

ph=input('single -1 or 3phase -3:') if ph==1 D=input ('distance between con in mtrs=') R=input('radius cond in mtrs=') L=(10^(-7)*(1+4*log(D/R))) c=((pi*(8.854*10^(-12))))/log(D/R)

5
else end if ph==3 spacing=input('sym_4 unsym_5:') if spacing ==4 D=input('distance between cond in mtrs =') R=input('radius cond in mtrs=') C=(2*pi*8.854*10^(-12))/log(D/R) L=10^(-7)*(0.5+2*log(D/R)) else end if spacing==5 d12=input('distance btw cond 1&2 in mtrs=') d23=input('distance btw cond 2&3 in mtrs=') d31=input('distance btw cond 3&1 in mtrs=') R=input('radius_cond in mtrs=') D=(D12*D23*D31)^(1/3) L=10^(-7)*(0.5+2*log(D/R)) C=(2*pi*8.854*10^(-12))/log(D/R) else end end

OUTPUT SINGLE PHASE:


single -1 or 3phase -3:1 ph = 1 distance between con in mtrs=2 D= 2 radius cond in mtrs=0.0060 R= 0.0060 L= 2.4237e-006 c= 4.7883e-012 OUTPUT THREE PHASE SYMMETRICAL: single -1 or 3phase -3:3 ph = 3 sym_4 unsym_5:4 spacing = 4 distance between cond in mtrs =2 D= 2 radius cond in mtrs=0.0062 R= 0.0062 C= 9.6309e-012 L = 1.2053e-006

OUTPUT FOR THREE PHASE UNSYMMETRICAL: single -1 or 3phase -3:3 ph = 3 sym_4 unsym_5:5 spacing = 5 distance btw cond 1&2 in mtrs=2 d12 = 2 distance btw cond 2&3 in mtrs=2 d23 = 2 distance btw cond 3&1 in mtrs=4 d31 = 4 radious_cond in mtrs =0.0125 R= 0.0125 D= 2.5198 L= 1.1112e-006 C= 1.0484e-011 >>

RESULT: Thus the transmission line parameters were determined by MATLAB and it is checked with manual calculation.

EX.NO:

IMPEDENCE MATRIX

DATE:

AIM: To determine the impedance matrix and verify it using MATLAB simulation SOFTWARE REQUIRED: MATLAB ALGORITHM: 1. The line impedance are converted to admittance 2. Initialize admittance bus(Y bus) to Zero 3. Line data searched in first loop 4. Then off diagonal elements are entered 5. Line data is searched to find the elements connected to a bus

THEORY: The power flow equation can be final out by using impedance and admittance matrix ADMITTANCE MATRIX: The interconnection between the various modes for a given system and the admittance value for each interconnecting circuits can be known as the admittancematrix.This matrix may be assembled as follows the diagonal element of each node is sum of admittance connected to it off diagonal element is the negated admittance between the nodes. IMPEDANCE MATRIX: The matrix consistingofdriving point impedances and transferimpedances of the buses and off diagonal elements of bus impedance matrix are called transfer impedances of the buses.

10

FLOW CHART:

start Line Impedance And Convered Into Admittance Initialize The Matrix

FOR K=1=nb r

IF NI(t) >0 &Nr(t)> 0

Y(n)(k),nr(k)=yn(k),nr(k),-y(k) Y(nr(k),n1(k)=y(n)(k),nr(k)

Continu e

for K=1=n bus

11

for K=1=n BUS

IF N1(K)= nNr (K)=n

Y(n,n)=Y(n,n)+Y(K)

Continu e

CONTIN UE

Stop

PROGRAM:

Stop

12

%FORMATION OF BUS ADMITTANCE MATRIX clc; data=[1 1 2 0+j*0.2 0+j*20 2 2 3 0+j*0.2 0+j*10 3 1 3 0+j*0.2 0+j*10] elements=max(data(:,1)) bus=max(max(data(:,2)),max(data(:,3))) y=zeros(bus,bus); for p=1:bus, for q=1:elements, if(data(q,2)==p|data(q,3)==p) y(p,p)=y(p,p)+data(q,4)+data(q,5); end end end for p=1:bus, for q=1:bus, if (p~=q) for r=1:elements if((data(r,2)==p&data(r,3)==q)|(data(r,2)==q&data(r,3)==p)) y(p,q)=-(data(r,5)); end end end end end y z(bus)=inv(y)

OUT PUT

13

zbus =

0 - 0.8487i 0 - 0.8289i 0 - 0.8224i

0 - 0.8289i 0 - 0.8487i 0 - 0.8224i

0 - 0.8224i 0 - 0.8224i 0 - 0.8553i

14

RESULT: Thus the impedance bus matrix was determined and verified using MATLAB.

15

EX.NO:

ADMITTANCE MATRIX

DATE:

AIM: To determine the admittance and impedance matrix and verify it using MATLAB simulation SOFTWARE REQUIRED: MATLAB ALGORITHM: 1. The line impedance are converted to admittance 2. Initialize admittance bus(Y bus) to Zero 3. Line data searched in first loop 4. Then off diagonal elements are entered 5. Line data is searched to find the elements connected to a bus

THEORY: The power flow equation can be final out by using impedance and admittance matrix ADMITTANCE MATRIX: The interconnection between the various modes for a given system and the admittance value for each interconnecting circuits can be known as the admittancematrix.This matrix may be assembled as follows the diagonal element of each node is sum of admittance connected to it off diagonal element is the negated admittance between the nodes. IMPEDANCE MATRIX: The matrix consistingofdriving point impedances and transferimpedances of the buses and off diagonal elements of bus impedance matrix are called transfer impedances of the buses

16

FLOW CHART:

Start Line Impedance Converted Into Admittance Initialize the Matrix

FOR K=1=nb r

IF NI(t) > 0 &Nr(t)>0

Y(n)(k),nr(k)=yn(k),nr(k),-y(k) Y(nr(k),n1(k)=y(n)(k),nr(k)

Continue

for K=1=nbu ss

17

for K=1=nBU S

IF N1(K)= nNr (K)=n

Y(n,n)=Y(n,n)+Y(K)

Continue

CONTINU E

Stop

Stop

18

PROGRAM:
%FORMATION OF BUS ADMITTANCE MATRIX clc; data=[1 1 2 0+j*0.2 0+j*20 2 2 3 0+j*0.2 0+j*10 3 1 3 0+j*0.2 0+j*10] elements=max(data(:,1)) bus=max(max(data(:,2)),max(data(:,3))) y=zeros(bus,bus); for p=1:bus, for q=1:elements, if(data(q,2)==p|data(q,3)==p) y(p,p)=y(p,p)+data(q,4)+data(q,5); end end end for p=1:bus, for q=1:bus, if (p~=q) for r=1:elements if((data(r,2)==p&data(r,3)==q)|(data(r,2)==q&data(r,3)==p)) y(p,q)=-(data(r,5)); end end end end end y

19

OUTPUT: y=

0 +30.4000i 0 -20.0000i 0 -10.0000i

0 -20.0000i 0 +30.4000i 0 -10.0000i

0 -10.0000i 0 -10.0000i 0 +20.4000i

20

RESULT: Thus the admittance bus matrix was determined and verified using MATLAB

21

EX.NO:

GAUSS- SEIDAL METHOD

DATE:

AIM: To determine and verify load flow solution by gauss-seidal method using MATLAB simulation. SOFTWARE REQUIRED: MATLAB ALGORITHM: 1. Assume a flat voltage profile for all nodal voltage except the slack bus 1 2. 1.set iteration count k=0. 3. Set bus count p=1. 4. Check for the slack bus. If it is not slack bus go to next step.
5. Calculate the bus voltage Vpk+1 using this equation

Vp=[1/Ypp]{[Pp-jQp)Vp*]-nYppVq q=1,qp
6. Advanced the bus count by 1 to evaluate other value of Vpk&Vpk

7. Check if all buses have been taken in to account ,if yes ,go to next step otherwise go to step4. 8. Determine the largest all data value of change in voltageV max. 9. If V max is less a specified tolerance & evaluate line flows & print the voltage & line flows.
10. If not, advance the iteration count k=k+1 & go to step3.

THEORY: The gauss-seidal method is an iterative algorithm for solving a set of non liner load flow equation The process of computing all the bus voltages is called one iterarion.the iterative process is then repeated till the bus voltage converges with in prescribed accuracy. The converges of bus voltage is quite sensitive to the initial values assumed. Based on practical experience it is easier to get a set of initial voltages very close to final solution. To compute the (k+1)th iteration value of the bus-p voltage, the (k+1)th iteration values of voltages are used for all buses less than p and kth iteration values are used for all buses greater than or equal top It is important to note that the slack bus is a reference bus and so its voltage will not change. Therefore in each iteration the slack bus voltage is not modified. For generator bus, the reactive power is not refer specified. Thee in order to calculate the phase of bus voltage of a generator bus.

22

PROGRAM:
clear all clc disp('..........load flow solution'); n=input('enter the no: of buses='); Ybus=[ 2.2-9i -1+5i -1.2+4i 0 -1+5i -1.2+4i 0 2.6-11i -0.5+4i -1.1+2i -0.5+4i 2.9-11i -1.2+3i -1.1+2i -1.2+3i 2.3-5i];

V(1)=input('slack bus vge:'); disp('enter power -ve for load and +ve for generators...'); for it=2:n text=sprintf('bus bo:%g',it); disp(text); p(it)=input('real power:'); q(it)=input('reactive power:'); if q(it)==0 Vnspe(it)=input('vge magnitude:'); elsenspe() Vnspe(it)==0 end end e=input('enter the tolerance limit:'); a=input('enter the acceleration factor:'); Kmax=input('enter the max number of iterations allowed:');

23

K=0 for it=2:n V(it,1)=1+0i; end delmax=1 while delmax>e K=K+1 if K>Kmax break disp('required convergance was not achieved...'); end for it=2:n sum1=0;sum2=0 V(1,K)= V(1,K) for ji=1:n if ji<it sum1=sum1+Ybus(it,ji)*V(ji,K); elseif ji>it sum2=sum2+Ybus(it,ji)*V(ji,K); end end V(it,K)=(1/Ybus(it,it))*(((p(it)-j*q(it))/conj(V(it,K)))-sum1-sum2); delV(it)=V(it,K)-V(it,K) V(it,K)=V(it,K)+a*delV(it) end end

24

OUTPUT:
..........load flow solution enter the no: of buses=4 slack bus vge:1.06 enter power -ve for load and +ve for generators... bus bo:2 real power:0.5 reactive power:0.1456 bus bo:3 real power:0.4 reactive power:0.3 bus bo:4 real power:0.2 reactive power:0.1 enter the tolerance limit:0.001 enter the acceleration factor:1 enter the max number of iterations allowed:1 K= 0 delmax = 1 K= 1 sum2 = 0 V=

25

1.0600 1.0000 1.0000 1.0000 delV = 0 V= 1.0600 1.0498 + 0.0391i 1.0000 1.0000 sum2 = 0 V= 1.0600 1.0498 + 0.0391i 1.0000 1.0000 delV = 0 V= 1.0600 1.0498 + 0.0391i 1.0758 + 0.0394i 1.0000 sum2 = 0 0 0 0

V=

26

1.0600 1.0498 + 0.0391i 1.0758 + 0.0394i 1.0000 delV = 0 V= 1.0600 1.0498 + 0.0391i 1.0758 + 0.0394i 1.0967 + 0.0640i K= 2 >> 0 0 0

27

RESULT: Thus the load flow solution was determined and verified by gauss-seidal method using MATLAB simulation.

28

EX.NO:

NEWTON RAPHSON METHOD

DATE:

AIM: To solve the load flow problem by using Newton raphson method with MATLAB program. SOFTWARE REQUIRED: MAT LAB ALGORITHM: 1.Assume a suitable solution for all buses except the slack bus 2.set convergence criterion = ie, if the largest of absolute of the residues exceeds the process. ,otherwise it is terminated. 3. set iteration count k=0 4.set bus count p=1 5.check if p is a slack bus . if yes ,go to step 10. 6.calculate the real $ reactive power Pp $ Qp respectively using formulate 7.Evaluate Ppk=psp - ppk 8.check if the bus in question is generator bus . if not go to step 10 9.Evaluate Qppk = Qps - Qpk 10.1advance the bus count by 1, ie p=p+1 $ check if all the buses have been accounted, 11.If not go to step 10 12.Determine the largest of the absolute value of the residue. 13.If the largest of the absolute value of the residue is lessthan $ go to step 17. 14.Evaluate the element b for jacobian matrix 15.calculate voltage in element epk $ fpk. 16.calculate new bus voltage epk+1=epk+ epk & fpk+1=fpk+fpk. It repeated

29

17.Advance iteration count k=k+1 & go to step 4 18.Evaluate bus & line power $ line power $ print the result b. PROGRAM: clear all clc nb=3%input('enter the no of buses:'); nl=3%input('enter the no of lines:'); sb=[1 1 2]; cb=[2 3 3]; z=[0.08+0.24*j 0.02+0.06*j 0.06+0.18*j]; lca=[0 0 0]; ybus=zeros(nb,nb); for j=1:nb k=sb(j); m=cb(j); ybus(k,k)=ybus(k,k)+(1/(z(j)+lca(j))); ybus(m,m)=ybus(m,m)+(1/(z(j)+lca(j))); ybus(k,m)=-1/z(j); ybus(m,k)=ybus(k,m); end ybus void=[1.06+0*j 1+0*j 1+0*j]; sl= [0+0*j 0.2+0*j -0.6-0.25*j]; e=real(void); f=imag(void); ps=real(sl); qs=imag(sl); g=real(ybus); b=imag(ybus); con=10; while(con>0.001) for j=2:nb p(j)=0; q(j)=0; for k=1:nb p(j)=p(j)+((e(j)*((e(k)*g(j,k))+(f(k)*b(j,k)))) +f(j)*((f(k)*g(j,k))-(e(k)*(b(j,k))))); q(j)=q(j)+((f(j)*((e(k)*g(j,k))+(f(k)*b(j,k))))(e(j)*((f(k)*g(j,k))-(e(k)*b(j,k))))); end end delp=ps-p; delq=qs-q; for j=2:nb sumpe=0; sumpf=0; sumqe=0; sumqf=0;

30

for k=1:nb if(k==j) sumpe=sumpe+((e(k)*g(j,k))+(f(k)*b(j,k))); sumpf=sumpf+((f(k)*g(j,k))-(e(k)*b(j,k))); sumqe=sumqe+((f(k)*g(j,k))-(e(k)*b(j,k))); sumqf=sumqf+((e(k)*g(j,k))+(f(k)*b(j,k))); end if(k==1)&(k==j) delpe(j,k)=(e(j)*g(j,k))-(f(j)*b(j,k)); delpe(j,k)=(e(j)*b(j,k))+(f(j)*g(j,k)); delpe(j,k)=(e(j)*b(j,k))+(f(j)*g(j,k)); delpe(j,k)=-(e(j)*g(j,k))+(f(j)*b(j,k)); end end delpe(j,j)=(2*e(j)*g(j,j))+sumpe; delpf(j,j)=(2*f(j)*g(j,j))+sumpf; delqe(j,j)=(2*e(j)*b(j,j))-sumqe; delqf(j,j)=(2*f(j)*b(j,j))+sumqf; end for j=1:nb-1 for k=1:nb-1 delpem(j,k)=delpe(j+1,k+1); delpfm(j,k)=delpf(j+1,k+1); delqem(j,k)=delqe(j+1,k+1); delqfm(j,k)=delqf(j+1,k+1); end delpm(j)=delp(j+1); delqm(j)=delq(j+1); end jacob=[delpem delpfm;delqem delqfm]; dels=[delpm delqm]; con=max(dels); c=inv(jacob)*dels'; for j=2:nb e(j)=0; f(j)=0; e(j)=e(j)+c(j-1); f(j)=f(j)+c(j+1); end end p q jacob e f

31

OUTPUT: nb = 3 nl = 3 ybus = 6.2500 -18.7500i -1.2500 + 3.7500i -5.0000 +15.0000i -1.2500 + 3.7500i 2.9167 - 8.7500i -1.6667 + 5.0000i -5.0000 +15.0000i -1.6667 + 5.0000i 6.6667 -20.0000i p= 0 1.2615 5.6411 q= 0 0.7887 2.6847 jacob = 2.8772 0 -1.5702 0

0 15.8571 -1.2193

0 0.1485 0

0 6.8890

0 -21.3904 e=

0 26.2305

1.0600 -0.4776 -0.4366 f= 0 -0.1990 -0.4584

32

RESULT: Thus the power flow using newton rapshon method was performed and verified using MATLAB simulation.

33

EX.NO:

STABILITY ANALISIS

DATE:

AIM: To determine the single machine infinite bus system stability. SOFTWARE REQUIRED: MATLAB FORMULAE: Pmax=Eu/x do=asin(pm/pmax) Ps=Pmax cos(do) Wm=(*60/Hps) Z=D/2(*60/Hps) Wd=Wn(1-Z^2) Fd=Wd/2 Tau=1/ZWn Th=a cosZ Ddo=10/180 Dd=Ddo/(1-Z^2)*exp(-ZWnt)*sin(Wdt+Th) d=(do+Dd)18/ Dw=-Wn*Ddo/(1-Z^2)*exp(-ZWnt)*sin(Wdt) =o+Dw/2*

34

PROGRAM: %Single machine infinite bus system stability% %stability analysis% clear all clc E=1.2056; V=1.1;H=4.5;X=0.65;Pm=1.7;D=0.138;fo=50; Pmax=E*V/X do=asin(Pm/Pmax) Ps=Pmax*cos(do) Wn=sqrt(pi*60/H*Ps) Z=D/2*sqrt(pi*60/(H*Ps)) Wd=Wn*sqrt(1-Z^2) Fd=Wd/(2*pi) Tau=1/(Z*Wn) Th=1/(Z*Wn) Th=acos(Z) Ddo=10*pi/180 t=0:.01:3; Dd=Ddo/sqrt(1-Z^2)*exp(-Z*Wn*t).*sin(Wd*t+Th); d=(do+Dd)*180/pi; Dw=-Wn*Ddo/sqrt(1-Z^2)*exp(-Z*Wn*t).*sin(Wd*t); f=fo+Dw/(2*pi); subplot(2,1,1),plot(t,d),grid xlabel('t sec'),ylabel('Delta deg') subplot(2,1,2),plot(t,f),grid xlabel('t sec'),ylabel('Freq hZ') subplot(111)

35

FLOW CHART:

START
Initialise The Value Of E ,V ,H ,X ,Pm ,D ,Fo

Calculate, Pmax=Eu/x Do= asin(Pm/Pmax) Ps= Pmax cos(do) Wn=(x60/Hps) Z=(D/2)(x60/Hps) Wd=Wn(1-z^2) Fd=Wd/2 Tau=1/Zwn Th=acosz Ddo=10/180 Dd=Ddo/(1-z^2)exp(-zwnt)sin(wdt+Tn) D=(do+Dd)18/ Dw=WnDdo/(1-z^2) exp(-zwnt)sin(wdt) =o+Dw2

STOP

36

OUTPUT: Pmax =2.0402 do = 0.9849 Ps = 1.1281 Wn = 6.8741 Z = 0.4205 Wd = 6.2370 Fd = 0.9926 Tau = 0.3460 Th = 0.3460 Th = 1.1368 Ddo = 0.1745

WAVE FORM:

37

38

RESULT: Thus the stability analysis of single machine infinite bus system was determined and it was checked by using MATLAB

EX.NO:

ECONOMIC DISPATCH CONTROL

DATE:

39

AIM: To determine the economic scheduling of generators and estimate the fuel cost and verifying it with MATLAB simulation.

SOFTWARE REQUIRED: MATLAB ALGORITHM: 1.Assign initial trial value of or calculate using

= 2. Compute PGi corresponding to using formula

PGi =

; i=1,2..N

3. Compute: 4. Check the power balance equation

ied

5. The power balanced equation is satisfied and then optimum solution is Obtained, otherwise go to step 6. If If = = ied assign =+ ,incremental and go to step 2

7. Assign =- , decrement and go to step 2; Therefore

= p/

40

THEORY: Purpose of the economic dispatch or optimal dispatch is to reduce the fuel costs for the power system. By economic load scheduling, we mean to find the generation of for different generators or plants, so that fuel cost is minimum and at the same time and losses at any instant must be met by the total generation. The economic dispatch problem involves the solution of two different problems, i.e... unit commitment and online dispatch. There are two methods used to find the economic dispatch. 1) Base load method, Where the most efficient unit is loaded to it is maximum capability, then the second most efficient unit is loaded etc. 2) Best point method (incremented method) Where units are successively loaded to their lowest heat rate point beginning with most efficient unit and working down to the last efficient unit.

41

FLOW CHART:

START
Read a1,a2,b1,b2,c1,c2,pd,pmax,pmi _=(pd+b1/2a1+b2/2a2) (1/2a1+1/2a2) Pg1=(_-b1)/(2*a1)

Pg2=(_-b2)/(2*a2)

If Pg1<p min

Pg1=pmin Pg2=pd-pg1

If Pg1>p Pg1=pmax max If Pg2<p max min F1=(((a1)*pg1^2)+pg1*b1+c1 Pg2=pmin Pg2=pmax F2=(((a2)*pg2^2)+pg2*b2+c2 Totalcost=f1+f2

Pg2=pd-pg1
Pg1=pd-pg2 Pg1=pd-pg2

42

END
PROGRAM: clc clear all a1=input('enter a1=') a2=input('enter a2=') b1=input('enter b1=') b2=input('enter b2=') c1=input('enter c1=') c2=input('enter c2=') PD=input('enter the total demand=') Pmax=input('enter the maximum limit=') Pmin=input('enter the minimum limit=') Lambda=(PD+(b1)/(2*a1)+(b2)/(2*a2))/((1)/(2*a1)+(1)/(2*a2)) disp('Lambda') pg1=(Lambda-b1)/(2*a1); pg2=(Lambda-b2)/(2*a2); if pg1<Pmin

43

pg1=pmin; pg2=PD-pg1; end if pg1>Pmax pg1=Pmax; pg2=PD-pg1; end if pg2<Pmin pg2=pmin; pg1=PD-pg2; end if pg2>Pmax pg2=Pmax; pg1=PD-pg2; end pg1 pg2 f1=(((a1)*pg1^2)+pg1*b1+c1) f2=(((a2)*pg2^2)+pg2*b2+c2) totalcost=f1+f2

OUTPUT enter a1=0.07 a1 =

44 0.0700 enter a2=0.1125 a2 = 0.1125 enter b1=21 b1 = 21 enter b2=21 b2 = 21 enter c1=100 c1 = 100 enter c2=200 c2 = 200 enter the total demand=250 PD = 250 enter the maximum limit=200 Pmax = 200 enter the minimum limit=1 Pmin = 1 Lambda = 42.5753 Lambda pg1 =

45 154.1096 pg2 = 95.8904 f1 = 4.9988e+003 f2 = 3.2481e+003 totalcost = 8.2469e+003

>>

46

RESULT: Thus the economic dispatch control was verified and determined using MATLAB.

EX.NO:

LOAD FREQUENCY CONTROL

DATE:

47

AIM: To simulate the transient analysis of load control model. Single area without PI controller, single area with PI controller, two area system. THEORY: Real or active power control is one of the important control actions to be performed during normal operation of the system to match the system generation with the continuously changing load, in order to maintain constancy of the system frequency to a tolerable limit of 5% A changing in system load causes a change in speed of all turbine generator system, leading to change in system frequency PRIMARY CONTROL: The speed change from synchronous speed initiates the governor control action resulting in all the participating generator-turbine units taking up the change in load ,and stabilize the system frequency. SECONDARY CONTROL: It adjust the load reference set points of selected turbine generator units so as to give normal value of frequency An isolated power station has the following terms Turbine time constant TT=0.5ses Governor time constant TG=0.2ses Governor inertia constant H=5ses Governor speed regulation=R per unit DPL=0.2

Using MATLAB SIMULINK obtain dynamic load frequency control system without PI controller and with PI controller assume Ki=7 and KP=20 A the area system connected by a tie line has the following parameters on a 1000MVA connection base. Area Speed regulation Frequency-sens.load Co-efficiency 1 R1=0.005 D1=0.6 R2=0.0625 D2=0.9 2

48

Inertia constant Base power Governor time constant Turbine time constant

H1=5 1000MVA Tg1=0.2ses TT1=0.5ses

H2=4 1000MVA Tg1=0.3ses TT2=0.6ses

Using MATLAB SIMULINK obtain dynamic response of the system.

LOAD FREQUENCY CONTROL WITHOUT INTEGRATER

49

LOAD FREQUENCY CONTROL WITH INTEGRATER

50

51

RESULT: The simulink was constructed using MATLAB and it was run in the simulink. The simulink response was checked and verified.

52

EX.NO:

SHORT CIRCUITY ANALYSIS

DATE:

AIM:

To perform short circuit analysis to find short circuit currents and bus voltages using MATLAB program
SOFTWARE REQUIRED:

MATLAB
ALGORITHM: From the bus admittance matrix for the network/ Assemble the bus admittance matrix(Ybus). Find the inversion of Ybus to get bus impedance matrix (Zbus). Compute the magnitude of the short circuits current in the fault.
From step4 obtain short circuits current at buses 1, 2, 3. Find the bus voltage drop using the formula and also short circuits current.

FORMULA:
Yii= N k=1 (Ypik+Ysik)

Ki Y1k=Yki

THEORY: Short circuit analysis is performed on a simple power system using the characteristic currents method. Assuming as reference the IEC 909, the characteristic currents method modifies the calculation of the initial symmetrical fault currents corresponding to the 1/2 cycle symmetrical fault currents discussed in the ANSI/IEEE Standards C37.0101979 and C37.13-1981. The approach is based on the correlation between the impedance of each power device and the inverse of a new parameter which is defined as the short circuit characteristic current of the component itself. The use of the characteristic currents as parameters makes the short circuit analysis easier and allow an immediate perception of what is calculated. Moreover, this method is particularly suitable to be implemented on a spreadsheet program and for the application to an approximate evaluation of the short circuit currents which is helpful during the preliminary design as well as in verifying and testing the electric power systems in buildings

53

CLASSICAL CALCULATION

. Begin by converting all impedances to per unit values. Per unit base values and formulae used are as follows: Sbase =100MVA Vbase =26.4 kV

54

SHORT CIRCUIT ANALYSIS PROGRAM: clear all clc % From To R X zdata=[0 1 0 0.15 0 2 0 0.075 1 2 0 0.1 2 3 0 0.1 3 1 0 0.1]; nl=zdata(:,1);nr=zdata(:,2);X=zdata(:,4); nbr=length(zdata(:,1));nbus=max(max(nl),max(nr)); Z=j*X; %branch impedance Y=ones(nbr,1)./Z; %branch admittance Ybus=zeros(nbus,nbus); %initialize Ybus to zero for k=1:nbr; % formation of the off diagonal elements 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; %bus admittance matrix Zbus=inv(Ybus); % bus impedance matrix zf=0; v=[1 1 1]; %pre fault voltage vfa=[0 0 0]; selectedbus=input('selected bus 1,2,3='); i=selectedbus If=v(i)/(zf+Zbus(i,i)); for k=1:3 if k~i vf(k)=v(k)-(Zbus(i,k)*v(k)/(zf+Zbus(i,i))); vfa(k)=vfa(k)+vf(k); vf(i)=zf*v(i)/(zf+Zbus(i,i)); vfa(i)=vfa(i)+vf(i); i12f=abs(vfa(1)-vfa(2))/X(3); i13f=abs(vfa(1)-vfa(3))/X(4); i23f=abs(vfa(2)-vfa(3))/X(5); end end vfa i12f

55

i13f i23f If=abs(If)

OUTPUT:
selected bus 1,2,3=1 i= 1 ans = 0 ans = 0 ans = 0 vfa = 0 i12f = 4.7059 i13f = 2.3529 i23f = 2.3529 If = 13.7255 >> selected bus 1,2,3=2 i= 2 0.4706 0.2353

56 ans = 0 ans = 0 ans = 0 vfa = 0.3077 i12f = 3.0769 i13f = 1.5385 i23f = 1.5385 If = 17.9487 >> selected bus 1,2,3=3 i= 3 ans = 0 ans = 0 ans = 0 vfa = i12f = 0.4507 0.5352 0 0 0.1538

57 0.8451 i13f = 4.5070 i23f = 5.3521 If = 9.8592 >>s

58

RESULT: Thus the short circuit current and bus voltage of symmetrical circuits were found using MATLAB program.

59

EX.NO:

LOAD FLOW ANALYSIS BY FAST DECOUPLED METHOD

DATE:

AIM: To perform load flow equation by using fast decoupled method using MATLAB THEORY: Due to the weak coupling between PV and q-d half of the elements of jacobian matrix are neglected further the assumptions made are Cos dij=1 Sin dij=0 Qi<<Bij|v|2 The simplified FDLF equations are (?P/|V|)=[B][?d] (?Q/|V|)=[B][?|V|] One iteration implies one solution for [?d] to update [d] and one solution for [?P/|V|] to update [|v|] and is termed as 1-d and 1-V iteration. The converges for the real and reactive power is achieved when max [?P]<?P; max[?Q]<=?Q. The main advantage of the decoupled load flow as compared to Newton Raphson method is its reduced memory is storing Jacobian. ALGORITHM: Step1: Input the total number of buses Step2: Input the Y-bus matrix of order n X n. Step3: Assume all the bus voltages are 1 pu except slack bus. Step4: Form susceptance matrix B and B. Step5: Set the iteration count as K=0. Step6: Set Vs=0; rv=0. Step7: Calculate the real and reactive power Pi using the formula ?Pir= ? VpqYpq*cos(Qpq + ?p - ?q) Step8: Evaluate ?Pir = Pispec Pir. Step9: Test for convergence if max(? Pir<?P)then set rs=1 and go to next step otherwise go to step2.

60

Step10: check if rv=1 then calculate the slack bus power and all line flows and print the result otherwise go to step 13. Step11: Set rv=0 then calculate ?sir using (?p/|V|)=[B][?d] Step12: Calculate dir+1=dir+dir. Step13: Calculate ?Qir using Qispec Qir. Step14: Test for convergence if max(? Qi)<?P then set rv=1 and go to next step otherwise go to step17. Step15: Check if rs=1 then go to step 19. Step16: Otherwise advance the iteration count by 1and go to step 8. Step17: Set rs=0 and calculate ?|Vi|r using (?Q / |V|)=[B][?|V|] Step18: Calculate |Vi|r +1= |Vi|r + ?|Vi|r and go to step 16. Step19: Calculate slack bus power and all lines flows and print the result.

FLOW CHART:

61

PROGRAM:

62

clear all; clc; k=2; %line data nb=input('Enter The Number Of Buses\n'); n1=input('\nEnter The Number Of Lines\n'); sb=input('\nEnter The Number Of Starting Bus\n'); eb=input('\nEnter The Number Of Ending Bus\n'); sli=input('\nEnter The Details of Series Line Impedance\n'); lca=input('\nEnter The Details of Line Charging Admittance\n'); volt=input('\nEnter The Voltage Magnitude of Buses\n'); %formation of y bus for m=1:nb for n=1:nb if m==n||m~=n if lca(m,n)==0 n=n+1; else y(m,n)=+sli(m,n)^-1+lca(m,n); y(n,n)=+sli(m,n)^-1+lca(m,n); y(n,m)=-sli(m,n)^-1; y(n,m)=y(m,n); end end end end fprintf('The Y Bus Matrix is \n'); ybus=y bbus=-imag(ybus)

63

fprintf('The b1-Bus Matrix is \n'); bbus1=bbus(2:nb,2:nb) fprintf('The b2-Bus Matrix is \n'); bbus2=bbus1(2:nb-1,2:nb-1) invbbus1=bbus1^-1 invbbus2=bbus2^-1 for k=2:nb for k=1:nb power(k,1)=(+(volt(k)*y(k,1)*volt(1))); end end po=power(1:nb,1:1) realpower=real(po) reactivepower=-imag(po) for k=1:nb-1 delpo(nb)=reactivepower(nb)-realpower(nb); delpq(nb)=reactivepower(nb)-realpower(nb); delnew(nb)=invbbus1(nb-1)*delpo(nb-1); delv(nb)=invbbus2(nb-2)*delpoq(nb-2); end de=delpo dq=delq dn=delnew dv=delv

OUTPUT:

64 Enter The Number Of Buses 3 Enter The Number Of Lines 3 Enter The Number Of Starting Bus [1 2 2] Enter The Number Of Ending Bus [2 3 3] Enter The Details of Series Line Impedance [0.02+0.04j 0.01+0.03j 0.0125+0.025j] Enter The Details of Line Charging Admittance [0.05j 0.025j 0.025j] Enter The Voltage Magnitude of Buses [1 .05 1 1] The Y Bus Matrix is ybus= 16-31.9750i -4.8077+0.9115i 16-31.9750i bbus= 31.9750i -0.9115i 31.9750i -0.9115i -29.9750i -29.9750i 31.9750i -29.9750i 29.9750i -4.8077+0.9115i -10+29.9750i 10+29.9750i 16-31.9750i 10+29.9750i 10+29.9750i

The b1-Bus Matrix is -29.9750i -29.9750i -29.9750 29.9750i

The b2-Bus Matrix is 29.9750 invbbus1=

65 -0.0167 -0.0167 invbbus2= 0.0334 po= 0 -5.0481+0.9571i 16.8000-33.5738i realpower= 0 -5.0481 16.8000 reactivepower= 0 -0.9571i 33.5738 de= 0 0 16.7738 dq= 0 0 16.7738 dn= 0 0 0 dv= 0 0 0 -0.0167 +0.0167

66

RESULT: The program for load analysis by fast decoupled method is written in MATLAB and the results are verified.

Вам также может понравиться