SlideShare a Scribd company logo
1 of 12
Download to read offline
Beam Displacements
                                    David Roylance
                     Department of Materials Science and Engineering
                          Massachusetts Institute of Technology
                                 Cambridge, MA 02139

                                      November 30, 2000


Introduction
We want to be able to predict the deflection of beams in bending, because many applications
have limitations on the amount of deflection that can be tolerated. Another common need for
deflection analysis arises from materials testing, in which the transverse deflection induced by a
bending load is measured. If we know the relation expected between the load and the deflection,
we can “back out” the material properties (specifically the modulus) from the measurement. We
will show, for instance, that the deflection at the midpoint of a beam subjected to “three-point
bending” (beam loaded at its center and simply supported at its edges) is

                                                P L3
                                           δP =
                                               48EI
where the length L and the moment of inertia I are geometrical parameters. If the ratio of δP
to P is measured experimentally, the modulus E can be determined. A stiffness measured this
way is called the flexural modulus.
    There are a number of approaches to the beam deflection problem, and many texts spend
a good deal of print on this subject. The following treatment outlines only a few of the more
straightforward methods, more with a goal of understanding the general concepts than with
developing a lot of facility for doing them manually. In practice, design engineers will usually
consult handbook tabulations of deflection formulas as needed, so even before the computer age
many of these methods were a bit academic.


Multiple integration
In Module 12, we saw how two integrations of the loading function q(x) produces first the shear
function V (x) and then the moment function M (x):

                                     V =−      q(x) dx + c1                                   (1)


                                     M =−      V (x) dx + c2                                  (2)

where the constants of integration c1 and c2 are evaluated from suitable boundary conditions on
V and M . (If singularity functions are used, the boundary conditions are included explicitly and
the integration constants c1 and c2 are identically zero.) From Eqn. 6 in Module 13, the curvature
                                                  1
v,xx (x) is just the moment divided by the section modulus EI. Another two integrations then
give
                                                 1
                                    v,x (x) =              M (x) dx + c3                             (3)
                                                EI

                                        v(x) =       v,x (x) dx + c4                                 (4)

where c3 and c4 are determined from boundary conditions on slope or deflection.

                                                Example 1




                                   Figure 1: Three-point bending.

As an illustration of this process, consider the case of “three-point bending” shown in Fig. 1. This
geometry is often used in materials testing, as it avoids the need to clamp the specimen to the testing
apparatus. If the load P is applied at the midpoint, the reaction forces at A and B are equal to half the
applied load. The loading function is then
                                              P                       L
                                     q(x) =     x    −1   −P x−           −1
                                              2                       2
Integrating according to the above scheme:
                                                 P        0           L    0
                                     V (x) = −     x          +P x−
                                                 2                    2
                                                P      1              L   1
                                      M (x) =     x           −P x−                                   (5)
                                                2                     2
                                           P       P      L 2
                                 EIv,x (x) =  x 2−     x−     + c3
                                           4        2     2
From symmetry, the beam has zero slope at the midpoint. Hence v,x = 0 @ x = L/2, so c3 can be found
to be −P L2 /16. Integrating again:

                                          P        P     L 3 P L2 x
                             EIv(x) =        x 3−    x−       −       + c4
                                         12        6      2       16
The deflection is zero at the left end, so c4 = 0. Rearranging, the beam deflection is given by


                                                       2
P                      L
                                  v=          4x3 − 3L2 x − 8 x −                  3
                                                                                                                      (6)
                                         48EI                     2
The maximum deflection occurs at x = L/2, which we can evaluate just before the singularity term
activates. Then

                                                               P L3
                                                δmax =                                                                (7)
                                                               48EI
This expression is much used in flexural testing, and is the example used to begin this module.

    Before the loading function q(x) can be written, the reaction forces at the beam supports
must be determined. If the beam is statically determinate, as in the above example, this can
be done by invoking the equations of static equilibrium. Static determinacy means only two
reaction forces or moments can be present, since we have only a force balance in the direction
transverse to the beam axis and one moment equation available. A simply supported beam (one
resting on only two supports) or a simply cantilevered beam are examples of such determinate
beams; in the former case there is one reaction force at each support, and in the latter case there
is one transverse force and one moment at the clamped end.
    Of course, there is no stringent engineering reason to limit the number of beam supports
to those sufficient for static equilibrium. Adding “extra” supports will limit deformations and
stresses, and this will often be worthwhile in spite of the extra construction expense. But the
analysis is now a bit more complicated, since not all of the unknown reactions can be found from
the equations of static equilibrium. In these statically indeterminate cases it will be necessary
to invoke geometrical constraints to develop enough equations to solve the problem.
    This is done by writing the slope and deflection equations, carrying the unknown reaction
forces and moments as undetermined parameters. The slopes and deflections are then set to
their known values at the supports, and the resulting equations solved for the unknowns. If
for instance a beam is resting on three supports, there will be three unknown reaction forces,
and we will need a total of five equations: three for the unknown forces and two more for the
constants of integration that arise when the slope and deflection equations are written. Two
of these equations are given by static equilibrium, and three more are obtained by setting the
deflections at the supports to zero. The following example illustrates the procedure, which is
straightforward although tedious if done manually.

                                                    Example 2

Consider a triply-supported beam of length L = 15 as shown in Fig. 2, carrying a constant uniform load
of w = −10. There are not sufficient equilibrium equations to determine the reaction forces Ra , Rb , and
Rc , so these are left as unknowns while multiple integration is used to develop a deflection equation:
                                                                                                    0
                       q(x) = Ra x   −1   + Rb x − 7.5         −1   + Rc x − 15     −1   − 10 x

                                                     0                     0                    0              1
                V (x) = −     q(x) dx = −Ra x            − Rb x − 7.5          − Rc x − 15          + 10 x

                                                    1                      1                    1       10     2
                M (x) = −      V (x) dx = Ra x           + Rb x − 7.5          + Rc x − 15          −      x
                                                                                                         2
                                         Ra     2        Rb            2       Rc           2       10     3
            EIy (x) =       M (x) dx =      x       +       x − 7.5        +      x − 15        −      x       + c1
                                         2               2                     2                     6
                                                           3
Figure 2: Uniformly loaded beam resting on three supports.


                                     Ra     3       Rb           3       Rc          3       10     4
         EIy(x) =     EIy (x) dx =      x       +      x − 7.5       +      x − 15       −      x       + c1 x + c2
                                     6              6                    6                   24
These equations have 5 unknowns: Ra , Rb , Rc , c1 , and c2 . These must be obtained from the two
equilibrium equations

                                        Fy = 0 = Ra + Rb + Rc − qL
                                                  L     L
                                        Ma = 0 = qL − Rb − Rc L
                                                  2     2
and the three known zero displacements at the supports

                                        y(0) = y(L/2) = y(L) = 0
