飛行器系統(tǒng)仿真

上傳人:開(kāi)心****21 文檔編號(hào):48348157 上傳時(shí)間:2022-01-04 格式:DOCX 頁(yè)數(shù):54 大?。?92.25KB
收藏 版權(quán)申訴 舉報(bào) 下載
飛行器系統(tǒng)仿真_第1頁(yè)
第1頁(yè) / 共54頁(yè)
飛行器系統(tǒng)仿真_第2頁(yè)
第2頁(yè) / 共54頁(yè)
飛行器系統(tǒng)仿真_第3頁(yè)
第3頁(yè) / 共54頁(yè)

下載文檔到電腦,查找使用更方便

12 積分

下載資源

還剩頁(yè)未讀,繼續(xù)閱讀

資源描述:

《飛行器系統(tǒng)仿真》由會(huì)員分享,可在線閱讀,更多相關(guān)《飛行器系統(tǒng)仿真(54頁(yè)珍藏版)》請(qǐng)?jiān)谘b配圖網(wǎng)上搜索。

1、《飛行器系統(tǒng)仿真與 CA》學(xué)習(xí)報(bào)告 第一部分仿真(40) 題目1:給定導(dǎo)彈相對(duì)于目標(biāo)的運(yùn)動(dòng)學(xué)方程組為 r(0) = 5km, q(0) = 60deg, ?(0) = 30deg,V = , V , 1Ma = 340m/s, k = 2 (1) 建立系統(tǒng)的方框圖模型; (2) 用MATLAB語(yǔ)言編寫S一函數(shù) (2)用MATLAB語(yǔ)言編寫S函數(shù) (3) (4) 用命令行對(duì)(1),(2進(jìn)行仿真,以圖形顯示結(jié)果 (1) 用窗口菜單對(duì)(1), (2世行仿真,動(dòng)態(tài)顯示結(jié)果; function [sys,x0,str,ts]=CAD1_sfun(t

2、,x,u,flag) switch flag case0 [sys,x0,str,ts]=mdlInitializeSizes; case1 sys = mdlDerivatives(t,x,u); case3 sys = mdlOutputs(t,x,u); case{2,4,9} sys = []; otherwise error(unhandled flag=,num2str(flag)) end function [sys,x0,str,ts]=mdlInitializeSizes sizes=simsizes; =3; =0; =3; =0; =1;

3、 =1; sys=simsizes(sizes); str=[]; x0=[5000,pi/3,pi/6]; ts=[0 0]; functionsys=mdlDerivatives(t,x,u) vm=*340; v=*340; k=2; dx(1)=vm*cos(x(2))-v*cos(x(2)-x(3)); dx(2)=(v*sin(x(2)-x(3))-vm*sin(x(2)))/x(1); dx(3)=k*dx(2); sys=dx; function sys=mdlOutputs(t,x,u) sys=x; 調(diào)用 S 函數(shù)的模型框圖 (3)框圖仿真

4、結(jié)果: S 函數(shù)仿真結(jié)果: ( 4)命令輸入 clear;clc [t x ] = sim(CAD1); hSimulink = figure(); subplot(3, 1, 1); plot(t,x(:,1)); grid; ylabelr(); subplot(3, 1, 2); plot(t,x(:,2)); grid; ylabelq(); subplot(3, 1, 3); plot(t,x(:,3)); grid; ylabels(igma); [t x ] = sim(CAD1_S); hSFun = figure(); subplot(3, 1,

5、1); plot(t,x(:,1)); grid; ylabelr(); subplot(3, 1, 2); plot(t,x(:,2)); grid; ylabelq(); subplot(3, 1, 3); plot(t,x(:,3)); grid; ylabels(igma); 模型仿真結(jié)果: S 函數(shù)仿真結(jié)果: 題目 2:給出動(dòng)態(tài)方程 x ( 1 x 2 ) x tx 1 ; x ( 0 ) 1 , x ( 0 ) 0 (1)用MATLAB語(yǔ)言編寫S-函數(shù); (2)用命令行g(shù)ear/adam汕對(duì)(1世行仿真,顯示曲線 x(t=0: 100); (3) 建立方框圖

6、,用 RK45 仿真 50秒,顯示曲線 答: (1)用MATLAB語(yǔ)言編寫S一函數(shù) function[sys,x0,str,ts]=CAD2_sfun(t,x,u,fl otherwise ag) error(unhandled flag=,num2str(flag)) switch flag end case0 function [sys,x0,str,ts]=mdlInitializeSizes sizes=simsizes; [sys,x0,str,ts]=mdlInitializeSizes; =2; case1 =0; sys=mdlDerivative

7、s(t,x,u); =2; case3 =0; sys=mdlOutputs(t,x,u); =1; case{2,4,9} =1; sys=[]; dx(1)=x(2); sys=simsizes(sizes); str=[]; dx(2)=1-t*x(1)-(1-x(1)A2)*x(2); x0=[1,0]; sys=dx; ts=[0 0]; function sys=mdlOutputs(t,x,u) function sys=mdlDerivatives(t,x,u) sys=x; (2)直接調(diào)用ode數(shù)值積分函數(shù)進(jìn)行仿真,系統(tǒng)微分方程: functi

8、on dx = CAD01_02odefun(t, x) dx(1) = x(2); dx(2) = 1-(1-x(1)*x(1))*x(2) - t*x(1); dx = dx; 調(diào)用ode解算器入口: clear; clc; [t x] = ode15s(@CAD01_02odefun, 0:100, [1 0]); hGear = figure(); set(hGear,NumberTitle, off, Name, Integrated by the Gear algorithm, Units, Normalized, Position, [ ]); subplot(

9、2, 1, 1); plot(t, x(:,1)); grid; ylabelx(); subplot(2, 1, 2); plot(t, x(:,2)); grid; ylabeld(x/dt ); [t x] = ode113(@CAD01_02odefun, 0:100, [1 0]); hAdams = figure(); set(hAdams,NumberTitle, off, Name, Integrated by the Adams algorithm, Units, Normalized, Position, [ ]); subplot(2, 1, 1); pl

10、ot(t, x(:,1)); grid; ylabelx(); subplot(2, 1, 2); plot(t, x(:,2)); grid; ylabeld(x/dt ); ode15s(Gear)仿真結(jié)果: ode113(Adams)仿真結(jié)果: ( 3)建立方框圖 ,用 RK45 仿真 50秒,顯示曲線 方框圖模型: Cnrstantl Subtraal IntE^rstcxI Cl:o Ir tE-JTH:D< “ Pj&Ju" Sfnt *o Sspe 仿真結(jié)果: 問(wèn)題3:質(zhì)量一彈簧系統(tǒng),質(zhì)量M,恢復(fù)系數(shù)K,阻力系數(shù)C,主動(dòng)力P,動(dòng) 力

11、學(xué)方程為 Mx(Cx2 Mg)sign(x) Kx PM=1kg, K=4kg/s 2, C=100kg/m, g= s2, ?二;; (1)在原點(diǎn)處用linmod線性化,求線性系統(tǒng)的A,B,C,D; (2)對(duì)線性模型,判斷能控性; (3)對(duì)線性模型,求階躍、脈沖響應(yīng)曲線; (4)對(duì)原模型進(jìn)行仿真,P=sin(t)(使用Simulink); (5)對(duì)原模型進(jìn)行仿真,P=sin(t)(使用ode23) (1)①線性化時(shí)需在模型中制定輸入端、輸出端(狀態(tài)),如下圖,狀態(tài) 選為位置和速度 ② linmod 函數(shù)應(yīng)用于該系統(tǒng)會(huì)出現(xiàn)奇異,故選用改進(jìn)的 linmod2 函數(shù) : clc

12、;clear; [A,B,C,D]=linmod2(CAD3); ss0 = ss(A, B, C, D); Co = ctrb(ss0) ; [row col] = size(A); isControllable = ~(rank(Co, eps) - row); hStep = figure(); set(hStep,NumberTitle, off, Name, Step Respons,eu nit,normalized,Position ,[,,,]); step(ss0);grid; hImpulse = figure(); set(hImpulse,Numbe

13、rTitle, off, Name, Impulse Response,unit,normalized,Position ,[,,,]); impulse(ss0);grid; 命令窗口輸出結(jié)果: A = +008 * 0 B = 0 1 C = 1 0 0 1 D = 0 0 The system is controlled 3)階躍響應(yīng): 脈沖響應(yīng) : ( 4)對(duì)原模型進(jìn)行仿真, P=sin(t) (使用 Simulink) 仿真結(jié)果: ( 5)對(duì)原模型進(jìn)行仿真, P=sin(t) (使用 ode23) 系統(tǒng)微分方程: function dx

14、= CAD3odefun(t, x) M = 1; K = 4; C = 100; g = ; miu = ; dx(1) = x(2); dx(2) = (sin(t)-K*x(1)-sign(x(2))*(C*x(2)*x(2)+miu*M*g))/M; dx = dx; 仿真入口程: clc;clear; options = odeset(RelTol,1e-3,AbsTol,[1e-5 5e-5]); [t x] = ode23(@CAD3odefun, 0::10, [0 0], options); hode23 = figure(); set(hode23,Nu

15、mberTitle, off, Name, Integrated by the ode23 solve,.r.. Units, Normalized, Position, [ ]); subplot(2, 1, 1); plot(t, x(:,1)); grid; ylabelx(); subplot(2, 1, 2); plot(t, x(:,2)); grid; ylabeld(x/dt ); 仿真結(jié)果: 問(wèn)題4:給出一個(gè)系統(tǒng),要求生成一個(gè)新Simulink模塊,實(shí)現(xiàn)其功能(1)Mask功 能(2) s-函數(shù) 答:實(shí)現(xiàn)所需功能的 S 函數(shù) function [sys,x

16、0,str,ts] = [sys,x0,str,ts]=mdlInitializeSizes; CAD01_04sfun_kernel(t,x,u,flag,ul,ur,yl,y case3, r) sys=mdlOutputs(t,x,u,ul,ur,yl,yr); switch flag, case9, case0, sys=[]; end function sys=mdlOutputs(t,x,u,ul,ur,yl,yr) function [sys,x0,str,ts]=mdlInitializeSizes if (u >= ur + yr) sizes =

17、simsizes; = 0; = 0; = 1; = 1; = 1; = 1; sys = simsizes(sizes); x0 = []; y = yr; elseif(u <= ul + yl) y = yl; elseif(u >ul + yl) && (u ur) y = u - ur; else y = 0; str = []; end ts = [0 0]; sys = y; 在Simulink中將調(diào)用S函數(shù)的模塊進(jìn)行封裝 參數(shù)傳遞及初始化 用戶界

18、面:測(cè)試結(jié)果 Q 孑翁聲廬足一金m ?4 問(wèn)題 5:已知系統(tǒng) A = [0 1;-1-2], B = [1 0; 0 1], C = [1 0; 0 1], D = [0 0; 0 0],求系 統(tǒng)的狀態(tài)空間方程(linmod),并分析系統(tǒng)的穩(wěn)定性,練習(xí)仿真參數(shù)設(shè)置 對(duì)模型進(jìn)行線性化并分析穩(wěn)定性 clear; clc; [A B C D] = linmod(CAD5) ss0 = ss(A, B, C, D); hpz = figure(); set(hpz,NumberTitle,off, Name,Pole-zero map of the linmod s

19、ystem; pzmap(ss0); sgrid; [row col] = size(A); P = lyap(A, eye(row)); for i = 1:row subdet(i) = det(P(1:i,1:i)); end subdet 系統(tǒng)零極點(diǎn)圖: 存在正實(shí)部的極點(diǎn),系統(tǒng)不穩(wěn)定。 問(wèn)題 6:系統(tǒng)的動(dòng)力學(xué)方程為 dx / dt = Ax + Bu, y = Cx + Du, A = [0 1 0 0; 0 0 1 0; 0 0 0 1; -1 -2 -3 -4], B = [1 2 ; 3 4; 2 3; 4 5], C = [1 1 2 2; 2 3 5

20、4]; D = [1 0; 0 求:1], (1) 系統(tǒng)動(dòng)態(tài)平衡點(diǎn) (2) x(0)=[1 1 1 1] ’ , ix=[1 2 3 4] ,dx=[0 1 0 1] 的系統(tǒng)動(dòng)態(tài)’ ,idx=[1 2 3 4] 平衡點(diǎn) 答:系統(tǒng)框圖模型 系統(tǒng)的平衡點(diǎn)分析 程序 clear; clc; [x, u, y, dx, options] = trim(CAD6); options(10) x0=[1 1 1 1]; ix=[1 2 3 4];dx=[0 1 0 1];idx=[1 2 3 4]; [x, u, y, dx, options] = trim(CAD01_0

21、6, x0, [], [],ix, [], [], dx, idx); options(10) 運(yùn)行結(jié)果 x=[0;0;0;0];u=[0;0];y=[0;0];ans=9 x=[;;;];u=[;];y=[;];ans=41 問(wèn)題 7:自學(xué)文件 C 與 M -s 函數(shù)模板和示例文件 答:Simulink中的示例文件實(shí)現(xiàn)了將輸入信號(hào)放大為 2倍輸出的功能,自學(xué) 時(shí)對(duì)示例程序進(jìn)行改進(jìn),使之可以指定信號(hào)放大的倍數(shù)。 語(yǔ)言 S 函數(shù)源代碼 #define S_FUNCTION_NAME CAD02_07sfun /***Modified: change the function

22、name*/ #define S_FUNCTION_LEVEL 2 #include "" static void mdlInitializeSizes(SimStruct *S) { ssSetNumSFcnParams(S, 1);/***Revised: set the number of input parameters to 1*/ if (ssGetNumSFcnParams(S) != ssGetSFcnParamsCount(S)) { return; } if (!ssSetNumInputPorts(S, 1)) return; ssSetInputPor

23、tWidth(S, 0, DYNAMICALLY_SIZED); ssSetInputPortDirectFeedThrough(S, 0, 1); if (!ssSetNumOutputPorts(S,1)) return; ssSetOutputPortWidth(S, 0, DYNAMICALLY_SIZED); ssSetNumSampleTimes(S, 1); ssSetOptions(S, SS_OPTION_EXCEPTION_FREE_CODE); } static void mdlInitializeSampleTimes(SimStruct *S) {

24、ssSetSampleTime(S, 0, INHERITED_SAMPLE_TIME); ssSetOffsetTime(S, 0, ; } static void mdlOutputs(SimStruct *S, int_Ttid) { int_T i; InputRealPtrsTypeuPtrs = ssGetInputPortRealSignalPtrs(S,0); real_T *y = ssGetOutputPortRealSignal(S,0); int_T width = ssGetOutputPortWidth(S,0); constmxArray *pm

25、xRatio = ssGetSFcnParam(S,0);/***Revised: get the pointer to the parameter in the type of mxArray*/ constreal_T *pRatio = mxGetPr(pmxRatio);/***Revised: get the pointer to the parameter in the type of real_T*/ for (i=0; i

26、atio is acquired from the input parameter*/ } } static void mdlTerminate(SimStruct *S){} #ifdef MATLAB_MEX_FILE #include "" #else #include "" #endif 封裝及用戶界面: 問(wèn)題8自學(xué)文件Stateflow示例文件 function [varargout] = stateflow( varargin ) %STATEFLOW Opens SIMULINK and calls sfnew when appropriate. % C

27、opyright 1995-2002 The MathWorks, Inc. ifnargout>0 [varargout{:}] = sf( varargin{:} ); else sf(varargin{:}); end Stateflow是有限狀態(tài)機(jī)(巾nite state machine的圖形工具,它可以用于解決 復(fù)雜的邏輯問(wèn)題,用戶可以通過(guò)圖形化工具實(shí)現(xiàn)在不同狀態(tài)之間的轉(zhuǎn)換。 StateflowM以直接嵌入到Simulink仿真模型中,并且在仿真的初始化階段, SIMULINK會(huì)把Stateflo法制的邏輯圖形通過(guò)編譯程序轉(zhuǎn)換成 C語(yǔ)言,使二者有機(jī) 地結(jié)合在一起。S

28、tateflowM以在SIMULINK Extra模塊庫(kù)中找到。 Stateflow勺仿真原理是有限狀態(tài)機(jī)(finite state machine理論,有限狀態(tài)機(jī) 是指系統(tǒng)含有可數(shù)的狀態(tài), 在相應(yīng)的狀態(tài)事件發(fā)生時(shí), 系統(tǒng)會(huì)從當(dāng)前狀態(tài)轉(zhuǎn)移到 與之對(duì)應(yīng)的狀態(tài)。 在有限狀態(tài)機(jī)中實(shí)現(xiàn)狀態(tài)的轉(zhuǎn)移是有一定條件的, 同時(shí)相互轉(zhuǎn) 換的狀態(tài)都會(huì)有狀態(tài)轉(zhuǎn)移事件,這樣就構(gòu)成了狀態(tài)轉(zhuǎn)移圖。在 SIMULINK 的仿真 窗口中, 允許用戶建立有限個(gè)狀態(tài)以及狀態(tài)轉(zhuǎn)移的條件與事件, 從而繪制出有限 狀態(tài)機(jī)系統(tǒng),這樣就可以實(shí)現(xiàn)對(duì)系統(tǒng)的仿真。StatefloW勺仿真框圖一般都會(huì)嵌入 到Simulin時(shí)真模型中,同

29、時(shí)實(shí)現(xiàn)狀態(tài)轉(zhuǎn)移的條件或是事件即可以取自 Stateflow 仿真框圖,也可以來(lái)自Simulink仿真模型。 第二部分綜合( 60) 2 . J2 HPOP 3 采用 STK 軌道機(jī)動(dòng)模塊實(shí)現(xiàn)任意兩個(gè)圓軌道間的霍曼轉(zhuǎn)移 答:利用軌道轉(zhuǎn)移模塊 Astrogator,結(jié)合軌道機(jī)動(dòng)打靶功能Target實(shí)現(xiàn)霍曼 轉(zhuǎn)移。對(duì)衛(wèi)星的Astrogator設(shè)置如下的任務(wù)控制序列(MSC} 09 May 2013 15:17:05 Satellite-Satellite1 Astrogator Mission Control Sequence Summary *** *** MCS Se

30、gment Type: InitialState Name: Initial State User Comment: -Initial State Description- Satellite State at End of Segment: UTC Gregorian Date: 1 Jun 2003 12:00:UTC Julian Date: 2452792 Julian Ephemeris Date: Time past epoch: 0 sec (Epoch in UTC Gregorian Date: 1 Jun 2003 12:00: State Vector in

31、 Coordinate System: Earth Centered Mean J2000 Parameter Set Type: Cartesian X: km Vx: km/sec Z: km Vz: km/sec Parameter Set Type: Keplerian sma: km RAAN: 0 deg ecc: w: 0 deg inc: 0 deg TA: 0 deg Parameter Set Type: Spherical Decl: 0 deg Azimuth: 90

32、 deg Other Elliptic Orbit Parameters : Ecc. Anom: 0 deg Mean Anom: 0 deg Long Peri: 0 deg Arg. Lat: 0 deg True Long: 0 deg Vert FPA: 90 deg Vel. RA: 90 deg Vel. Decl: 0 deg Time Past Periapsis: 0 sec Geodetic Parameters: Geocentric Parameters: Spacecraft Configuration: Drag Area: 1e-00

33、6 kmA2 SRP Area: 1e-006 52 Dry Mass: 500 kg Fuel Mass: 500 kg Total Mass: 1000 kg Area/Mass Ratio: 1e-009 kmA2/kg Tank Pressure: 5000 Pa Cr: Cd: *** *** MCS Segment Type: Propagate Name: Propagate User Comment: -Propagation Description- Propagator model used: Earth_Point_Mass(Simple nu

34、merical twobody) Stopping Condition Information (Gregorian Date [Julian Date]): Propagation Statistics: Number of steps: 581 Average step size: sec Largest step size: sec Smallest step size: sec Satellite State at End of Segment: UTC Gregorian Date: 2 Jun 2003 00:00:UTC Julian Date: Time pa

35、st epoch: 43200 sec (Epoch in UTC Gregorian Date: 1 Jun 2003 12:00: State Vector in Coordinate System: Earth Centered Mean J2000 Parameter Set Type: Cartesian Z: km Vz: km/sec Parameter Set Type: Keplerian ecc: w: 0 deg Parameter Set Type: Spherical

36、 Decl: 0 deg Azimuth: 90 deg Other Elliptic Orbit Parameters : Geodetic Parameters: Geocentric Parameters: Spacecraft Configuration: Drag Area: 1e-006 kmA2 SRP Area: 1e-006 52 Dry Mass: 500 kg Fuel Mass: 500 kg Total Mass: 1000 kg Area/Mass Ratio: 1e-009 kmA2/kg Cr: Cd: ***

37、*** MCS Segment Type: TargeterSequence Name: Target Sequence User Comment: -Targeter Sequence Description- Sequence Start: 2 Jun 2003 00:00: UTCG; UTC Julian Date Sequence Stop: 2 Jun 2003 00:00: UTCG; UTC Julian Date ***<<<< Start of Sequence: Target Sequence >>>>*** *** *** MCS Segment Typ

38、e: Maneuver:Impulsive Name: Impulsive Maneuver User Comment: -Impulsive Maneuver Description- Maneuver Summary: Maneuver Start: 2 Jun 2003 00:00: UTCG; UTC Julian Date Maneuver Stop: 2 Jun 2003 00:00: UTCG; UTC Julian Date Duration: 0 sec Mass Loss: 0 kg DeltaV Magnitude: 0 km/sec Maneuve

39、r Direction Specification: Thrust Vector DeltaV vector with respect to VNC axes: X (Velocity): 0 km/sec Y (Normal): 0 km/sec Z (Co-Normal): 0 km/sec Azimuth: 0 deg Elevation: 0 deg Magnitude: 0 km/sec DeltaV vector with respect to Earth_Mean_J2000 axes: X (X): 0 km/sec Y (Y): 0 km/

40、sec Z (Z): 0 km/sec Azimuth: 0 deg Elevation: 0 deg Magnitude: 0 km/sec Estimated Burn Duration: 0 sec Estimated Fuel Used: 0 kg (Decrement mass OFF) Satellite State at Beginnin

41、g of Segment: UTC Gregorian Date: 2 Jun 2003 00:00:UTC Julian Date: Time past epoch: 43200 sec (Epoch in UTC Gregorian Date: 1 Jun 2003 12:00: State Vector in Coordinate System: Earth Centered Mean J2000 Parameter Set Type: Cartesian Z: km Vz: km/sec Parameter Set Type: Keplerian Decl: 0 de

42、g Azimuth: Parameter Set Type: Spherical Decl: 0 deg 90 deg Azimuth: Other Elliptic Orbit Parameters : Mean Mot.:deg/sec Geodetic Parameters: Geocentric Parameters: Spacecraft Configuration: Drag Area: 1e-006 kmA2 SRP Area: 1e-006 52 Dry Mass: 500 kg Fuel Mas

43、s: 500 kg Total Mass: 1000 kg Area/Mass Ratio: 1e-009 kmA2/kg Cr: Cd: User-selected results: Satellite State at End of Segment: UTC Gregorian Date: 2 Jun 2003 00:00:UTC Julian Date: Time past epoch: 43200 sec (Epoch in UTC Gregorian Date: 1 Jun 2003 12:00: State Vector in Coordinate System:

44、 Earth Centered Mean J2000 Parameter Set Type: Cartesian Z: km Vz: km/sec Parameter Set Type: Keplerian 0 deg ecc: w: 0 deg 90 deg Other Elliptic Orbit Parameters : Mean Sidereal Greenwich Hour Angle: Geodetic Parameters: Geocentric Parameters: Spacecraft Configuration: Drag Area: 1e-006

45、 kmA2 SRP Area: 1e-006 52 Dry Mass: 500 kg Fuel Mass: 500 kg Total Mass: 1000 kg Area/Mass Ratio: 1e-009 kmA2/kg Pa Tank Pressure: 5000 Cr: Cd: User-selected results: Radius Of Apoapsis ***<<<< End of Sequence: Target Sequence >>>>*** Satellite State at End of Segment: UTC Gregorian Da

46、te: 2 Jun 2003 00:00:UTC Julian Date: Time past epoch: 43200 sec (Epoch in UTC Gregorian Date: 1 Jun 2003 12:00: State Vector in Coordinate System: Earth Centered Mean J2000 Parameter Set Type: Cartesian Z: km Vz: km/sec Parameter Set Type: Keplerian ecc: w: 0 deg inc: 0 deg

47、deg 90 deg Other Elliptic Orbit Parameters : Geodetic Parameters: Geocentric Parameters: Spacecraft Configuration: Drag Area: 1e-006 kmA2 SRP Area: 1e-006 52 Dry Mass: 500 kg Fuel Mass: 500 kg Total Mass: 1000 kg Area/Mass Ratio: 1e-009 kmA2/kg Tank Pressure: 5000 Pa Cr: Cd: *** ***

48、 MCS Segment Type: Propagate Name: Propagate User Comment: -Propagation Description Propagator model used: Earth_Full_RKF (Numerical including all perturbations using RKF integrator) Stopping Condition Information (Gregorian Date [Julian Date]): Propagation Statistics: Number of steps: 72

49、7 Average step size: sec Largest step size: sec Smallest step size: sec Satellite State at End of Segment: UTC Gregorian Date: 2 Jun 2003 12:00:UTC Julian Date: 2452793 Julian Ephemeris Date: Time past epoch: 86400 sec (Epoch in UTC Gregorian Date: 1 Jun 2003 12:00: State Vector in Coordinat

50、e System: Earth Centered Mean J2000 Parameter Set Type: Cartesian Parameter Set Type: Keplerian eccdeg inc Parameter Set Type: Spherical Other Elliptic Orbit Parameters : Geodetic Parameters: Geocentric Parameters: Spacecraft Configuration: Drag Area: 1e-006 kmA2 SRP Area: 1e-006 52 Dry M

51、ass: 500 kg Fuel Mass: 500 kg Total Mass: 1000 kg Area/Mass Ratio: 1e-009 kmA2/kg Tank Pressure: 5000 Pa Cr: Cd: User-selected results: *** *** MCS Segment Type: TargeterSequence Name: Target Sequence User Comment: -Targeter Sequence Description Sequence Start: 2 Jun 2003 12:00: UTCG;24

52、52793 UTC Julian Date Sequence Stop: 2 Jun 2003 12:00: UTCG; 2452793 UTC Julian Date ***<<<< Start of Sequence: Target Sequence >>>>*** *** *** MCS Segment Type: Maneuver:Impulsive Name: Impulsive Maneuver User Comment: -Impulsive Maneuver Description- Maneuver Summary: Maneuver Start: 2 J

53、un 2003 12:00: UTCG; 2452793 UTC Julian Date Maneuver Stop: 2 Jun 2003 12:00: UTCG; 2452793 UTC Julian Date Duration: 0 sec Mass Loss: 0 kg DeltaV Magnitude: 0 km/sec Maneuver Direction Specification: Thrust Vector DeltaV vector with respect to VNC axes: X (Velocity): 0 km/sec Y (Normal): 0

54、 km/sec Z (Co-Normal): 0 km/sec Azimuth: 0 deg Elevation: 0 deg 0 km/sec Magnitude: DeltaV vector with respect to Earth_Mean_J2000 axes: X (X): 0 km/sec Y (Y): 0 km/sec

55、 Z (Z): 0 km/sec Azimuth: 0 deg Elevation: 0 deg Magnitude: 0 km/sec Estimated Burn Duration: 0 sec Estimated Fuel Used: 0 kg (Decrement mass OFF) Satellite State at Beginning of Segment: UTC Gregorian Date: 2 Jun 2003 12:00:UTC Julian Date: 2452793 Julian Ephemeris Date: Ti

56、me past epoch: 86400 sec (Epoch in UTC Gregorian Date: 1 Jun 2003 12:00: State Vector in Coordinate System: Earth Centered Mean J2000 Parameter Set Type: Cartesian Parameter Set Type: Keplerian Parameter Set Type: Spherical Other Elliptic Orbit Parameters : Mean Sidereal Greenwich Hour Angle:

57、 Geodetic Parameters: Geocentric Parameters: deg Spacecraft Configuration: Drag Area: 1e-006 kmA2 SRP Area: 1e-006 52 Dry Mass: 500 kg Fuel Mass: 500 kg Total Mass: 1000 kg Area/Mass Ratio: 1e-009 kmA2/kg Pa Tank Pressure: 5000 Cr: Cd: User-selected results: Radius Of Satellite State

58、 at End of Segment: UTC Gregorian Date: 2 Jun 2003 12:00:UTC Julian Date: 2452793 Julian Ephemeris Date: Time past epoch: 86400 sec (Epoch in UTC Gregorian Date: 1 Jun 2003 12:00: State Vector in Coordinate System: Earth Centered Mean J2000 Parameter Set Type: Cartesian Parameter Set Type: Kep

59、lerian Parameter Set Type: Spherical deg Other Elliptic Orbit Parameters : sec Geodetic Parameters: Geocentric Parameters: deg Spacecraft Configuration: Drag Area: 1e-006 kmA2 SRP Area: 1e-006 52 Dry Mass: 500 kg Fuel Mass: 500 kg Total Mass: 1000 kg Area/Mass Ratio: 1e-009 kmA2/kg Pa

60、Tank Pressure: 5000 Cr: Cd: User-selected results: ***<<<< End of Sequence: Target Sequence >>>>*** Satellite State at End of Segment: UTC Gregorian Date: 2 Jun 2003 12:00:UTC Julian Date: 2452793 Julian Ephemeris Date: Time past epoch: 86400 sec (Epoch in UTC Gregorian Date: 1 Jun 2003 12:0

61、0: State Vector in Coordinate System: Earth Centered Mean J2000 Parameter Set Type: Cartesian Parameter Set Type: Keplerian Parameter Set Type: Spherical Decldegdeg Other Elliptic Orbit Parameters : Mean Mot.:deg/sec Geodetic Parameters: Geocentric Parameters: Spacecraft Configuration: Dr

62、ag Area: 1e-006 kmA2 SRP Area: 1e-006 52 Dry Mass: 500 kg Fuel Mass: 500 kg Total Mass: 1000 kg Area/Mass Ratio: 1e-009 kmA2/kg Tank Pressure: 5000 Pa Cr: Cd: *** *** MCS Segment Type: Propagate Name: Propagate User Comment: -Propagation Description Propagator model used: Earth_Full_RK

63、F (Numerical including all perturbations using RKF integrator) Stopping Condition Information (Gregorian Date [Julian Date]): Propagation Statistics: Number of steps: 726 Average step size: sec Largest step size: sec Smallest step size: sec Satellite State at End of Segment: UTC Gregorian D

64、ate: 3 Jun 2003 00:00:UTC Julian Date: Time past epoch: 129600 sec (Epoch in UTC Gregorian Date: 1 Jun 2003 12:00: State Vector in Coordinate System: Earth Centered Mean J2000 Parameter Set Type: Cartesian Parameter Set Type: Keplerian sma Parameter Set Type: Spherical Other Elliptic Orbi

65、t Parameters : Ecc. Mean Mot.:deg/sec Geodetic Parameters: Geocentric Parameters: Spacecraft Configuration: Drag Area: 1e-006 kmA2 SRP Area: 1e-006 52 Dry Mass: 500 kg Fuel Mass: 500 kg Total Mass: 1000 kg Area/Mass Ratio: 1e-009 kmA2/kg Tank Pressure: 5000 Pa Cr: Cd: (二)課題應(yīng)用 結(jié)合自

66、己的課題 (可以假想課題, 不要說(shuō)還沒(méi)有進(jìn)入課題或不需要仿真而不 做,否則本部分沒(méi)有成績(jī)?。?,論述課題中: 需求分析,分析需要的仿真工作,解決什么問(wèn)題。 使用或準(zhǔn)備使用那些仿真軟件(如 C/ Fortran/ Pascal/ Basic/ MATLAB/ SIMULINK /STATEFLOW/ RTW/ MATRIXx/ STK …或其它的仿真軟件)和硬件 (如單軸氣浮臺(tái)、三軸氣浮臺(tái)、伺服轉(zhuǎn)臺(tái)、目標(biāo)模擬器、傳感器(敏感器)、計(jì) 算機(jī)、動(dòng)作裝置(執(zhí)行機(jī)構(gòu))等);如何使用這些軟件和硬件,它們?cè)谀愕姆抡? 里作用是什么 描述問(wèn)題,有哪些已知條件,仿真輸出那些參數(shù) 給出解決問(wèn)題步驟、方案和流程圖,畫出仿真系統(tǒng)的原理框圖 給出初步的仿真結(jié)果(如果有的話)和結(jié)論。 Lambert問(wèn)題描述: 在Lambert問(wèn)題中:若給定飛行器運(yùn)行的始

展開(kāi)閱讀全文
溫馨提示:
1: 本站所有資源如無(wú)特殊說(shuō)明,都需要本地電腦安裝OFFICE2007和PDF閱讀器。圖紙軟件為CAD,CAXA,PROE,UG,SolidWorks等.壓縮文件請(qǐng)下載最新的WinRAR軟件解壓。
2: 本站的文檔不包含任何第三方提供的附件圖紙等,如果需要附件,請(qǐng)聯(lián)系上傳者。文件的所有權(quán)益歸上傳用戶所有。
3.本站RAR壓縮包中若帶圖紙,網(wǎng)頁(yè)內(nèi)容里面會(huì)有圖紙預(yù)覽,若沒(méi)有圖紙預(yù)覽就沒(méi)有圖紙。
4. 未經(jīng)權(quán)益所有人同意不得將文件中的內(nèi)容挪作商業(yè)或盈利用途。
5. 裝配圖網(wǎng)僅提供信息存儲(chǔ)空間,僅對(duì)用戶上傳內(nèi)容的表現(xiàn)方式做保護(hù)處理,對(duì)用戶上傳分享的文檔內(nèi)容本身不做任何修改或編輯,并不能對(duì)任何下載內(nèi)容負(fù)責(zé)。
6. 下載文件中如有侵權(quán)或不適當(dāng)內(nèi)容,請(qǐng)與我們聯(lián)系,我們立即糾正。
7. 本站不保證下載資源的準(zhǔn)確性、安全性和完整性, 同時(shí)也不承擔(dān)用戶因使用這些下載資源對(duì)自己和他人造成任何形式的傷害或損失。

相關(guān)資源

更多
正為您匹配相似的精品文檔

相關(guān)搜索

關(guān)于我們 - 網(wǎng)站聲明 - 網(wǎng)站地圖 - 資源地圖 - 友情鏈接 - 網(wǎng)站客服 - 聯(lián)系我們

copyright@ 2023-2025  zhuangpeitu.com 裝配圖網(wǎng)版權(quán)所有   聯(lián)系電話:18123376007

備案號(hào):ICP2024067431號(hào)-1 川公網(wǎng)安備51140202000466號(hào)


本站為文檔C2C交易模式,即用戶上傳的文檔直接被用戶下載,本站只是中間服務(wù)平臺(tái),本站所有文檔下載所得的收益歸上傳人(含作者)所有。裝配圖網(wǎng)僅提供信息存儲(chǔ)空間,僅對(duì)用戶上傳內(nèi)容的表現(xiàn)方式做保護(hù)處理,對(duì)上載內(nèi)容本身不做任何修改或編輯。若文檔所含內(nèi)容侵犯了您的版權(quán)或隱私,請(qǐng)立即通知裝配圖網(wǎng),我們立即給予刪除!