You are on page 1of 39

Industrial structure subjected to the El Centro earthquake motion (Chopra, 2012)

Contents
Statement of the problem
Initialization of structural input data
Calculation of structural properties
Load earthquake response spectrum data
Dynamic Response Spectrum Analysis (DRSA)
Modal combination with the ABSolute SUM (ABSSUM) method.
Modal combination with the Square Root of Sum of Squares (SRSS) method.
Modal combination with the Complete Quadratic Combination (CQC) method.
Assemble values of peak response in a table.
Copyright

Statement of the problem


An industrial structure is modeled as 2-DOF system as shown in the following figure. Determine the lateral displacement, base shear and base moment of the structure due to El-Centro,
1940 earthquake ground motion using the response spectrum method. Take , , and . The damping ratio for all natural modes
is .

Initialization of structural input data


Set the length of the structure members in m.

L=2;

Set the flexural stiffness in Nm^2.

EI=80000;

Set the lumped masses in kg.

m1=100;
m2=200;

Calculation of structural properties


Calculate the stiffness matrix of the structure in N/m.

K=6*EI/(7*L^3)*[8,-3;-3,2];

Calculate the mass matrix of the structure in kg.


M=[m1+m2,0;0,m2];

Set the spatial distribution of the effective earthquake forces. Earthquake forces are applied only at dof No 1 of the structure.

r=[1;0];

Load earthquake response spectrum data


Earthquake displacement response spectrum of the El Centro earthquake (El Centro, 1940, El Centro Terminal Substation Building)

Sd=load('Sd2.txt');

Earthquake pseudoacceleration response spectrum of the El Centro earthquake (El Centro, 1940, El Centro Terminal Substation Building)

PSa=load('PSa2.txt');

Set the critical damping ratio of the response spectra ( )

ksi=0.02;

Dynamic Response Spectrum Analysis (DRSA)


Consider all eigenmodes of the building

eigInd=[1;2];

Perform DRSA analysis

[U,~,~,f,omega,Eigvec] = DRSA(K,M,r,PSa,Sd,[],[],eigInd);

Set the number of eigenmodes of the structure.

neig=numel(omega);

Plot the natural modes of vibration of the industrial structure

FigHandle=figure('Name','Natural Modes','NumberTitle','off');
set(FigHandle,'Position',[50, 50, 1000, 500]);
for i=1:neig
subplot(neig,1,i)
plot([0;10*Eigvec(1,i);L],[0;L;10*Eigvec(2,i)+L],'LineWidth',2.,...
'Marker','.','MarkerSize',20,'Color',[0 0 1],'markeredgecolor','k')
grid on
xlabel('Displacement','FontSize',13);
ylabel('Height','FontSize',13);
title(['Mode ',num2str(i)],'FontSize',13)
end
Calculate the peak modal base shear (N).

Vb=zeros(neig,1);
for i=1:neig
Vb(i)=f(1,i);
end
Vb

Vb =

1.0e+03 *

0.2239
2.0932

Calculate the peak modal base overturning moment (Nm).

Mb=zeros(neig,1);
for i=1:neig
Mb(i)=L*sum(f(:,i));
end
Mb

Mb =

1.0e+03 *

1.1388
2.3778

Modal combination with the ABSolute SUM (ABSSUM) method.


Calculation of peak base shear.

VbAbsSum=ABSSUM(Vb);
Calculation of peak base overturning moment.

MbAbsSum=ABSSUM(Mb);

Calculation of peak lateral displacement.

