1 · Web viewPressure Vessel Analysis - George Mseis % AAE 450 - Spring 2004 % Author: George Mseis...

43
Appendix H - Structures H Structures Nomenclature σ allow = allowable stress σ design = design stress t = thickness of outer skin c = length of the crack a = width of the crack b = length of specific segment of consideration K = fracture toughness Q = non-dimensional parameters g = non-dimensional parameters f φ = non-dimensional parameters f w = non-dimensional parameters M 1 = non-dimensional parameters M 2 = non-dimensional parameters M 3 = non-dimensional parameters M f = non-dimensional parameters φ = angle of crack orientation MS = margin of safety R cm = distance from endpoint to center of mass of the tether H.1 Pressure Vessel Analysis - George Mseis % AAE 450 - Spring 2004 % Author: George Mseis % Date Created: 1/17/04 % Date Modified: 2/2/04 %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% % Description % This code will merely find the stress inside a hollow cylinder that is % subjected to a axial load N a Torque T and an internal pressure p0. % % Variable % N: Axial load on cylinder % T = Torque on Cylinder AAE 450 Senior Spacecraft Design Spring 2004 343

Transcript of 1 · Web viewPressure Vessel Analysis - George Mseis % AAE 450 - Spring 2004 % Author: George Mseis...

1

Appendix H - Structures

H Structures

Nomenclature

allow=allowable stress

design=design stress

t=thickness of outer skin

c=length of the crack

a=width of the crack

b=length of specific segment of consideration

K=fracture toughness

Q=non-dimensional parameters

g=non-dimensional parameters

f=non-dimensional parameters

fw=non-dimensional parameters

M1=non-dimensional parameters

M2=non-dimensional parameters

M3=non-dimensional parameters

Mf=non-dimensional parameters

=angle of crack orientation

MS=margin of safety

Rcm= distance from endpoint to center of mass of the tether

H.1 Pressure Vessel Analysis - George Mseis

% AAE 450 - Spring 2004

% Author: George Mseis

% Date Created: 1/17/04

% Date Modified: 2/2/04

%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%

% Description

% This code will merely find the stress inside a hollow cylinder that is

% subjected to a axial load N a Torque T and an internal pressure p0.

%

% Variable

% N: Axial load on cylinder

% T = Torque on Cylinder

% p0: Internal pressure

% a = Outer radius of cylinder

% t = Thickness of cylinder

%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%

clear all

N = 0; % Normal load

T = 0; % Torque on the Cylinder

p0 = 101325.01; % Internal Pressure

for j = 1:4

a = j

for i = 1:10

t= i/1000;

t1(i) = i/1000;

sig_xx(i,j) = N/(2*pi*a*t);

tau_xy(i,j) = T/(2*pi*a^2*t);

sig_yy(i,j) = p0*a/t; % Hoop Stress

end

end

plot(t1,sig_yy(:,1)/1e6,'rx',t1,sig_yy(:,2)/1e6,'bx',t1,sig_yy(:,3)/1e6,'gx',t1,sig_yy(:,4)/1e6,'cx')

xlabel('Thickness of the Module (m)')

ylabel(' Hoop Stress on the Module (Pa)')

title('A Plot of Hoop Stress VS Thickness due to 1 atm internal pressure')

legend('Hoop Stress with a = 1','Hoop Stress with a = 2','Hoop Stress with a = 3','Hoop Stress with a = 4')

H.2 Buckling Analysis - George Mseis

We perform the analysis for the buckling on both a supported and unsupported cylinder. Analysis is essential because, we need show to show that the thin walled cylinder is not capable of withstanding the expected axial loads to justify the need of the stringers. Note that the axial load is a result of the g-loading on the entire structure. Fig. H.2 shows that the thickness of the shell cannot solely withstand the g-loading. Additionally, Fig. H.1 shows the buckling of a single stiffener with a specific moment of inertia. Since we use 30 stringers, we achieve the required critical load capability. The analysis is done using the developed code.

% Buckling Analysis of Spacecraft

% AAE 450 - Spring 2004

% Author: George Mseis

% Date Created: 1/25/04

% Date Modified: 2/2/04

%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%

% Description

% This code finds Critical Loads for both an unstiffened cylindrical shell and a stiffened

% cylindrical shell. The stiffened shell calculation assumes some moment of

% inertia and incorporates the distance between the stringers and also the

% distance between the frames in the shell.

%

% Variable for Unstiffened Analysis %%%%%%%%%%%%%%%%%%%

%

% t: Thickness of unstiffened cylindrical shell

% R: Outer Radius of the shell

% Mass: Expected total mass of System that will be distributed axially

% Load_factor: The expected number of g's that the system will experiance

%

% Variables for stiffened Analysis

% Is: A range for the moment of inertia of the stringer

% r_s: Radius of the stringer

% Re: Inner Radius the Shell

% b: Distance between the Stringers in meters

% c : Distance between the frames in meters

%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%

clear all

%%%%%%%%%%%%%%%%%%%%%%%%% Buckling Analysis Without Stiffeners

E = 71e9; % Youngs Modulus

R = 5; % Outer Radius of Cylinder

t = [0.001:0.001:0.05]; % Thickness

Rin = R-t % Inner Radius

lam = 1/16*sqrt(R./t) % Used For Reduction factor

alp = 1-0.901.*(1-exp(-lam)) % Reduction factor

Sigma_cr = 0.6.*alp.*E.*t./R % Critical Stress

A = (pi.*(R^2-Rin.^2)) % Area

Pcr = Sigma_cr.*A % Critical Load Without Stiffeners

Mass = 150000; % Total Mass of Structure

Weight = Mass*9.8; % Weight of Structure

Load_factor = Weight*6 % With number of g's

Fig.(1)

plot(t,Pcr/1e6,'r')

title('Plot Pcr of Unstiffened Cylinder VS Thickness')

xlabel('Thickness in meters m')

ylabel('Critical Load in Mega Newtons')

line([0.001 t(length(t))],[Load_factor/1e6 Load_factor/1e6])

legend('Pcritical Vs thickness','Max Load Expected')

%%%%%%%%%%%%%%%%%%%%%%%%%%%% Buckling With Stifferners

E2 = 71e9;

Is = [1e-8:1e-7:1e-6]; % Moment of Inertia of Stiffener

r_s = 0.015 % Radius of Stringer to be used

Re = 4.998; % Outer radius of frame

Ri = Re-(2*r_s+1/100); % Inner Radius of Frame + 2 Cm of Clearance

A_Fr = pi*(Re.^2-Ri.^2) % Area of Frame

b = 1; % Distance between Stiffeners in meters

c = 5; % Distance between Frames in meters

a_th = Re ; % Outer Radius of Frame AGAIN

a = R ; % Outer Radius of Cylinder

