It is known from elementary physics that, in the absence of air friction, a ball thrown up from the ground into earth's atmosphere with initial speed v0 would attain a maximum altitude of v20/(2g). In this case the return time is 2v0/g, independent of the ball's mass. Here g is the acceleration due to gravity. If the ball is thrown up from altitude y0 (which we later assume to be zero), then the time T0 spent traveling is given by
The presence of air influences the ball's motion: it experiences two forces acting on it---the force of gravity and the air resistance force. Let's define the symbol T as follows:
Without air resistance, the object travels farther up than with air resistance. On the way down, without air resistance the object travels a larger distance, but it also gathers more speed. A natural question is, which travel time (with air resistance vs. no air resistance) is larger? Also, it is of interest to find the maximum altitude ymax of the ball, the time Tmax to reach maximum altitude, and the time Tdown to return back from ymax. Therefore, Tmax+Tdown=Ttotal (the total time the ball spent in the air). The landing velocity is denoted by vℓ.
We would like to think that there is a nice formula for the air resistance in terms of speed and other variables. Such a formula would help in making calculations and predicting various quantities. A starting point for obtaining such a formula is our everyday experience. Based on our experience, a reasonable assumption to make\footnote{Our intuition based on everyday experience is limited to a small range of conditions. This may lead to erroneous assumptions.
It has been observed that, under suitable conditions, the magnitude of the air resistance is proportional to a power of the speed s=|v|:
The air resistance force depends on the velocity (v) of the object at time t, so let us denote this force with the symbol F(v). Note that the air resistance, force F(v), always acts in the direction opposite to the motion. Therefore, F(v) acts in the down (negative) direction when the ball is moving up, and it acts in the up (positive) direction when the ball is moving down. If we measure the displacement y = y(t) vertically upwards from the ground, then v=dy/dt=˙y is the velocity of the object. Newton's law of motion for the ball on the way up gives the differential equation
To find an equation for vℓ, the landing velocity, we rewrite the equation dvdt=−g−km|v|p as dt=−dv/(g+F(v)/m) and integrate both sides from t=0 and v = v0 to t=Tmax and v=0. Here Tmax is the time to reach the maximum altitude ymax, which is also the time to have velocity v=0. We obtain,
To find an equation for vℓ, we rewrite the equation dvdt=−g−km|v|p as vdt=−vdv/(g+F(v)/m) and integrate both sides from t=0 and v = v0 to t=Tmax and v=0. Here Tmax is the time to reach the maximum altitude ymax, which is also the time to have velocity v=0. Using the fact that the integral of the velocity is the displacement, we obtain,
We would like to determine the ratio:
For a tennis ball thrown upward with the initial velocity v0 =10, it is possible to find x0 that γ > 1 when p=0.9. In general, it is unknown for what values of p< 1, x0, and v0 we can achieve γ > 1.
xxxxxxxxxx
clearvars;
% fixed constants
n = 1/2; % drag-law power
V_0 = 10.456; % launch speed relative to terminal speed
DT = 1e-5; % time step
% initial values
i = 1; j = 1; % array indices
Y(1) = 0; % value of Y at T = 0 in fluid
Y_vac(1) = 0; % value of Y at T = 0 in vacuum
V(1) = V_0; % value of V at T = 0 in fluid
T(1) = 0; % starting value of T in fluid
T_vac(1) = 0; % starting value of T in vacuum
% numerical solution in fluid
while Y(i) >= 0
if V(i) > 0
A(i) = -1-V(i)^n; % A if going upward
i_up = i; % ends up being the index at the peak
else
A(i) = -1+(-V(i))^n; % A if going downward
end
i = i + 1; % step forward
T(i) = (i-1)*DT; % new value of T
V(i) = V(i-1)+A(i-1)*DT; % new value of V
Y(i) = Y(i-1)+V(i)*DT; % new value of Y
end
% analytic solution in vacuum
while Y_vac(j) >= 0
j = j + 1; % step forward
T_vac(j) = (j-1)*DT; % new value of T
Y_vac(j) = V_0*T_vac(j)-0.5*T_vac(j)^2;
% new value of Y
end
% times and peak heights
T_up = T(i_up); % time to reach peak
H_fluid = Y(i_up); % peak height in fluid
T_down = T(i-1)-T_up; % time to fall back to ground
T_half = V_0; % time up or down in vacuum
H_vac = 0.5*T_half^2; % peak height in vacuum
disp (T_up/T_half)% we must fix the display for the code
disp(+ T_down/T_half)
disp((T_up+T_down)/(2*T_half));
disp( H_fluid/H_vac)
plot(T,Y) % plot the line of the speed not in a vaccuum
hold on
plot(T_vac,Y_vac)% while at the same time plotting the line in a vacuum
title('Speed of Falling Ball with air resistance and in a vacuum')
xlabel('time')
ylabel('speed')
legend('ball in a fluid','ball in a vaccuum', 'Location','northeast')
Suppose that initially at t=0, the ball of mass m is dropped from the altitude y=h>1 without initial velocity. At the same time, it is assumed that the floor starts moving according to the formula z=sinωt. When elastic ball hits a hard flat surface, it bounces back with the same velocity. It is assumed that the collision is totally elastic, so the ball loses no kinetic energy in the collision, and its speed after collision is the same as before the collision. At this point, ignore the time needed for the ball to be deformed during collision before fully rebounded and has lifted off from the surface instantly. Hence the ball can be treated as a rigid body with negligible deformation during impact.
After collision, the ball climbs up until its velocity becomes zero, and then the ball falls vertically downward under the influence of gravity, hits the the moving floor, and bounces back.
Newton's law of motion for the ball on the way down is
g≈9.806 m/sec2 | the acceleration due to gravity near sea level at 45 deg. latitude; |
---|---|
m = 0.08 | mass of the object, in kg because a tennis ball is about 80 grams; |
k = 0.02 | drag coefficient, positive; |
p = 2 | power of the speed term in the resistance force; |
ω = π | frequency of the oscillating floor; |
y0=h>1 | initial altitude, positive, in meters. |
A ball that is dropped from height h> 1 can be described by its velocity v(t) and position y(t):
On the second stage, the ball bounced up with the initial velocity V1≈3.93453 and from the position Y1≈0.996038. Therefore, we need to solve two intial value problems:
Finally, we use Euler's method to find approximate solution to the sequence of initial value problems.
function jumping
g = 9.807; % gravitational acceleration, m/s^2
A = 1; w = .5; % amplitude, m, and frequency of surface oscillation, Hz or 1/s
m = .08; k = .02; % mass of a ball, kg, and coefficient of air resistance, kg/m
H = 2.5; % initial height of a ball, m
v0 = 0; % initial speed of a ball, m/s
J = 5; % maximal number of bounces
T = 5; % maximal duration of a process, s
dt = 1e-5; % time integration step, s
epsh = .0001; % a threshold height of a ball over surface, m
epsv = .0005; % a threshold for speed of a ball, m/s
n = round(T/dt); % maximal number of steps
s = @(t) A*sin(2*pi*w*t); % surface oscillation function
vs = @(t) A*2*pi*w*cos(2*pi*w*t); % surface velocity function
i = 1; % steps counter
j = -1; % bounces counter
h(n) = 0; v(n) = 0; % memory allocation
h(1) = H; v(1) = v0; % initial values
while j <= J
while i < n % down
v(i + 1) = (g - k*v(i)^2/m)*dt + v(i);
h(i + 1) = -v(i)*dt + h(i);
S = s(dt*(i + 1));
if abs(S - h(i + 1)) < epsh % a ball meets a surface
h(i + 1) = S + epsh;
v(i + 1) = v(i) + vs(i*dt);
i = i + 1;
j = j + 1;
break
end
i = i + 1;
end
if j >= J || i >= n
break
end
while i < n % up
v(i + 1) = -(g + k*v(i)^2/m)*dt + v(i);
h(i + 1) = v(i)*dt + h(i);
S = s(dt*(i + 1));
if abs(v(i + 1)) < epsv % speed of a ball near zero
break
end
if (abs(S - h(i + 1))) < epsh % a ball meets a surface
h(i + 1) = S + epsh;
v(i + 1) = v(i) + vs(i*dt);
j = j + 1;
if j >= J || i >= n
break
end
end
i = i + 1;
end
end
subplot(2,1,1)
t = dt*(0:i - 1);
plot(t,h(1:i),t,s(dt*(1:i)),'linewidth',2);
title('Height, m'); xlabel('Time, s')
legend('Ball','Surface')
grid; axis tight;
subplot(2,1,2)
plot(t,v(1:i),'.',t,abs(vs(t)),'linewidth',2);
title('Speed, m/s'); xlabel('Time, s')
grid; axis tight
clear;
g = 9.807; % gravitational acceleration, m/s^2
A = 1; w = .5; % amplitude, m, and frequency of surface oscillation, Hz or 1/s
m = .08; k = .02; % mass of a ball, kg, and coefficient of air resistance, kg/m
H = 2.5; % initial height of a ball, m
v0 = 0; % initial speed of a ball, m/s
J = 5; % maximal number of bounces
T = 5; % maximal duration of a process, s
dt = 1e-5; % time integration step, s
epsh = .0001; % a threshold height of a ball over surface, m
epsv = .0005; % a threshold for speed of a ball, m/s
n = round(T/dt); % maximal number of steps
s = @(t) A*sin(2*pi*w*t); % surface oscillation function
vs = @(t) A*2*pi*w*cos(2*pi*w*t); % surface velocity function
i = 1; % steps counter
j = 0; % bounces counter
h(n) = 0; v(n) = 0;
h(1) = H; v(1) = v0; % initial values
bounceindex(J,2)=0; % memory allocation
D=400; % To speed up or slow down the animation, you need
% to increase or decrease D. With a suitable choice
% of D, you can observe the process in real time
while j <= J
while i < n % down
v(i + 1) = (g - k*v(i)^2/m)*dt + v(i);
h(i + 1) = -v(i)*dt + h(i);
S = s(dt*(i + 1));
if abs(S - h(i + 1)) < epsh % a ball meets a surface
h(i + 1) = S + epsh;
v(i + 1) = v(i) + vs(i*dt);
i = i + 1;
j = j + 1;
bounceindex(j,1:2)=[i,j];
break
end
i = i + 1;
end
if j >= J || i >= n
h(i + 1) = S;
break
end
while i < n % up
v(i + 1) = -(g + k*v(i)^2/m)*dt + v(i);
h(i + 1) = v(i)*dt + h(i);
S = s(dt*(i + 1));
if abs(v(i + 1)) < epsv % speed of a ball near zero
break
end
if (abs(S - h(i + 1))) < epsh % a ball meets a surface
h(i + 1) = S + epsh;
v(i + 1) = v(i) + vs(i*dt);
j = j + 1;
bounceindex(j,1:2)=[i,j];
if j >= J || i >= n
h(i + 1) = S;
break
end
end
i = i + 1;
end
end
figure('menubar', 'none','Name','Bouncing Ball via Euler''s Method')
subplot(2,1,1)
t = dt*(0:i - 1);
plot(t,h(1:i),t,s(dt*(1:i)),'linewidth',2);
title('Height, m'); xlabel('Time, s')
legend('Ball','Surface')
grid; axis tight;
subplot(2,1,2)
plot(t,v(1:i),'.',t,abs(vs(t)),'linewidth',2);
title('Speed, m/s'); xlabel('Time, s')
grid; axis tight
Name = 'Animation of Bouncing Ball';
figure('menubar', 'none', 'Name', Name);
ball = rectangle('Position',[4 h(1) 2 2],'Curvature',[1,1],'FaceColor','r');
ground = rectangle('Position',[0 s(t(1))-10 10 10],'FaceColor','k');
elevation = text('Position',[8 h(1)+2]);
surface = text('Position',[8 h(1)+1.5]);
time = text('Position',[0 h(1)+2]);
height = text('Position',[8 h(1)+2.5]);
bounce = text('Position',[0 h(1)+1.5]);
k = 1;
axis off
tic
for i = [2:D:numel(t) - 1,numel(t) - 1]
set(ball,'Position',[4 h(i) 2 2]);
set(ground,'Position',[0 s(t(i)) - 10 10 10]);
set(height,'String',['Height, m: ' num2str(round(h(i - 1),3))]);
set(time,'String',['Time, s: ' num2str(round(t(i),2))]);
set(surface,'String',['Surface, m: ' num2str(round(s(t(i)),3))]);
set(elevation,'String',['Elevation, m: '...
num2str(round(h(i)-s(t(i)),2))]);
if i >= bounceindex(k,1)-1
set(bounce,'String',['Bounce: ' num2str(bounceindex(k,2))]);
k = k + 1;
end
hold off;
axis([0 10 -2 h(1)+3]);
drawnow
end
dur=num2str(round(toc,2));
set(gcf,'Name',[Name,'. Duration: ',dur,' s'])