Steady State Solution Mass Spring System

Lesson28.mw

  • Outline of Lesson 28
  • Initialization
  • 28.A Unforced Oscillatory Motion - Undamped
    • 28.A-1 Example 1
    • 28.A-2 Example 2
  • 28.B Unforced Oscillatory Motion - Damped
    • 28.B-1 Case 1: Underdamped Motion ( b^2-4*m*k; < 0 )
    • 28.B-2 Case 2: Critically Damped Motion ( b^2-4*m*k; = 0 )
      • Subcase 1: b > 0
      • Subcase 2: b = 0
    • 28.B-3 Case 3: Overdamped Motion ( b^2-4*m*k; > 0 )
  • 28.C Resonance
    • 28.C-1 Realistic Resonance
    • 28.C-2Unrealistic Resonance

ORDINARY DIFFERENTIAL EQUATIONS POWERTOOL

Lesson 28 -- Application: Unforced Spring-Mass Oscillators

Prof. Douglas B. Meade

Industrial Mathematics Institute

Department of Mathematics

University of South Carolina

Columbia, SC 29208

URL: http://www.math.sc.edu/~meade/

E-mail: meade@math.sc.edu

Copyright  2001  by Douglas B. Meade

All rights reserved

-------------------------------------------------------------------

Outline of Lesson 28

28.A Unforced Oscillatory Motion - Undamped

28.A-1 Example 1

28.A-2 Example 2

28.B Unforced Oscillatory Motion - Damped

28.B-1 Case 1: Underdamped Motion ( b^2-4*a*c < 0 )

28.B-2 Case 2: Critically Damped Motion ( b^2-4*a*c = 0 )

28.B-3 Case 3: Overdamped Motion ( b^2-4*a*c > 0 )

28.C Resonance

28.C-1 Realistic Resonance

28.C-2 Unrealistic Resonance

Initialization

Warning, the name changecoords has been redefined

28.A Unforced Oscillatory Motion - Undamped

A spring that obeys Hooke's law - the displacement is proportional to the applied force - is called a linear spring.  Suppose that such a spring whose natural (unstretched or compressed) length is L is suspended vertically so that its upper end is attached to a fixed support, and its lower end is attached to a mass m .  The attached mass will stretch the spring until it attains an equilibrium position.  In a coordinate system x measured positive upward from the equilibrium position of the mass, measure displacements of the mass with the variable x(t) .  Again, the origin of this coordinate system is the equilibrium position of the suspended mass, and displacements upward are positive.

The force of gravity acting downward on the mass is -m*g j , where g is the gravitational constant, is counterbalanced by the sag in the spring past its natural length L when the mass is first attached.  This downward gravitational force is always in balance with the upward force generated by the spring as it sags from its natural length to the equilibrium position that establishes the origin x = 0 for the coordinate system.  This gravitational force never appears in the equation of motion for the spring-mass system described above.

According to Hooke's law, the force exerted by the spring on the mass is -k*x j , where k is the spring constant expressed in units of force divided by distance.  The acceleration of the mass under the action of the spring is a = d^2*x/(dt^2) j .  Newton's second law, namely, F = m a , then gives the equation of motion as

m d^2*x/(dt^2) = -k*x(t)

or

m*`x''`(t)+k*x(t) = 0

Initial conditions would be the initial displacement of the mass from equilibrium , and any initial velocity given to the mass.  Thus, the mass could be lifted initially, in which case x(0)*`>`*0 .  Alternatively, the mass could be pulled down below equilibrium so that x(0) < 0 .  Of course, if the mass is not displaced from equilibrium initially, x(0) = 0 .

If the mass is thrown upward initially, it would have a positive initial velocity, and hence, `x'`(0)*`>`*0 .  Alternatively, the mass could be tossed downward initially, in which case `x'`(0) < 0 .  If the mass is released from rest , then `x'`(0) = 0 .

These considerations lead to the IVP

