1. Trang chủ
  2. » Giáo Dục - Đào Tạo

(Luận văn thạc sĩ) phân tích kết cấu tấm phân lớp chức năng (FGM) chịu tải trọng cơ nhiệt bằng phân tử CS MITC3+

119 11 0

Đang tải... (xem toàn văn)

Tài liệu hạn chế xem trước, để xem đầy đủ mời bạn chọn Tải xuống

THÔNG TIN TÀI LIỆU

BỘ GIÁO DỤC VÀ ĐÀO TẠO TRƯỜNG ĐẠI HỌC SƯ PHẠM KỸ THUẬT THÀNH PHỐ HỒ CHÍ MINH LUẬN VĂN THẠC SĨ LA TUẤN MINH PHÂN TÍCH KẾT CẤU TẤM PHÂN LỚP CHỨC NĂNG (FGM) CHỊU TẢI TRỌNG CƠ NHIỆT BẰNG PHẦN TỬ CS-MITC3+ NGÀNH: KỸ THUẬT XÂY DỰNG CÔNG TRÌNH DÂN DỤNG VÀ CƠNG NGHIỆP - 60580208 SKC005834 Tp Hồ Chí Minh, tháng 7/2018 BỘ GIÁO DỤC VÀ ĐÀO TẠO TRƢỜNG ĐẠI HỌC SƢ PHẠM KỸ THUẬT THÀNH PHỐ HỒ CHÍ MINH LUẬN VĂN THẠC SĨ LA TUẤN MINH PHÂN TÍCH KẾT CẤU TẤM PHÂN LỚP CHỨC NĂNG (FGM) CHỊU TẢI TRỌNG CƠ NHIỆT BẰNG PHẦN TỬ CS-MITC3+ NGÀNH: KỸ THUẬT XÂY DỰNG CƠNG TRÌNH DD VÀ CN - 60580208 Tp Hồ Chí Minh, tháng 7/2018 BỘ GIÁO DỤC VÀ ĐÀO TẠO TRƢỜNG ĐẠI HỌC SƢ PHẠM KỸ THUẬT THÀNH PHỐ HỒ CHÍ MINH LUẬN VĂN THẠC SĨ LA TUẤN MINH PHÂN TÍCH KẾT CẤU TẤM PHÂN LỚP CHỨC NĂNG (FGM) CHỊU TẢI TRỌNG CƠ NHIỆT BẰNG PHẦN TỬ CS-MITC3+ NGÀNH: KỸ THUẬT XÂY DỰNG CƠNG TRÌNH DD VÀ CN - 60580208 Hƣớng dẫn khoa học: TS CHÂU ĐÌNH THÀNH Tp Hồ Chí Minh, tháng 7/2018 BỘ GIÁO DỤC VÀ ĐÀO TẠO TRƢỜNG ĐẠI HỌC SƢ PHẠM KỸ THUẬT THÀNH PHỐ HỒ CHÍ MINH LUẬN VĂN THẠC SĨ LA TUẤN MINH PHÂN TÍCH KẾT CẤU TẤM PHÂN LỚP CHỨC NĂNG (FGM) CHỊU TẢI TRỌNG CƠ NHIỆT BẰNG PHẦN TỬ CS-MITC3+ NGÀNH: KỸ THUẬT XÂY DỰNG CƠNG TRÌNH DD VÀ CN - 60580208 Hƣớng dẫn khoa học: TS CHÂU ĐÌNH THÀNH Tp Hồ Chí Minh, tháng 7/2018 Scanned with CamScanner Scanned with CamScanner Scanned with CamScanner Scanned with CamScanner Scanned with CamScanner Scanned with CamScanner % -displ=kk\ff; num=1:1:sdof; displace=[num' displ]; % print nodal displacements disp('Maximum displacement') cen_node= (nnode+1)/2; % central node of the squared plate w_mx= displ((cen_node-1)*ndof+3) % maximum displacement at the centre str= sprintf('Normalized displ at centre (100wcEct^3/(12(1-nu^2)q0L^4)): %.4f\n',100*w_mx*Ec*t^3/((12*(1-nu^2)*q0*L^4))); disp(str) % -% post-processing % -% compute strain at nodes of elements ndpt=[0 0; 0; 1]; % nodal coordinates in the natural domain memb_ndel= zeros(3,size(ndpt,1),nel); cur1_ndel= zeros(3,size(ndpt,1),nel); cur2_ndel= zeros(3,size(ndpt,1),nel); she1_ndel= zeros(2,size(ndpt,1),nel); she2_ndel= zeros(2,size(ndpt,1),nel); for iel=1:nel nd= nodes(iel,:); % extract connected node for (iel)-th element ecoord= gcoord(nd,:); % extract x, y value of the node index= feeldof(nd,nnel,ndof); % extract system dofs for the element edisp= displ(index); % extract displacements associated with (iel)-th element % interpolate displacements at node for i=1:ndof idx= nnel*ndof + i; edisp(idx,1)= mean(edisp([i,i+ndof,i+2*ndof])); end edisp(24,:)= []; % remove w4 [kinmtsm,kinmtsb1,kinmtsb2]= fekine_smb_CSMITC3Plus_HSDT7(ecoord,t); 64 for ig=1:size(ndpt,1) memb_ndel(:,ig,iel)= kinmtsm*edisp; % compute membrane strains cur1_ndel(:,ig,iel)= kinmtsb1*edisp; % compute curvature strain cur2_ndel(:,ig,iel)= kinmtsb2*edisp; % compute curvature strain [shape,dNdrds]= lagrange_basis('T3',ndpt(ig,:),2); % compute shape func jacob2= dNdrds'*ecoord; % compute Jacobian [shapeF,dFdrds]= lagrange_basis('T4Mini2',ndpt(ig,:),2); % compute shape func kinmtss1= fekine_ss1_MITC3Plus_HSDT7(t,ecoord,gpt(ig,:),dNdrds,shapeF,dFdrds,jacob2); she1_ndel(:,ig,iel)= kinmtss1*edisp; % compute shear strain kinmtss2= fekine_ss2_MITC3Plus_HSDT7(shapeF); kinmtss2= (-4/t^2)*kinmtss2; she2_ndel(:,ig,iel)= kinmtss2*edisp; % compute shear strain end end % average strain at nodes memb_node= zeros(3,nnode); cur1_node= zeros(3,nnode); cur2_node= zeros(3,nnode); she1_node= zeros(2,nnode); she2_node= zeros(2,nnode); for inode=1:nnode count=0; for iel=1:nel [flag,idx]= ismember(inode,nodes(iel,:)); if flag count= count + 1; memb_node(:,inode)= memb_node(:,inode) + memb_ndel(:,idx,iel); cur1_node(:,inode)= cur1_node(:,inode) + cur1_ndel(:,idx,iel); cur2_node(:,inode)= cur2_node(:,inode) + cur2_ndel(:,idx,iel); she1_node(:,inode)= she1_node(:,inode) + she1_ndel(:,idx,iel); 65 she2_node(:,inode)= she2_node(:,inode) + she2_ndel(:,idx,iel); end end memb_node(:,inode)= memb_node(:,inode)/count; cur1_node(:,inode)= cur1_node(:,inode)/count; cur2_node(:,inode)= cur2_node(:,inode)/count; she1_node(:,inode)= she1_node(:,inode)/count; she2_node(:,inode)= she2_node(:,inode)/count; end % compute stress along z-direction numdiv= 32; % number of divisions % central node (a/2,a/2) [sig_cen,ga_cen]= calStressThrgThk_HSDT_FGM(cen_node,numdiv,t,Ec,Em,n,nu, memb_node,cur1_node,cur2_node,she1_node,she2_node); sig_cen_bar= -sig_cen*t^2/q0/L^2; sigX_cen_bar= sig_cen_bar(1,:)' % plot distribution of stress along the thickness zk= []; for i= 1:numdiv+1 if i==1 z_tmp= -t/2; else z_tmp= z_tmp + t/numdiv; end zk= [zk z_tmp]; end zk'/t figure(2) plot(sig_cen_bar(1,:),zk/t,'-k*') % sig_xx title('Normalized sigma_{xx} at (a/2,a/2)') 66 Bài tốn vng Al/ZrO2-1 tựa đơn chịu tải trọng nhiệt clear; clc; close all; format short; % % geometric data % - L= 0.2; ratio= 0.01/0.2 %0.1 %0.05 thk= ratio*L; % % Functionally grade materials data % - Ec= 151; % ceramic ZrO2-2 Em= 70; % Aluminum nu=0.3; tc= 500; %0, 100, 200, 300, 400, 500 tm= 20; kc= 2.09; % thermal conductivity ceramic ZrO2-1=2.09 km= 204; % thermal conductivity metal Al=204 alc= 10e-6; % thermal expansion ceramic ZrO2-1= 10e6 alm= 23e-6; % thermal expansion metal Al= 23e-6 syms z; % thickness coordinate, varies from -t/2 to t/2 n= % n is the power law index 0, 0.5, E1=((Ec-Em)*(0.5+z/thk)^n+Em); Ez1=((EcEm)*(0.5+z/thk)^n+Em)*z; Ez2=((EcEm)*(0.5+z/thk)^n+Em)*z^2; Ez3=((EcEm)*(0.5+z/thk)^n+Em)*z^3; Ez4=((EcEm)*(0.5+z/thk)^n+Em)*z^4; Ez6=((EcEm)*(0.5+z/thk)^n+Em)*z^6; % % meshing data % elemType= 'T3'; nnel= 3; % TRI number of nodes per element ndof= 7; % 7dof-COMPOSITE PLATE number of dofs per node 67 numx= 12; % number of elements in the x-direction (beam length) numy= 12; % number of elements in the y-direction (beam length) nnx=numx+1; % number of nodes in the x-direction nny=numy+1; % number of nodes in the y-direction gcoord=square_node_array([0 0],[L 0],[L L],[0 L],nnx,nny); % nodal coordinates node_pattern1=[ nnx+2 ]; node_pattern2=[ nnx+2 nnx+1 ]; inc_u=1; inc_v=nnx; nodes=[make_elem(node_pattern1,numx,numy,inc_u,inc_v); make_elem(node_pattern2,numx,numy,inc_u,inc_v) ]; % nodal elements % number of elements nel= size(nodes,1); % total number of nodes in system nnode= size(gcoord,1); % total system dofs sdof=nnode*ndof; % degrees of freedom per element edof=nnel*ndof; % plot the mesh plotMesh= 0; if ( plotMesh ) % if plotMesh==1 we will plot the mesh plot_mesh(gcoord,nodes,elemType,'b-'); end % -% boundary conditions % bcdof=[]; bcval=[]; % lower x-axis (y=0) is simple support: u= w= thty= phiy= for i=1:nnx ind=ndof*(i-1); bcdof=[bcdof ind+1 ind+3 ind+5 ind+7]; end % upper x-axis (y=L) is simple support: u= w= thty= phiy= for i=1:nnx 68 ind=ndof*(nnx*(nny-1) + i - 1); bcdof=[bcdof ind+1 ind+3 ind+5 ind+7]; end % left y-axis (x=0) is simple support: v= w= thtx= phix= for i=1:nny ind=ndof*(i-1)*nnx; bcdof=[bcdof ind+2 ind+3 ind+4 ind+6]; end % right y-axis (x=L) is simple support: v= w= thtx= phix= for i=1:nny ind=ndof*(i*nnx-1); bcdof=[bcdof ind+2 ind+3 ind+4 ind+6]; end bcdof=unique(bcdof); bcval=zeros(size(bcdof)); % -% force vector % -ff=zeros(sdof,1); % initialize system force vector % % computation of element matrices and vectors and their assembly % - nu1=[1/(1-nu^2) 1*nu/(1-nu^2) 0; 1*nu/(1-nu^2) 1/(1-nu^2) 0; 0 1*(1-nu)/(2*(1-nu^2))]; nu2=[1/(2*(1+nu)) 0; 1/(2*(1+nu))]; [AA,BB,DD,EE,FF,HH,As,Bs,Ds]= matmtFGMHSDT7(nu1,nu2,E1,Ez1,Ez2,Ez3,Ez4,Ez6,thk); Cs= [As Bs; Bs Ds]; % temparature load al= ((alc-alm)*(0.5+z/thk)^n+alm); % thermal expansion at z Tz= Tzz(tm,tc,km,kc,z,thk,n,50); % temparature at z Del_T= Tz - tm; N_th= eval(int(nu1*E1*al*Del_T,z,-thk/2,thk/2))*[1 0]'; M_th= eval(int(nu1*Ez1*al*Del_T,z,-thk/2,thk/2))*[1 0]'; P_th= eval(int(nu1*Ez3*al*Del_T,z,-thk/2,thk/2))*[1 0]'; 69 % % computation of element matrices and vectors and their assembly % [weight,gpt]= quadrature(2,'TRIANGULAR',2); % sampling points % system matrix kk=zeros(sdof,sdof); % initialize system force vector ff=zeros(sdof,1); for % loop for the total number of elements iel=1:nel nd= nodes(iel,:); % extract connected node for (iel)-th element ecoord= gcoord(nd,:); % extract x, y value of the node % compute thermal loads % Ae= cal_area(ecoord(:,1),ecoord(:,2)); a= ecoord(2,1) - ecoord(1,1); % a= x2 - x1 b= ecoord(2,2) - ecoord(1,2); % b= y2 - y1 c= ecoord(3,2) - ecoord(1,2); % c= y3 - y1 d= ecoord(3,1) - ecoord(1,1); % d= x3 - x1 % kinematic matrix for membrane kinmtm= [ b-c 0 d-a 0 0 0 -d 0 0 0 a 0 0 0; fe_Nth= kinmtm'*N_th*Ae; % thermal loads % kinematic matrix for bending kinmtb1= [ 0 0 0 -d+a 0 0 -b+c d-a 0 0 -c -d 0 0 fe_Mth= kinmtb1'*M_th*Ae; % thermal load kinmtb2= -4/3/thk^2*[ 0 0 fe_Pth= kinmtb2'*P_th*Ae; % thermal load 70 % compute stiffness matrices % % cell-based smooth for membrane and bending stiffness matrices kmb_tmp=festif_smb_CSMITC3Plus_HSDT7(ecoord,thk,AA,BB,DD,EE,FF,HH); % shearing stiffness matrix ks_tmp = zeros(27,27); % initialization of element matrix to zero for ig=1:size(weight) [shape,dNdrds]= lagrange_basis('T3',gpt(ig,:),2); % compute shape func jacob2= dNdrds'*ecoord; % compute Jacobian detjacob= det(jacob2); % determinant of Jacobian [shapeF,dFdrds]= lagrange_basis('T4Mini2',gpt(ig,:),2); % compute shape func kinmtss1= fekine_ss1_MITC3Plus_HSDT7(thk,ecoord,gpt(ig,:),dNdrds,shapeF,dFdrds,jacob2); kinmtss2= (-4/thk^2)*fekine_ss2_MITC3Plus_HSDT7(shapeF); kinmtss= [kinmtss1; kinmtss2]; ks_tmp = ks_tmp + kinmtss'*Cs*kinmtss*weight(ig)*detjacob; end index= feeldof(nd,nnel,ndof); % extract system dofs associated with element % assemble element stiffness matrices into global matrix k_tmp= kmb_tmp + ks_tmp; k= staticCondenseKe_MITC3Plus_HSDT7(k_tmp); kk= feasmbl1(kk,k,index); % assemble element matrices % assemble thermal load into global load fe_th= fe_Nth + fe_Mth + fe_Pth; ff(index)= ff(index) + fe_th; end 71 % % apply boundary conditions % [kk,ff]=feaplyc2(kk,ff,bcdof,bcval); % -% solve the matrix equation % -displ=kk\ff; num=1:1:sdof; displace=[num' displ]; % print nodal displacements disp('Maximum displacement') cen_node= (nnode+1)/2; % central node of the squared plate w_mx= displ((cen_node-1)*ndof+3) % maximum displacement at the centre str= sprintf('Normalized displ at centre (wc/t): %.4f\n',w_mx/thk); disp(str) Bài tốn vng Al/ZrO2-1 tựa đơn chịu tải trọng nhiệt clear; clc; close all; format short; % % geometric data % - L= 0.2; ratio= 0.01/0.2 %0.1 %0.05 t= ratio*L; % % Functionally grade materials data % - Ec= 151; % ceramic ZrO2-2 Em= 70; % Aluminum nu=0.3; tc= 300; tm= 20; kc= 2.09; % thermal conductivity ceramic ZrO2-1=2.09 72 km= 204; % thermal conductivity metal Al=204 alc= 10e-6; % thermal expansion ceramic ZrO2-1= 10e6 alm= 23e-6; % thermal expansion metal Al= 23e-6 syms z; % thickness coordinate, varies from -t/2 to t/2 n= % n is the power law index 0, 0.5, E1=((Ec-Em)*(0.5+z/t)^n+Em); Ez1=((EcEm)*(0.5+z/t)^n+Em)*z; Ez2=((EcEm)*(0.5+z/t)^n+Em)*z^2; Ez3=((EcEm)*(0.5+z/t)^n+Em)*z^3; Ez4=((EcEm)*(0.5+z/t)^n+Em)*z^4; Ez6=((EcEm)*(0.5+z/t)^n+Em)*z^6; % % meshing data % elemType= 'T3'; nnel= 3; % TRI number of nodes per element ndof= 7; % 7dof-COMPOSITE PLATE number of dofs per node numx= 12; % number of elements in the x-direction (beam length) numy= 12; % number of elements in the y-direction (beam length) nnx=numx+1; % number of nodes in the x-direction nny=numy+1; % number of nodes in the y-direction gcoord=square_node_array([0 0],[L 0],[L L],[0 L],nnx,nny); % nodal coordinates node_pattern1=[ nnx+2 ]; node_pattern2=[ nnx+2 nnx+1 ]; inc_u=1; inc_v=nnx; nodes=[make_elem(node_pattern1,numx,numy,inc_u,inc_v); make_elem(node_pattern2,numx,numy,inc_u,inc_v) ]; % nodal elements nel= size(nodes,1); nnode= size(gcoord,1); sdof=nnode*ndof; % number of elements % total number of nodes in system % total system dofs 73 edof=nnel*ndof; % degrees of freedom per element % plot the mesh plotMesh= 0; if ( plotMesh ) % if plotMesh==1 we will plot the mesh plot_mesh(gcoord,nodes,elemType,'b-'); end % -% boundary conditions % bcdof=[]; bcval=[]; % lower x-axis (y=0) is simple support: u= w= thty= phiy= for i=1:nnx ind=ndof*(i-1); bcdof=[bcdof ind+1 ind+3 ind+5 ind+7]; end % upper x-axis (y=L) is simple support: u= w= thty= phiy= for i=1:nnx ind=ndof*(nnx*(nny-1) + i - 1); bcdof=[bcdof ind+1 ind+3 ind+5 ind+7]; end % left y-axis (x=0) is simple support: v= w= thtx= phix= for i=1:nny ind=ndof*(i-1)*nnx; bcdof=[bcdof ind+2 ind+3 ind+4 ind+6]; end % right y-axis (x=L) is simple support: v= w= thtx= phix= for i=1:nny ind=ndof*(i*nnx-1); bcdof=[bcdof ind+2 ind+3 ind+4 ind+6]; end bcdof=unique(bcdof); bcval=zeros(size(bcdof)); % -% force vector % -ff=zeros(sdof,1); % initialize system force vector q0= -2*Em*t^4/L^4; %0, -2, -4, -6, -8, -10, -12, -14; % distributed load 74 [ff]= N_ff_Uniload_PlateHSDT_7dof('T3',gcoord,nodes,q0); % % computation of element matrices and vectors and their assembly % - nu1=[1/(1-nu^2) 1*nu/(1-nu^2) 0; 1*nu/(1-nu^2) 1/(1-nu^2) 0; 0 1*(1-nu)/(2*(1-nu^2))]; nu2=[1/(2*(1+nu)) 0; 1/(2*(1+nu))]; [AA,BB,DD,EE,FF,HH,As,Bs,Ds]= matmtFGMHSDT7(nu1,nu2,E1,Ez1,Ez2,Ez3,Ez4,Ez6,t); Cs= [As Bs; Bs Ds]; % temparature load al= ((alc-alm)*(0.5+z/t)^n+alm); % thermal expansion at z Tz= Tzz(tm,tc,km,kc,z,t,n,50); % temparature at z Del_T= Tz - tm; N_th= eval(int(nu1*E1*al*Del_T,z,-t/2,t/2))*[1 0]'; M_th= eval(int(nu1*Ez1*al*Del_T,z,-t/2,t/2))*[1 0]'; P_th= eval(int(nu1*Ez3*al*Del_T,z,-t/2,t/2))*[1 0]'; % % computation of element matrices and vectors and their assembly % [weight,gpt]= quadrature(2,'TRIANGULAR',2); % sampling points kk=zeros(sdof,sdof); for iel=1:nel % system matrix % loop for the total number of elements nd= nodes(iel,:); % extract connected node for (iel)-th element ecoord= gcoord(nd,:); % extract x, y value of the node % compute thermal loads % Ae= cal_area(ecoord(:,1),ecoord(:,2)); a= ecoord(2,1) - ecoord(1,1); % a= x2 - x1 b= ecoord(2,2) - ecoord(1,2); % b= y2 - y1 c= ecoord(3,2) - ecoord(1,2); % c= y3 - y1 75 d= ecoord(3,1) - ecoord(1,1); % d= x3 - x1 % kinematic matrix for membrane kinmtm= [ b-c 0 d-a 0 0 0 -d 0 0 0 a 0 0 0; fe_Nth= kinmtm'*N_th*Ae; % thermal loads % kinematic matrix for bending kinmtb1= [ 0 0 0 -d+a 0 0 -b+c d-a 0 0 -c -d 0 0 fe_Mth= kinmtb1'*M_th*Ae; % thermal load kinmtb2= -4/3/t^2*[ 0 0 fe_Pth= kinmtb2'*P_th*Ae; % thermal load % compute stiffness matrices % % cell-based smooth for membrane and bending stiffness matrices kmb_tmp=festif_smb_CSMITC3Plus_HSDT7(ecoord,t,AA,BB,DD,EE,FF,HH); % shearing stiffness matrix ks_tmp = zeros(27,27); % initialization of element matrix to zero for ig=1:size(weight) [shape,dNdrds]= lagrange_basis('T3',gpt(ig,:),2); % compute shape func jacob2= dNdrds'*ecoord; % compute Jacobian detjacob= det(jacob2); % determinant of Jacobian [shapeF,dFdrds]= lagrange_basis('T4Mini2',gpt(ig,:),2); % compute shape func kinmtss1= fekine_ss1_MITC3Plus_HSDT7(t,ecoord,gpt(ig,:),dNdrds,shapeF,dFdrds,jacob2); kinmtss2= (-4/t^2)*fekine_ss2_MITC3Plus_HSDT7(shapeF); 76 kinmtss= [kinmtss1; kinmtss2]; ks_tmp = ks_tmp + kinmtss'*Cs*kinmtss*weight(ig)*detjacob; end index= feeldof(nd,nnel,ndof); % extract system dofs associated with element % assemble element stiffness matrices into global matrix k_tmp= kmb_tmp + ks_tmp; k= staticCondenseKe_MITC3Plus_HSDT7(k_tmp); kk= feasmbl1(kk,k,index); % assemble element matrices % assemble thermal load into global load fe_th= fe_Nth + fe_Mth + fe_Pth; index= feeldof(nd,length(nd),ndof); % extract system dofs associated with element ff(index)= ff(index) + fe_th; end % % apply boundary conditions % [kk,ff]=feaplyc2(kk,ff,bcdof,bcval); % -% solve the matrix equation % -displ=kk\ff; num=1:1:sdof; displace=[num' displ]; % print nodal displacements disp('Maximum displacement') cen_node= (nnode+1)/2; % central node of the squared plate w_mx= displ((cen_node-1)*ndof+3) % maximum displacement at the centre str= sprintf('Normalized displ at centre (wc/t): %.4f\n',w_mx/t); disp(str) 77 ... THÀNH PHỐ HỒ CHÍ MINH LUẬN VĂN THẠC SĨ LA TUẤN MINH PHÂN TÍCH KẾT CẤU TẤM PHÂN LỚP CHỨC NĂNG (FGM) CHỊU TẢI TRỌNG CƠ NHIỆT BẰNG PHẦN TỬ CS- MITC3+ NGÀNH: KỸ THUẬT XÂY DỰNG CƠNG TRÌNH DD VÀ CN - 60580208... THÀNH PHỐ HỒ CHÍ MINH LUẬN VĂN THẠC SĨ LA TUẤN MINH PHÂN TÍCH KẾT CẤU TẤM PHÂN LỚP CHỨC NĂNG (FGM) CHỊU TẢI TRỌNG CƠ NHIỆT BẰNG PHẦN TỬ CS- MITC3+ NGÀNH: KỸ THUẬT XÂY DỰNG CƠNG TRÌNH DD VÀ CN - 60580208... PHẠM KỸ THUẬT THÀNH PHỐ HỒ CHÍ MINH LUẬN VĂN THẠC SĨ LA TUẤN MINH PHÂN TÍCH KẾT CẤU TẤM PHÂN LỚP CHỨC NĂNG (FGM) CHỊU TẢI TRỌNG CƠ NHIỆT BẰNG PHẦN TỬ CS- MITC3+ NGÀNH: KỸ THUẬT XÂY DỰNG CÔNG TRÌNH

Ngày đăng: 30/12/2021, 16:43

Xem thêm:

w