Although the process is straightforward, there is a lot of algebra to wade through. Statically indeterminate
beams tend to generate tedious mathematics, but fortunately this can be reduced greatly by modern
software. Follow how easily this example is handled by the Maple V package (some of the Maple responses
removed for brevity):


>   # read the library containing the Heaviside function
>   readlib(Heaviside);
>   # use the Heaviside function to define singularity functions;
>   #   sfn(x,a,n) is same is <x-a>^n
>   sfn := proc(x,a,n) (x-a)^n * Heaviside(x-a) end;
>   # define the deflection function:
>   y := (x)-> (Ra/6)*sfn(x,0,3)+(Rb/6)*sfn(x,7.5,3)+(Rc/6)*sfn(x,15,3)
>     -(10/24)*sfn(x,0,4)+c1*x+c2;
>   # Now define the five constraint equations; first vertical equilibrium:
>   eq1 := 0=Ra+Rb+Rc-(10*15);
>   # rotational equilibrium:
>   eq2 := 0=(10*15*7.5)-Rb*7.5-Rc*15;
>   # Now the three zero displacements at the supports:
>   eq3 := y(0)=0;
>   eq4 := y(7.5)=0;
>   eq5 := y(15)=0;
>   # set precision; 4 digits is enough:

                                                        4
> Digits:=4;
> # solve the 5 equations for the 5 unknowns:
> solve({eq1,eq2,eq3,eq4,eq5},{Ra,Rb,Rc,c1,c2});
            {c2 = 0, c1 = -87.82, Rb = 93.78, Ra = 28.11, Rc = 28.11}
> # assign the known values for plotting purposes:
> c1:=-87.82;c2:=0;Ra:=28.11;Rb:=93.78;Rc:=28.11;
> # the equation of the deflection curve is:
> y(x);
          3                                3
   4.686 x Heaviside(x) + 15.63 (x - 7.5) Heaviside(x - 7.5)

                          3                           4
          + 4.686 (x - 15) Heaviside(x - 15) - 5/12 x Heaviside(x) - 87.82 x
>   # plot the deflection curve:
>   plot(y(x),x=0..15);
>   # The maximum deflection occurs at the quarter points:
>   y(15/4);
                                       -164.7


The plot of the deflection curve is shown in Fig. 3.




Figure 3: Deflection curve EIy(x) for uniformly loaded triply-supported beam (Note difference
in horizontal and vertical scales).




Energy method
The strain energy in bending as given by Eqn. 8 of Module 13 can be used to find deflections,
and this may be more convenient than successive integration if the deflection at only a single
point is desired. Castigliano’s Theorem gives the deflection congruent to a load P as

                                             ∂U    ∂          M 2 dx
                                      δP =      =
                                             ∂P   ∂P      L   2EI


                                                      5
It is usually more convenient to do the differentiation before the integration, since this lowers
the order of the expression in the integrand:

                                             M ∂M
                                       δP =          dx
                                           L EI ∂P
where here E and I are assumed not to vary with x.
   The shear contribution to bending can be obtained similarly. Knowing the shear stress
τ = V Q/Ib (omitting the xy subscript on τ for now), the strain energy due to shear Us can be
written

                                     τ2                 V2              Q2
                          Us =          dV =                               dA dx
                                 V   2G            L   2GI          A   L2
The integral over the cross-sectional area A is a purely geometrical factor, and we can write

                                                       V 2 fs
                                         Us =                 dA                                (8)
                                                   L   2GA
where the fs is a dimensionless form factor for shear defined as

                                               A               Q2
                                        fs =                      dA                            (9)
                                               I2          A   b2




                              Figure 4: Rectangular beam section.

   Evaluating fs for rectangular sections for illustration (see Fig. 4), we have in that case

                                                                 bh3
                                        A = bh,            I=
                                                                  12
                                           (h/2) − y                 h
                               Q= y+                             b     −y
                                               2                     2
                                         (bh)              h/2   1          6
                               fs =                                  Q dy =
                                      (bh3 /12)2       −h/2      b 2        5
Hence fs is the same for all rectangular sections, regardless of their particular dimensions.
Similarly, it can be shown (see Prob. 3) that for solid circular sections fs = 10/9 and for hollow
circular sections fs = 2.
                                                       6
Example 3
 If for instance we are seeking the deflection under the load P in the three-point bending example done
earlier, we can differentiate the moment given in Eqn. 5 to obtain
                                             ∂M  1           1          L   1
                                                = x              − x−
                                             ∂P  2                      2
Then

                              1           P     1             L   1     1       1          L   1
                      δP =                  x       −P x−                 x         − x−           dx
                             EI   L       2                   2         2                  2
Expanding this and adjusting the limits of integration to account for singularity functions that have not
been activated:
                                      L                L                                       2
                           P              x2                            L              L
                    δP =                     dx +            −x x −           + x−                 dx
                           EI     0       4            L/2              2              2

                                                             P L3
                                                        =−
                                                             48EI
as before.
    The contribution of shear to the deflection can be found by using V = P/2 in the equation for strain
energy. For the case of a rectangular beam with fs = 6/5 we have:

                                                         (P/2)2 (6/5)
                                                Us =                  L
                                                            2GA
                                                          ∂Us      6P L
                                                δP,s   =      =
                                                          ∂P      20GA
The shear contribution can be compared with the bending contribution by replacing A with 12I/h2 (since
A = bh and I = bh3 /12). Then the ratio of the shear to bending contributions is

                                                P Lh2 /40GI   3h2 E
                                                            =
                                                P L3 /24EI    5L2 G
Hence the importance of the shear term scales as (h/L)2 , i.e. quadratically as the span-to-depth ratio.

    The energy method is often convenient for systems having complicated geometries and com-
bined loading. For slender shafts transmitting axial, torsional, bending and shearing loads the
strain energy is

                                             P2   T2   M2    V 2 fs
                             U=                 +    +     +                           dx               (10)
                                      L     2EA 2GJ    2EI   2GA


                                                       Example 4

Consider a cantilevered circular beam as shown in Fig. 5 that tapers from radius r1 to r2 over the length
L. We wish to determine the deflection caused by a force F applied to the free end of the beam, at an
angle θ from the horizontal. Turning to Maple to avoid the algebraic tedium, the dimensional parameters
needed in Eqn. 10 are defined as:




                                                             7
Figure 5: Tapered circular beam.


>   r    :=   proc   (x)    r1 + (r2-r1)*(x/L) end;
>   A    :=   proc   (r)    Pi*(r(x))^2 end;
>   Iz   :=   proc   (r)    Pi*(r(x))^4 /4 end;
>   Jp   :=   proc   (r)    Pi*(r(x))^4 /2 end;

where r(x) is the radius, A(r) is the section area, Iz is the rectangular moment of inertia, and Jp is the
polar moment of inertia. The axial, bending, and shear loads are given in terms of F as