> ode1 := m*diff(x(t),t,t)+k*x(t) = 0;
ic1 := x(0)=alpha, D(x)(0)=beta;

ode1 := m*(diff(x(t), `$`(t, 2)))+k*x(t) = 0

ic1 := x(0) = alpha, D(x)(0) = beta

for x(t) , the displacement of the mass from equilibrium.  The solution of the differential equation itself, namely,

x(t) = _C1*sin(k^(1/2)*t/m^(1/2))+_C2*cos(k^(1/2)*t/m^(1/2))

follows from the exponential guess x(t) = exp(rt) and the characteristic equation

m*r^2+k = 0

Since the characteristic roots are then

r = + i*sqrt(k/m)

the general solution will be a linear combination of the members of the (real) fundamental set {cos(omega*t), sin(omega*t)} , where omega = sqrt(k/m) is called the angular frequency .

The trigonometric form

a*cos(omega*t)+b*sin(omega*t)

can be transformed to

A*cos(omega*t-phi)

where

A = sqrt(a^2+b^2)

and the phase angle phi is determined by the two equations

cos(phi) = a/A and sin(phi) = b/A

In this form, the general solution of the undamped spring-mass system clearly undergoes periodic motion with angular frequency omega = sqrt(k/m) and amplitude A .  Such motion is called harmonic motion , and without damping, would persist undiminished forever.  Undamped spring-mass systems are therefore called natural harmonic oscillators .

28.A-1 Example 1

Maple does not have a single command for converting the trigonometric form

> q := a*cos(omega*t) + b*sin(omega*t);

q := a*cos(omega*t)+b*sin(omega*t)

to the form

> Q := A*cos(omega*t - phi);

Q := A*cos(omega*t-phi)

Much of the management of this transition remains in the hands of the user.  For example, the equation

a*cos(omega*t)+b*sin(omega*t) = A*cos(omega*t-phi)

could be treated as an identity in t , so that Maple can compute the appropriate values of A and phi as

> qq := solve(identity(q=Q,t), {A,phi});

qq := {phi = arctan(b/(b^2+a^2)^(1/2), a/(b^2+a^2)^(1/2)), A = (b^2+a^2)^(1/2)}, {phi = arctan(-b/(b^2+a^2)^(1/2), -a/(b^2+a^2)^(1/2)), A = -(b^2+a^2)^(1/2)}

It is typical to take the amplitude as positive, so the first solution would be the preferred one.

Note also the usage of the two-argument arctangent function.  The single-argument arctangent function, arctan(y/x) , returns an angle in the range ``(-Pi/2, Pi/2) , which is equivalent to the angle being in the first or fourth quadrants.  This is the function one finds on the typical scientific calculator.  Use of this function with a point ``(x, y) loses sign information when either x or y is negative.

Most scientific programming languages have some form of the two-argument arctangent function, arctan(y, x) , which returns an angle in the range ( -Pi, Pi ].  This is equivalent to preserving the signs on the coordinates of points ``(x, y) so that the angle returned is in the proper one of the four quadrants.

28.A-2 Example 2

Convert the trigonometric form

> q := 3*cos(2*t) - 5*sin(2*t);

q := 3*cos(2*t)-5*sin(2*t)

to the form

Q := A*cos(2*t-phi)

Again treating the equation

3*cos(2*t)-5*sin(2*t) = A*cos(2*t-phi)

as an identity in t , Maple determines two solutions for the constants A and phi via

> qq := solve(identity(q = Q,t), {A,phi});

qq := {A = 34^(1/2), phi = -arctan(5/3)}, {A = -34^(1/2), phi = -arctan(5/3)+Pi}

Selecting the positive amplitude, the desired form is then

34^(1/2)*cos(2*t+arctan(5/3))

The amplitude and phase angle are, respectively,

> A = eval(A,qq[1]);
phi = eval(phi,qq[1]);

A = 34^(1/2)

