3 Force Method Example Parabolic Arch Solution
3 Force Method Example Parabolic Arch Solution
Rise: Paris
f
3
Example from the 1st or 2nd lecture: two-hinged parabolic arch with a roller support
– statically determinate Problem: determine
bending moment and
the normal- and shear
Support reactions:
forces at support.
4
II – Analysis of two-hinged arch – Theory 1(3)
Real structure Primary structure
The needed theory is know to you, however, we show
here the specificity for arches.
Here follows some recall of the theory related to arches:
In curved structures, one has to remember that Mohr
integrals are taken over the material structure and then Primary structure
the differential element is the material element of arch- loaded with X 1 1
length ds and not over dx . s s 2
f [ x(s)]ds
s s1 Free Body Diagram
If you need to integrate over x then you have to make a FBD - VKK
change of variable in the integrand and in differential ds
Compatibility Equation: 11 X 1 10 0
************************ h
Determination of flexibility coefficients and the free terms:
EA 2 EI
h 1 M 1M 0 (one can neglect the Virtual bending
b
When 10
f 2 EI
ds effect of axial moment and axial
force:
L deformation. Check if
However, effect of axial deformation you don’t believe)
should be accounted for the Bending moment from
flexibility coefficient: 11 external load in the
The bending moment M 0 in
primary structure: M 0 M0
the primary structure is simply equal to the bending
moment M 0 of a simply supported beam covering the
same span as the arch and bearing the same loading. (I
showed this on black-board in the 1st or 2nd lecture when solving the
three-hinged arch). Thus M M 0 10
0
II – Analysis of two-hinged arch – Theory 2(3)
Real structure Primary structure
The needed theory is know to you, however, we show
here the specificity for arches.
Here follows some recall of the theory related to arches:
In curved structures, one has to remember that Mohr
integrals are taken over the material structure and then Primary structure
the differential element is the material element of arch- loaded with X 1 1
length ds and not over dx .
s s 2
f [ x(s)]ds
s s1
Free Body Diagram
FBD - VKK
If you need to integrate over x then you have to make a
change of variable in the integrand and in differential ds Compatibility Equation: 11 X 1 10 0
h
************************ EA 2 EI
Solve the unknown the horizontal thrust: H X1
b
Expressions should
10 integrate numerically La grande finale: Draw
H X1 these by Simson’s rule
accurately the diagrams as
or any other numerical
function of x or s by hand first and
quadrature.
then by computer
f [ x(s)]ds
s s1
Free Body Diagram
FBD - VKK
If you need to integrate over x then you have to make a
change of variable in the integrand and in differential ds Compatibility Equation: 11 X 1 10 0
h
************************ EA 2 EI
Solve the unknown the horizontal thrust: H X1
b
Expressions should
10 integrate numerically La grande finale: Draw
H X1 these by Simson’s rule
accurately the diagrams as
or any other numerical
function of x or s by hand first and
quadrature.
then by computer
(b a)
3 n
the number
of intervals
N+1
d_11_M_fun = M_1_bar .* M_1_bar / EI; % bending
d_11_N_fun = N_1_bar .* N_1_bar / EA;
% ------------------------------------------------------------------
d_11_M_fun = M_1_bar .* M_1_bar / EI; % bending
d_11_N_fun = N_1_bar .* N_1_bar / EA; % streching or axial force
figure
1]
title(' Two-hinged parabolic arch ')
for i = 2:N/2+1
4 plot(x, y, 'b.-','markersize',12)
xlabel('x (m)')
w = [w; [4; 2]];
end
16m ylabel(' y(x)')
grid on
axis equal
w = [1; w];
1]
% integration weights w = [1 4 2 4 2 4 .... 4 2
NP = length(w);
w(NP) = 1;
L_arch 17.89 m figure
plot(x, cos_Fi, 'b.-', x, sin_Fi,' r.-' )
w = (L_span / (3*N)) * w; % integration weights
% ---------------------------------------------------
grid on
Matlab-code: xlabel('x (m)')
ylabel(' cos(\phi) & sin(\phi)')
ds_func = sqrt ( 1.0 + dy_dx .^2);
L_arch = sum ( w .* ds_func); % {integral-of-ds} from x = 0
legend('cos(\phi)', 'sin(\phi)')
to x = L_span
d_11_M = 8.3888e+05 figure
% L_arch = sum { w(x_i) * ds(xi) }
% <-- see how cude and simple it is :-)
d_11_N = 100.5310 plot(x, Fi_deg, 'b.-' )
grid on
% ------------------------------------------------------
xlabel('x (m)')
d_11 = 8.3898e+05 ylabel(' \phi [deg.]')
%-------------------------------------------
Parabolic 2-hinged arch- computing the length of the arch
% -----------------------------------------------------
% Example: The two-hinged arch
% --------------------
% Purpose: the student does the intellectual part of ...
% ... deriving the needed formulae (not a computational task)
% and the computer does the mechanical work of
% ... computing (computational task)
% NB. the formulae you derive should be computable ..
% and no need to open them or expand unnesessarily, keep them
% ... implicit once the internal functions are computable
% ----------------------------------------------------
% Matlab or scilab % Arch geometry -----------
% Djebar Baroudi, PhD. 6.10.2016 x = L_span/2;
% parabolic arch f = x .* ( 1 - x / L_span); % the rise
% -------------------------
N = 2*10; % number of intervals - odd number
% Data --------- dx = L_span / N;
L_span = 16; x = 0:dx:L_span;
h = 0.50; x = x'; % transpose
b = 0.25; y = x .* ( 1 - x / L_span);
dy_dx = 1 - 2*x / L_span;
%-------------------------------------------
I = (b*h)^3 /12;
% 1: computing the length of the arch:
A = b * h; tan_Fi = dy_dx;
% ---------------------------------------------
r2 = I / A; Fi = atan(dy_dx);
% Simpson's quadrature:
% --------------------------
EA_per_EI = A / I; pi = 4. * atan(1.0);
% integration weights ---------
alpha_coef = EA_per_EI * L_span^2; Fi_deg = Fi * 180/ pi;
% n = length(x) - 1; % number of intervals - should be odd
% ---------------------------------------
number
cos_Fi = 1 ./ sqrt( 1 + tan_Fi .^2);
w = zeros(N+1,1);
sin_Fi = tan_Fi ./ sqrt( 1 + tan_Fi .^2);
w = [];
f 1 w0 = [4; 2]; % integration weights w = [1 4 2 4 2 4 .... 4 2
figure
1]
title(' Two-hinged parabolic arch ')
for i = 2:N/2+1
8 plot(x, y, 'b.-','markersize',12)
xlabel('x (m)')
w = [w; [4; 2]];
end
ylabel(' y(x)')
w = [1; w]; % integration weights w = [1 4 2 4 2 4 .... 4 2
grid on
Numerical integration: axis equal
1]
NP = length(w);
w(NP) = 1;
figure
w = (L_span / (3*N)) * w; % integration weights
L_arch = 18.36 m plot(x, cos_Fi, 'b.-', x, sin_Fi,' r.-' )
grid on
% ---------------------------------------------------
16m
xlabel('x (m)')
ds_func = sqrt ( 1.0 + dy_dx .^2);
ylabel(' cos(\phi) & sin(\phi)')
L_arch = sum ( w .* ds_func); % {integral-of-ds} from x = 0
legend('cos(\phi)', 'sin(\phi)')
to x = L_span
% L_arch = sum { w(x_i) * ds(xi) }
figure
% <-- see how cude and simple it is :-)
plot(x, Fi_deg, 'b.-' )
% ------------------------------------------------------
grid on
xlabel('x (m)')
ylabel(' \phi [deg.]')
%-------------------------------------------
% ----------------------------------------------------- This script compute you the length of the arch and the
% Example: The two-hinged arch by Matlab.
% you can do the samething with any other programming flexibility coefficient d_11 % stress resultant in the primary structure when loaded by X_1_bar = 1;
% :-) yes, this simple they are
environement M_1_bar = - y;
figure
% Mathcad, Excell, ....however, do it numerically. title(' Two-hinged parabolic arch ')
N_1_bar = - cos_Fi;
% Remember: all units in SI-system plot(x, y, 'b.-','markersize',12)
figure
% xlabel('x (m)')
plot(x, N_1_bar, 'b.-' )
% -------------------- ylabel(' y(x)')
grid on
% Purpose: the student does the intellectual part of grid on
xlabel('x (m)')
axis equal
... ylabel(' N_1_{bar}')
% ... deriving the needed formulae (not a computationalfigure
task) figure
plot(x, cos_Fi, 'b.-', x, sin_Fi,' r.-' )
plot(x, M_1_bar, 'b.-' )
% and the computer does the mechanical work of grid on
grid on
% ... computing (computational task) xlabel('x (m)')
xlabel('x (m)')
% NB. the formulae you derive should be computable .. ylabel(' cos(\phi) & sin(\phi)') ylabel(' M_1_{bar}')
legend('cos(\phi)', 'sin(\phi)')
% and no need to open them or expand unnesessarily, % ---
keep them figure
% ... implicit once the internal functions are E = 1; % E = 1 Pa ... means that E is taken out off the integral as
plot(x, Fi_deg, 'b.-' )
% a commun factor, and it multiplies d_11. Indeed we compute E*d_11
computable grid on
% I keep it in the formulae to not forget it...it is my way.
% ---------------------------------------------------- xlabel('x (m)') EI = E * I;
% Matlab or scilab ylabel(' \phi [deg.]')
EA = E * A;
%-------------------------------------------
% Djebar Baroudi, PhD. 6.10.2016 % ------------------------------------------------------------------
% parabolic arch %-------------------------------------------
d_11_M_fun = M_1_bar .* M_1_bar / EI; % bending
% ------------------------- d_11_N_fun = N_1_bar .* N_1_bar / EA; % streching or axial force
% 1: Computing the length of the arch by INTEGRATION
% ---------------------------------------------
% Data --------- % Simpson's numerical integration: d_11_M = sum ( w .* d_11_M_fun .* ds_func ); % integrating...Bending part
L_span = 16; % -------------------------- d_11_N = sum ( w .* d_11_N_fun .* ds_func ); % integrating...stretching part
% integration weights ---------
h = 0.50;
% n = length(x) - 1; % number of intervals - should
d_11be= odd
d_11_M + d_11_N % delta_11 for combined bending and streching
b = 0.25; number %--------------------------------
w = zeros(N+1,1);
I = (b*h)^3 /12; w = []; % algorithm ... to the end... is left for you
A = b * h; w0 = [4; 2]; % integration weights w = [1 4 2 4 %2 Integrating
4 .... 4 2 d_10:
r2 = I / A; 1] % -----------------------
for i = 2:N/2+1 % M_0 =
w = [w; [4; 2]]; % N_0 =
EA_per_EI = A / I; end % d_10_fun =
alpha_coef = EA_per_EI * L_span^2; w = [1; w]; % integration weights w = [1 4 2 4% 2d_10
4 ....
= sum4 ( w .* d_10_fun)
% --------------------------------------- 2 1] %
NP = length(w); % X_1 = - d_11 / d_10;
% Arch geometry ----------- w(NP) = 1; %
w = (L_span / (3*N)) * w; % integration weights % Stress resultants
x = L_span/2;
% ---------------------------------------------------
% ---------------------
f = x .* ( 1 - x / L_span); % the rise % M = M_0 + X_1 * M_1_bar;
ds_func = sqrt ( 1.0 + dy_dx .^2); % N = N_0 + X_1 * N_1_bar;
N = 2*10; % number of intervals - should be odd L_arch = sum ( w .* ds_func) % {integral-of-ds}% from x = +0 X_1 * Q_1_bar;
Q = Q_0
number to x = L_span % ---------------------------------------
dx = L_span / N; % L_arch = sum { %w(x_i) *
ds(xi) } % READ_ME: Now the ball is up to you ... to continue integrating d_10 and
x = 0:dx:L_span;
% <-- see how cude andsolve
then simple
x = x'; % transpose it is :-) % ..
y = x .* ( 1 - x / L_span); % ------------------------------------------------------
% .. X_1 = - d_10 / d_11 , and then by superpostion M(x) = M_0(x) + x_1 *
dy_dx = 1 - 2*x / L_span; % M_1_bar, etc...
% Now do the same (integrate) for flexibility coefficients
% Good luck--... do not give up...now
tan_Fi = dy_dx; % flexibility coefficients: d_11 and d_10. Indeed we ...
% ... compute E*d_11 and E*d_10, since elasticity
Fi = atan(dy_dx);
% ... coefficient E is a commun factor
% ---------------------------------------------------
pi = 4. * atan(1.0); % let us compute delta_11 the same way as we did for the
Fi_deg = Fi * 180/ pi; length of
% ... the arch by numerical quadrature
cos_Fi = 1 ./ sqrt( 1 + tan_Fi .^2); % -------------------------
sin_Fi = tan_Fi ./ sqrt( 1 + tan_Fi .^2);