> P := F* cos(theta);
> V := F* sin(theta);
> M := proc (x) -F* sin(theta) * x end;

The strain energies corresponding to tension, bending and shear are

>   U1   :=   P^2/(2*E*A(r));
>   U2   :=   (M(x))^2/(2*E*Iz(r));
>   U3   :=   V^2*(10/9)/(2*G*A(r));
>   U    :=   int( U1+U2+U3, x=0..L);

Finally, the deflection congruent to the load F is obtained by differentiating the total strain energy:

> dF := diff(U,F);

The result of these manipulations yields

                            LF 12 L2G − 12GL2 cos2 θ + 9Gr2 cos2 θ + 10 r2 E − 10 r2 E cos2 θ
                                                             2           2         2
                     δF =                                  3 Eπ G
                                                     9 r1 r2
This displacement is in the direction of the applied force F ; the horizontal and vertical deflections of the
end of the beam are then

                                                   δx = δF cos θ
                                                    δy = δF sin θ




                                                         8
Superposition
In practice, many beams will be loaded in a complicated manner consisting of several concen-
trated or distributed loads acting at various locations along the beam. Although these multiple-
load cases can be solved from scratch using the methods described above, it is often easier to
solve the problem by superposing solutions of simpler problems whose solutions are tabulated.
Fig. 6 gives an abbreviated collection of deflection formulas1 that will suffice for many problems.
The superposition approach is valid since the governing equations are linear; hence the response
to a combination of loads is the sum of the responses that would be generated by each separate
load acting alone.




Figure 6: Deflections for cantilevered and simply-supported beams, under concentrated and
distributed loading.


                                               Example 5

We wish to find the equation of the deflection curve for a simply-supported beam loaded in symmetric
four-point bending as shown in Fig. 7. From Fig. 6, the deflection of a beam with a single load at a
   1
   A more exhaustive listing is available in W.C. Young, Roark’s Formulas for Stress and Strain, McGraw-Hill,
New York, 1989.

                                                     9
Figure 7: Four-point bending.


distance a from the left end is δ(x) = 6LEI L x − a
                                        Pb
                                             b
                                                      3
                                                          − x3 + L2 − b2 x . Our present problem is just
two such loads acting simultaneously, so we have

                              P (L − a)  L            3
                     δ(x) =                 x−a           − x3 + L2 − (L − a)2 x
                                6LEI    L−a
                                Pa    L               3
                           +            x − (L − a)       − x3 + L2 − a2 x
                               6LEI   a


   In some cases the designer may not need the entire deflection curve, and superposition of
tabulated results for maximum deflection and slope is equally valid.


Problems
  1. (a)–(h) Write expressions for the slope and deflection curves of the beams shown here.




                                              Prob. 1

  2. (a)–(h) Use MapleV (or other) software to plot the slope and deflection curves for the beams
     in Prob. 1, using the values (as needed) L = 25 in, a = 15 in, w = 10 lb/in, P = 150 lb.

  3. Show that the shape factor for shear for a circular cross section is


                                                 10
A        Q        10
                                    fs =                dA =
                                           I2   A   b 2       9

4. (a)–(b) Determine the deflection curves for the beams shown here. Plot these curves for
   the the values (as needed) L = 25 in, a = 5 in, w = 10 lb/in, P = 150 lb.




                                        Prob. 4

5. (a) Determine the deflection of a coil spring under the influence of an axial force F ,
   including the contribution of bending, direct shear, and torsional shear effects. Using
   r = 1 mm and R = 10 mm, compute the relative magnitudes of the three contributions.
  (b) Repeat the solution in (a), but take the axial load to be placed at the outer radius of
  the coil.




                                        Prob. 5

6. (a)–(c) Use the method of superposition to write expressions for the deflection curve δ(x)
   for the cases shown here.




                                            11
Prob. 6




  12

More Related Content

What's hot

Black hole formation by incoming electromagnetic radiation
 Black hole formation by incoming electromagnetic radiation Black hole formation by incoming electromagnetic radiation
Black hole formation by incoming electromagnetic radiationXequeMateShannon
 
Interpolation
InterpolationInterpolation
InterpolationCAALAAA
 
Lesson 16: Inverse Trigonometric Functions
Lesson 16: Inverse Trigonometric FunctionsLesson 16: Inverse Trigonometric Functions
Lesson 16: Inverse Trigonometric FunctionsMatthew Leingang
 
Analysis and algebra on differentiable manifolds
Analysis and algebra on differentiable manifoldsAnalysis and algebra on differentiable manifolds
Analysis and algebra on differentiable manifoldsSpringer
 
Relative superior mandelbrot sets and relative
Relative superior mandelbrot sets and relativeRelative superior mandelbrot sets and relative
Relative superior mandelbrot sets and relativeeSAT Publishing House
 
Theme 5
Theme 5Theme 5
Theme 5aks29
 
Elementary Landscape Decomposition of the Hamiltonian Path Optimization Problem
Elementary Landscape Decomposition of the Hamiltonian Path Optimization ProblemElementary Landscape Decomposition of the Hamiltonian Path Optimization Problem
Elementary Landscape Decomposition of the Hamiltonian Path Optimization Problemjfrchicanog
 
Lesson 12: Linear Approximation
Lesson 12: Linear ApproximationLesson 12: Linear Approximation
Lesson 12: Linear ApproximationMatthew Leingang
 
Fractional Newton-Raphson Method and Some Variants for the Solution of Nonlin...
Fractional Newton-Raphson Method and Some Variants for the Solution of Nonlin...Fractional Newton-Raphson Method and Some Variants for the Solution of Nonlin...
Fractional Newton-Raphson Method and Some Variants for the Solution of Nonlin...mathsjournal
 
Markov Chain Monte Carlo Methods
Markov Chain Monte Carlo MethodsMarkov Chain Monte Carlo Methods
Markov Chain Monte Carlo MethodsFrancesco Casalegno
 
Jensen's inequality, EM 알고리즘
Jensen's inequality, EM 알고리즘 Jensen's inequality, EM 알고리즘
Jensen's inequality, EM 알고리즘 Jungkyu Lee
 
International Journal of Computational Engineering Research(IJCER)
International Journal of Computational Engineering Research(IJCER)International Journal of Computational Engineering Research(IJCER)
International Journal of Computational Engineering Research(IJCER)ijceronline
 

What's hot (20)

Black hole formation by incoming electromagnetic radiation
 Black hole formation by incoming electromagnetic radiation Black hole formation by incoming electromagnetic radiation
Black hole formation by incoming electromagnetic radiation
 
Jere Koskela slides
Jere Koskela slidesJere Koskela slides
Jere Koskela slides
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
 
Dag in mmhc
Dag in mmhcDag in mmhc
Dag in mmhc
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
 