phi = -arctan(5/3)

28.B Unforced Oscillatory Motion - Damped

Linear damping is resistance proportional to dx/dt , the velocity, and opposing the motion.  Air resistance against the moving mass would be an example of such a force.  If linear damping is added to the spring-mass system of Section 28.A, the differential equation governing displacements from equilibrium becomes

> ode1 := m * diff( x(t), t$2 ) + b * diff( x(t), t ) + k * x(t) = 0;

ode1 := m*(diff(x(t), `$`(t, 2)))+b*(diff(x(t), t))+k*x(t) = 0

where b is the coefficient of linear damping .  The oscillatory motion experienced by such a system is called unforced, or free motion, and corresponds to the absence of a driving, or forcing term on the right-hand side of the equation.  Hence, the DE for unforced motion is homogeneous.

Surprisingly, the very similar DE

L d^2*x/(dt^2)+R dx/dt+1/C x = 0

governs the unforced RLC electric circuit (see Lesson 29 ) where x(t) represents the charge, dx/dt represents the current, R is the resistance, L is the inductance, and C is the capacitance ( 1/C is the elastance).

The solution procedure for a second-order linear ODE with constant coefficients calls for a search for exponential solutions, so the exponential guess leads to

> q1 := factor( eval( ode1, x(t)=exp(lambda*t) ) );

q1 := exp(lambda*t)*(m*lambda^2+b*lambda+k) = 0

and the characteristic equation

> chareqn := q1 / exp( lambda*t );

chareqn := m*lambda^2+b*lambda+k = 0

The values of the characteristic roots are then

> charvals := solve( chareqn, {lambda} );

charvals := {lambda = -1/2*(b-(b^2-4*k*m)^(1/2))/m}, {lambda = -1/2*(b+(b^2-4*k*m)^(1/2))/m}

Since the characteristic equation is quadratic, the discriminant

> discrim(lhs(chareqn),lambda);

b^2-4*k*m

determines the nature of the characteristic roots which, for m positive, and b and k nonnegative, can be negative, zero, or positive.  In each case, the system experiences a distinctive motion called respective, underdamped, critically damped, or overdamped.

These three cases are examined individually in the next three subsections.

28.B-1 Case 1: Underdamped Motion ( b^2-4*m*k < 0 )

When the discriminant is negative, that is, in the case b^2-4*m*k < 0 , the characteristic values are complex conjugates that can be written as

alpha + omega*i

where

alpha = -b/(2*m) and omega = sqrt(4*m*k-b^2)/(2*m) = sqrt(k/m-(b/(2*m))^2)

A fundamental set contains the independent solutions

x[1] = exp(alpha*t)*cos(omega*t)

x[2] = exp(alpha*t)*sin(omega*t)

which are both exponentially damped sinusoids .  (The literature refers to both the sine and cosine functions as sinusoids.)

The general solution, a linear combination of these functions, can be written either as

exp(alpha*t)*(c[1]*cos(omega*t)+c[2]*sin(omega*t))

or as

A*exp(alpha*t)*cos(omega*t-phi)

where A = sqrt(c[1]^2+c[2]^2) , cos(phi) = c[1]/A , and sin(phi) = c[2]/A .

In this latter form, A*exp(alpha*t) is the damped amplitude , omega is the angular frequency, omega/(2*Pi) is the quasi-frequency, 2*Pi/beta is the quasi-period, and phi is the phase angle.

The decaying exponential term forces all solutions to decay to the zero function as t increases.

A typical example of underdamped motion is generated by the differential equation

> q1 := eval(ode1, {m=1,b=4,k=16});

q1 := (diff(x(t), `$`(t, 2)))+4*(diff(x(t), t))+16*x(t) = 0

whose solution for the initial conditions

> ic1 := x(0)=2, D(x)(0)=2;

ic1 := x(0) = 2, D(x)(0) = 2

is