Pcr_stiff = 2.*E2.*sqrt((Is.*A_Fr*b./(a*a_th*c))) ; % Critical Load for one Stiffener in the Cylinder

Fig.(7)

plot(Is,Pcr_stiff/1e6,'r') % Plot of Moment of Inertia VS Critical Load

title('Plot Pcr of stiffened Cylinder VS Moment of Inertia')

xlabel('Moment of Inertia in m^4')

ylabel('Critical Load in Mega Newtons')

line([0 Is(length(Is))],[Load_factor/1e6 Load_factor/1e6])

legend('Pcritical Vs Is','Max Load Expected')

%%%%%% Margin of Safety calculation %%%%%%%

%%% This section of the code simply calculates the margin of saftey of the

%%% entire buckling analysis

String_number = 2*pi*Re;

Crit_load = input('What is the Critical load of one stringer in MN =')

Crit_load = Crit_load*1e6;

Crit_load_total = Crit_load*String_number;

Load_total = Load_factor + Weight*3*5;

MS = Crit_load_total/Load_total - 1

Code for stiffener analysis

% Stiffner Analysis

% AAE 450 - Spring 2004

% Author: George Mseis

% Date Created: 1/25/04

% Date Modified: 2/2/04

%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%

% %%%%%%%%%%%Description%%%%%%%%%%%%%%%%%%%%%%%

% This code Analysis different types of stringer cross-sections.

% This program merely finds the moments of inertia in m^4 for both a

% circular crosssection and a T-beam cross section

%

% The weight of each section with specific dimensions is compared. The

% depth is assumed to be 1 m.

%

%%%%%% Variable for Unstiffened Analysis %%%%%%%%%%%%%%%%%%%

%

% d: total length of the T-beam

% R: Outer Radius of the shell

% Mass: Expected total mass of System that will be distributed axially

% Load_factor: The expected number of g's that the system will experiance

%

% Variables for stiffened Analysis

% Is: A range for the moment of inertia of the stringer

% r_s: Radius of the stringer

% Re: Inner Radius the Shell

% b: Distance between the Stringers in meters

% c : Distance between the frames in meters

%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%

clear all

%T-Beam

d = [0.01:0.01:0.15];

b1 = 0.15;

b2 = 0.0;

tf = 0.05;

tw = 0.08;

h = d;

J = ((b1+b2)*tf^3 +h.*tw^3)/3

Area = tf*b1+(h-tf/2)*tw

Weight = Area*2700

% plot(s_i(i),Ixc_Tbeam)

% hold on

%Circle Stifener

r = [0.01:0.0001:0.02];

Is = pi.*r.^4./4

A_Circle = pi.*r.^2;

Weight_Circle = A_Circle*2700

% Plots e

Fig.(4)

plot(Is,Weight_Circle,'x',J,Weight,'x')

title('Plot of Weight of Stringer VS Moment of Inertia')

xlabel('Moment of Inertia m^4')

ylabel('Weight in Kg')

Fig.(5)

plot(r,Is,'x')

title('Plot of Area moment of Inertia Vs radius for Circular Cross section')

xlabel('radius in ''m''')

ylabel('Is in ''m^4''')

H.3 Simple FEM Analysis Debanik Barua

We analyze a column with Finite Element Model (FEM) varying the thickness from 0.01 to 0.05 m. We then write a Matlab code STRUC_support_column.m by plugging the output values of the analysis from CATIA. The code generates a plot demonstrating the effect of the thickness of the middle tubular part of a column on the von Mises stress and displacement. The plot is shown as Fig. H.3. The graph basically illustrates that as the thickness increases both the von Mises stress and displacement decrease. The analysis justifies our selection of 0.02 m thickness of outer shell as the von Mises stress is below the yield stress of the graphite/epoxy composite (

8

10

60

.

7

MPa).

%STRUC_support_column.m

%AAE 450 - Spring 2004

%Author: Debanik Barua

%Date Created: 02/29/04

%Last Modified: 02/29/04

%**************************************************************************

%DESCRIPTION

%This code generates the plot that compares von Mises stress and mass

%as functions of thickness of the column on each floor. Values were

%obtained from the model analysis in CATIA.

%METHODS OF CALCULATION

%None

%CALLED FUNCTIONS

%None

%VARIABLES

%(units are in parentheses)

% th = thickness of each brace (cm)

%Following parameters are based on thickness of each column

% vmstress = von Mises stress (N/m^2);

% disp = displacement of each column (m)

% mass = mass of each column (kg)

%**************************************************************************

clear all

close all

clc

th = [0.01:0.01:0.05]*100;

vmstress = [12.7 9.65 8.18 6.77 5.77]*1e6;

disp = [1.39 1.36 1.33 1.18 1.09]*1e-4;

mass = [814 916.34 1016.72 1112.74 1206.467];

plotyy(th,vmstress,th,disp)

xlabel('Thickness (cm)')

ax = findobj(gcf,'Type','axes');

axes(ax(2))

ylabel('von Mises Stress (N/m^2)')

axes(ax(1))

ylabel('Displacement (m)')

grid on

_____________________________________________________________________________________________

In a similar way, we analyze a brace using the CATIA FEM feature. Afterwards, we incorporate the result into another Matlab code STRUC_support_brace.m. The code generates multiple graphs, which represent the effects of the quantity and width of the braces on the von Mises stress, displacement and total mass. Note that both the von Mises stress and displacement decrease with the increasing width and number of braces. Nevertheless, as the width and quantity go up the total mass becomes greater.

______________________________________________________________________________

%STRUC_support_brace.m

%AAE 450 - Spring 2004

%Author: Debanik Barua

%Date Created: 02/29/04

%Last Modified: 02/29/04

%**************************************************************************

%DESCRIPTION

%This code primarily generates 3D plots of von Mises stress, displacement,

%and mass as the functions of number of braces and width of each brace. The

%values were obtained from the model analysis in CATIA. Since all the values

%of von Mises stress and displacment are below the values that may cause

%structure to fail the mass was laid more emphasize on, as it is one of the most

%important design criteria. Hence the code was written to produce another

%plot that compares von Mises stress and displacement as the functions of width

%for each brace.

%METHODS OF CALCULATION

%None

%CALLED FUNCTIONS

%None

%VARIABLES

%(units are in parentheses)

% num_brace = number of braces

% width = width of each brace (cm)

%Following parameters are based on number of braces and their widths

% vmstress = von Mises stress (N/m^2);

% disp = displacement of each brace (m)

% mass = mass of each brace (kg)

% total_mass = total mass of all the braces for 3 floors (kg)

%**************************************************************************

clear all

close all

clc

num_brace = [6 8 10];

width = [0.15 0.2 0.25 0.3]*100;

vmstress = [4.06 3.05 2.44;3.61 2.71 2.17;3.46 2.60 2.08;3.58 2.68 2.15]*1e7;