Interpolation
InterpolationInterpolation
Interpolation
 
Lesson 16: Inverse Trigonometric Functions
Lesson 16: Inverse Trigonometric FunctionsLesson 16: Inverse Trigonometric Functions
Lesson 16: Inverse Trigonometric Functions
 
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
 
Analysis and algebra on differentiable manifolds
Analysis and algebra on differentiable manifoldsAnalysis and algebra on differentiable manifolds
Analysis and algebra on differentiable manifolds
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
 
Relative superior mandelbrot sets and relative
Relative superior mandelbrot sets and relativeRelative superior mandelbrot sets and relative
Relative superior mandelbrot sets and relative
 
Theme 5
Theme 5Theme 5
Theme 5
 
Elementary Landscape Decomposition of the Hamiltonian Path Optimization Problem
Elementary Landscape Decomposition of the Hamiltonian Path Optimization ProblemElementary Landscape Decomposition of the Hamiltonian Path Optimization Problem
Elementary Landscape Decomposition of the Hamiltonian Path Optimization Problem
 
Richard Everitt's slides
Richard Everitt's slidesRichard Everitt's slides
Richard Everitt's slides
 
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
 
Lesson 12: Linear Approximation
Lesson 12: Linear ApproximationLesson 12: Linear Approximation
Lesson 12: Linear Approximation
 
Fractional Newton-Raphson Method and Some Variants for the Solution of Nonlin...
Fractional Newton-Raphson Method and Some Variants for the Solution of Nonlin...Fractional Newton-Raphson Method and Some Variants for the Solution of Nonlin...
Fractional Newton-Raphson Method and Some Variants for the Solution of Nonlin...
 
Markov Chain Monte Carlo Methods
Markov Chain Monte Carlo MethodsMarkov Chain Monte Carlo Methods
Markov Chain Monte Carlo Methods
 
Jensen's inequality, EM 알고리즘
Jensen's inequality, EM 알고리즘 Jensen's inequality, EM 알고리즘
Jensen's inequality, EM 알고리즘
 
International Journal of Computational Engineering Research(IJCER)
International Journal of Computational Engineering Research(IJCER)International Journal of Computational Engineering Research(IJCER)
International Journal of Computational Engineering Research(IJCER)
 

Viewers also liked

Deflection 2
Deflection 2Deflection 2
Deflection 2anashalim
 
Aer 101 chapter 5
Aer 101 chapter 5Aer 101 chapter 5
Aer 101 chapter 5anashalim
 
14 three moment equation
14 three moment equation14 three moment equation
14 three moment equationalokbshukla
 
Centroids moments of inertia
Centroids moments of inertiaCentroids moments of inertia
Centroids moments of inertiacoolzero2012
 
Hibbeler chapter10
Hibbeler chapter10Hibbeler chapter10
Hibbeler chapter10ahmedalnamer
 

Viewers also liked (6)

Deflection 2
Deflection 2Deflection 2
Deflection 2
 
H.w.5
H.w.5H.w.5
H.w.5
 
Aer 101 chapter 5
Aer 101 chapter 5Aer 101 chapter 5
Aer 101 chapter 5
 
14 three moment equation
14 three moment equation14 three moment equation
14 three moment equation
 
Centroids moments of inertia
Centroids moments of inertiaCentroids moments of inertia
Centroids moments of inertia
 
Hibbeler chapter10
Hibbeler chapter10Hibbeler chapter10
Hibbeler chapter10
 

Similar to Deformation 1

Parametric time domain system identification of a mass spring-damper
Parametric time domain system identification of a mass spring-damperParametric time domain system identification of a mass spring-damper
Parametric time domain system identification of a mass spring-damperMidoOoz
 
Numerical Analysis Assignment Help
Numerical Analysis Assignment HelpNumerical Analysis Assignment Help
Numerical Analysis Assignment HelpMath Homework Solver
 
20070823
2007082320070823
20070823neostar
 
StructuralTheoryClass2.ppt
StructuralTheoryClass2.pptStructuralTheoryClass2.ppt
StructuralTheoryClass2.pptChristopherArce4
 
Solution to schrodinger equation with dirac comb potential
Solution to schrodinger equation with dirac comb potential Solution to schrodinger equation with dirac comb potential
Solution to schrodinger equation with dirac comb potential slides
 
What are free particles in quantum mechanics
What are free particles in quantum mechanicsWhat are free particles in quantum mechanics
What are free particles in quantum mechanicsbhaskar chatterjee
 
My paper for Domain Decomposition Conference in Strobl, Austria, 2005
My paper for Domain Decomposition Conference in Strobl, Austria, 2005My paper for Domain Decomposition Conference in Strobl, Austria, 2005
My paper for Domain Decomposition Conference in Strobl, Austria, 2005Alexander Litvinenko
 
Friedrichs1958
Friedrichs1958Friedrichs1958
Friedrichs1958staros11
 
Mp6 15 phase field modelling
Mp6 15 phase field modellingMp6 15 phase field modelling
Mp6 15 phase field modellingNguyen Hanh
 
Schrodinger equation in quantum mechanics
Schrodinger equation in quantum mechanicsSchrodinger equation in quantum mechanics
Schrodinger equation in quantum mechanicsRakeshPatil2528
 
matrix theory and linear algebra.pptx
matrix theory and linear algebra.pptxmatrix theory and linear algebra.pptx
matrix theory and linear algebra.pptxMaths Assignment Help
 
Learning Spectral Graph Transformations for Link Prediction
Learning Spectral Graph Transformations for Link PredictionLearning Spectral Graph Transformations for Link Prediction
Learning Spectral Graph Transformations for Link PredictionJérôme KUNEGIS
 
ep ppt of it .pptx
ep ppt of it .pptxep ppt of it .pptx
ep ppt of it .pptxbsabjdsv
 

Similar to Deformation 1 (20)

Parametric time domain system identification of a mass spring-damper
Parametric time domain system identification of a mass spring-damperParametric time domain system identification of a mass spring-damper
Parametric time domain system identification of a mass spring-damper
 
Dynamics
DynamicsDynamics
Dynamics
 
Quantum Hw 15
Quantum Hw 15Quantum Hw 15
Quantum Hw 15
 
Numerical Analysis Assignment Help
Numerical Analysis Assignment HelpNumerical Analysis Assignment Help
Numerical Analysis Assignment Help
 
20070823
2007082320070823
20070823
 
project report(1)
project report(1)project report(1)
project report(1)
 
StructuralTheoryClass2.ppt
StructuralTheoryClass2.pptStructuralTheoryClass2.ppt
StructuralTheoryClass2.ppt
 
Solution to schrodinger equation with dirac comb potential
Solution to schrodinger equation with dirac comb potential Solution to schrodinger equation with dirac comb potential
Solution to schrodinger equation with dirac comb potential
 