> X1 := collect(rhs(dsolve({q1,ic1},x(t))),exp);

X1 := (3^(1/2)*sin(2*3^(1/2)*t)+2*cos(2*3^(1/2)*t))*exp(-2*t)

Alternatively, this solution can be expressed in the form

> QQ := A*cos(2*sqrt(3)*t-phi)*exp(-2*t);

QQ := A*cos(2*3^(1/2)*t-phi)*exp(-2*t)

where A is the positive solution in

> params := solve(identity(X1=QQ,t), {A,phi});

params := {A = 7^(1/2), phi = arctan(1/2*3^(1/2))}, {A = -7^(1/2), phi = arctan(1/2*3^(1/2))-Pi}

Hence, the equivalent form of the solution is

> X2 := eval(QQ,params[1]);

X2 := 7^(1/2)*cos(2*3^(1/2)*t-arctan(1/2*3^(1/2)))*exp(-2*t)

Figure 28.1 shows the solution in black, and the exponential envelopes + sqrt(7)*exp(-2*t) in red.

> plot([X1, sqrt(7)*exp(-2*t), -sqrt(7)*exp(-2*t)], t=0..3, color=[black,red,red], title="Figure 28.1");

[Plot]

28.B-2 Case 2: Critically Damped Motion ( b^2-4*m*k = 0 )

When the discriminant is zero, that is, in the case b^2-4*m*k = 0 , the characteristic values are the repeated root alpha = -b/(2*m) .  In this case, two linearly independent solutions to the ODE are

x[1] = exp(alpha*t) and x[2] = t*exp(alpha*t)

so that the general solution is

> X := (c[1]+c[2]*t)*exp(-b/2/m*t);

X := (c[1]+c[2]*t)*exp(-1/2*b*t/m)

The motion that results from the case of the repeated characteristic root is called critically damped motion. It stands at the interface between underdamped motion and overdamped motion, the third case to be studied below.  However, engineers consider that critically damped motion never occurs in actual practice.  This is because the parameters in a physical system are never determined so precisely as to cause the discriminant to vanish.  Even if the perfect system were built so that the oscillator experienced critically damped motion, the very motion of the spring would warm the metal and change the spring constant, and the system would no longer be truely critically damped.  Thus, critical damping is really a mathematical concept.

Initial values for x(t) and `x'`(t) lead to the equations

> eq1 := eval(X,t=0) = x(0);
eq2 := eval(diff(X,t),t=0) = `x'`(0);

eq1 := c[1] = x(0)

eq2 := c[2]-1/2*c[1]*b/m = `x'`(0)

whose solution is

> expand(solve({eq1,eq2},{c[1],c[2]}));

{c[2] = 1/2*x(0)*b/m+`x'`(0), c[1] = x(0)}

Surprisingly, the initial velocity `x'`(0) = -b*x(0)/(2*m) implies c[2] = 0 .

The IVP

> ode2 := eval(ode1, {m=1,b=8,k=16});
ic2 := x(0)=2, D(x)(0)=0;

ode2 := (diff(x(t), `$`(t, 2)))+8*(diff(x(t), t))+16*x(t) = 0

ic2 := x(0) = 2, D(x)(0) = 0

governs the critically damped motion exhibited by the solution

> XC1 := rhs(dsolve({ode2, ic2}, x(t)));

XC1 := 2*exp(-4*t)+8*exp(-4*t)*t

that is graphed in Figure 28.2.

> plot(XC1, t=0..3, title="Figure 28.2");

[Plot]

Subcase 1: b > 0

So long as b*`>`*0 , the common exponential factor overwhelms the linear factor and forces all solutions to zero. The decay to zero is not necessarily monotonic. The general solution of the critically damped equation has a critical point at

> t[crit] = expand(solve( diff(X,t)=0, t));

t[crit] = 2*m/b-c[1]/c[2]

which is positive if and only if c[2] <> 0 and c[1]/c[2] < 2*m/b .