disp = [7.34 5.51 4.41;6.25 4.69 3.75;6.01 4.51 3.61;5.63 4.23 3.38]*1e-4;

mass = [58.11 65.80 73.84 81.17];

Fig. (1)

surf(num_brace,width,vmstress)

xlabel('Number of Braces')

ylabel('Width (cm)')

zlabel('von Mises Stress (N/m^2)')

Fig. (2)

surf(num_brace,width,disp)

xlabel('Number of Braces')

ylabel('Width (cm)')

zlabel('Displacement (m)')

for ii = 1:length(width)

for jj = 1:length(num_brace)

total_mass(ii,jj) = mass(ii)*num_brace(jj)*3;

end

end

Fig. (3)

surf(num_brace,width,total_mass)

xlabel('Number of Braces')

ylabel('Width (cm)')

zlabel('Mass (kg)')

Fig. (4)

plotyy(width,vmstress(:,1),width,disp(:,1));

xlabel('Width (cm)')

ax = findobj(gcf,'Type','axes');

axes(ax(2))

ylabel('von Mises Stress (N/m^2)')

axes(ax(1))

ylabel('Displacement (m)')

grid on

H.4 Crack Propagation Debanik Barua

As mentioned in the section 3.2.7, we apply the following set of equations to compute Q, g, f, fw, M1, M2 and M3. We then implement the parameters to calculate Mf and eventually MS.

65

.

1

464

.

1

1

+

=

c

a

Q

H1

(

)

2

2

10.10.351sin

a

g

t

f

=++-

H2

1

2

4

22

cossin

a

f

c

f

ff

=+

H3

1

2

sec

2

w

ca

f

bt

p

=

H4

1

1.130.09

a

M

c

=-

H5

2

0.89

0.54

0.2

M

a

c

=-+

+

H6

24

3

1

0.5141

0.65

a

M

a

c

c

=-+-

+

H7

We analyze the crack propagation for the outer shell thickness ranging from 0.0001 to 0.01 m with a Matlab code STRUC_crack_propagation.m. The outcome examines the effect of K and t on MS due to crack propagation, which is graphically illustrated in Fig. H.8. We can observe that as the K and t increase MS increases nonlinearly. We assure the safety of our skin structure as the orange dot in the graph indicates that the MS is over 100%.

%STRUC_crack_propagation.m

%AAE 450 - Spring 2004

%Author: Debanik Barua

%Date Created: 02/12/04

%Last Modified: 02/16/04

%**************************************************************************

%DESCRIPTION

%This code generates the margin of safety based on the crack propagation

%thru the skin thickness. It also generates a plot that indicates the

%effect of fracture toughness & thickness on margin of safety.

%METHODS OF CALCULATION

%Allowable stress is calculated using given thickness and following assumptions:

% 1. Leak beafore break

% 2. (a/c) = 1.0

% 3. (a/t) = 1.0

% 4. (a/b) = 0.1

%Margin of safety is then calculated using design and allowable stresses.

%CALLED FUNCTIONS

%None