u1AbsSum=ABSSUM(U(1,:)');

Modal combination with the Square Root of Sum of Squares (SRSS) method.
Calculation of peak base shear.

VbSRSS=SRSS(Vb);

Calculation of peak base overturning moment.

MbSRSS=SRSS(Mb);

Calculation of peak lateral displacement.

u1SRSS=SRSS(U(1,:)');

Modal combination with the Complete Quadratic Combination (CQC) method.


Calculation of peak base shear.

VbCQC=CQC(Vb,omega,ksi);

Calculation of peak base overturning moment.

MbCQC=CQC(Mb,omega,ksi);

Calculation of peak lateral displacement.

u1CQC=CQC(U(1,:)',omega,ksi);

Assemble values of peak response in a table.

C{1,2}='Lateral Displ. (m)';


C{1,3}='Base Shear (N)';
C{1,4}='Base Moment (Nm)';
C{2,1}='ABSSUM';
C{2,2}=u1AbsSum;
C{2,3}=VbAbsSum;
C{2,4}=MbAbsSum;
C{3,1}='SRSS';
C{3,2}=u1SRSS;
C{3,3}=VbSRSS;
C{3,4}=MbSRSS;
C{4,1}='CQC';
C{4,2}=u1CQC;
C{4,3}=VbCQC;
C{4,4}=MbCQC;
C

C =

4×4 cell array

Columns 1 through 3

{0×0 double} {'Lateral Displ. …'} {'Base Shear (N)'}


{'ABSSUM' } {[ 0.0494]} {[ 2.3171e+03]}
{'SRSS' } {[ 0.0349]} {[ 2.1052e+03]}
{'CQC' } {[ 0.0349]} {[ 2.1054e+03]}

Column 4

{'Base Moment (Nm)'}


{[ 3.5166e+03]}
{[ 2.6364e+03]}
{[ 2.6374e+03]}

Copyright
Copyright (c) 2015-2021 by George Papazafeiropoulos

Major, Infrastructure Engineer, Hellenic Air Force


Civil Engineer, M.Sc., Ph.D. candidate, NTUA
Email: gpapazafeiropoulos@yahoo.gr

Published with MATLAB® R2017b


2-DOF shear buiding analyzed according to a design response spectrum

Contents
Statement of the problem
Initialization of structural input data
Calculation of structural properties
Load earthquake response spectrum data
Dynamic Response Spectrum Analysis (DRSA)
Modal combination with the Square Root of Sum of Squares (SRSS) method.
Copyright

Statement of the problem


For the design spectrum below calculate the maximum displacements and interstorey drifts of the two floors and the base shear. Take behavior factor equal to 3.

Initialization of structural input data


Set the storey stiffnesses of the structure in N/m.

k1=200e6;
k2=150e6;

Set the storey lumped masses of the structure in kg.


m1=100e3;
m2=80e3;

Set the number of eigenmodes of the structure, which is equal to the number of its storeys.

neig=2;

Calculation of structural properties


Calculate the stiffness matrix of the structure in N/m.

K=[k2,-k2;-k2,k2+k1];

Calculate the mass matrix of the structure.

M=[m2,0;0,m1];

Set the spatial distribution of the effective earthquake forces. Earthquake forces are applied at all dofs of the structure.

r=[1;1];

Load earthquake response spectrum data


Pseudoacceleration design response spectrum

T1=linspace(0.01,0.24,30)';
T2=linspace(0.25,5,100)';
PSa=[[T1;T2],[0.3*9.81*ones(size(T1));0.3*9.81*(0.25./T2).^(2/3)]];

Displacement design response spectrum

Sd=[PSa(:,1),PSa(:,2).*(PSa(:,1).^2)/4/pi^2];

Set the behavior factor

q=3;

Dynamic Response Spectrum Analysis (DRSA)


Consider all eigenmodes of the building

eigInd=[1;2];

Perform DRSA analysis

[U,~,~,f,omega,Eigvec] = DRSA(K,M,r,PSa,Sd,[],[],eigInd);

Cyclic eigenfrequencies of the structure

omega

omega =

28.7053
67.4611
Normalize the eigenmodes of the structure

phi1=Eigvec(:,1)/Eigvec(1,1)
phi2=Eigvec(:,2)/Eigvec(1,2)

phi1 =

1.0000
0.5605

phi2 =

1.0000
-1.4272

Design forces

f_design=f/q

f_design =

1.0e+04 *

9.5831 -1.7351
6.7146 3.0954

Plot the natural modes of vibration of the uniform five-story shear building

FigHandle=figure('Name','Natural Modes','NumberTitle','off');
set(FigHandle,'Position',[50, 50, 1000, 500]);
for i=1:neig
subplot(1,neig,i)
plot([0;Eigvec(:,i)],(0:1:neig)','LineWidth',2.,'Marker','.',...
'MarkerSize',20,'Color',[0 0 1],'markeredgecolor','k')
grid on
xlabel('Displacement','FontSize',13);
ylabel('Height','FontSize',13);
title(['Mode ',num2str(i)],'FontSize',13)
end
Plot the peak modal displacement response.

FigHandle=figure('Name','Displacements','NumberTitle','off');
set(FigHandle, 'Position', [50, 50, 1000, 500]);
for i=1:neig
subplot(1,neig,i)
plot([0;U(:,i)],(0:1:neig)','LineWidth',2.,'Marker','.',...
'MarkerSize',20,'Color',[0 1 0],'markeredgecolor','k')
xlim([-max(abs(U(:,i))) max(abs(U(:,i)))])
grid on
xlabel('Displacement (m)','FontSize',13);
ylabel('Height','FontSize',13);
title(['Mode ',num2str(i)],'FontSize',13)
end
Plot the peak modal equivalent static force response.

FigHandle=figure('Name','Equivalent static forces','NumberTitle','off');


set(FigHandle, 'Position', [50, 50, 1000, 500]);
for i=1:neig
subplot(1,neig,i)
plot([0;f_design(:,i)],(0:1:neig)','LineWidth',2.,'Marker','.',...
'MarkerSize',20,'Color',[1 0 0],'markeredgecolor','k')
xlim([-max(abs(f_design(:,i))) max(abs(f_design(:,i)))])
grid on
xlabel('Static force (N)','FontSize',13);
ylabel('Height','FontSize',13);
title(['Mode ',num2str(i)],'FontSize',13)
end
Calculate the design modal base shear in N.

Vb=zeros(neig,1);
for i=1:neig
Vb(i)=sum(f_design(:,i));
end
Vb

Vb =

1.0e+05 *

1.6298
0.1360

Modal combination with the Square Root of Sum of Squares (SRSS) method.
Design base shear.

VbSRSS=SRSS(Vb)

VbSRSS =

1.6354e+05

Design top-story shear.

V2SRSS=SRSS(f_design(2,:)')

V2SRSS =

7.3937e+04
Design top-story displacement.

u2SRSS=SRSS(U(2,:)')

u2SRSS =

0.0025

Design interstorey drift between 1st and 2nd storey.

i21SRSS=SRSS(U(2,:)'-U(1,:)')

i21SRSS =

0.0019

Design interstorey drift between 1st storey and ground.

u1SRSS=SRSS(U(1,:)')

u1SRSS =

0.0044

Copyright
Copyright (c) 2015-2021 by George Papazafeiropoulos

Major, Infrastructure Engineer, Hellenic Air Force


Civil Engineer, M.Sc., Ph.D. candidate, NTUA
Email: gpapazafeiropoulos@yahoo.gr

Published with MATLAB® R2017b


2-DOF shear buiding subjected to motion with exponential response spectrum

Contents
Statement of the problem
Initialization of structural input data
Calculation of structural properties
Load earthquake response spectrum data
Dynamic Response Spectrum Analysis (DRSA)
Modal combination with the ABSolute SUM (ABSSUM) method.
Modal combination with the Square Root of Sum of Squares (SRSS) method.
Modal combination with the Complete Quadratic Combination (CQC) method.
Assemble values of peak response in a table.
Copyright

Statement of the problem


A 2-degree-of-freedom system is subjected to horizontal earthquake excitation (figure below) with its response spectra as given below. Take the flexural rigidity, EI = 10^6 Nm^2
and length, L = 2m. Each lumped mass is 100 kg. Determine the maximum top mass floor displacement and base shear. Take 2% damping in each mode of vibration.
Initialization of structural input data
Set the storey height of the structure in m.

L=2;

Set the number of eigenmodes of the structure, which is equal to the number of its storeys.

neig=2;

Set the flexural rigidity of each floor in Nm^2

EI=1e6;

Set the lumped mass at each floor in kg.

m=100;

Calculation of structural properties


Calculate the stiffness matrix of the structure in N/m.

K=6*EI/(7*L^3)*[16,-5;-5,2];

Calculate the mass matrix of the structure.

M=m*eye(neig);

Set the spatial distribution of the effective earthquake forces. Earthquake forces are applied at all dofs of the structure.

r=ones(2,1);

Load earthquake response spectrum data


Earthquake pseudoacceleration response spectrum of the El Centro earthquake (El Centro, 1940, El Centro Terminal Substation Building)

T=linspace(0.01,5,100)';
PSa=[T,9.81*(0.1+T).*exp(-T)];
Earthquake displacement response spectrum of the El Centro earthquake (El Centro, 1940, El Centro Terminal Substation Building)

Sd=[T,PSa(:,2)./((2*pi./T).^2)];

Set the critical damping ratio of the response spectra ( )

ksi=0.02;

Dynamic Response Spectrum Analysis (DRSA)


Consider all eigenmodes of the building

eigInd=[1;2];

Perform DRSA analysis

[U,~,~,f,omega,Eigvec] = DRSA(K,M,r,PSa,Sd,[],[],eigInd);

Plot the natural modes of vibration of the uniform five-story shear building

FigHandle=figure('Name','Natural Modes','NumberTitle','off');
set(FigHandle,'Position',[50, 50, 1000, 500]);
for i=1:neig
subplot(1,neig,i)
plot([0;Eigvec(:,i)],(0:L:L*neig)','LineWidth',2.,'Marker','.',...
'MarkerSize',20,'Color',[0 0 1],'markeredgecolor','k')
grid on
xlabel('Displacement','FontSize',13);
ylabel('Height (m)','FontSize',13);
title(['Mode ',num2str(i)],'FontSize',13)
end

Plot the peak modal displacement response.


FigHandle=figure('Name','Displacements','NumberTitle','off');
set(FigHandle, 'Position', [50, 50, 1000, 500]);
for i=1:neig
subplot(1,neig,i)
plot([0;U(:,i)],(0:L:L*neig)','LineWidth',2.,'Marker','.',...
'MarkerSize',20,'Color',[0 1 0],'markeredgecolor','k')
xlim([-max(abs(U(:,i))) max(abs(U(:,i)))])
grid on
xlabel('Displacement (m)','FontSize',13);
ylabel('Height (m)','FontSize',13);
title(['Mode ',num2str(i)],'FontSize',13)
end

Plot the peak modal equivalent static force response.

FigHandle=figure('Name','Equivalent static forces','NumberTitle','off');


set(FigHandle, 'Position', [50, 50, 1000, 500]);
for i=1:neig
subplot(1,neig,i)
plot([0;f(:,i)],(0:L:L*neig)','LineWidth',2.,'Marker','.',...
'MarkerSize',20,'Color',[1 0 0],'markeredgecolor','k')
xlim([-max(abs(f(:,i))) max(abs(f(:,i)))])
grid on
xlabel('Static force (N)','FontSize',13);
ylabel('Height (m)','FontSize',13);
title(['Mode ',num2str(i)],'FontSize',13)
end
Calculate the peak modal base shear in N.

Vb=zeros(neig,1);
for i=1:neig
Vb(i)=sum(f(:,i));
end
Vb

Vb =

462.3558
57.0054

Calculate the peak modal base overturning moment in Nm.

Mb=zeros(neig,1);
for i=1:neig
Mb(i)=sum(f(:,i).*(L:L:2*L)');
end
Mb

Mb =

1.0e+03 *

1.6250
0.0602

Modal combination with the ABSolute SUM (ABSSUM) method.


Peak base shear.

VbAbsSum=ABSSUM(Vb);

Peak top-story shear.


V2AbsSum=ABSSUM(f(2,:)');

Peak base overturning moment.

MbAbsSum=ABSSUM(Mb);

Peak top-story displacement.

u2AbsSum=ABSSUM(U(2,:)');

Modal combination with the Square Root of Sum of Squares (SRSS) method.
Peak base shear.

VbSRSS=SRSS(Vb);

Peak top-story shear.

V2SRSS=SRSS(f(2,:)');

Peak base overturning moment.

MbSRSS=SRSS(Mb);

Peak top-story displacement.

u2SRSS=SRSS(U(2,:)');

Modal combination with the Complete Quadratic Combination (CQC) method.


Peak base shear.

VbCQC=CQC(Vb,omega,ksi);

Peak top-story shear.

V2CQC=CQC(f(2,:)',omega,ksi);

Peak base overturning moment.

MbCQC=CQC(Mb,omega,ksi);

Peak top-story displacement.

u2CQC=CQC(U(2,:)',omega,ksi);

Assemble values of peak response in a table.


Assemble values of peak response in a cell.

C{1,2}='Vb (N)';
C{1,3}='V2 (N)';
C{1,4}='Mb (Nm)';
C{1,5}='u2 (m)';
C{2,1}='ABSSUM';
C{2,2}=VbAbsSum;
C{2,3}=V2AbsSum;
C{2,4}=MbAbsSum;
C{2,5}=u2AbsSum;
C{3,1}='SRSS';
C{3,2}=VbSRSS;
C{3,3}=V2SRSS;
C{3,4}=MbSRSS;
C{3,5}=u2SRSS;
C{4,1}='CQC';
C{4,2}=VbCQC;
C{4,3}=V2CQC;
C{4,4}=MbCQC;
C{4,5}=u2CQC;
C

C =

4×5 cell array

Columns 1 through 4

{0×0 double} {'Vb (N)' } {'V2 (N)' } {'Mb (Nm)' }


{'ABSSUM' } {[519.3613]} {[377.0297]} {[1.6852e+03]}
{'SRSS' } {[465.8568]} {[351.1767]} {[1.6261e+03]}
{'CQC' } {[465.8695]} {[351.1707]} {[1.6261e+03]}

Column 5

{'u2 (m)'}
{[0.0083]}
{[0.0083]}
{[0.0083]}

Copyright
Copyright (c) 2015-2021 by George Papazafeiropoulos

Major, Infrastructure Engineer, Hellenic Air Force


Civil Engineer, M.Sc., Ph.D. candidate, NTUA
Email: gpapazafeiropoulos@yahoo.gr

Published with MATLAB® R2017b


Shear buiding subjected to the El Centro earthquake motion (Chopra, 2012)

Contents
Statement of the problem
Initialization of structural input data
Calculation of structural properties
Load earthquake response spectrum data
Dynamic Response Spectrum Analysis (DRSA)
Verification of figure 13.8.3 of Chopra (Dynamics of Structures, 2012)
Modal combination with the ABSolute SUM (ABSSUM) method.
Modal combination with the Square Root of Sum of Squares (SRSS) method.
Modal combination with the Complete Quadratic Combination (CQC) method.
Assemble values of peak response in a table.
Verification of table 13.8.5 of Chopra (Dynamics of Structures, 2012)
Copyright

Statement of the problem


Chopra (2012), Section 12.8: Consider the structure of Fig. 12.8.1: a uniform five-story shear building (i.e., flexurally rigid floor beams and slabs) with lumped mass m at each floor,
and same story stiffness k for all stories.

Chopra (2012), Section 13.2.6: The structure is subjected to the El Centro ground motion (Chopra (2012), Fig. 6.1.4). The lumped mass at each floor, the
lateral stiffness of each story is , and the height of each story is 12 ft. The damping ratio for all natural modes is .

Initialization of structural input data


Set the storey height of the structure in ft.

h=12;

Set the number of eigenmodes of the structure, which is equal to the number of its storeys.

neig=5;

Set the lateral stiffness of each storey in kips/inch.

k=31.54;

Set the lumped mass at each floor (g=386.4 inch/sec^2).

m=100/9.81*0.0254;

Calculation of structural properties


Calculate the stiffness matrix of the structure in kips/inch.

K=k*(diag([2*ones(neig-1,1);1])+diag(-ones(neig-1,1),1)+diag(-ones(neig-1,1),-1));

Calculate the mass matrix of the structure.

M=m*eye(neig);

Set the spatial distribution of the effective earthquake forces. Earthquake forces are applied at all dofs of the structure.

r=ones(5,1);

Load earthquake response spectrum data


Earthquake displacement response spectrum of the El Centro earthquake (El Centro, 1940, El Centro Terminal Substation Building)

Sd=load('Sd1.txt');

Earthquake pseudoacceleration response spectrum of the El Centro earthquake (El Centro, 1940, El Centro Terminal Substation Building)

PSa=load('PSa1.txt');

Set the critical damping ratio of the response spectra ( )

ksi=0.05;

Dynamic Response Spectrum Analysis (DRSA)


Consider all eigenmodes of the building

eigInd=[1;2;3;4;5];

Perform DRSA analysis

[U,~,~,f,omega,Eigvec] = DRSA(K,M,r,PSa,Sd,[],[],eigInd);

Plot the natural modes of vibration of the uniform five-story shear building

FigHandle=figure('Name','Natural Modes','NumberTitle','off');
set(FigHandle,'Position',[50, 50, 1000, 500]);
for i=1:neig
subplot(1,neig,i)
plot([0;Eigvec(:,i)],(0:h:h*neig)','LineWidth',2.,'Marker','.',...
'MarkerSize',20,'Color',[0 0 1],'markeredgecolor','k')
grid on
xlabel('Displacement','FontSize',13);
ylabel('Height (ft)','FontSize',13);
title(['Mode ',num2str(i)],'FontSize',13)
end
Compare the eigenmodes with those shown in Figure 12.8.2. in Chopra (2012).

Plot the peak modal displacement response.

FigHandle=figure('Name','Displacements','NumberTitle','off');
set(FigHandle, 'Position', [50, 50, 1000, 500]);
for i=1:neig
subplot(1,neig,i)
plot([0;U(:,i)],(0:h:h*neig)','LineWidth',2.,'Marker','.',...
'MarkerSize',20,'Color',[0 1 0],'markeredgecolor','k')
xlim([-max(abs(U(:,i))) max(abs(U(:,i)))])
grid on
xlabel('Displacement (in)','FontSize',13);
ylabel('Height (ft)','FontSize',13);
title(['Mode ',num2str(i)],'FontSize',13)
end
Plot the peak modal equivalent static force response.

FigHandle=figure('Name','Equivalent static forces','NumberTitle','off');


set(FigHandle, 'Position', [50, 50, 1000, 500]);
for i=1:neig
subplot(1,neig,i)
plot([0;f(:,i)],(0:h:h*neig)','LineWidth',2.,'Marker','.',...
'MarkerSize',20,'Color',[1 0 0],'markeredgecolor','k')
xlim([-max(abs(f(:,i))) max(abs(f(:,i)))])
grid on
xlabel('Static force (kips)','FontSize',13);
ylabel('Height (ft)','FontSize',13);
title(['Mode ',num2str(i)],'FontSize',13)
end
Calculate the peak modal base shear in kips.

Vb=zeros(neig,1);
for i=1:neig
Vb(i)=sum(f(:,i));
end
Vb

Vb =

60.4059
24.1621
9.7562
2.8113
0.5984

Calculate the peak modal base overturning moment in kips-ft.

Mb=zeros(neig,1);
for i=1:neig
Mb(i)=sum(f(:,i).*(h:h:5*h)');
end
Mb

Mb =

1.0e+03 *

2.5467
-0.3490
0.0894
-0.0201
0.0037

Verification of figure 13.8.3 of Chopra (Dynamics of Structures, 2012)


Compare the peak modal responses with those shown in figure 13.8.3 of Chopra (2012).
Modal combination with the ABSolute SUM (ABSSUM) method.
Peak base shear.

VbAbsSum=ABSSUM(Vb);

Peak top-story shear.

V5AbsSum=ABSSUM(f(5,:)');

Peak base overturning moment.

MbAbsSum=ABSSUM(Mb);

Peak top-story displacement.

u5AbsSum=ABSSUM(U(5,:)');

Modal combination with the Square Root of Sum of Squares (SRSS) method.
Peak base shear.

VbSRSS=SRSS(Vb);

Peak top-story shear.

V5SRSS=SRSS(f(5,:)');

Peak base overturning moment.


MbSRSS=SRSS(Mb);

Peak top-story displacement.

u5SRSS=SRSS(U(5,:)');

Modal combination with the Complete Quadratic Combination (CQC) method.


Peak base shear.

VbCQC=CQC(Vb,omega,ksi);

Peak top-story shear.

V5CQC=CQC(f(5,:)',omega,ksi);

Peak base overturning moment.

MbCQC=CQC(Mb,omega,ksi);

Peak top-story displacement.

u5CQC=CQC(U(5,:)',omega,ksi);

Assemble values of peak response in a table.


Assemble values of peak response in a cell.

C{1,2}='Vb (kips)';
C{1,3}='V5 (kips)';
C{1,4}='Mb (kip-ft)';
C{1,5}='u5 (in)';
C{2,1}='ABSSUM';
C{2,2}=VbAbsSum;
C{2,3}=V5AbsSum;
C{2,4}=MbAbsSum;
C{2,5}=u5AbsSum;
C{3,1}='SRSS';
C{3,2}=VbSRSS;
C{3,3}=V5SRSS;
C{3,4}=MbSRSS;
C{3,5}=u5SRSS;
C{4,1}='CQC';
C{4,2}=VbCQC;
C{4,3}=V5CQC;
C{4,4}=MbCQC;
C{4,5}=u5CQC;
C

C =

4×5 cell array

Columns 1 through 4

{0×0 double} {'Vb (kips)'} {'V5 (kips)'} {'Mb (kip-ft)'}


{'ABSSUM' } {[ 97.7338]} {[ 55.9240]} {[ 3.0089e+03]}
{'SRSS' } {[ 65.8492]} {[ 29.7584]} {[ 2.5721e+03]}
{'CQC' } {[ 66.2797]} {[ 29.0414]} {[ 2.5694e+03]}

Column 5

{'u5 (in)'}
{[ 7.9465]}
{[ 6.7954]}
{[ 6.7882]}

Verification of table 13.8.5 of Chopra (Dynamics of Structures, 2012)


Compare the peak responses with those shown in table 13.8.5 of Chopra (2012).

Copyright
Copyright (c) 2015-2021 by George Papazafeiropoulos

Major, Infrastructure Engineer, Hellenic Air Force


Civil Engineer, M.Sc., Ph.D. candidate, NTUA
Email: gpapazafeiropoulos@yahoo.gr

Published with MATLAB® R2017b


3D one-story building subjected to the El Centro earthquake motion (Chopra, 2012)

Contents
Statement of the problem
Initialization of structural input data
Calculation of structural properties
Load earthquake response spectrum data
Dynamic Response Spectrum Analysis (DRSA)
Verification of table E13.12a of Chopra (Dynamics of Structures, 2012)
Modal combination with the ABSolute SUM (ABSSUM) method.
Modal combination with the Square Root of Sum of Squares (SRSS) method.
Modal combination with the Complete Quadratic Combination (CQC) method.
Assemble values of peak response in a table.
Verification of table E13.12b of Chopra (Dynamics of Structures, 2012)
Copyright

Statement of the problem


Chopra (2012), Example 10.6: Figure 9.5.1 shows the plan view of a one-story building. The structure consists of a roof, idealized as a rigid diaphragm, supported on three frames,
A, B, and C, as shown. The roof weight is uniformly distributed and has a magnitude of . The lateral stiffnesses of the frames are for frame A, and
for frames B and C. The plan dimensions are and , the eccentricity is , and the height of the building is . Determine the
natural periods and modes of vibration of the structure.
Chopra (2012), Example 13.12: Determine the peak values of the response of the one-story unsymmetric-plan system of Examples 13.7 and 10.6 with modal damping ratios
to the El Centro ground motion in the y-direction, directly from the response spectrum for this ground motion.

Initialization of structural input data


Set the dimensions of the rigid slab (ft).

b=30;
d=20;

Set the height of the building (ft).


h=12;

Set the eccentricity (ft).

e=1.5;

Set the lateral stiffnesses of the frames (kips/ft).

ky=75;
kx=40;

Set the mass of the slab (kips*sec^2/ft).

m=1.863;

Set the moment of inertia of the roof about its center of mass (kips*ft*sec^2).

Io=m*(b^2+d^2)/12;

Calculation of structural properties


Calculate the stiffness matrix of the structure according to eq.(9.5.17).

K=[2*kx,0,0;0,ky,e*ky;0,e*ky,e^2*ky+(d^2/2)*kx];

Calculate the mass matrix of the structure.

M=[m,0,0;0,m,0;0,0,Io];

Calculate the length of the semi-diagonal.

rbd=sqrt(b^2+d^2)/2;

Set the spatial distribution of the effective earthquake forces. Earthquake forces are applied only at dof No 2 of the structure.

r=[0;1;0];

Load earthquake response spectrum data


Earthquake displacement response spectrum of the El Centro earthquake (El Centro, 1940, El Centro Terminal Substation Building)

Sd=load('Sd3.txt');

Earthquake pseudoacceleration response spectrum of the El Centro earthquake (El Centro, 1940, El Centro Terminal Substation Building)

PSa=load('PSa3.txt');

Set the critical damping ratio of the response spectra ( )

ksi=0.05;

Dynamic Response Spectrum Analysis (DRSA)


Consider all eigenmodes of the building
eigInd=[1;2;3];

Perform DRSA analysis

[U,~,~,f,omega,Eigvec] = DRSA(K,M,r,PSa,Sd,[],[],eigInd);

Set the number of eigenmodes of the structure.

neig=numel(omega);

Plot the natural modes of vibration of the structure

FigHandle=figure('Name','Natural Modes','NumberTitle','off');
set(FigHandle,'Position',[50, 50, 1000, 500]);
for i=1:neig
subplot(1,neig,i)
plot([0;b;b;0;0],[0;0;d;d;0],'LineWidth',2.,'Marker','.',...
'MarkerSize',20,'Color',[0 0 1],'markeredgecolor','k');
hold on
phi=10*Eigvec(3,i);
plot([10*Eigvec(1,i)+(rbd*sin(phi)*cos(pi/4+phi/2)/cos(phi/2));
b+10*Eigvec(1,i)+(rbd*sin(phi)*cos(pi/4+phi/2)/cos(phi/2));
b+10*Eigvec(1,i)-(rbd*sin(phi)*cos(pi/4+phi/2)/cos(phi/2));
10*Eigvec(1,i)-(rbd*sin(phi)*cos(pi/4+phi/2)/cos(phi/2));
10*Eigvec(1,i)+(rbd*sin(phi)*cos(pi/4+phi/2)/cos(phi/2))],...
[10*Eigvec(2,i)-(rbd*sin(phi)*sin(pi/4+phi/2)/cos(phi/2));
10*Eigvec(2,i)+(rbd*sin(phi)*sin(pi/4+phi/2)/cos(phi/2));
d+10*Eigvec(2,i)+(rbd*sin(phi)*sin(pi/4+phi/2)/cos(phi/2));
d+10*Eigvec(2,i)-(rbd*sin(phi)*sin(pi/4+phi/2)/cos(phi/2));
10*Eigvec(2,i)-(rbd*sin(phi)*sin(pi/4+phi/2)/cos(phi/2))],...
'LineWidth',2.,'Marker','.','MarkerSize',20,'Color',[1 0 0],...
'markeredgecolor','k');
hold off
axis equal
grid on
title(['Mode ',num2str(i)],'FontSize',13)
end

Compare the eigenmodes with those shown in Figure E10.6. in Chopra (2012).
Convert peak modal displacements from ft to inch. Only displacements are multiplied. The rotation angles are given in rad.

U(1:2,:)=12*U(1:2,:);

Calculate the peak modal base shear of frame A (kips).

VbA=zeros(neig,1);
for i=1:neig
VbA(i)=[0 ky e*ky]*U(:,i);
end
VbA

VbA =

156.1677
0
161.2502

Calculate the peak modal base shear of frame B (kips).

VbB=zeros(neig,1);
for i=1:neig
VbB(i)=[kx 0 -d/2*kx]*U(:,i);
end
VbB

VbB =

6.6231
0
-6.9306

Verification of table E13.12a of Chopra (Dynamics of Structures, 2012)


Compare the peak modal responses with those shown in table E13.12a in Chopra (2012). Mode 1 corresponds to translation in y direction (here as mode 1) and mode 2 corresponds to
rotation about z axis (here as mode 3).
Modal combination with the ABSolute SUM (ABSSUM) method.
Peak displacement in y direction (inch).

uyAbsSum=ABSSUM(U(2,:)');

Peak torsional rotation (rad).

uthAbsSum=ABSSUM(U(3,:)');

Peak base shear of the whole structure (kips).

VbAbsSum=ABSSUM(f(2,:)');

Peak base torsional moment of the whole structure (kips*ft).

TbAbsSum=ABSSUM(f(3,:)');

Peak base shear of frame A (kips).

VbAAbsSum=ABSSUM(VbA);

Peak base shear of frame B (kips).

VbBAbsSum=ABSSUM(VbB);

Modal combination with the Square Root of Sum of Squares (SRSS) method.
Peak displacement in y direction (inch).

uySRSS=SRSS(U(2,:)');

Peak torsional rotation (rad).

uthSRSS=SRSS(U(3,:)');

Peak base shear of the whole structure (kips).

VbSRSS=SRSS(f(2,:)');

Peak base torsional moment of the whole structure (kips*ft).

TbSRSS=SRSS(f(3,:)');

Peak base shear of frame A (kips).


VbASRSS=SRSS(VbA);

Peak base shear of frame B (kips).

VbBSRSS=SRSS(VbB);

Modal combination with the Complete Quadratic Combination (CQC) method.


Peak displacement in y direction (inch).

uyCQC=CQC(U(2,:)',omega,ksi);

Peak torsional rotation (rad).

uthCQC=CQC(U(3,:)',omega,ksi);

Peak base shear of the whole structure (kips).

VbCQC=CQC(f(2,:)',omega,ksi);

Peak base torsional moment of the whole structure (kips*ft).

TbCQC=CQC(f(3,:)',omega,ksi);

Peak base shear of frame A (kips).

VbACQC=CQC(VbA,omega,ksi);

Peak base shear of frame B (kips).

VbBCQC=CQC(VbB,omega,ksi);

Assemble values of peak response in a table.


Assemble values of peak response in a cell.

C{1,2}='uy (in)';
C{1,3}='(b/2)uth (in)';
C{1,4}='Vb (kips)';
C{1,5}='Tb (kip-ft)';
C{1,6}='VbA (kips)';
C{1,7}='VbB (kips)';
C{2,1}='ABSSUM';
C{2,2}=uyAbsSum;
C{2,3}=(b/2)*uthAbsSum*12;
C{2,4}=VbAbsSum;
C{2,5}=TbAbsSum;
C{2,6}=VbAAbsSum;
C{2,7}=VbBAbsSum;
C{3,1}='SRSS';
C{3,2}=uySRSS;
C{3,3}=(b/2)*uthSRSS*12;
C{3,4}=VbSRSS;
C{3,5}=TbSRSS;
C{3,6}=VbASRSS;
C{3,7}=VbBSRSS;
C{4,1}='CQC';
C{4,2}=uyCQC;
C{4,3}=(b/2)*uthCQC*12;
C{4,4}=VbCQC;
C{4,5}=TbCQC;
C{4,6}=VbACQC;
C{4,7}=VbBCQC;
C
C =

4×7 cell array

Columns 1 through 4

{0×0 double} {'uy (in)'} {'(b/2)uth (in)'} {'Vb (kips)'}


{'ABSSUM' } {[ 4.2311]} {[ 6.0992]} {[ 26.5851]}
{'SRSS' } {[ 2.9919]} {[ 4.3139]} {[ 18.9985]}
{'CQC' } {[ 3.4397]} {[ 3.5534]} {[ 21.7311]}

Columns 5 through 7

{'Tb (kip-ft)'} {'VbA (kips)'} {'VbB (kips)'}


{[ 277.5111]} {[ 317.4179]} {[ 13.5537]}
{[ 198.8671]} {[ 224.4771]} {[ 9.5864]}
{[ 165.8039]} {[ 258.0673]} {[ 7.8964]}

Verification of table E13.12b of Chopra (Dynamics of Structures, 2012)


Compare the peak responses with those shown in table E13.12b of Chopra (2012).

Copyright
Copyright (c) 2015-2021 by George Papazafeiropoulos

Major, Infrastructure Engineer, Hellenic Air Force


Civil Engineer, M.Sc., Ph.D. candidate, NTUA
Email: gpapazafeiropoulos@yahoo.gr

Published with MATLAB® R2017b


ABSSUM

Documentation of the ABSSUM function.

helpFun('ABSSUM')

Modal combination with the ABSolute SUM (ABSSUM) method

function Y = ABSSUM(X)

Input parameters
X [double(:inf x 1)]: A column vector containing the peak response
for each eigenmode of a structure.

Output parameters
Y [double(1 x 1)]: Combination of the peak responses of the various
eigenmodes according to the sum of the absolute (ABSSUM) values
rule.

Example
x=rand(5,1)-0.5;
y=ABSSUM(x)

__________________________________________________________________________
Copyright (c) 2015-2021
George Papazafeiropoulos
Major, Infrastructure Engineer, Hellenic Air Force
Civil Engineer, M.Sc., Ph.D. candidate, NTUA
Email: gpapazafeiropoulos@yahoo.gr
_________________________________________________________________________

Published with MATLAB® R2017b


CQC

Documentation of the CQC function.

helpFun('CQC')

Modal combination with the Complete Quadratic Combination (CQC) method

function Y = CQC(X,OMEGA,KSI)

Input parameters
X [double(:inf x 1)]: A column vector containing the peak response
for each eigenmode of a structure.
OMEGA [double(:inf x 1)]: Cyclic eigenfrequencies of the eigenmodes
of the structure. SIZE(OMEGA,1) must be equal to SIZE(X,1).
KSI [double(1 x 1)]: Critical damping ratio

Output parameters
Y [double(1 x 1)]: Combination of the peak responses of the various
eigenmodes according to the Complete Quadratic Combination (CQC)
rule.

Example
x=rand(5,1)-0.5;
omega=rand(5,1);
ksi=0.05;
y = CQC(x,omega,ksi)

__________________________________________________________________________
Copyright (c) 2015-2021
George Papazafeiropoulos
Major, Infrastructure Engineer, Hellenic Air Force
Civil Engineer, M.Sc., Ph.D. candidate, NTUA
Email: gpapazafeiropoulos@yahoo.gr
_________________________________________________________________________

Published with MATLAB® R2017b


DRSA

Documentation of the DRSA function.

helpFun('DRSA')

Peak modal structural response

function [U,V,A,F,OMEGA,EIGVEC] = DRSA(K,M,R,PSA,SD,SV,SA,EIGIND)

Description
Determine the peak structural response using the linear elastic
response spectrum of the ground motion, without carrying a response
history analysis.

Input parameters
K [double(:NDOFS x :NDOFS)]: Stiffness matrix of the structure to
be analysed. #ndofs# is the number of degrees of freedom of the
structure
M [double(:NDOFS x :NDOFS)]: Mass matrix of the structure to be
analysed
R [double(:NDOFS x 1)]: Influence vector. It determines the spatial
distribution of the effective earthquake forces
PSA [double(:inf x 2)]: Pseudo spectral acceleration. The first
column contains the period values and the second column contains
the pseudospectral acceleration values.
SD [double(:inf x 2)]: Spectral displacement. The first column
contains the period values and the second column contains the
spectral displacement values.
SV [double(:inf x 2)]: Spectral velocity. The first column contains
the period values and the second column contains the spectral
velocity values.
SA [double(:inf x 2)]: Spectral acceleration. The first column
contains the period values and the second column contains the
spectral acceleration values.
EIGIND [double(:inf x 1)]: Eigenmode indicator. Only the eigenmode
numbers that are contained in EIGIND are taken into account for
the calculation of the peak modal responses.

Output parameters
U [double(1:NDOFS x 1:NEIG)]: Peak modal displacements.
V [double(1:NDOFS x 1:NEIG)]: Peak modal velocities
A [double(1:NDOFS x 1:NEIG)]: Peak modal accelerations
F [double(1:NDOFS x 1:NEIG)]: Peak modal equivalent static forces
OMEGA [double(1:NEIG x 1)]: Cyclic eigenfrequencies
EIGVEC [double(1:NDOFS x 1:NEIG)]: Eigenvectors (stored as columns)
sorted in ascending order of eigenfrequency

__________________________________________________________________________
Copyright (c) 2015-2021
George Papazafeiropoulos
Major, Infrastructure Engineer, Hellenic Air Force
Civil Engineer, M.Sc., Ph.D. candidate, NTUA
Email: gpapazafeiropoulos@yahoo.gr
_________________________________________________________________________
Published with MATLAB® R2017b
SRSS

Documentation of the SRSS function.

helpFun('SRSS')

Modal combination with the Square Root of Sum of Squares (SRSS) method

function Y = SRSS(X)

Input parameters
Y [double(:inf x 1)]: A column vector containing the peak response
for each eigenmode of a structure.

Output parameters
X [double(1 x 1)]: Combination of the peak responses of the various
eigenmodes according to the Square Root of the Sum of Squares
(SRSS) rule.

Example
x=rand(5,1)-0.5;
y=SRSS(x)

__________________________________________________________________________
Copyright (c) 2015-2021
George Papazafeiropoulos
Major, Infrastructure Engineer, Hellenic Air Force
Civil Engineer, M.Sc., Ph.D. candidate, NTUA
Email: gpapazafeiropoulos@yahoo.gr
_________________________________________________________________________

Published with MATLAB® R2017b

You might also like