What are free particles in quantum mechanics
What are free particles in quantum mechanicsWhat are free particles in quantum mechanics
What are free particles in quantum mechanics
 
M2l11
M2l11M2l11
M2l11
 
My paper for Domain Decomposition Conference in Strobl, Austria, 2005
My paper for Domain Decomposition Conference in Strobl, Austria, 2005My paper for Domain Decomposition Conference in Strobl, Austria, 2005
My paper for Domain Decomposition Conference in Strobl, Austria, 2005
 
Friedrichs1958
Friedrichs1958Friedrichs1958
Friedrichs1958
 
Mp6 15 phase field modelling
Mp6 15 phase field modellingMp6 15 phase field modelling
Mp6 15 phase field modelling
 
Cse41
Cse41Cse41
Cse41
 
Schrodinger equation in quantum mechanics
Schrodinger equation in quantum mechanicsSchrodinger equation in quantum mechanics
Schrodinger equation in quantum mechanics
 
matrix theory and linear algebra.pptx
matrix theory and linear algebra.pptxmatrix theory and linear algebra.pptx
matrix theory and linear algebra.pptx
 
Diffusion Assignment Help
Diffusion Assignment HelpDiffusion Assignment Help
Diffusion Assignment Help
 
Learning Spectral Graph Transformations for Link Prediction
Learning Spectral Graph Transformations for Link PredictionLearning Spectral Graph Transformations for Link Prediction
Learning Spectral Graph Transformations for Link Prediction
 
Networking Assignment Help
Networking Assignment HelpNetworking Assignment Help
Networking Assignment Help
 
ep ppt of it .pptx
ep ppt of it .pptxep ppt of it .pptx
ep ppt of it .pptx
 

Recently uploaded

ISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITY
ISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITYISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITY
ISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITYKayeClaireEstoconing
 
Procuring digital preservation CAN be quick and painless with our new dynamic...
Procuring digital preservation CAN be quick and painless with our new dynamic...Procuring digital preservation CAN be quick and painless with our new dynamic...
Procuring digital preservation CAN be quick and painless with our new dynamic...Jisc
 
Keynote by Prof. Wurzer at Nordex about IP-design
Keynote by Prof. Wurzer at Nordex about IP-designKeynote by Prof. Wurzer at Nordex about IP-design
Keynote by Prof. Wurzer at Nordex about IP-designMIPLM
 
Student Profile Sample - We help schools to connect the data they have, with ...
Student Profile Sample - We help schools to connect the data they have, with ...Student Profile Sample - We help schools to connect the data they have, with ...
Student Profile Sample - We help schools to connect the data they have, with ...Seán Kennedy
 
call girls in Kamla Market (DELHI) 🔝 >༒9953330565🔝 genuine Escort Service 🔝✔️✔️
call girls in Kamla Market (DELHI) 🔝 >༒9953330565🔝 genuine Escort Service 🔝✔️✔️call girls in Kamla Market (DELHI) 🔝 >༒9953330565🔝 genuine Escort Service 🔝✔️✔️
call girls in Kamla Market (DELHI) 🔝 >༒9953330565🔝 genuine Escort Service 🔝✔️✔️9953056974 Low Rate Call Girls In Saket, Delhi NCR
 
Concurrency Control in Database Management system
Concurrency Control in Database Management systemConcurrency Control in Database Management system
Concurrency Control in Database Management systemChristalin Nelson
 
Science 7 Quarter 4 Module 2: Natural Resources.pptx
Science 7 Quarter 4 Module 2: Natural Resources.pptxScience 7 Quarter 4 Module 2: Natural Resources.pptx
Science 7 Quarter 4 Module 2: Natural Resources.pptxMaryGraceBautista27
 
Karra SKD Conference Presentation Revised.pptx
Karra SKD Conference Presentation Revised.pptxKarra SKD Conference Presentation Revised.pptx
Karra SKD Conference Presentation Revised.pptxAshokKarra1
 
Inclusivity Essentials_ Creating Accessible Websites for Nonprofits .pdf
Inclusivity Essentials_ Creating Accessible Websites for Nonprofits .pdfInclusivity Essentials_ Creating Accessible Websites for Nonprofits .pdf
Inclusivity Essentials_ Creating Accessible Websites for Nonprofits .pdfTechSoup
 
ECONOMIC CONTEXT - PAPER 1 Q3: NEWSPAPERS.pptx
ECONOMIC CONTEXT - PAPER 1 Q3: NEWSPAPERS.pptxECONOMIC CONTEXT - PAPER 1 Q3: NEWSPAPERS.pptx
ECONOMIC CONTEXT - PAPER 1 Q3: NEWSPAPERS.pptxiammrhaywood
 
How to do quick user assign in kanban in Odoo 17 ERP
How to do quick user assign in kanban in Odoo 17 ERPHow to do quick user assign in kanban in Odoo 17 ERP
How to do quick user assign in kanban in Odoo 17 ERPCeline George
 
Like-prefer-love -hate+verb+ing & silent letters & citizenship text.pdf
Like-prefer-love -hate+verb+ing & silent letters & citizenship text.pdfLike-prefer-love -hate+verb+ing & silent letters & citizenship text.pdf
Like-prefer-love -hate+verb+ing & silent letters & citizenship text.pdfMr Bounab Samir
 
Barangay Council for the Protection of Children (BCPC) Orientation.pptx
Barangay Council for the Protection of Children (BCPC) Orientation.pptxBarangay Council for the Protection of Children (BCPC) Orientation.pptx
Barangay Council for the Protection of Children (BCPC) Orientation.pptxCarlos105
 
Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17
Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17
Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17Celine George
 
Virtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdf
Virtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdfVirtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdf
Virtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdfErwinPantujan2
 
4.18.24 Movement Legacies, Reflection, and Review.pptx
4.18.24 Movement Legacies, Reflection, and Review.pptx4.18.24 Movement Legacies, Reflection, and Review.pptx
4.18.24 Movement Legacies, Reflection, and Review.pptxmary850239
 
MULTIDISCIPLINRY NATURE OF THE ENVIRONMENTAL STUDIES.pptx
MULTIDISCIPLINRY NATURE OF THE ENVIRONMENTAL STUDIES.pptxMULTIDISCIPLINRY NATURE OF THE ENVIRONMENTAL STUDIES.pptx
MULTIDISCIPLINRY NATURE OF THE ENVIRONMENTAL STUDIES.pptxAnupkumar Sharma
 
Global Lehigh Strategic Initiatives (without descriptions)
Global Lehigh Strategic Initiatives (without descriptions)Global Lehigh Strategic Initiatives (without descriptions)
Global Lehigh Strategic Initiatives (without descriptions)cama23
 

Recently uploaded (20)

ISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITY
ISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITYISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITY
ISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITY
 