The IVP

> ode2;
ic3 := x(0)=2, D(x)(0)=5;

(diff(x(t), `$`(t, 2)))+8*(diff(x(t), t))+16*x(t) = 0

ic3 := x(0) = 2, D(x)(0) = 5

governs the critically damped motion exhibited by the solution

> XC2 := rhs(dsolve({ode2, ic3}, x(t)));

XC2 := 2*exp(-4*t)+13*exp(-4*t)*t

and graphed in Figure 28.3.

> plot(XC2, t=0..3, title="Figure 28.3");

[Plot]

Lifting the mass and tossing it upward to set it into motion causes it to rise above the initial height, but then to descend exponentially to equilibrium.

Subcase 2: b = 0

Note that if b = 0, then 4*m*k = 0 and m*`>`*0 imply that c = 0 . In this case of undamped motion , the ODE simplifies to

> eval( ode1, [m=1,b=0,k=0] );

diff(x(t), `$`(t, 2)) = 0

a fundamental set of solutions is {1, t} , and the general solution is a linear function. Hence, solutions do not tend to zero as t increases. In fact, except in special cases where the solution is a constant function, the solutions become unbounded as t increases.

28.B-3 Case 3: Overdamped Motion ( b^2-4*m*k > 0 )

The third case is the most straightforward. If the discriminant is positive, that is, if b^2-4*m*k > 0, then there are two distinct, real characteristic roots, namely,

alpha + beta

where again

alpha = -b/(2*m)

but

beta = sqrt(b^2-4*m*k)/(2*m) = sqrt((b/(2*m))^2-k/m)

Writing these characteristic roots as

> lambda[1] := eval( lambda, charvals[1] );
lambda[2] := eval( lambda, charvals[2] );

lambda[1] := -1/2*(b-(b^2-4*k*m)^(1/2))/m

lambda[2] := -1/2*(b+(b^2-4*k*m)^(1/2))/m

a fundamental set of solutions is then

> X[1] := exp( lambda[1]*t );
X[2] := exp( lambda[2]*t );

X[1] := exp(-1/2*(b-(b^2-4*k*m)^(1/2))*t/m)

X[2] := exp(-1/2*(b+(b^2-4*k*m)^(1/2))*t/m)

so the general solution is

> X[h] := c[1]*X[1] + c[2]*X[2];

X[h] := c[1]*exp(-1/2*(b-(b^2-4*k*m)^(1/2))*t/m)+c[2]*exp(-1/2*(b+(b^2-4*k*m)^(1/2))*t/m)

The system giving rise to such a solution is called overdamped , and by a stretch of notation, the differential equation itself, its solution, or the resulting motion, can be modified by the adjective "overdamped."

Observe that, because 0 < b^2-4*m*k `` <= b^2 , both characteristic values are negative. In fact, lambda[2] < lambda[1] < 0. All solutions of an overdamped equation ultimately decay to zero as t increases. But, just as with the critically damped case, the solution can have one critical point:

> dX[h] := diff( X[h], t ):
> tcrit := solve( dX[h] = 0, t );

tcrit := -m*ln(-2*c[1]*k*m/(c[2]*((b^2-4*k*m)^(1/2)*b+b^2-2*k*m)))/(b^2-4*k*m)^(1/2)

To determine when the critical point occurs with t*`>`*0 , observe that the location of the critical point can be expressed as

t[crit] = -m/sqrt(b^2-4*m*k) ln( c[1]/c[2] lambda[1]/lambda[2] )

This time is positive precisely when 0 < c[1]/c[2] lambda[1]/lambda[2] < 1.

To conclude, note that except for the trivial case with b = k = 0, all solutions to the ODE for unforced oscillatory motion are transient solutions that eventually "die out" as time passes.  (The first generation of television sets were built with vacuum tubes that had to "warm up" to reach their operating points.  During this warm-up phase, the TV screen would generally show a gradually brightening, wavering and distorted image that was the physical realization of the transients in the circuits.)