%VARIABLES (See Fig. in page # of debanik_barua_3.ppt)

%(units are in parentheses)

% K = fracture toughness (Pa-m^(1/2))

% phi - angle of crack orientation (rad)

% t - thickness of outer skin (m)

% a = width of the crack (m)

% c = length of the crack (m)

% b - length of a specific segment (m)

% M1,M2,M3,Q,g,fphi,fw,Mf - nondimensional parameters

% allow_sigma - allowable stress (N/m^2)

% p - pressure inside the vessel (Pa)

% r - radius of the pressure vessel (m)

% design_sigma - design stress (N/m^2)

% MS - margin of safety (%)

%**************************************************************************

clear all

close all

clc

K = [25:1:35]*(6894757)*sqrt(0.0254);

phi = pi/2;

t = [0.0001:0.0001:0.01];

for jj = 1:length(K)

for ii = 1:length(t)

a = t(ii);

c = t(ii);

b = a/0.1;

M1 = 1.13-0.09*(a/c);

M2 = -0.54 + (0.89/(0.2+(a/c)));

M3 = 0.5 - (1/(0.65+(a/c))) + 14*(1-(a/c))^24;

Q = 1 + 1.464*(a/c)^1.65;

g = 1 + (0.1+0.35*(a/t(ii))^2)*(1-sin(phi))^2;

fphi = (((a/c)^2*cos(phi))^2 + (sin(phi))^2)^(1/4);

fw = (sec(pi*c*sqrt(a/t(ii))/(2*b)))^(1/2);

Mf = (M1+M2*(a/t(ii))^2+M3*(a/t(ii))^4)*fphi*g*fw;

allow_sigma(jj,ii) = K(jj)/(sqrt(pi*a/Q)*Mf);

p = 1.01e5;

r = 10.08/2;

design_sigma(jj,ii) = p*r/t(ii);

MS(jj,ii) = (allow_sigma(jj,ii)/design_sigma(jj,ii)-1)*100;

end

end

surf(t*1000,K/1e6,MS)

hold on

plot3(t(20)*1000,K(9)/1e6,MS(9,20),'r*')

grid on

xlabel('Skin Thickness, t (mm)')

ylabel('K_I_c (MPa-m^1^/^2)')

zlabel('Margin of Safety, MS (%)')

H.5 Rigid Body Model George Mseis & Debanik Barua

We consider the rigid body as a preliminary design criteria. Our analysis mainly involves finding the volume, dimensions and mass of the structure. The trade studies between the rigid body and tethered structure are necessary for a decision to be made. We find that the rigid body has a higher mass than the tethered body. A code is written to draw the structure for any outer diameter. The outer diameter has a great effect on the internal volume and the total mass of the structure.

Fig. H.9 illustrates the basic structure of the model. The octagonal tube has a diameter of 4.38 m. The outer shell is 2 mm thick. There are 15 stringers and 2 rings in each of the 8 segments of the spacecraft. Refer to Fig. H.9 for the stringers and rings configuration. Each stringer is 3 cm in diameter and has a length of 7.65 m. The cylinder at the center models the propulsion tank supported by 4 trusses. The structural mass of the spacecraft without the propulsion tank is about 1.72104 kg using aluminum. The material volume is 6.10 m3. Fig. H.10 gives an idea of how large the inside is with respect to a regular human Fig..

% AAE 450 - Spring 2004

% Author: George Mseis

% Date Created: 2/15/04

% Date Modified: 2/30/04

%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%

% Description

% This code will draw the rigid body structure for any diameter. It will

% provide all the necessary properties for the design of the rigid body.

% This extends from the total length, total volume and the mass. This will

% be essential in the design process of for the spacecraft. The main

% assumption in the code is that the structure will be an octagon,

% therefore the angle between each section will be 45 deg. This however,

% can be modified.

%

% Variable

% The only variable will be

% Diam_pl = This is an input and will dictate the drawing that matlab

% generates.

% dia_int = initial diameter

% dia_last = last diameter

%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%

close all

clear all

dia_int = 2

dia_last = 6

ang = 360/8

ang_rad = ang*pi/180;

i = 1

for Dia = linspace(dia_int,dia_last,100)

rad_inner = 10/cos(22.5*pi/180);

rad_outer = (rad_inner*cos(22.5*pi/180)+Dia)/cos(22.5*pi/180)

%rad_outer = Dia+rad_inner;

base_outer = rad_outer*sin(ang_rad/2);

base_inner = rad_inner*sin(ang_rad/2);

base_outer_f =linspace(0,base_outer,100);

base_inner_f =linspace(0,base_inner,100);

ang_f = linspace(0:ang*pi/180,100);

Tot_out_leng = 16*base_outer;

Tot_inn_leng = 16*base_inner;

Vol_inn = 8*pi*(Dia/2)^2*2*base_inner;

Vol_extra = (8*pi*(Dia/2)^2*2*base_outer - 8*pi*(Dia/2)^2*2*base_inner)/2;

Dia_cyl(i) = Dia

Vol_total(i) = Vol_inn+Vol_extra;

i = i+1;

end

plot(Dia_cyl,Vol_total)

xlabel('Cylinder Diameter (m)')

ylabel('Volume of the Spacecraft')

Diam_pl = input('What Diameter do you want the see the plot for?')

rad_outer_as = (Diam_pl+rad_inner*cos(22.5*pi/180))/cos(22.5*pi/180);

for radi = [rad_inner rad_outer_as]

Fig.(2)

plot(0,0)

hold on

polar([-ang_rad/2 ang_rad/2],[radi radi])

polar([-ang_rad/2 -ang_rad-ang_rad/2 ],[radi radi])

polar([-ang_rad-ang_rad/2 -pi/2-ang_rad/2 ],[radi radi])

polar([-pi/2-ang_rad/2 -pi/2-ang_rad/2-ang_rad ],[radi radi])

polar([4*ang_rad+ang_rad/2 4*ang_rad-ang_rad/2],[radi radi])

polar([ang_rad/2 ang_rad/2+ang_rad],[radi radi])

polar([2*ang_rad+ang_rad/2 ang_rad+ang_rad/2],[radi,radi])

polar([3*ang_rad+ang_rad/2 3*ang_rad-ang_rad/2],[radi,radi])

end

H.6 Tether Design and Analysis Rachel Malashock

Two of the possibilities we consider for a spacecraft configuration are a rigid body structure, and a tethered structure. The two main differences between the two options are the variations of complexity and the mass. Each can be designed to accommodate the same volume, however when adding in truss supports and joint connections the mass increases drastically. A basic tethered schematic has already been seen in section 3.2.8, and so a basic rigid body schematic is shown in Fig. H.11. A rigid body structure has some benefits over a tethered design. All of the compartments and capsules onboard the spacecraft are easily accessible to the crew for storage or repair needs. The spacecraft is also more stable than a tethered craft, and does not require a complicated spin up or spin down sequence. The drawbacks however, are the obvious increase in mass along with the high angular rate of rotation necessary to maintain such a short Rcm. The following spreadsheet shows the analysis that we perform in order to help with the choosing of the spacecraft structure.

Capsule Dimensions

(m)

Diameter Outer

Diameter In

Length

Structural Volume

Total Volume

Structural Mass (assume Al)

4 total

6.00

5.95

17.50

8.21

32.85

90000.00

8 total

6.00

5.95

9.00

4.22

33.79

92000.00

Tether Dimensions

dimensions

unit mass

Total

5 km

66 kg

15180.00

Housing

.12 m^3

5 kg

2300.00

Connection Dimensions

Diameter Outer

Diameter In

Length

Structural Volume

Total Volume

Structural Mass (assume Al)

1 total

2.00

1.60

2.50

2.83

-

7641.00

2 total

2.00

1.60

2.00

2.26

4.52

12150.00

Truss Dimensions

Length

Width

Height

Estimated Mass (S1 Truss: ISS)

Total

4 total

13

4.5

2

14000

56000

Tethered Spacecraft 1

Tethered Spacecraft 2

4 Capsules

9.00E+04

9.00E+04

230 Tethers

1.52E+04

1.52E+04

Housings

2.30E+03

2.30E+03

Connections

7641.00

12150.00

Counter Balance

8.49E+03

8.89E+03

TOTAL

1.24E+05

1.29E+05

Rigid Spacecraft 1

Rigid Spacecraft2

8 Capsules

9.20E+04

9.20E+04

4 Trusses

5.60E+04

5.60E+04

Thruster Arm

1.30E+05

-

TOTAL

2.78E+05

1.48E+05

Once we choose a tethered spacecraft design, we then have to analyze several different configurations in order to decide which is the most feasible. There is also some debate as to what a reasonable pressurized volume would be, so several variations are tested. As can be seen in Fig. H.12, the mass of the system increases linearly as the volume increases. We need to minimize the volume as much as possible, in order to keep mass to a reasonable amount.

Once we choose an angular rate of rotation of 5 RPM, along with a pressurized volume of approximately 809 m3, the final steps of the analysis including tether lengths and dimensions are completed.

H.7 Tether Length Analysis George Mseis

The tether length is a variable and needs to change as the mass of the counter weight is changing. The center of mass is confined to a specific location, to keep the artificial gravity constant. A simple code is developed to meet this end.

% AAE 450 - Spring 2004

% Author: George Mseis

% Date Created: 3/1/04

% Date Modified: 2/1/04

%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%

% Description

% This code simply finds the length of the tether as the weight of the

% counter weight varries. This is essential to keep the centre of mass

% constant

%

% Variable

% X1 = Position of the hab relative to the corrdinate system

% Xcm = position of where the centre of mass needs to be

% m1 = mass of hab

% m2 = mass of propulsion system on the other side

%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%

clear all

X1 = 0;

Xcm= 36;

m1 = 150000;

m2 = 200000;

for i = 1:5500

t = i;

X2(i)= (Xcm*(m1+m2) - X1*m1)/m2;

m2(i) = 200000 - 20*t;

time(i) = t;

end

Fig.(1)

plot(time,m2)

xlabel('Time in sec')

ylabel('Mass of Counter weight')

Fig.(2)

plot(time,X2)

xlabel('Time in sec')

ylabel('Length of Counter Weight')

H.8 Mass Budget Analysis Jamie KrakoverTotals

Item

HAB

Storage

Tether

Propulsion

Mass (kg)

Mass %

HF

66,910.25

0.00

0.00

0.00

66,910.25

17.52%

Comm

850.00

0.00

0.00

650.00

1,500.00

0.39%

Power

6,111.82

6,815.00

183.70

0.00

13,110.52

3.43%

Thermal

27,125.88

0.00

0.00

4,660.80

31,786.68

8.32%

Structure

36,500.00

24,500.00

7,000.00

0.00

68,000.00

17.80%

Rover/Lander

0.00

5,148.38

0.00

0.00

5,148.38

1.35%

Storage Components

0.00

6,716.45

0.00

0.00

6,716.45

1.76%

Total dry mass

137,497.96

43,179.83

7,183.70

5,310.80

193,172.29

Propulsion

7,880.00

0.00

0.00

180,936.00

188,816.00

49.43%

Total wet mass

145,377.96

43,179.83

7,183.70

186,246.80

381,988.29

9.31 m

Stringer

Ring/Frame

4.38 m

9.31 m

Stringer

Ring/Frame

4.38 m

Power

Tether Cabling

kg

Wire

112.3

Insulation

19.9

Magnetic Shielding

51.5

TOTAL CABLE

183.7

Winch

Approx.

6815

Plasma Contactors(Ground)

159.21

Transformers

Large

670

Small Scale

< 0.5

TOTAL TRANSFORMERS

2680

Components

Regulators, Convertors, charge controllers

11.4

TOTAL COMPONENTS

1140

Wiring

14-3 AWG

Typical Wiring

8.9

12-3 AWG

Dishwasher

7.0

10-3 AWG

Dryer

11.8

8-3 AWG

Stove

19.0

HAB Length

10

m

HAB Circum.

31.416

m

Copper Dens.

8920

kg/m^3

Total Possible Length of Wire

41.416

m

Area of 14-3

6.03E-06

m^2

Area of 12-3

9.42E-06

m^2

Area of 10-3

1.59E-05

m^2

Area of 8-3

2.57E-05

m^2

Volume of 14-3

2.50E-04

m^3

Volume of 12-3

3.90E-04

m^3

Volume of 10-3

6.60E-04

m^3

Volume of 8-3

1.06E-03

m^3

TOTAL WIRING

46.6

Fuel Cell

LOX

893

LH2

112

TOTAL FUEL

1005

LOX Tank

229

LH2 Tank

262

Fuel Cells

590

TOTAL HARDWARE

1081

TOTAL POWER MASS

13110.5

Rover/Lander

Item

Mass (kg)

Rocket

Prop production

30.00

Hydrogen

50.00

Dry mass

160.00

RCS

10.00

Docking

10.00

Computer

5.00

Radio Isotope

15.00

Total

280.00

Rover

Head

8.31

Arms

11.07

Mobility System

20.96

Communications

2.20

Structure

113.01

Total

155.55

Lander

Lander

790.00

Radar Altimeter

15.00

Radio Isotope

75.00

Aeroshell

595.00

Cruise Stage

239.00

Attitude Control Rocket

0.64

Drogue

17.00

Parachutes

32.00

Fuel

175.00

Arm/Piston

200.00

Total

2,138.64

Total System

2,574.19

Structure

Item

Mass (kg)

HAB

Structure

34,000.00

Micrometeorite Protection

2,500.00

Total

36,500.00

Storage

Total

24,500.00

Tether

Total

7,000.00

Total Structure

68,000.00

Aerodynamics and Dynamics & Controls

Crew Return Vehicle (CRV)

Mass (Kg)

Comm.

100.00

Computer

130.00

Control Systems:

600.00

Consumables:

10.00

Crew:

280.00

Heat Shield:

975.00

Navigation:

500.00

Martian Sample:

10.00

Misc Contingency:

200.00

Personal Storage:

60.00

Power

50.50

Propellant:

80.00

Recovery Equip.:

250.00

Scientific:

15.00

Seats & Provisions:

440.00

Structure:

1,600.00

Telemetry:

200.00

Flight Suits

44.00

Parachute

1,148.22

Total Mass:

6,692.72

Probe 1 Mass

13.53

Probe 2 Mass

10.20

Probes

23.73

Launch Escape System (LES)

Launch Escape Motor

2,200.00

Tower Titanium Truss

520.00

Boost Protective Cover

430.00

Pitch Control Motor

23.00

Tower Jettison Motor

50.00

Total Mass

3,223.00

Total Aero/D&C

9,939.45

Communications

Item

Mass (kg)

Main Dish

450.00

Backup Dish

450.00

Rover Dish

200.00

Hardware

250.00

Spare Servos

150.00

Total

1,500.00

Thermal

Item

Mass (kg)

Prop

Power System Panels

780.80

Power System Structure

3,780.00

Cryogenic Cooling

100.00

Total

4,660.80

Hab

Electronics Cooling Assembly

91.00

Humidity Control and Heat Exchanger Assembly

144.20

Cold Plate

87.50

Water Pump Assembly

101.50

Freon Pump Assembly

142.10

Freon to Water Heat Exchanger

88.90

Hydraulics Heat Exchanger

77.70

Flash Evaporator

616.00

Water Tank

3,600.00

Plumbing and Valves

202.00

Instruments and Controls

68.00

Fluids

68.00

Spacecraft MLI

802.72

Cabin Panels

364.01

Cabin Structure

1,762.25

Total

8,215.88

Insulation

Aeroshell

18,910.00

Total Thermal

31,786.68

Human Factors

Components

Units

Unit Mass kg

Total Mass kg

4th Floor

Airlock

1

2,706.00

2,706.00

3rd Floor

Console

5

130.00

650.00

Table

1

15.00

15.00

Chair

4

5.00

20.00

Mainframe

2

200.00

400.00

Large TV

1

30.00

30.00

Work Table

1

20.00

20.00

Table

1

15.00

15.00

Chair

3

5.00

15.00

TV

2

10.00

20.00

Airlock

1

550.32

550.32

WPA

2

658.00

1,316.00

OGA

1

140.00

140.00

4BMS

1

120.00

120.00

2nd Floor

0.00

Microwave

2

35.00

70.00

Dishwasher

1

40.00

40.00

Sink

1

15.00

15.00

WCS

1

112.00

112.00

Small Sink

1

8.00

8.00

Med Suite

1

1,000.00

1,000.00

Bed

1

55.00

55.00

Desk

1

15.00

15.00

Table

1

15.00

15.00

Chairs

5

5.00

25.00

TV

4

10.00

40.00

Scientific Payload

1

200.00

200.00

1st Floor

0.00

Bed

4

46.00

184.00

Washing Machine

1

100.00

100.00

Dryer

1

60.00

60.00

Desk

4

15.00

60.00

Chair

8

5.00

40.00

Shower

1

75.00

75.00

Sink

1

8.00

8.00

WCS

1

112.00

112.00

Multigym

1

200.00

200.00

Stepper

1

136.00

136.00

Treadmill

1

150.00

150.00

Gym Equip

1

25.00

25.00

Table

1

15.00

15.00

Couch

1

45.00

45.00

TV

7

10.00

70.00

Stored Component

0.00

*

Food

3600

2.30

8,280.00

*

Cleaning Supplies

900

0.25

225.00

Cooking Supplies

4

5.00

20.00

*

Bathroom Supplies

3600

0.05

180.00

*

Backup Bathroom Bags

3600

0.25

900.00

Personal Hygiene Kit

4

1.80

7.20

*

Hygiene Supplies

3600

0.08

270.00

Clothing

4

90.00

360.00

Rec Items

1

1,000.00

1,000.00

Personal Items

4

50.00

200.00

Vacuum

1

13.00

13.00

*

Disposable Wipes

3600

0.30

1,080.00

*

Trash Bags

3600

0.05

180.00

Operational Supplies

4

20.00

80.00

Restraints

1

100.00

100.00

Hand Tools

1

300.00

300.00

Test Equipment

1

500.00

500.00

Other Maintenance Equipment

1

1,000.00

1,000.00

Photography

1

120.00

120.00

Fire Suppression

4

5.00

20.00

EVA Tools

1

123.00

123.00

Manuerving Unit

2

35.00

70.00

EVA Suits

4

135.00

540.00

*

Med Consumables

1

500.00

500.00

Crew

4

70.00

280.00

Water Tank Spares

1

329.00

329.00

Waste Spare

1

56.00

56.00

Atmosphere Spare

1

130.00

130.00

Other

Water Tanks

1

204.00

204.00

*

Water

1

10,199.00

10,199.00

Air Tanks

1

743.00

743.00

*

Total Gas

1

1,566.00

1,566.00

Installation Margin for Zero g

-

0.40

15,387.01

Total Mass (kg)

53,854.53

Total with 5% Growth

56,547.25

HF Consumables

23,380.00

HF Dry Mass

33,167.25

Safe Haven

10,363.00

Total HF

66,910.25

Propulsion

Item

Mass (kg)

Hab

RCS Engines

126.00

Fuel and Oxidizer Tanks

146.00

RCS Fuel

3,500.00

Hall Effect Engines

108.00

Hall Effect Fuel

4,000.00

Total

7,880.00

Prop

Nuc Engines

6,800.00

Propellant

164,232.00

Skin

5,066.00

RCS Engines

84.00

RCS Fuel

3,500.00

Fuel and Oxidizer Tanks

146.00

Hall Effect Engines

108.00

Canadian Arm

1,000.00

Total

180,936.00

Total Propulsion

188,816.00

MASSES OF LAUNCH VEHICLE

TOTAL MASS of launch vehicle (kg):

4.85E+06

1st STAGE

CORE BOOSTER (RD 180)

Initial Mass Core Booster (kg):

2.94e+006 ------------------------------------- without payload 2.74e6 kg

Final Mass Core Booster (kg):

2.68e+006 ------------------------------------- without payload 2.74e6 kg

Propellant Mass Core Booster (kg):

4.65E+05

STRAP-ON BOOSTER ( RSRM)

Initial Mass of Strap-on Boosters (kg):

1.71E+06

Final Mass of Strap-on Boosters (kg):

2.03E+05

Propellant Mass of Strap-on Boosters (kg):

1.50E+06

2nd STAGE

2nd Stage CORE BOOSTER (RD 180)

Initial Mass Core Booster (kg):

2.48e+006 ------------------------------------- without payload 2.28e6 kg

Final Mass Core Booster (kg):

4.61e+005 ------------------------------------- without payload 2.61e5 kg

Propellant Mass Core Booster (kg):

2.48E+06

3rd STAGE (SSME)

Initial Mass Core Booster (kg):

3.44e+005 ------------------------------------- without payload 1.44e5 kg

Final Mass Core Booster (kg):

2.38e+005 ------------------------------------- without payload 0.38e5 kg

Propellant Mass Core Booster (kg):

1.06E+05

%%MATLAB CODE CONVENTIONS STRUC_shipcm

%AAE 450 - Spring 2004

%Author/s: Jamie Krakover

%Date Created: 3/22/04

%Last Modified: 3/27/04

%**********************************************************************************

%DESCRIPTION

%This code determines the center of mass for the enitire spacecraft at important points in the mission.

%METHODS OF CALCULATION

%Calculating the CM using the center of masses of each major section and their respective masses.

%This code assumes that the center of mass in the propulsion tanks is at the center of each tank.

%Assume the hab is a closed system and the mass remains constant.

%In addition all points are located from the center front end of the HAB.

%The x axis is through the side of the ship.

%The y axis goes through the length of the ship.

%The z axis is vertically through the top of the ship.

%CALLED FUNCTIONS

%There are no called functions.

%VARIABLES

% ltether - length of the tether

% hab_cm - hab cm location

% commdish_cm - commdish cm location

% storage_cm - storage cm location

% prop1_cm - first propulsion tank cm

% prop2_cm - second propulsion tank cm (jetisoned tank)

% habrad_cm - cm for both the radiators together

% maero - mass of the aeroshell

% mhab - mass of the hab

% mtether - mass of the tether

% mcommdish - mass of the communications dish

% mstorage - mass of the crv storage container and contents

% mprop1 - mass of the first propulsion tank

% mprop2 - mass of the second propulsion tank (jetisoned tank)

% mhabrad - mass of hab radiators

% mproprad - mass of propulsion side radiators

% mtotal - total mass of the system

%thether length (m)

%**********************************************************************************

ltether=75;

%cm locations of each object located from the origin in x-y-z coordinates (in m)

aero_cm=[0 14.8 -2.6];

hab_cm=[0.187 3.65 0.5];

commdish_cm=[0 7 10.5];

storage_cm=[0 15.75 0];

prop1_cm=[0 29.25 0];

prop2_cm=[0 28.7 10];

habrad_cm=[0 9 0];

%masses of each component (in kg)

maero=18910;

mcommdish=450;

mstorage=25000+5148.38+6716.45;

mtether=7183.7;

mprop1=180936+5310.8-78856;

mprop2=78856;

mhabrad=265.5+1285.3;

mproprad=3780+780.8;

mhab=150467.96-mhabrad-maero;

mtotal=maero + mhab + mcommdish + mstorage + mprop1 + mprop2 + mhabrad + mproprad + mtether;

%locating the cm in LEO

cm1x=(1/mtotal)*(maero*aero_cm(1) + mhab*hab_cm(1) + mcommdish*commdish_cm(1) + (mtether+mstorage)*storage_cm(1) + (mproprad + mprop1)*prop1_cm(1) + mprop2*prop2_cm(1))

cm1y=(1/mtotal)*(maero*aero_cm(2) + mhab*hab_cm(2) + mcommdish*commdish_cm(2) + (mtether + mstorage)*storage_cm(2) + (mproprad+mprop1)*prop1_cm(2) + mprop2*prop2_cm(2) + mhabrad*habrad_cm(2))

cm1z=(1/mtotal)*(maero*aero_cm(3) + mhab*hab_cm(3) + mcommdish*commdish_cm(3) + (mtether+mstorage)*storage_cm(3) + (mproprad+mprop1)*prop1_cm(3) + mprop2*prop2_cm(3))

%locating the cm with tether deployed

cm2x=(1/mtotal)*(maero*aero_cm(1) + mhab*hab_cm(1) + mcommdish*commdish_cm(1) + mstorage*storage_cm(1) + (mproprad + mprop1)*prop1_cm(1))

cm2y=(1/mtotal)*(maero*aero_cm(2) + mhab*hab_cm(2) + mcommdish*commdish_cm(2) + mstorage*storage_cm(2) + (mproprad + mprop1)*(ltether+prop1_cm(2)) + mhabrad*habrad_cm(2))

cm2z=(1/mtotal)*(maero*aero_cm(3) + mhab*hab_cm(3) + mcommdish*commdish_cm(3) + mstorage*storage_cm(3) + (mproprad + mprop1)*prop1_cm(3))

%locating the cm just before aerobrake

cm3x=(1/mtotal)*(maero*aero_cm(1) + (mcommdish + mhab)*hab_cm(1) + (mtether + mstorage)*storage_cm(1) + (mproprad + mprop1)*prop1_cm(1))

cm3y=(1/mtotal)*(maero*aero_cm(2) + (mcommdish + mhab)*hab_cm(2) + (mtether + mstorage)*storage_cm(2) + (mproprad + mprop1)*prop1_cm(2))

cm3z=(1/mtotal)*(maero*aero_cm(3) + (mcommdish + mhab)*hab_cm(3) + (mtether+mstorage)*storage_cm(3) + (mproprad + mprop1)*prop1_cm(3))

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 9Octagonal rigid body model with trusses and propulsion tank (left) and stingers/ring configuration (right)created by Debanik Barua

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 8Effect of K and t on MS due to crack propagation

Selected Thickness = 0.02 m

147% MS at current skin thickness (0.002 m)

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 4Effects of the quantity (per floor) and width on the von Mises stress

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 3von Mises stress and displacement vs. thickness of each column

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 5Effects of the quantity (per floor) and width on the displacement

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 6Effects of the quantity (per floor) and width on total mass

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 7von Mises stress and displacement vs. width of each brace

Selected point

Selected point

Selected point

Selected width = 0.2 m

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 10Inside the rigid body spacecraftcreated by Debanik Barua

EMBED Unknown

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 11Basic rigid body spacecraft structurecreated by Rachel Malashockcial gravity will iminary design criteria e achieve the required e ____________

__

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 12Total system mass vs. pressurized volume

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 1Effect of moment of inertia on critical load of stiffened shell

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 2Effect of thickness of shell on critical load of unstiffened shell

EMBED Excel.Chart.8 \s

Fig. STYLEREF 1 \s H. SEQ Figure \* ARABIC \s 1 13Mass percentage of each section

Grandt, Alten F., Fundamentals of Structural Integrity, John Wiley and Sons Inc., Hoboken, NJ, 2003, page 224

PAGE

AAE 450 Senior Spacecraft Design Spring 2004

365

11.522.533.544.55

0.5

1

1.5

x 10

7

Thickness (cm)

von Mises Stress (N/m

2

)

11.522.533.544.55

1

1.2

1.4

x 10

-4

Displacement (m)

0

5000

10000

15000

20000

25000

400600800100012001400160018002000

Capsule Volume (m^3)

System Mass (kg)

3 RPM

4 RPM

5 RPM

6 RPM

49.37%

17.91%

8.31%

0.39%

17.49%

3.43%

1.35%

1.76%

HF

Comm

Power

Thermal

Structure

Rover/Lander

Storage

Components

Propulsion

_1142007373.unknown

_1142008674.unknown

_1142164910.xlsChart2

0.1749341256

0.0039216887

0.0342769312

0.0831049758

0.1790904505

0.0134602291

0.017559884

0.4936517152

Totals

ItemHABStorageTetherPropulsionMass (kg)Mass %

HF66,910.250.000.000.0066,910.2517.49%

Comm850.000.000.00650.001,500.000.39%

Power6,111.826,815.00183.700.0013,110.523.43%

Thermal27,125.880.000.004,660.8031,786.688.31%

Structure36,500.0025,000.007,000.000.0068,500.0017.91%

Rover/Lander0.005,148.380.000.005,148.381.35%

Storage Components0.006,716.450.000.006,716.451.76%

Total dry mass137,497.9643,679.837,183.705,310.80193,672.29

Propulsion7,880.000.000.00180,936.00188,816.0049.37%

Total wet mass145,377.9643,679.837,183.70186,246.80382,488.29

Totals

Power

Power Mass Budget by Component

Tether Cablingkg

Wire112.3

Insulation19.9

Magnetic Shielding51.5

TOTAL CABLE183.7

WinchApprox.6815

Plasma Contactors(Ground)159.21(x# of contactors)

has yet to be decided

Transformers(1per floor)

Large670

Small Scale< 0.5

TOTAL TRANSFORMERS2680

Components

Regulators, Convertors, charge controllers11.4kg/kWe

TOTAL COMPONENTS1140

Wiring

14-3 AWGTypical Wiring8.9

12-3 AWGDishwasher7.0

10-3 AWGDryer11.8

8-3 AWGStove19.0

HAB Length10m

HAB Circum.31.416m

Copper Dens.8920kg/m^3

Total Possible Length of Wire41.416m

Area of 14-36.03E-06m^2

Area of 12-39.42E-06m^2

Area of 10-31.59E-05m^2

Area of 8-32.57E-05m^2

Volume of 14-32.50E-04m^3

Volume of 12-33.90E-04m^3

Volume of 10-36.60E-04m^3

Volume of 8-31.06E-03m^3

TOTAL WIRING46.6

Fuel Cell

LOX893

LH2112

TOTAL FUEL1005

LOX Tank229

LH2 Tank262

Fuel Cells590

TOTAL HARDWARE1081

TOTAL POWER MASS13110.5

Rover Lander

ItemMass (kg)

Rocket

Prop production30.00

Hydrogen50.00

Dry mass160.00

RCS10.00

Docking10.00

Computer5.00

Radio Isotope15.00

Total280.00

Rover

Head8.31

Arms11.07

Mobility System20.96

Communications2.20

Structure113.01

Total155.55

Lander

Lander790.00

Radar Altimeter15.00

Radio Isotope75.00

Aeroshell595.00

Cruise Stage250.00

Attitude Control Rocket0.64

Drogue13.00

Parachutes25.00

Fuel175.00

Arm/Piston200.00

Total2,138.64

Total System2,574.19

Structure

ItemMass (kg)

HAB

Structure34,000.00

Micrometeorite Protection2,500.00

Total36,500.00

Storage

Total25,000.00

Tether

Total7,000.00

Total Structure68,500.00

Aero D&C

Mass Breakdown

Crew Return Vehicle (CRV)Mass (Kg)

Comm.100.00

Computer130.00

Control Systems:600.00

Consumables:10.00

Crew:280.00

Heat Shield:975.00

Navigation:500.00

Martian Sample:10.00

Misc Contingency:200.00

Personal Storage:60.00

Power50.50

Propellant:80.00

Recovery Equip.:250.00

Scientific:15.00

Seats & Provisions:440.00

Structure:1,600.00

Telemetry:200.00

Flight Suits44.00

Parachute1,148.22

Total Mass:6,692.72

Probe 1 Mass13.53

Probe 2 Mass10.20

Probes23.73

Launch Escape System (LES)

Launch Escape Motor2,200.00

Tower Titanium Truss520.00

Boost Protective Cover430.00

Pitch Control Motor23.00

Tower Jettison Motor50.00

Total Mass3,223.00

Total Aero/D&C9,939.45

Communications

ItemMass (kg)

Main Dish450.00

Backup Dish450.00

Rover Dish200.00

Hardware250.00

Spare Servos150.00

Total1,500.00

Thermal

ItemMass (kg)

Prop

Power System Panels780.80

Power System Structure3,780.00

Cryogenic Cooling100.00

Total4,660.80

Hab

Electronics Cooling Assembly91.00

Humidity Control and Heat Exchanger Assembly144.20

Cold Plate87.50

Water Pump Assembly101.50

Freon Pump Assembly142.10

Freon to Water Heat Exchanger88.90

Hydraulics Heat Exchanger77.70

Flash Evaporator616.00

Water Tank3,600.00

Plumbing and Valves202.00

Instruments and Controls68.00

Fluids68.00

Spacecraft MLI802.72

Cabin Panels364.01

Cabin Structure1,762.25

Total8,215.88

Insulation

Aeroshell18,910.00

Total Thermal31,786.68

HF

TOF900

ComponentsUnitsUnit MassTotal Mass

4th Floor

Airlock12,706.002,706.00

3rd Floor

Console5130.00650.00

Table115.0015.00

Chair45.0020.00

Mainframe2200.00400.00

Large TV130.0030.00

Work Table120.0020.00

Table115.0015.00

Chair35.0015.00

TV210.0020.00

Airlock1550.32550.32

WPA2658.001,316.00

OGA1140.00140.00

4BMS1120.00120.00

2nd Floor0.00

Microwave235.0070.00

Dishwasher140.0040.00

Sink115.0015.00

WCS1112.00112.00

Small Sink18.008.00

Med Suite11,000.001,000.00

Bed155.0055.00

Desk115.0015.00

Table115.0015.00

Chairs55.0025.00

TV410.0040.00

Scientific Payload1200.00200.00

1st Floor0.00

Bed446.00184.00

Washing Machine1100.00100.00

Dryer160.0060.00

Desk415.0060.00

Chair85.0040.00

Shower175.0075.00

Sink18.008.00

WCS1112.00112.00

Multigym1200.00200.00

Stepper1136.00136.00

Treadmill1150.00150.00

Gym Equip125.0025.00

Table115.0015.00

Couch145.0045.00

TV710.0070.00

Stored Component0.00

*Food36002.308,280.00

*Cleaning Supplies9000.25225.00

Cooking Supplies45.0020.00

*Bathroom Supplies36000.05180.00

*Backup Bathroom Bags36000.25900.00

Personal Hygiene Kit41.807.20

*Hygiene Supplies36000.08270.00

Clothing490.00360.00

Rec Items11,000.001,000.00

Personal Items450.00200.00

Vacuum113.0013.00

*Disposable Wipes36000.301,080.00

*Trash Bags36000.05180.00

Operational Supplies420.0080.00

Restraints1100.00100.00

Hand Tools1300.00300.00

Test Equipment1500.00500.00

Other Maintenance Equipment11,000.001,000.00

Photography1120.00120.00

Fire Suppression45.0020.00

EVA Tools1123.00123.00

Manuerving Unit235.0070.00

EVA Suits4135.00540.00

*Med Consumables1500.00500.00

Crew470.00280.00

Water Tank Spares1329.00329.00

Waste Spare156.0056.00

Atmosphere Spare1130.00130.00

Other

Water Tanks1204.00204.00

*Water110,199.0010,199.00

Air Tanks1743.00743.00

*Total Gas11,566.001,566.00

Installation Margin for Zero g-0.4015,387.01

Total Mass (kg)53,854.53

Total with 5% Growth56,547.25

HF Consumables23,380.00

HF Dry Mass33,167.25

Safe Haven10,363.00

Total HF66,910.25

Propulsion

ItemMass (kg)

Hab

RCS Engines126.00

Fuel and Oxidizer Tanks146.00

RCS Fuel3,500.00

Hall Effect Engines108.00

Hall Effect Fuel4,000.00

Total7,880.00

Prop

Nuc Engines6,800.00

Propellant164,232.00

Skin5,066.00

RCS Engines84.00

RCS Fuel3,500.00

Fuel and Oxidizer Tanks146.00

Hall Effect Engines108.00

Canadian Arm1,000.00

Total180,936.00

Total Propulsion188,816.00

MASSES OF LAUNCH VEHICLE

TOTAL MASS of launch vehicle (kg):4.85E+06

1st STAGE

CORE BOOSTER (RD 180)

Initial Mass Core Booster (kg):2.94e+006 ------------------------------------- without payload 2.74e6 kg

Final Mass Core Booster (kg):2.68e+006 ------------------------------------- without payload 2.74e6 kg

Propellant Mass Core Booster (kg):4.65E+05

STRAP-ON BOOSTER ( RSRM)

Initial Mass of Strap-on Boosters (kg):1.71E+06

Final Mass of Strap-on Boosters (kg):2.03E+05

Propellant Mass of Strap-on Boosters (kg):1.50E+06

2nd STAGE

2nd Stage CORE BOOSTER (RD 180)

Initial Mass Core Booster (kg):2.48e+006 ------------------------------------- without payload 2.28e6 kg

Final Mass Core Booster (kg):4.61e+005 ------------------------------------- without payload 2.61e5 kg

Propellant Mass Core Booster (kg):2.48E+06

3rd STAGE (SSME)

Initial Mass Core Booster (kg):3.44e+005 ------------------------------------- without payload 1.44e5 kg

Final Mass Core Booster (kg):2.38e+005 ------------------------------------- without payload 0.38e5 kg

Propellant Mass Core Booster (kg):1.06E+05

_1142327792.dwg

_1142030100.unknown

_1142007508.unknown

_1142007449.unknown

_1142007292.unknown

_1142007305.unknown

_1142007127.unknown