Procuring digital preservation CAN be quick and painless with our new dynamic...
Procuring digital preservation CAN be quick and painless with our new dynamic...Procuring digital preservation CAN be quick and painless with our new dynamic...
Procuring digital preservation CAN be quick and painless with our new dynamic...
 
Keynote by Prof. Wurzer at Nordex about IP-design
Keynote by Prof. Wurzer at Nordex about IP-designKeynote by Prof. Wurzer at Nordex about IP-design
Keynote by Prof. Wurzer at Nordex about IP-design
 
Student Profile Sample - We help schools to connect the data they have, with ...
Student Profile Sample - We help schools to connect the data they have, with ...Student Profile Sample - We help schools to connect the data they have, with ...
Student Profile Sample - We help schools to connect the data they have, with ...
 
call girls in Kamla Market (DELHI) 🔝 >༒9953330565🔝 genuine Escort Service 🔝✔️✔️
call girls in Kamla Market (DELHI) 🔝 >༒9953330565🔝 genuine Escort Service 🔝✔️✔️call girls in Kamla Market (DELHI) 🔝 >༒9953330565🔝 genuine Escort Service 🔝✔️✔️
call girls in Kamla Market (DELHI) 🔝 >༒9953330565🔝 genuine Escort Service 🔝✔️✔️
 
YOUVE_GOT_EMAIL_PRELIMS_EL_DORADO_2024.pptx
YOUVE_GOT_EMAIL_PRELIMS_EL_DORADO_2024.pptxYOUVE_GOT_EMAIL_PRELIMS_EL_DORADO_2024.pptx
YOUVE_GOT_EMAIL_PRELIMS_EL_DORADO_2024.pptx
 
Concurrency Control in Database Management system
Concurrency Control in Database Management systemConcurrency Control in Database Management system
Concurrency Control in Database Management system
 
Science 7 Quarter 4 Module 2: Natural Resources.pptx
Science 7 Quarter 4 Module 2: Natural Resources.pptxScience 7 Quarter 4 Module 2: Natural Resources.pptx
Science 7 Quarter 4 Module 2: Natural Resources.pptx
 
Karra SKD Conference Presentation Revised.pptx
Karra SKD Conference Presentation Revised.pptxKarra SKD Conference Presentation Revised.pptx
Karra SKD Conference Presentation Revised.pptx
 
Inclusivity Essentials_ Creating Accessible Websites for Nonprofits .pdf
Inclusivity Essentials_ Creating Accessible Websites for Nonprofits .pdfInclusivity Essentials_ Creating Accessible Websites for Nonprofits .pdf
Inclusivity Essentials_ Creating Accessible Websites for Nonprofits .pdf
 
Raw materials used in Herbal Cosmetics.pptx
Raw materials used in Herbal Cosmetics.pptxRaw materials used in Herbal Cosmetics.pptx
Raw materials used in Herbal Cosmetics.pptx
 
ECONOMIC CONTEXT - PAPER 1 Q3: NEWSPAPERS.pptx
ECONOMIC CONTEXT - PAPER 1 Q3: NEWSPAPERS.pptxECONOMIC CONTEXT - PAPER 1 Q3: NEWSPAPERS.pptx
ECONOMIC CONTEXT - PAPER 1 Q3: NEWSPAPERS.pptx
 
How to do quick user assign in kanban in Odoo 17 ERP
How to do quick user assign in kanban in Odoo 17 ERPHow to do quick user assign in kanban in Odoo 17 ERP
How to do quick user assign in kanban in Odoo 17 ERP
 
Like-prefer-love -hate+verb+ing & silent letters & citizenship text.pdf
Like-prefer-love -hate+verb+ing & silent letters & citizenship text.pdfLike-prefer-love -hate+verb+ing & silent letters & citizenship text.pdf
Like-prefer-love -hate+verb+ing & silent letters & citizenship text.pdf
 
Barangay Council for the Protection of Children (BCPC) Orientation.pptx
Barangay Council for the Protection of Children (BCPC) Orientation.pptxBarangay Council for the Protection of Children (BCPC) Orientation.pptx
Barangay Council for the Protection of Children (BCPC) Orientation.pptx
 
Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17
Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17
Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17
 
Virtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdf
Virtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdfVirtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdf
Virtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdf
 
4.18.24 Movement Legacies, Reflection, and Review.pptx
4.18.24 Movement Legacies, Reflection, and Review.pptx4.18.24 Movement Legacies, Reflection, and Review.pptx
4.18.24 Movement Legacies, Reflection, and Review.pptx
 
MULTIDISCIPLINRY NATURE OF THE ENVIRONMENTAL STUDIES.pptx
MULTIDISCIPLINRY NATURE OF THE ENVIRONMENTAL STUDIES.pptxMULTIDISCIPLINRY NATURE OF THE ENVIRONMENTAL STUDIES.pptx
MULTIDISCIPLINRY NATURE OF THE ENVIRONMENTAL STUDIES.pptx
 
Global Lehigh Strategic Initiatives (without descriptions)
Global Lehigh Strategic Initiatives (without descriptions)Global Lehigh Strategic Initiatives (without descriptions)
Global Lehigh Strategic Initiatives (without descriptions)
 

