All Courses
All Courses
Courses by Software
Courses by Semester
Courses by Domain
Tool-focused Courses
Machine learning
POPULAR COURSES
Success Stories
AIM The aim of this project is to simulate one dimensional super-sonic flow using Macormack method OBJECTIVES The objectives of the project are to write a program to solve the conservative and the non-conservative form of equations perform a comparison study between the normalised mass flow rate of both the forms of equations…
ANURAG M BHARADWAJ
updated on 06 Jun 2020
AIM
The aim of this project is to simulate one dimensional super-sonic flow using Macormack method
OBJECTIVES
The objectives of the project are to
ONE DIMENSIONAL SUPERSONIC FLOW OVER A CONVERGENT-DIVERGENT NOZZLE
A nozzle is a device which is used to control the characteristics of fluid flow as it exits a closed chamber. Now in the above figure we can see that we are seeing a convergent-divergent nozzle in which we have assumed that the flow parameters are only changing in the X direction only. Such a condition where the parameters change only in one direction is known as "Quasi One Dimensional Flow. The flow at the inlet comes from a reservoir with large area of cross-section and we can also see that the flow is in subsonic conditions at the convergent part, as we move towards divergent section the flow turns out to be in supersonic state.
NON CONSERVATIVE FORM OF EQUATIONS (MACORMACK METHOD)
The Non- conservative form of the governing equations indicates that the control volume is moving. So lets define the equations and we are to take a note that all the variables defined are in the non-dimensional form
Continuity equation:- ∂ρ′∂t′=-ρ′∂V′∂x′-ρ′V′∂(lnA′)∂x′-V′∂ρ′∂x′
Momentum Equation:- ∂V′∂t′=-V∂V′∂x′-1γ(∂T′∂x′+T′ρ′∂ρ′∂x′)
Energy Equation:- ∂T′∂t′=-V∂T′∂x′-(γ-1)T′[∂V′∂x′+V′∂(lnA′)∂x′]
To solve the above equations we have to apply Macormack method to form the difference equations. Macormack method is a numerical technique which uses explicit scheme of Finite Difference method to solve the equations. So, the first step would be to apply the predictor step in Macormack technique. The MacCormack method is an explicit finite difference method that is 2nd order accurate in both time and space. The predictor step we use forward differencing scheme for the first order time derivative terms. We have to calculate the the flow variables from the previous time step. In the corrector step we use bacward difference scheme for the time derivative terms and then compute the corrected values of the flow field. Finally we find the average values of both the predictor and corrector step for steady state values.
Predictor step
(∂ρ∂t)t=-ρiVti+1-Vti△x-ρtiVtilnAi+1-lnAi△x-Vtiρti+1-ρti△x
(∂V∂t)ti=-VtiVti+1-Vt△x-1γ(Tti+1-Tti△x+Ttiρtiρti+1-ρti△x)
(∂T∂t)ti=-VtiTti+1-Tti△x-(γ-1)Tti(Vti+1-VtI△x+VtilnAi+1-lnAi△x)
Now, we obtain predicted values of ρ,V,T as follows
ˉρt+△ti=ρti+(∂ρ∂t)ti△t
ˉVt+△ti=Vti+(∂V∂t)ti△t
ˉTt+△ti=Tti+(∂T∂t)ti△t
Corrector Step
(∂ρ∂t)t+△ti=-ρiVt+△ti+1-Vt+△ti△x-ρt+△tiVt+△tilnAi+1-lnAi△x-Vt+△tiρt+△ti+1-ρt+△ti△x
(∂V∂t)t+△ti=-Vt+△tiVt+△ti+1-Vt+△t△x-1γ(Tt+△ti+1-Tt+△ti△x+Tt+△tiρt+△tiρt+△ti+1-ρt+△ti△x)
(∂T∂t)t+△ti=-Vt+△tiTt+△ti+1-Tt+△ti△x-(γ-1)Tt+△ti(Vt+△ti+1-Vt+△ti△x+Vt+△tilnAi+1-lnAi△x)
After the predictor and corrector step we need to compute the average of the predictor and corrector derivatives
(∂ρ∂t)av=0.5[(∂ρ∂t)ti+(∂ρ∂t)t+△ti]
(∂V∂t)av=0.5[(∂V∂t)ti+(∂V∂t)t+△ti]
(∂T∂t)av=0.5[(∂T∂t)ti+(∂T∂t)t+△ti]
MATLAB CODE
Main Program
clear all;
close all;
clc;
n=31;
x=linspace(0,3,n);
m=0.579*ones(n);
tic;
% solving equations in the non-conservation form
[rho_nc,T_nc,p_nc,M_nc,m_nc,n_nc] = non_conservative_form;
time_nc=toc;
tic;
% solving equations in the consevtion form
[rho_c,T_c,p_c,M_c,m_c,n_c] = conservative_form;
time_c=toc;
% Comparing the normalized mass flow rate between conservation & non-conservation forms
figure(7)
plot(x,m_nc,x,m_c,x,m,'g');
xlabel('Length');
ylabel('Mass flow rate');
title(sprintf('Comparison of mass flow variations of conservative and non-cionservative form'));
legend('Non-conservation form','Conservation form','Analytical solution');
FUNCTION CODE FOR NON CONSERVATIVE FORM
function [rho,t,p,M,m,count]= non_conservative_form
% initialization
n=31;
nt=1400;
x = linspace(0,3,n);
dx = x(2)-x(1);
A = 1 + 2.2*(x-1.5).^2;
throat = (n+1)/2;
nt_x = linspace(1,nt,nt);
gamma = 1.4;
error = 1;
count = 1;
m_old = 0;
C=0.5;
tol=1e-4;
% Initial conditions
rho = 1 - 0.3146*x;
t = 1 - 0.2314*x;
v = (0.1 + 1.09.*x).*t.^(1/2);
m= 0.579*ones(n);
m_initial=rho.*A.*v;
% loop to calculate dt
for k = 1:n
dt_x(k) = C*dx/(t(k)^(1/2)+v(k));
end
dt = min(dt_x);
%outer time loop
for j = 1:nt
% updating old values
rho_old = rho;
v_old = v;
t_old = t;
% predictor step
for i = 2:n-1
drho_dx = (rho(i+1) - rho(i))/dx;
dv_dx = (v(i+1) - v(i))/dx;
dt_dx = (t(i+1) - t(i))/dx;
dlogA_dx = (log(A(i+1)) - log(A(i)))/dx;
drho_dtp(i) = -rho(i)*dv_dx - rho(i)*v(i)*dlogA_dx - v(i)*drho_dx; % continuity equation
dv_dtp(i) = -v(i)*dv_dx - (1/gamma)*(dt_dx+(t(i)/rho(i))*drho_dx); % momentum equation
dt_dtp(i) = -v(i)*dt_dx - (gamma-1)*t(i)*(dv_dx + v(i)*dlogA_dx);% energy equation
% predictor step update
rho(i) = rho_old(i) + drho_dtp(i)*dt;
v(i) = v_old(i) + dv_dtp(i)*dt;
t(i) = t_old(i) + dt_dtp(i)*dt;
end
% corrector step
for i = 2:n-1
drho_dx = (rho(i) - rho(i-1))/dx;
dv_dx = (v(i) - v(i-1))/dx;
dt_dx = (t(i) - t(i-1))/dx;
dlogA_dx = (log(A(i))-log(A(i-1)))/dx;
drho_dtc(i) = - rho(i)*dv_dx - rho(i)*v(i)*dlogA_dx - v(i)*drho_dx; % continuity equation
dv_dtc(i) = - v(i)*dv_dx - (1/gamma)*(dt_dx + (t(i)/rho(i))*drho_dx); % momentum equation
dt_dtc(i) = - v(i)*dt_dx - (gamma-1)*t(i)*(dv_dx + v(i)*dlogA_dx); % energy equation
end
% average value of time derivatives
drho_dt = 0.5*(drho_dtp + drho_dtc);
dv_dt = 0.5*(dv_dtp + dv_dtc);
dt_dt = 0.5*(dt_dtp + dt_dtc);
% corrector step update
for i = 2:n-1
rho(i) = rho_old(i) + drho_dt(i)*dt;
v(i) = v_old(i) + dv_dt(i)*dt;
t(i) = t_old(i) + dt_dt(i)*dt;
end
% Inlet boundary condition
v(1) = 2*v(2) - v(3);
% Outlet boundary conditions
v(n) = 2*v(n-1) - v(n-2);
rho(n) = 2*rho(n-1) - rho(n-2);
t(n) = 2*t(n-1) - t(n-2);
% Calculating pressure, mass flow rate and Mach number
p = rho.*t;
M = v./t.^0.5;
m = rho.*v.*A;
m_t(j,:) = rho.*v.*A;
% Capturing flow field variables at the throat
rho_throat(j) = rho(throat);
T_throat(j) = t(throat);
p_throat(j) = p(throat);
M_throat(j) = M(throat);
% convergence
error = max(abs(m-m_old));
if error>tol
count = count + 1;
m_old = m;
end
end
% plotting the solutions
figure(1);
title(sprintf('Flow-field variables across nozzle in Non-conservation form n No. of time steps = %g',nt));
subplot(4,1,1);
plot(x,M,'b','linewidth',2);
xlabel('Length');
ylabel('Mach no');
title(sprintf('Mach number'));
subplot(4,1,2);
plot(x,rho,'g','linewidth',2);
xlabel('Length');
ylabel('Density');
title(sprintf('Non-dimensional Density'));
subplot(4,1,3);
plot(x,t,'m','linewidth',2);
xlabel('Length');
ylabel('Temperature');
title(sprintf('Non-dimensional Temperature'));
subplot(4,1,4);
plot(x,p,'r','linewidth',2);
xlabel('Length');
ylabel('Pressure');
title(sprintf('Non-dimensional Pressure'));
% Variarion of flow field variables at nozzle throat
figure(2)
plot(nt_x,rho_throat,'b','linewidth',2);
hold on
plot(nt_x,T_throat,'r','linewidth',2);
plot(nt_x,p_throat,'g','linewidth',2);
plot(nt_x,M_throat,'y','linewidth',2);
title(sprintf(['Timewise variation of Flow-field variables at nozzle throat Non-conservation form']));
xlabel('Number of time steps');
legend('Density','Temperature','Pressure','Mach number');
% Mass flow variation across nozzle at different time steps
figure(3)
plot(x,m_initial,x,m_t(50,:),x,m_t(100,:),x,m_t(150,:),x,m_t(200,:),x,m_t(700,:),x,m,'r');
xlabel('Non-dimensional distance through nozzle');
ylabel('Non-dimensional mass flow');
legend('0Deltat','50Deltat','100Deltat','150Deltat','200Deltat','700Deltat','Analytical solution');
title(sprintf('Non-dimensional mass flow rate across the nozzle Non-conservation form'));
end
When we go through the function code we can see that the first we define a user function by using function command. The subsequent lines of the code we define some of the parameters such as
So when we enter the time loop we use the for command and define the time loop. Next in the predictor step we define the spacial loop for the inner nodes and write the continuity, momentum and energy equations by defining some standard derivative terms like dvdx, drhodx,dtdx,dlogadx. In the same fashion the corrector step is also defined and then we write down the equations to compute the average derivatives. Next we define the boundary conditions at the inlet and outlet of the nozzle and compute the flow parameters at the throat section. We then define the convergence criteria for the mass flow rate and then plot the following graphs
RESULTS AND DISCUSSIONS
Qualitative aspects of flow field parameters
The above plot shows how the flow parameters inside the convergent divergent nozzle is taking place and we can infer that the flow parameters changes inside the nozzle configuration. The variation of pressure, density, and temperature shows there is a decrease in the plot which shows us that the nozzle pressure, density and temperature is dropping throughout the length of the nozzle. The Mach number increases because the flow is sub sonic at the inlet boundary condition. As we progress along the length of convergent- divergent nozzle the flow has become a supersonic flow towards the outlet boundary conditions. The normalised pressure ratio across the nozzle exerts a force on the gas to accelerate it through the nozzle. The variation of the normalised flow parameters can be expressed as a function of the Mach number which are defined by
Pressure Ratioppo=(1+γ-12M2)-γγ-1
Density Ratio ρρo=(1+γ-12M2)-1γ-1
Temperature Ratio TTo=(1+γ-12M2)-1
Timewise variations of flow field parameters
Now we have to have a interest in the timewise variations of the flow field parameters, so to give a basic idea which shows us the variation of density, temperature pressure and mach number at the nozzle throat plotted with the number of time steps. The initial condition for the flow field parameters start from zero and the time step ends at 1400. With increasing time as we progress from left to right we can see that the time marching plots where the time is increasing from 0 and ends at 1400. We can see in the plots that the changes are taking place in early stages of the time and as we move onto to the right hand side of the plots we are able to see that the solution has reached the steady state value of the flow field. The flow field variables are driven by a stronger potential which changes rapidly. At the later stage as the steady state is approached, the changes become much more smaller as the time progresses. we can also see that there is no artificial viscosity has been added for the simulation.
Mass flow rate plot versus length of the nozzle
The insight for another concept of fluid mechanics for timewise variation of the flow is provided by the mass flow variation as shown in the above plot. There are 7 different curves which suggests the behaviour of the mass flow rate which is coming into the nozzle. The 7 curves shows us different time step in the time-marching solution. The first curve which is labelled as "time step=0" it shows the initial conditions at which the flow occurs. Next we have the time step=50 which indicates after 50 time steps the mass flow variation has changed by a certain amount. After 100 time steps the mass flow distribution has changed radically. As and when we have increased the number of time steps from 150, 200, 500 we are able to see that the behaviour of the mass flow begins to settle down and when the time step is reached to 700 we can see that the mass flow variation is a straight horizontal line in the graph. This indicates that it has reached a steady state value throughout the nozzle.
CONSERVATIVE FORM OF EQUATIONS IN (MACORMACK METHOD)
The Non- conservative form of the governing equations indicates that the control volume is moving. So lets define the equations and we are to take a note that all the variables defined are in the non-dimensional form
Continuity Equation ∂(ρ′A′)∂t′+∂(ρ′A′V′)∂x=0
Momentum Equation ∂(ρ′A′V′)∂t′+∂[ρ′A′V′+(1γ)p′A′]∂x′=1γp′∂A′∂x′
Energy Equation ∂[ρ′(e′γ-1+γ2V′2)A′]∂t′+∂[ρ′(e′γ-1+γ2V′2)A′V′+p′A′V′]∂x′=0
the above equations are conservation form of continuity, momentum and energy equations for quasi 1D flow. Now let us define the elements of solution vector U, the flux Vector F and source term J as follows
U1=ρ′A′
U2=ρ′A′V′
U3=ρ′(e′γ-1+γ2V2)A′
F1=ρ′A′V′
F2=ρ′A′V′2+1γp′A′
F3=ρ′(e′γ-1+γ2V′2)V′A′+ρ′A′V′
J2=1γp∂A′∂x′
With these updates we can write the equations of the conservation form as
∂U1∂t′=-∂F1∂x′
∂U2∂t′=-∂F2∂x′+J2
∂U3∂t′=-∂F3∂x′
The above equations represent the conservative form of quasi 1D flow and these are the equations we wish to solve. Now, we may note that the numerical solution will give us values for U1, U2, and U3 which is known as solution vector. In order to obtain the primitive variables we must decode the solution vector as follows.
ρ′=U1A′
V′=U2U1
T′=e′=(γ-1)(U3U1-γ2V′2)
p′=ρ′T′
Now we have to compute the pure form of the flux terms in order to express primitive variables solution from the solution vectors and the flux terms
F1=U2
F2=U22U1+γ-1γ(U3-γU222U1)
F3=γU2U3U1-γ(γ-1)2U32U21
J2=γ-1γ(U3-γU222U1)∂(lnA′)∂x′
Predictor Step
(∂U1∂t′)ti=-Ft1(i+1)-Ft1(i)△x′
(∂U2∂t′)ti=Ft2(i+1)-Ft2(i)△x′+J2
(∂U3∂t′)ti=-Ft3(i+1)-Ft3(i)△x′
Corrector Step
Now the solution vector for the must be updated from the above equations for the next time step
ˉUt+Δt1(i)=(∂U1∂t′)ti.△t
ˉUt+Δt2(i)=(∂U2∂t′)ti.△t
(¯∂U3∂t′)t+△ti=-ˉFt+△t3(i)-ˉFt+△t3(i-1)△x′
After the predictor and corrector step we calculate the average of the derivatives calculated from the predictor and corrector step.
(∂U1∂t′)av=12[(∂U1∂t′)ti+(¯∂U1∂t′)t+△ti]
(∂U2∂t′)av=12[(∂U2∂t′)ti+(¯∂U2∂t′)t+△ti)
(∂U3∂t′)av=12[(∂U3∂t′)ti+(¯∂U3∂t′)t+△ti]
FUNCTION CODE FOR CONSERVATIVE FORM
function [rho,t,p,M,m,count]= conservative_form
% Initialization
n=31;
nt=1400;
C=0.5;
tol=1e-4;
x = linspace(0,3,n);
dx = x(2)-x(1);
A = 1 + 2.2*(x-1.5).^2;
throat = (n+1)/2;
nt_x = linspace(1,nt,nt);
gamma = 1.4;
error = 1;
count = 1;
m_old = 0;
m = 0.579*ones(n);
% Initial conditions
u2_i = 0.59;
for i= 1:n
if ((x(i)>=0) && (x(i)<=0.5))
rho(i) = 1;
t(i) = 1;
elseif ((x(i)<1.5) && (x(i)>0.5))
rho(i) = 1 - 0.366*(x(i)-0.5);
t(i) = 1 - 0.167*(x(i)-0.5);
elseif ((x(i)>=1.5) && (x(i)<=3.5))
rho(i) = 0.634 - 0.3879*(x(i) - 1.5);
t(i) = 0.833 - 0.3507*(x(i) - 1.5);
end
v(i) = u2_i/(rho(i)*A(i));
u1(i) = rho(i)*A(i);
u2(i) = rho(i)*A(i)*v(i);
u3(i) = rho(i)*A(i)*(t(i)/(gamma-1) + (gamma/2)*v(i)^2);
end
% copy of initial values
u1_initial = u1;
u2_initial = u2;
u3_initial = u3;
% loop to calculate dt
for k = 1:n
dt_x(k) = C*dx/(t(k)^(1/2)+v(k));
end
dt = min(dt_x);
% time loop
for j = 1:nt
u1_old = u1;
u2_old = u2;
u3_old = u3;
% predictor step
for i = 2:n-1
% computing flux and source terms
f1_i = u2(i);
f1_ip1 = u2(i+1);
f2_i = u2(i)^2/u1(i) + ((gamma-1)/gamma)*(u3(i) - (gamma/2)*u2(i)^2/u1(i));
f2_ip1 = u2(i+1)^2/u1(i+1) + ((gamma-1)/gamma)*(u3(i+1) - (gamma/2)*u2(i+1)^2/u1(i+1));
j2 = (1/gamma)*rho(i)*t(i)*((A(i+1) - A(i))/dx);
f3_i = gamma*u2(i)*u3(i)/u1(i) - (gamma*(gamma-1)/2)*u2(i)^3/u1(i)^2;
f3_ip1 = gamma*u2(i+1)*u3(i+1)/u1(i+1) - (gamma*(gamma-1)/2)*u2(i+1)^3/u1(i+1)^2;
du1_dtp(i) = -(f1_ip1 - f1_i)/dx; % continuity eq
du2_dtp(i) = j2 - (f2_ip1 - f2_i)/dx; % momentum eq
du3_dtp(i) = -(f3_ip1 - f3_i)/dx; % energy eq
% updating the predicted values
u1(i) = u1(i) + du1_dtp(i)*dt;
u2(i) = u2(i) + du2_dtp(i)*dt;
u3(i) = u3(i) +du3_dtp(i)*dt;
end
% Updating primitive variables after predictor step
rho = u1./A;
v = u2./u1;
t = (gamma-1)*((u3./u1) - (gamma/2)*v.^2);
% corrector step
for i = 2:n-1
f1_i = u2(i);
f1_ic1 = u2(i-1);
f2_i = u2(i)^2/u1(i) + ((gamma-1)/gamma)*(u3(i) - (gamma/2)*u2(i)^2/u1(i));
f2_ic1 = u2(i-1)^2/u1(i-1) + ((gamma-1)/gamma)*(u3(i-1) - (gamma/2)*u2(i-1)^2/u1(i-1));
j2 = (1/gamma)*rho(i)*t(i)*((A(i) - A(i-1))/dx);
f3_i = gamma*u2(i)*u3(i)/u1(i) - (gamma*(gamma-1)/2)*u2(i)^3/u1(i)^2;
f3_ic1 = gamma*u2(i-1)*u3(i-1)/u1(i-1) - (gamma*(gamma-1)/2)*u2(i-1)^3/u1(i-1)^2;
du1_dtc(i) = -(f1_i - f1_ic1)/dx;
du2_dtc(i) = j2 - (f2_i - f2_ic1)/dx;
du3_dtc(i) = -(f3_i - f3_ic1)/dx;
end
%average value
du1_dt = 0.5*(du1_dtp + du1_dtc);
du2_dt = 0.5*(du2_dtp + du2_dtc);
du3_dt = 0.5*(du3_dtp + du3_dtc);
for i = 2:n-1
% computing corrected values
u1(i) = u1_old(i) + du1_dt(i)*dt;
u2(i) = u2_old(i) + du2_dt(i)*dt;
u3(i) = u3_old(i) + du3_dt(i)*dt;
end
% Inlet BC
u1(1) = rho(1)*A(1);
u2(1) = 2*u2(2) - u2(3);
v(1) = u2(1)/(rho(1)*A(1));
u3(1) = u1(1)*(t(1)/(gamma-1) + (gamma/2)*v(1)^2);
% Outlet BC
u1(n) = 2*u1(n-1) - u1(n-2);
u2(n) = 2*u2(n-1) - u2(n-2);
u3(n) = 2*u3(n-1) - u3(n-2);
% computing the values of the primitive variables
for i= 1:n
rho(i) = u1(i)/A(i);
v(i) = u2(i)/u1(i);
t(i) = (gamma-1)*(u3(i)/u1(i) - gamma/2*v(i)^2);
end
% Pressure, mass flow rate and Mach number
p = rho.*t;
M = v./t.^0.5;
m = rho.*v.*A;
m_t(j,:) = rho.*v.*A;
% Flow field variables at the throat
rho_throat(j) = rho(throat);
T_throat(j) = t(throat);
p_throat(j) = p(throat);
M_throat(j) = M(throat);
% Convergence
error = max(abs(m-m_old));
if error>tol
count = count + 1;
m_old = m;
end
end
% plotting steady state solutions of flow-field variables
figure(4);
title(sprintf('Flow-field variables across nozzle Conservation form n No. of time steps = %g',nt));
subplot(4,1,1);
plot(x,M,'b','linewidth',2);
xlabel('Length');
ylabel('Mach number');
title(sprintf('Mach number'));
subplot(4,1,2);
plot(x,rho,'g','linewidth',2);
xlabel('Length');
ylabel('Density');
title(sprintf('Non-dimensional Density'));
subplot(4,1,3);
plot(x,t,'m','linewidth',2);
xlabel('Length');
ylabel('Temperature');
title(sprintf('Non-dimensional Temperature'));
subplot(4,1,4);
plot(x,p,'r','linewidth',2);
xlabel('Length');
ylabel('Pressure');
title(sprintf('Non-dimensional Pressure'));
%Variarion of flow field variables at nozzle throat
figure(5)
plot(nt_x,rho_throat,'b','linewidth',2);
hold on
plot(nt_x,T_throat,'r','linewidth',2);
plot(nt_x,p_throat,'g','linewidth',2);
plot(nt_x,M_throat,'y','linewidth',2);
title(sprintf('Timewise variation of Flow-field variables at nozzle throat conservative form'));
xlabel('Number of time steps');
legend('Density','Temperature','Pressure','Mach number');
% Mass flow variation across nozzle at different time steps
figure(6)
plot(x,u2_initial,'--',x,m_t(50,:),x,m_t(100,:),x,m_t(150,:),x,m_t(200,:),x,m_t(700,:),x,m,':');
xlabel('Non-dimensional distance through nozzle');
ylabel('Non-dimensional mass flow');
legend('0Deltat','50Deltat','100Deltat','150Deltat','200Deltat','700Deltat','Analytical solution');
title(sprintf('Mass flow rate across the nozzle Conservation form'));
end
When we go through the function code we can see that the first we define a user function by using function command. The subsequent lines of the code we define some of the parameters such as
So when we enter the time loop we use the for command and define the time loop. Next in the predictor step we define the spacial loop for the inner nodes and write the continuity, momentum and energy equations by defining some standard derivative terms like solution vector U, flux vector F and the source term J. In the same fashion the corrector step is also defined and then we write down the equations to compute the average derivatives. Next we define the boundary conditions at the inlet and outlet of the nozzle and compute the flow parameters at the throat section. We then define the convergence criteria for the mass flow rate and then plot the following graphs
RESULTS AND DISCUSSIONS
Qualitative aspects of flow field parameters
The above plot shows how the flow parameters inside the convergent divergent nozzle is taking place and we can infer that the flow parameters changes inside the nozzle configuration. The variation of pressure, density, and temperature shows there is a decreases in the plot which shows us that the nozzle pressure, density and temperature is dropping throughout the length of the nozzle. The Mach number increases because the flow is sub sonic at the inlet boundary condition. As we progress along the length of convergent- divergent nozzle the flow has become a supersonic flow towards the outlet boundary conditions. The normalised pressure ratio across the nozzle exerts a force on the gas to accelerate it through the nozzle. The variation of the normalised flow parameters can be expressed as a function of the Mach number which are defined by
Pressure Ratio`ppo=(1+γ-12M2)-γγ-1`
Density Ratio ρρo=(1+γ-12M2)-1γ-1
Temperature Ratio TTo=(1+γ-12M2)-1
Timewise variations of flow field parameters
Now we have to have a interest in the timewise variations of the flow field parameters, so to give a basic idea which shows us the variation of density, temperature pressure and mach number at the nozzle throat plotted with the number of time steps. The initial condition for the flow field parameters start from zero and the time step ends at 1400. With increasing time as we progress from left to right we can see that the time marching plots where the time is increasing from 0 and ends at 1400. We can see in the plots that the changes are taking place in early stages of the time and as we move onto to the right hand side of the plots we are able to see that the solution has reached the steady state value of the flow field. The flow field variables are driven by a stronger potential which changes rapidly. At the later stage as the steady state is approached, the changes become much more smaller as the time progresses. we can also see that there is no artificial viscosity has been added for the simulation.
Mass flow rate plot versus length of the nozzle
The insight for another concept of fluid mechanics for timewise variation of the flow is provided by the mass flow variation as shown in the above plot. There are 7 different curves which suggests the behaviour of the mass flow rate which is coming into the nozzle. The 7 curves shows us different time step in the time-marching solution. The first curve which is labelled as "time step=0" it shows the initial conditions at which the flow occurs. Next we have the time step=50 which indicates after 50 time steps the mass flow variation has changed by a certain amount. After 100 time steps the mass flow distribution has some kind of a humped distribution . As and when we have increased the number of time steps from 150, 200, 500 we are able to see that the behaviour of the mass flow begins to settle down and when the time step is reached to 700 we can see that the mass flow variation is a straight horizontal line in the graph. This indicates that it has reached a steady state value throughout the nozzle.
COMPARITIVE STUDY BETWEEN THE CONSERVATIVE AND NON CONSERVATIVE FORM FOR NON DIMENSIONAL MASS FLOW RATE
Now to perform the comparison study lets go back to those plots which shows us the mass flow rates of both the forms of governing equations. At time step zero both the plots shows us that the plots for mass flow distribution starts of at the same point as it has but as and when we increase the number of time steps the distributions converge to steady state value. In the non conservative form the distribution of mass flow is quite scattered and in that of conservative form the scattering of the plot is lot organised. The conservation does a better plot of preserving the mass throughout the flow field because mass itself is a dependent variable in the equation. Dependent variables on the non conservative form of equations are primitive variables and the mass flow is obtained only as a secondary result. The mass flow rate plots are less fluctuating in Conservative form and are closer to one another as compared to that of Non-conservative form.
CONCLUSION
We can draw some of the conclusions from the simulation to be as follows
Leave a comment
Thanks for choosing to leave a comment. Please keep in mind that all the comments are moderated as per our comment policy, and your email will not be published for privacy reasons. Please leave a personal & meaningful conversation.
Other comments...
Hybrid Vehicle Case Study
AIM The aim of this challenge is to simulate the hybrid vehicle model OBJECTIVES Simulation run of hybrid vehicle Increase the Vehicle mass by 50%. Increase the Drag coefficient by 5%. Comparison of the results HYBRID ELECTRIC VEHICLES A hybrid vehicle is one that uses two or more distinct types of power, such…
10 Sep 2021 02:28 PM IST
Week 11: FSAE Car Project
AIM The aim is to simulate the Aerodynamics Behaviour of FSAE Car OBJECTIVE ABCD Racing company is looking to perform Aero Simulations for their FSAE vehicle and they have hired you to do the job. The suspension team wants a detailed report on the total downforce on individual components. They have two races in this…
29 Aug 2021 08:15 AM IST
Week 10: Modeling and Simulation of flow around an Ahmed Body
AIM The aim of this validation project is to simulate and validate the flow over an Ahmed Body OBJECTIVES Creating the CAD file for the Ahmed body Making of virtual wind tunnel for the car Simulating the case and validation of results with experimental values AHMED BODY The Ahmed body was described originally by…
22 Aug 2021 12:40 PM IST
Flow over an NACA 2412 Airfoil
AIM The aim of this project is to simulate the flow over a NACA 2412 Airfoil OBJECTIVES Plot Coefficient of drag vs angle of attack Plot Lift Coefficient vs angle of attack Comparison of turbulence model results AIRFOIL An airfoil (American English) or aerofoil (British English) is the cross-sectional shape…
04 Aug 2021 04:01 PM IST
Related Courses
Skill-Lync offers industry relevant advanced engineering courses for engineering students by partnering with industry experts.
© 2025 Skill-Lync Inc. All Rights Reserved.