The driven or forced oscillator is governed by the nonhomogeneous ODE

m d^2*x/(dt^2)+b dx/dt+k*x = f(t)

where f(t) is called the forcing term.  The general solution of this equation has the form

x[g] = x[h]+x[p]

where x[h] is the homogeneous solution built as a linear combination of the members of the fundamental set.  This solution contains the decaying exponentials discussed in this worksheet.  The particular solution x[p] is determined by the driving term, and any part of it that persists over time constitutes the steady - state solution, the solution that is seen after all transients die out.

28.C Resonance

Anthropomorphically speaking, resonance can be described as a temper tantrum thrown by Mother Nature.  It is an exaggerated response to a stimulus.

Analytically speaking, resonance in a driven oscillator is the phenomenon whereby the steady-state response to a sinusoidal forcing term attains maximal amplitude.  Thus, the amplitude of the steady-state solution of the driven damped oscillator described by the ODE

m d^2*x/(dt^2)+b dx/dt+k*x = f(t)

where

f(t) = A*cos(omega*t)

achieves a maximal value at some angular frequency omega = omega[R] .

Familiar occurrences of resonance might include the sound-box on a stringed musical instrument, the tuning circuit in an AM radio, the annoying rattle of a motor driven at certain speeds, or the collapse of the Tacoma Narrows Bridge.  The body of an acoustic guitar is a resonator that amplifies the sound of the vibrating strings.  The tuning circuit of an AM radio is essentially a driven RLC circuit whose resonant oscillations are used to oppose those of the carrier signal, leaving behind the broadcast information.  Less useful instances of resonance include the irritation of a noisy motor whose resonance is causing nearby objects to vibrate noisily or destructively.  The rythmic driving of a bridge under the footfalls of an army marching in step can cause destructive resonance.  Supposedly, to avoid resonance, marching armies were instructed to break step when crossing bridges.

The collapse in 1940 of the Tacoma Narrows Bridge over the Puget Sound requires more discussion.  This enormous (almost 6000 feet long) engineering structure was designed to withstand winds of up to 120 mph. But, due to its tendency to undulate in light winds, the bridge was fondly known as Galloping Gertie.  On November 7, 1940, only four months after being completed, the bridge was completely destroyed in 42 mph winds.  The full incident is preserved on a famous four-minute film clip;  a short excerpt is available at http://www.physics.bcit.ca/netshow/tacoma.avi .  For many years the accepted explanation of this tragedy was resonance.  In recent years, however, an alternate theory based on aerodynamically induced condition of self-excitation or "negative damping" has gained wide acceptance.  Additional details can be found at many sites on the WWW, including

http://www.urbanlegends.com/science/bridge_resonance.html
http://www.vibrationdata.com/Tacoma.htm

http://www.ketchum.org/wind.html

http://www.eng.uab.edu/cee/reu_nsf99/tacoma.htm
http://www.math.uconn.edu/~kmoore/tacoma.html
http://www.madsci.org/posts/archives/may98/892678504.Eg.r.html
http://www.nationmaster.com/encyclopedia/Tacoma-Narrows-Bridge
http://en2.wikipedia.org/wiki/Tacoma_Narrows_Bridge

This is not the place to debate these theories, but both require a solid understanding of resonance and damping.

The following discussion of resonance proceeds in two parts.  First, the realistic case of the driven damped oscillator is considered.  Second, the unrealistic case of the undamped oscillator is discussed.  Since all real systems have damping of some sort, undamped oscillators are actually only met as an approximation to real systems.

28.C-1 Realistic Resonance

Without loss of generality, let the equation for the driven damped oscillator be

> ODE := diff(x(t),t,t) + B*diff(x(t),t) + K*x(t) = A*cos(omega*t);

ODE := (diff(x(t), `$`(t, 2)))+B*(diff(x(t), t))+K*x(t) = A*cos(omega*t)