Deformation 1

  • 1. Beam Displacements David Roylance Department of Materials Science and Engineering Massachusetts Institute of Technology Cambridge, MA 02139 November 30, 2000 Introduction We want to be able to predict the deflection of beams in bending, because many applications have limitations on the amount of deflection that can be tolerated. Another common need for deflection analysis arises from materials testing, in which the transverse deflection induced by a bending load is measured. If we know the relation expected between the load and the deflection, we can “back out” the material properties (specifically the modulus) from the measurement. We will show, for instance, that the deflection at the midpoint of a beam subjected to “three-point bending” (beam loaded at its center and simply supported at its edges) is P L3 δP = 48EI where the length L and the moment of inertia I are geometrical parameters. If the ratio of δP to P is measured experimentally, the modulus E can be determined. A stiffness measured this way is called the flexural modulus. There are a number of approaches to the beam deflection problem, and many texts spend a good deal of print on this subject. The following treatment outlines only a few of the more straightforward methods, more with a goal of understanding the general concepts than with developing a lot of facility for doing them manually. In practice, design engineers will usually consult handbook tabulations of deflection formulas as needed, so even before the computer age many of these methods were a bit academic. Multiple integration In Module 12, we saw how two integrations of the loading function q(x) produces first the shear function V (x) and then the moment function M (x): V =− q(x) dx + c1 (1) M =− V (x) dx + c2 (2) where the constants of integration c1 and c2 are evaluated from suitable boundary conditions on V and M . (If singularity functions are used, the boundary conditions are included explicitly and the integration constants c1 and c2 are identically zero.) From Eqn. 6 in Module 13, the curvature 1
  • 2. v,xx (x) is just the moment divided by the section modulus EI. Another two integrations then give 1 v,x (x) = M (x) dx + c3 (3) EI v(x) = v,x (x) dx + c4 (4) where c3 and c4 are determined from boundary conditions on slope or deflection. Example 1 Figure 1: Three-point bending. As an illustration of this process, consider the case of “three-point bending” shown in Fig. 1. This geometry is often used in materials testing, as it avoids the need to clamp the specimen to the testing apparatus. If the load P is applied at the midpoint, the reaction forces at A and B are equal to half the applied load. The loading function is then P L q(x) = x −1 −P x− −1 2 2 Integrating according to the above scheme: P 0 L 0 V (x) = − x +P x− 2 2 P 1 L 1 M (x) = x −P x− (5) 2 2 P P L 2 EIv,x (x) = x 2− x− + c3 4 2 2 From symmetry, the beam has zero slope at the midpoint. Hence v,x = 0 @ x = L/2, so c3 can be found to be −P L2 /16. Integrating again: P P L 3 P L2 x EIv(x) = x 3− x− − + c4 12 6 2 16 The deflection is zero at the left end, so c4 = 0. Rearranging, the beam deflection is given by 2
  • 3. P L v= 4x3 − 3L2 x − 8 x − 3 (6) 48EI 2 The maximum deflection occurs at x = L/2, which we can evaluate just before the singularity term activates. Then P L3 δmax = (7) 48EI This expression is much used in flexural testing, and is the example used to begin this module. Before the loading function q(x) can be written, the reaction forces at the beam supports must be determined. If the beam is statically determinate, as in the above example, this can be done by invoking the equations of static equilibrium. Static determinacy means only two reaction forces or moments can be present, since we have only a force balance in the direction transverse to the beam axis and one moment equation available. A simply supported beam (one resting on only two supports) or a simply cantilevered beam are examples of such determinate beams; in the former case there is one reaction force at each support, and in the latter case there is one transverse force and one moment at the clamped end. Of course, there is no stringent engineering reason to limit the number of beam supports to those sufficient for static equilibrium. Adding “extra” supports will limit deformations and stresses, and this will often be worthwhile in spite of the extra construction expense. But the analysis is now a bit more complicated, since not all of the unknown reactions can be found from the equations of static equilibrium. In these statically indeterminate cases it will be necessary to invoke geometrical constraints to develop enough equations to solve the problem. This is done by writing the slope and deflection equations, carrying the unknown reaction forces and moments as undetermined parameters. The slopes and deflections are then set to their known values at the supports, and the resulting equations solved for the unknowns. If for instance a beam is resting on three supports, there will be three unknown reaction forces, and we will need a total of five equations: three for the unknown forces and two more for the constants of integration that arise when the slope and deflection equations are written. Two of these equations are given by static equilibrium, and three more are obtained by setting the deflections at the supports to zero. The following example illustrates the procedure, which is straightforward although tedious if done manually. Example 2 Consider a triply-supported beam of length L = 15 as shown in Fig. 2, carrying a constant uniform load of w = −10. There are not sufficient equilibrium equations to determine the reaction forces Ra , Rb , and Rc , so these are left as unknowns while multiple integration is used to develop a deflection equation: 0 q(x) = Ra x −1 + Rb x − 7.5 −1 + Rc x − 15 −1 − 10 x 0 0 0 1 V (x) = − q(x) dx = −Ra x − Rb x − 7.5 − Rc x − 15 + 10 x 1 1 1 10 2 M (x) = − V (x) dx = Ra x + Rb x − 7.5 + Rc x − 15 − x 2 Ra 2 Rb 2 Rc 2 10 3 EIy (x) = M (x) dx = x + x − 7.5 + x − 15 − x + c1 2 2 2 6 3
  • 4. Figure 2: Uniformly loaded beam resting on three supports. Ra 3 Rb 3 Rc 3 10 4 EIy(x) = EIy (x) dx = x + x − 7.5 + x − 15 − x + c1 x + c2 6 6 6 24 These equations have 5 unknowns: Ra , Rb , Rc , c1 , and c2 . These must be obtained from the two equilibrium equations Fy = 0 = Ra + Rb + Rc − qL L L Ma = 0 = qL − Rb − Rc L 2 2 and the three known zero displacements at the supports y(0) = y(L/2) = y(L) = 0 Although the process is straightforward, there is a lot of algebra to wade through. Statically indeterminate beams tend to generate tedious mathematics, but fortunately this can be reduced greatly by modern software. Follow how easily this example is handled by the Maple V package (some of the Maple responses removed for brevity): > # read the library containing the Heaviside function > readlib(Heaviside); > # use the Heaviside function to define singularity functions; > # sfn(x,a,n) is same is <x-a>^n > sfn := proc(x,a,n) (x-a)^n * Heaviside(x-a) end; > # define the deflection function: > y := (x)-> (Ra/6)*sfn(x,0,3)+(Rb/6)*sfn(x,7.5,3)+(Rc/6)*sfn(x,15,3) > -(10/24)*sfn(x,0,4)+c1*x+c2; > # Now define the five constraint equations; first vertical equilibrium: > eq1 := 0=Ra+Rb+Rc-(10*15); > # rotational equilibrium: > eq2 := 0=(10*15*7.5)-Rb*7.5-Rc*15; > # Now the three zero displacements at the supports: > eq3 := y(0)=0; > eq4 := y(7.5)=0; > eq5 := y(15)=0; > # set precision; 4 digits is enough: 4
  • 5. > Digits:=4; > # solve the 5 equations for the 5 unknowns: > solve({eq1,eq2,eq3,eq4,eq5},{Ra,Rb,Rc,c1,c2}); {c2 = 0, c1 = -87.82, Rb = 93.78, Ra = 28.11, Rc = 28.11} > # assign the known values for plotting purposes: > c1:=-87.82;c2:=0;Ra:=28.11;Rb:=93.78;Rc:=28.11; > # the equation of the deflection curve is: > y(x); 3 3 4.686 x Heaviside(x) + 15.63 (x - 7.5) Heaviside(x - 7.5) 3 4 + 4.686 (x - 15) Heaviside(x - 15) - 5/12 x Heaviside(x) - 87.82 x > # plot the deflection curve: > plot(y(x),x=0..15); > # The maximum deflection occurs at the quarter points: > y(15/4); -164.7 The plot of the deflection curve is shown in Fig. 3. Figure 3: Deflection curve EIy(x) for uniformly loaded triply-supported beam (Note difference in horizontal and vertical scales). Energy method The strain energy in bending as given by Eqn. 8 of Module 13 can be used to find deflections, and this may be more convenient than successive integration if the deflection at only a single point is desired. Castigliano’s Theorem gives the deflection congruent to a load P as ∂U ∂ M 2 dx δP = = ∂P ∂P L 2EI 5
  • 6. It is usually more convenient to do the differentiation before the integration, since this lowers the order of the expression in the integrand: M ∂M δP = dx L EI ∂P where here E and I are assumed not to vary with x. The shear contribution to bending can be obtained similarly. Knowing the shear stress τ = V Q/Ib (omitting the xy subscript on τ for now), the strain energy due to shear Us can be written τ2 V2 Q2 Us = dV = dA dx V 2G L 2GI A L2 The integral over the cross-sectional area A is a purely geometrical factor, and we can write V 2 fs Us = dA (8) L 2GA where the fs is a dimensionless form factor for shear defined as A Q2 fs = dA (9) I2 A b2 Figure 4: Rectangular beam section. Evaluating fs for rectangular sections for illustration (see Fig. 4), we have in that case bh3 A = bh, I= 12 (h/2) − y h Q= y+ b −y 2 2 (bh) h/2 1 6 fs = Q dy = (bh3 /12)2 −h/2 b 2 5 Hence fs is the same for all rectangular sections, regardless of their particular dimensions. Similarly, it can be shown (see Prob. 3) that for solid circular sections fs = 10/9 and for hollow circular sections fs = 2. 6
  • 7. Example 3 If for instance we are seeking the deflection under the load P in the three-point bending example done earlier, we can differentiate the moment given in Eqn. 5 to obtain ∂M 1 1 L 1 = x − x− ∂P 2 2 Then 1 P 1 L 1 1 1 L 1 δP = x −P x− x − x− dx EI L 2 2 2 2 Expanding this and adjusting the limits of integration to account for singularity functions that have not been activated: L L 2 P x2 L L δP = dx + −x x − + x− dx EI 0 4 L/2 2 2 P L3 =− 48EI as before. The contribution of shear to the deflection can be found by using V = P/2 in the equation for strain energy. For the case of a rectangular beam with fs = 6/5 we have: (P/2)2 (6/5) Us = L 2GA ∂Us 6P L δP,s = = ∂P 20GA The shear contribution can be compared with the bending contribution by replacing A with 12I/h2 (since A = bh and I = bh3 /12). Then the ratio of the shear to bending contributions is P Lh2 /40GI 3h2 E = P L3 /24EI 5L2 G Hence the importance of the shear term scales as (h/L)2 , i.e. quadratically as the span-to-depth ratio. The energy method is often convenient for systems having complicated geometries and com- bined loading. For slender shafts transmitting axial, torsional, bending and shearing loads the strain energy is P2 T2 M2 V 2 fs U= + + + dx (10) L 2EA 2GJ 2EI 2GA Example 4 Consider a cantilevered circular beam as shown in Fig. 5 that tapers from radius r1 to r2 over the length L. We wish to determine the deflection caused by a force F applied to the free end of the beam, at an angle θ from the horizontal. Turning to Maple to avoid the algebraic tedium, the dimensional parameters needed in Eqn. 10 are defined as: 7
  • 8. Figure 5: Tapered circular beam. > r := proc (x) r1 + (r2-r1)*(x/L) end; > A := proc (r) Pi*(r(x))^2 end; > Iz := proc (r) Pi*(r(x))^4 /4 end; > Jp := proc (r) Pi*(r(x))^4 /2 end; where r(x) is the radius, A(r) is the section area, Iz is the rectangular moment of inertia, and Jp is the polar moment of inertia. The axial, bending, and shear loads are given in terms of F as > P := F* cos(theta); > V := F* sin(theta); > M := proc (x) -F* sin(theta) * x end; The strain energies corresponding to tension, bending and shear are > U1 := P^2/(2*E*A(r)); > U2 := (M(x))^2/(2*E*Iz(r)); > U3 := V^2*(10/9)/(2*G*A(r)); > U := int( U1+U2+U3, x=0..L); Finally, the deflection congruent to the load F is obtained by differentiating the total strain energy: > dF := diff(U,F); The result of these manipulations yields LF 12 L2G − 12GL2 cos2 θ + 9Gr2 cos2 θ + 10 r2 E − 10 r2 E cos2 θ 2 2 2 δF = 3 Eπ G 9 r1 r2 This displacement is in the direction of the applied force F ; the horizontal and vertical deflections of the end of the beam are then δx = δF cos θ δy = δF sin θ 8
  • 9. Superposition In practice, many beams will be loaded in a complicated manner consisting of several concen- trated or distributed loads acting at various locations along the beam. Although these multiple- load cases can be solved from scratch using the methods described above, it is often easier to solve the problem by superposing solutions of simpler problems whose solutions are tabulated. Fig. 6 gives an abbreviated collection of deflection formulas1 that will suffice for many problems. The superposition approach is valid since the governing equations are linear; hence the response to a combination of loads is the sum of the responses that would be generated by each separate load acting alone. Figure 6: Deflections for cantilevered and simply-supported beams, under concentrated and distributed loading. Example 5 We wish to find the equation of the deflection curve for a simply-supported beam loaded in symmetric four-point bending as shown in Fig. 7. From Fig. 6, the deflection of a beam with a single load at a 1 A more exhaustive listing is available in W.C. Young, Roark’s Formulas for Stress and Strain, McGraw-Hill, New York, 1989. 9
  • 10. Figure 7: Four-point bending. distance a from the left end is δ(x) = 6LEI L x − a Pb b 3 − x3 + L2 − b2 x . Our present problem is just two such loads acting simultaneously, so we have P (L − a) L 3 δ(x) = x−a − x3 + L2 − (L − a)2 x 6LEI L−a Pa L 3 + x − (L − a) − x3 + L2 − a2 x 6LEI a In some cases the designer may not need the entire deflection curve, and superposition of tabulated results for maximum deflection and slope is equally valid. Problems 1. (a)–(h) Write expressions for the slope and deflection curves of the beams shown here. Prob. 1 2. (a)–(h) Use MapleV (or other) software to plot the slope and deflection curves for the beams in Prob. 1, using the values (as needed) L = 25 in, a = 15 in, w = 10 lb/in, P = 150 lb. 3. Show that the shape factor for shear for a circular cross section is 10
  • 11. A Q 10 fs = dA = I2 A b 2 9 4. (a)–(b) Determine the deflection curves for the beams shown here. Plot these curves for the the values (as needed) L = 25 in, a = 5 in, w = 10 lb/in, P = 150 lb. Prob. 4 5. (a) Determine the deflection of a coil spring under the influence of an axial force F , including the contribution of bending, direct shear, and torsional shear effects. Using r = 1 mm and R = 10 mm, compute the relative magnitudes of the three contributions. (b) Repeat the solution in (a), but take the axial load to be placed at the outer radius of the coil. Prob. 5 6. (a)–(c) Use the method of superposition to write expressions for the deflection curve δ(x) for the cases shown here. 11
  • 12. Prob. 6 12