where the driving (angular) frequency omega is as yet undetermined.  Treat it as a parameter that can be adjusted, much like the speed on an electric fan can be changed by turning a knob.  The standard equation for the damped oscillator has been divided by the mass m , so B = b/m and K = k/m .

The steady-state response is essentially the particular solution since the homogeneous solution, containing exponentials whose real parts are negative, will be a transient of the system and become negligible after a certain time.  This particular solution is

> XP := dsolve(ODE,x(t),output=basis)[2];

XP := (A*cos(omega*t)*K-A*cos(omega*t)*omega^2+A*sin(omega*t)*omega*B)/(B^2*omega^2+K^2-2*K*omega^2+omega^4)

The form

> Q := a*cos(omega*t-phi);

Q := a*cos(omega*t-phi)

is more convenient for determining the amplitude a , which is found via

> sol := solve(identity(XP=Q,t),{a,phi});

sol := {phi = arctan(omega*B/(B^2*omega^2+K^2-2*K*omega^2+omega^4)^(1/2), (K-omega^2)/(B^2*omega^2+K^2-2*K*omega^2+omega^4)^(1/2)), a = A/(B^2*omega^2+K^2-2*K*omega^2+omega^4)^(1/2)}, {phi = arctan(-o... sol := {phi = arctan(omega*B/(B^2*omega^2+K^2-2*K*omega^2+omega^4)^(1/2), (K-omega^2)/(B^2*omega^2+K^2-2*K*omega^2+omega^4)^(1/2)), a = A/(B^2*omega^2+K^2-2*K*omega^2+omega^4)^(1/2)}, {phi = arctan(-o...

Again selecting the positive amplitude, and ignoring the phase angle, write

AMP := A/(B^2*omega^2+K^2-2*K*omega^2+omega^4)^(1/2)

This amplitude is a function of the driving frequency omega .  Resonance occurs at the frequency that causes this function to be a maximum.  Simple calculus reveals that this resonant frequency is

> SOL := solve(diff(AMP,omega)=0,omega);

SOL := 0, 1/2*(-2*B^2+4*K)^(1/2), -1/2*(-2*B^2+4*K)^(1/2)

The positive solution is the resonant frequency, written as

> omega[R] = eval(SOL[2], {B=b/m, K=k/m});

omega[R] = 1/2*(-2*b^2/m^2+4*k/m)^(1/2)

An alternate form for this expression is

omega[R] = sqrt(k/m-b^2/(2*m^2))

where omega[R] is real and positive if b^2 < 2*k*m .  Thus, if the damping coefficient b is nto less than sqrt(2*m*k) , no value of the driving frequency will cause the system to resonate.  Alternatively, the threshold of damping for resonance is b^2 < 2*m*k , whereas the threshold of damping for the system to be underdamped is b^2 < 4*m*k .  Loosely speaking, it might be said that half the systems that can oscillate can be made to resonate.  An underdamped system that is made to resonate will also have a natural frequency

omega[N] = sqrt(k/m-b^2/(4*m^2))

Thus, for the damped oscillator, the natural frequency is slightly larger than the resonant frequency, whereas for the undamped oscillator, the natural and resonant frequencies will shortly be seen to be the same.

If m = 1 , the expression for the amplitude of the steady-state response is

A/(B^2*omega^2+K^2-2*K*omega^2+omega^4)^(1/2)

Choosing the parameter values

> params1 := {A=1, B=1/10, K=1};

params1 := {A = 1, B = 1/10, K = 1}

gives the amplitude function

> F := eval(AMP, params1);

F := 1/(-199/100*omega^2+1+omega^4)^(1/2)

whose graph is seen in Figure 28.4.

> plot(F,omega=0..3, title="Figure 28.4");

[Plot]

Figure 28.4 supports the initial claim that resonance can be thought of as a temper tantrum by Mother Nature.  The amplitude of the driving function is just A = 1 , but the magnitude of the response at steady-state is on the order of 10.  For very little provocation, the oscillator has over-responded, much like a child having a temper tantrum.

The response to the driving term clearly depends on the damping parameter.  Choose the system parameters to be m = 1 and

> params2 := {A=1, B=b, K=1};

params2 := {A = 1, B = b, K = 1}

so that the amplitude function is

> G := eval(AMP, params2);

G := 1/(b^2*omega^2+1-2*omega^2+omega^4)^(1/2)

The dependence of the amplitude on both the damping coefficient and the driving frequency can be seen in Figure 28.5.

> plot3d(G, omega=0..2, b=0..1, axes=box, title="Figure 28.5");

[Plot]

As damping increases upward from b = 0 , the magnitude of the steady-state amplitude diminishes.  Thus, the greater the damping, the less the effect of resonance.  As b decreases, the spike in amplitude at resonance clearly increases.  The plane sections b = constant shown in Figure 28.6 again capture the dependence of the resonant peak on damping.  The tallest peak corresponds to the smallest value of b , and the smallest peak, to the largest.

> plot([seq(eval(G,b=j/10),j=1..9)],omega=0..2, title="Figure 28.6");

[Plot]

28.C-2Unrealistic Resonance

Without damping, the driven oscillator equation would be

ODE1 := (diff(x(t), `$`(t, 2)))+K*x(t) = A*cos(omega*t)

in which case a particular solution would be

> dsolve(ODE1, x(t), output=basis)[2];

A*cos(omega*t)/(K-omega^2)

Clearly, as omega approaches sqrt(K) = sqrt(k/m) , the natural (angular) frequency of the system, the amplitude of the steady-state solution will become infinite.  In reality, there is always some damping that prevents this solution from actually existing forever. In physical terms usually one or more system components break while the amplitude is still finite. Because these unbounded solutions are primarily of theoretical interest, this is called unrealistic resonance.

Another approach to unrealistic resonance is to drive the system initially at the natural angular frequency.  The differential equation for the system then becomes

> ODE2 := eval(ODE1, {K=k/m, omega=sqrt(k/m)});

ODE2 := (diff(x(t), `$`(t, 2)))+k*x(t)/m = A*cos((k/m)^(1/2)*t)

A particular solution is then

> XP := dsolve(ODE2, x(t), output=basis)[2];

XP := 1/4*(2*A*m^(1/2)*t*sin(k^(1/2)*t/m^(1/2))*k+A*m*cos(k^(1/2)*t/m^(1/2))*k^(1/2))/k^(3/2)

where, in spite of the complicated form, it should be clear that one of the trigonometric terms is multiplied by t .  This is because, by the method of undetermined coefficients, the homogeneous solution and the driving term share a common term.  Hence, the particular solution requires multiplication by t , and the trigonometric term in the particular solution without the factor t is actually redundant - it also appears in the homogeneous solution.

To within a constant factor, the particular solution is actually

> Xp := t*sin(sqrt(k/m)*t);

Xp := t*sin((k/m)^(1/2)*t)

Taking k = m = 1, this becomes

> xt := eval(Xp, {k=1,m=1});

xt := t*sin(t)

whose graph is then seen in Figure 28.7, along with the lines x = + t , the envelopes on the oscillations generated by sin(t) .

> plot([xt, t,-t], t=0..25, color=[black,red,red], title="Figure 28.7");

[Plot]

The oscillations would become unbounded were it not for the constraints of physical reality.

[Back to ODE Powertool Table of Contents ]

Steady State Solution Mass Spring System

Source: https://www.maplesoft.com/applications/view.aspx?SID=4716&view=html

0 Response to "Steady State Solution Mass Spring System"

Post a Comment

Iklan Atas Artikel

Iklan Tengah Artikel 1

Iklan Tengah Artikel 2

Iklan Bawah Artikel