SlideShare a Scribd company logo
1 of 2
plot (gamma, Ex):
clc
clear all
%% inputs
%modulus of elasticity (GPa)
Em=3.4; Ef=72.345;
%thermal expansion coefficient (/c)
alpham=54*10^-4; alphaf=-0.9*10^-4;
%poisson's ratio
neum=0.38; neuf=0.22;
%%shear modulus (GPa)
Gm=Em/(2*(1+neum)); Gf=Ef/(2*(1+neuf));
%volume fraction
Vf=0.5; Vm=1-Vf;
theta(1)=0; theta(2)=90; theta(3)=45; theta(4)=theta(3);
theta(5)=theta(2);
theta(6)=theta(1);
z(1)=0; z(2)=1; z(3)=3; z(4)=6; z(5)=9; z(6)=11; z(7)=12;
%% outputs
E1=Vf*Ef+Vm*Em;
E2=(Em*Ef)/(Vm*Ef+Vf*Em);
alpha1=(Vf*Ef*alphaf+Vm*Em*alpham)/(Vf*Ef+Vm*Em);
alpha2=Vm*alpham+Vf*alphaf;
G12=(Gm*Gf)/(Vf*Gm+Vm*Gf);
neu12=Vf*neuf+Vm*neum;
delta=1-(((neu12)^2)*(E2/E1));
Q=[(E1/delta) ((neu12*E2)/delta) 0; ((neu12*E2)/delta) (E2/delta) 0; 0
0 G12];
t(1)=z(7)-z(6);
t(2)=z(6)-z(5);
t(3)=z(5)-z(4);
t(4)=t(3);
t(5)=t(2);
t(6)=t(1);
t_total=2*t(1)+2*t(2)+2*t(3);
t_theta1=t(1)+t(6);
t_theta2=t(2)+t(5);
t_theta3=t(3)+t(4);
A=zeros(3);
B=zeros(3);
D=zeros(3);
alpha=0:0.1:1;
gamma=0:0.1:1;
beta=0;
for i=1:1:6
for L=1:length(alpha)
for j=1:1:length(gamma)
C(i)=cosd(theta(i)) ;
S(i)=sind(theta(i));
T(:,:,i)=[(C(i)^2) (S(i)^2) (2*S(i)*C(i)); (S(i)^2) (C(i)^2) (-
2*S(i)*C(i)); (-C(i)*S(i)) (S(i)*C(i)) ((C(i)^2)-(S(i)^2))];
Q_bar(:,:,i)=inv(T(:,:,i))*Q*T(:,:,i);
if i==1|i==6
a(:,:,i)=Q_bar(:,:,i)*((alpha(L)*t_total)/2);
b(:,:,i)=Q_bar(:,:,i)*((alpha(L)*t_total)/2)*(z(i+1)+z(i));
d(:,:,i)=Q_bar(:,:,i)*(((alpha(L)*t_total)/2)^3+3*(z(i+1)^2*z(i)-
z(i+1)*z(i)^2));
end
if i==2|i==5
a(:,:,i)=Q_bar(:,:,i)*((beta*t_total)/2);
b(:,:,i)=Q_bar(:,:,i)*((beta*t_total)/2)*(z(i+1)+z(i));
d(:,:,i)=Q_bar(:,:,i)*(((beta*t_total)/2)^3+3*(z(i+1)^2*z(i)-
z(i+1)*z(i)^2));
end
if i==3|i==4
a(:,:,i)=Q_bar(:,:,i)*((gamma(j)*t_total)/2);
b(:,:,i)=Q_bar(:,:,i)*((gamma(j)*t_total)/2)*(z(i+1)+z(i));
d(:,:,i)=Q_bar(:,:,i)*(((gamma(j)*t_total)/2)^3+3*(z(i+1)^2*z(i)-
z(i+1)*z(i)^2));
end
A(:,:,i)=zeros(3)+a(:,:,i);
B(:,:,i)=zeros(3)+b(:,:,i);
D(:,:,i)=zeros(3)+d(:,:,i);
Ex(j)=((A(1,1)*A(2,2))/(t_theta3*A(2,2)))-
(((A(1,2).^2)*gamma(j))/(t_theta3*A(2,2)));
neuxy(j)=A(1,2)/A(2,2);
Gxy(j)=(gamma(j)*A(3,3))/t_theta3;
Exb(j)=(gamma(j)^3*12*(D(1,1)*D(2,2)-D(1,2).^2))/(D(2,2)*t_theta3.^3);
neuxyb(j)=D(1,2)/D(2,2);
end
plot (gamma, Ex)
hold on
grid on
xlabel('gamma')
ylabel('Ex')
end
end

More Related Content

What's hot

小波变换程序
小波变换程序小波变换程序
小波变换程序byron zhao
 
matlab code for channel estimation for ofdm
matlab code for channel estimation for ofdmmatlab code for channel estimation for ofdm
matlab code for channel estimation for ofdmGyana Ranjan Mati
 
งาน 9 อังสนา
งาน 9 อังสนางาน 9 อังสนา
งาน 9 อังสนาAreeya Onnom
 
Matlab code of chapter 4
Matlab code of chapter 4Matlab code of chapter 4
Matlab code of chapter 4Abdo Khalaf
 
Matlab code of chapter 4
Matlab code of chapter 4Matlab code of chapter 4
Matlab code of chapter 4Mohamed El Kiki
 
Effects of varying number of samples in an image
Effects of varying number of samples in an imageEffects of varying number of samples in an image
Effects of varying number of samples in an imagelakshmymk
 
block diagram reduction with examples
block diagram reduction with examplesblock diagram reduction with examples
block diagram reduction with examplesWaqas Afzal
 

What's hot (8)

小波变换程序
小波变换程序小波变换程序
小波变换程序
 
matlab code for channel estimation for ofdm
matlab code for channel estimation for ofdmmatlab code for channel estimation for ofdm
matlab code for channel estimation for ofdm
 
งาน 9 อังสนา
งาน 9 อังสนางาน 9 อังสนา
งาน 9 อังสนา
 
Matlab dsp examples
Matlab dsp examplesMatlab dsp examples
Matlab dsp examples
 
Matlab code of chapter 4
Matlab code of chapter 4Matlab code of chapter 4
Matlab code of chapter 4
 
Matlab code of chapter 4
Matlab code of chapter 4Matlab code of chapter 4
Matlab code of chapter 4
 
Effects of varying number of samples in an image
Effects of varying number of samples in an imageEffects of varying number of samples in an image
Effects of varying number of samples in an image
 
block diagram reduction with examples
block diagram reduction with examplesblock diagram reduction with examples
block diagram reduction with examples
 

Viewers also liked

compañeros de clase
compañeros de clasecompañeros de clase
compañeros de clasemacobolo
 
Watch henderson vs thatch
Watch henderson vs thatchWatch henderson vs thatch
Watch henderson vs thatchabott_adrus
 
Career Opportunities in Indonesian Capital Market
Career Opportunities in Indonesian Capital MarketCareer Opportunities in Indonesian Capital Market
Career Opportunities in Indonesian Capital MarketFurqan Maudhudy
 
Estadísticos descriptivos. ppt aurora
Estadísticos descriptivos. ppt auroraEstadísticos descriptivos. ppt aurora
Estadísticos descriptivos. ppt auroraauro_herco
 
presentacion power point tic
presentacion power point ticpresentacion power point tic
presentacion power point ticrnunem000
 
Las tics noveno a
Las tics noveno aLas tics noveno a
Las tics noveno aNattramn
 
Introduction to Islamic Business Terms
Introduction to Islamic Business Terms Introduction to Islamic Business Terms
Introduction to Islamic Business Terms Usama Abid
 
IAU île-de-France : SRCAE de l’Île-de-France en lien avec la révision du SDRIF
IAU île-de-France : SRCAE de l’Île-de-France en lien avec la révision du SDRIF IAU île-de-France : SRCAE de l’Île-de-France en lien avec la révision du SDRIF
IAU île-de-France : SRCAE de l’Île-de-France en lien avec la révision du SDRIF L'Institut Paris Region
 
Rpp kelas xi questions tag
Rpp kelas xi questions tagRpp kelas xi questions tag
Rpp kelas xi questions tagSri Wahyu
 
Lembar kegiatan siswa
Lembar kegiatan siswa Lembar kegiatan siswa
Lembar kegiatan siswa eka noviana
 
PwC - ¿Cómo gestionar el riesgo de tipo de cambio?
PwC - ¿Cómo gestionar el riesgo de tipo de cambio?PwC - ¿Cómo gestionar el riesgo de tipo de cambio?
PwC - ¿Cómo gestionar el riesgo de tipo de cambio?PwC Perú
 

Viewers also liked (15)

compañeros de clase
compañeros de clasecompañeros de clase
compañeros de clase
 
Halloween 5. bekkur enska
Halloween 5. bekkur   enskaHalloween 5. bekkur   enska
Halloween 5. bekkur enska
 
Watch henderson vs thatch
Watch henderson vs thatchWatch henderson vs thatch
Watch henderson vs thatch
 
Career Opportunities in Indonesian Capital Market
Career Opportunities in Indonesian Capital MarketCareer Opportunities in Indonesian Capital Market
Career Opportunities in Indonesian Capital Market
 
Bahasa indonesia
Bahasa indonesiaBahasa indonesia
Bahasa indonesia
 
Estadísticos descriptivos. ppt aurora
Estadísticos descriptivos. ppt auroraEstadísticos descriptivos. ppt aurora
Estadísticos descriptivos. ppt aurora
 
presentacion power point tic
presentacion power point ticpresentacion power point tic
presentacion power point tic
 
Las tics noveno a
Las tics noveno aLas tics noveno a
Las tics noveno a
 
Introduction to Islamic Business Terms
Introduction to Islamic Business Terms Introduction to Islamic Business Terms
Introduction to Islamic Business Terms
 
IAU île-de-France : SRCAE de l’Île-de-France en lien avec la révision du SDRIF
IAU île-de-France : SRCAE de l’Île-de-France en lien avec la révision du SDRIF IAU île-de-France : SRCAE de l’Île-de-France en lien avec la révision du SDRIF
IAU île-de-France : SRCAE de l’Île-de-France en lien avec la révision du SDRIF
 
Rpp kelas xi questions tag
Rpp kelas xi questions tagRpp kelas xi questions tag
Rpp kelas xi questions tag
 
A Casa Branca
A Casa BrancaA Casa Branca
A Casa Branca
 
Periodisasi kasusastraan bali
Periodisasi kasusastraan baliPeriodisasi kasusastraan bali
Periodisasi kasusastraan bali
 
Lembar kegiatan siswa
Lembar kegiatan siswa Lembar kegiatan siswa
Lembar kegiatan siswa
 
PwC - ¿Cómo gestionar el riesgo de tipo de cambio?
PwC - ¿Cómo gestionar el riesgo de tipo de cambio?PwC - ¿Cómo gestionar el riesgo de tipo de cambio?
PwC - ¿Cómo gestionar el riesgo de tipo de cambio?
 

Similar to Project (10)

Results after modifying errors
Results after modifying errorsResults after modifying errors
Results after modifying errors
 
Echantionnage.docx
Echantionnage.docxEchantionnage.docx
Echantionnage.docx
 
matlab codes.pdf
matlab codes.pdfmatlab codes.pdf
matlab codes.pdf
 
Ejercicio de fasores
Ejercicio de fasoresEjercicio de fasores
Ejercicio de fasores
 
H.w.5
H.w.5H.w.5
H.w.5
 
小波变换程序
小波变换程序小波变换程序
小波变换程序
 
Capsizing
CapsizingCapsizing
Capsizing
 
Radiation
RadiationRadiation
Radiation
 
Statistical Inference Using Stochastic Gradient Descent
Statistical Inference Using Stochastic Gradient DescentStatistical Inference Using Stochastic Gradient Descent
Statistical Inference Using Stochastic Gradient Descent
 
Statistical Inference Using Stochastic Gradient Descent
Statistical Inference Using Stochastic Gradient DescentStatistical Inference Using Stochastic Gradient Descent
Statistical Inference Using Stochastic Gradient Descent
 

Recently uploaded

Introduction to Microprocesso programming and interfacing.pptx
Introduction to Microprocesso programming and interfacing.pptxIntroduction to Microprocesso programming and interfacing.pptx
Introduction to Microprocesso programming and interfacing.pptxvipinkmenon1
 
Gurgaon ✡️9711147426✨Call In girls Gurgaon Sector 51 escort service
Gurgaon ✡️9711147426✨Call In girls Gurgaon Sector 51 escort serviceGurgaon ✡️9711147426✨Call In girls Gurgaon Sector 51 escort service
Gurgaon ✡️9711147426✨Call In girls Gurgaon Sector 51 escort servicejennyeacort
 
Call Us ≽ 8377877756 ≼ Call Girls In Shastri Nagar (Delhi)
Call Us ≽ 8377877756 ≼ Call Girls In Shastri Nagar (Delhi)Call Us ≽ 8377877756 ≼ Call Girls In Shastri Nagar (Delhi)
Call Us ≽ 8377877756 ≼ Call Girls In Shastri Nagar (Delhi)dollysharma2066
 
Concrete Mix Design - IS 10262-2019 - .pptx
Concrete Mix Design - IS 10262-2019 - .pptxConcrete Mix Design - IS 10262-2019 - .pptx
Concrete Mix Design - IS 10262-2019 - .pptxKartikeyaDwivedi3
 
Biology for Computer Engineers Course Handout.pptx
Biology for Computer Engineers Course Handout.pptxBiology for Computer Engineers Course Handout.pptx
Biology for Computer Engineers Course Handout.pptxDeepakSakkari2
 
main PPT.pptx of girls hostel security using rfid
main PPT.pptx of girls hostel security using rfidmain PPT.pptx of girls hostel security using rfid
main PPT.pptx of girls hostel security using rfidNikhilNagaraju
 
CCS355 Neural Network & Deep Learning Unit II Notes with Question bank .pdf
CCS355 Neural Network & Deep Learning Unit II Notes with Question bank .pdfCCS355 Neural Network & Deep Learning Unit II Notes with Question bank .pdf
CCS355 Neural Network & Deep Learning Unit II Notes with Question bank .pdfAsst.prof M.Gokilavani
 
Electronically Controlled suspensions system .pdf
Electronically Controlled suspensions system .pdfElectronically Controlled suspensions system .pdf
Electronically Controlled suspensions system .pdfme23b1001
 
Current Transformer Drawing and GTP for MSETCL
Current Transformer Drawing and GTP for MSETCLCurrent Transformer Drawing and GTP for MSETCL
Current Transformer Drawing and GTP for MSETCLDeelipZope
 
Call Girls Delhi {Jodhpur} 9711199012 high profile service
Call Girls Delhi {Jodhpur} 9711199012 high profile serviceCall Girls Delhi {Jodhpur} 9711199012 high profile service
Call Girls Delhi {Jodhpur} 9711199012 high profile servicerehmti665
 
OSVC_Meta-Data based Simulation Automation to overcome Verification Challenge...
OSVC_Meta-Data based Simulation Automation to overcome Verification Challenge...OSVC_Meta-Data based Simulation Automation to overcome Verification Challenge...
OSVC_Meta-Data based Simulation Automation to overcome Verification Challenge...Soham Mondal
 
VICTOR MAESTRE RAMIREZ - Planetary Defender on NASA's Double Asteroid Redirec...
VICTOR MAESTRE RAMIREZ - Planetary Defender on NASA's Double Asteroid Redirec...VICTOR MAESTRE RAMIREZ - Planetary Defender on NASA's Double Asteroid Redirec...
VICTOR MAESTRE RAMIREZ - Planetary Defender on NASA's Double Asteroid Redirec...VICTOR MAESTRE RAMIREZ
 
Application of Residue Theorem to evaluate real integrations.pptx
Application of Residue Theorem to evaluate real integrations.pptxApplication of Residue Theorem to evaluate real integrations.pptx
Application of Residue Theorem to evaluate real integrations.pptx959SahilShah
 
SPICE PARK APR2024 ( 6,793 SPICE Models )
SPICE PARK APR2024 ( 6,793 SPICE Models )SPICE PARK APR2024 ( 6,793 SPICE Models )
SPICE PARK APR2024 ( 6,793 SPICE Models )Tsuyoshi Horigome
 
What are the advantages and disadvantages of membrane structures.pptx
What are the advantages and disadvantages of membrane structures.pptxWhat are the advantages and disadvantages of membrane structures.pptx
What are the advantages and disadvantages of membrane structures.pptxwendy cai
 
GDSC ASEB Gen AI study jams presentation
GDSC ASEB Gen AI study jams presentationGDSC ASEB Gen AI study jams presentation
GDSC ASEB Gen AI study jams presentationGDSCAESB
 

Recently uploaded (20)

young call girls in Green Park🔝 9953056974 🔝 escort Service
young call girls in Green Park🔝 9953056974 🔝 escort Serviceyoung call girls in Green Park🔝 9953056974 🔝 escort Service
young call girls in Green Park🔝 9953056974 🔝 escort Service
 
Introduction to Microprocesso programming and interfacing.pptx
Introduction to Microprocesso programming and interfacing.pptxIntroduction to Microprocesso programming and interfacing.pptx
Introduction to Microprocesso programming and interfacing.pptx
 
Gurgaon ✡️9711147426✨Call In girls Gurgaon Sector 51 escort service
Gurgaon ✡️9711147426✨Call In girls Gurgaon Sector 51 escort serviceGurgaon ✡️9711147426✨Call In girls Gurgaon Sector 51 escort service
Gurgaon ✡️9711147426✨Call In girls Gurgaon Sector 51 escort service
 
POWER SYSTEMS-1 Complete notes examples
POWER SYSTEMS-1 Complete notes  examplesPOWER SYSTEMS-1 Complete notes  examples
POWER SYSTEMS-1 Complete notes examples
 
Call Us ≽ 8377877756 ≼ Call Girls In Shastri Nagar (Delhi)
Call Us ≽ 8377877756 ≼ Call Girls In Shastri Nagar (Delhi)Call Us ≽ 8377877756 ≼ Call Girls In Shastri Nagar (Delhi)
Call Us ≽ 8377877756 ≼ Call Girls In Shastri Nagar (Delhi)
 
Concrete Mix Design - IS 10262-2019 - .pptx
Concrete Mix Design - IS 10262-2019 - .pptxConcrete Mix Design - IS 10262-2019 - .pptx
Concrete Mix Design - IS 10262-2019 - .pptx
 
Biology for Computer Engineers Course Handout.pptx
Biology for Computer Engineers Course Handout.pptxBiology for Computer Engineers Course Handout.pptx
Biology for Computer Engineers Course Handout.pptx
 
main PPT.pptx of girls hostel security using rfid
main PPT.pptx of girls hostel security using rfidmain PPT.pptx of girls hostel security using rfid
main PPT.pptx of girls hostel security using rfid
 
CCS355 Neural Network & Deep Learning Unit II Notes with Question bank .pdf
CCS355 Neural Network & Deep Learning Unit II Notes with Question bank .pdfCCS355 Neural Network & Deep Learning Unit II Notes with Question bank .pdf
CCS355 Neural Network & Deep Learning Unit II Notes with Question bank .pdf
 
Electronically Controlled suspensions system .pdf
Electronically Controlled suspensions system .pdfElectronically Controlled suspensions system .pdf
Electronically Controlled suspensions system .pdf
 
Current Transformer Drawing and GTP for MSETCL
Current Transformer Drawing and GTP for MSETCLCurrent Transformer Drawing and GTP for MSETCL
Current Transformer Drawing and GTP for MSETCL
 
Call Girls Delhi {Jodhpur} 9711199012 high profile service
Call Girls Delhi {Jodhpur} 9711199012 high profile serviceCall Girls Delhi {Jodhpur} 9711199012 high profile service
Call Girls Delhi {Jodhpur} 9711199012 high profile service
 
young call girls in Rajiv Chowk🔝 9953056974 🔝 Delhi escort Service
young call girls in Rajiv Chowk🔝 9953056974 🔝 Delhi escort Serviceyoung call girls in Rajiv Chowk🔝 9953056974 🔝 Delhi escort Service
young call girls in Rajiv Chowk🔝 9953056974 🔝 Delhi escort Service
 
OSVC_Meta-Data based Simulation Automation to overcome Verification Challenge...
OSVC_Meta-Data based Simulation Automation to overcome Verification Challenge...OSVC_Meta-Data based Simulation Automation to overcome Verification Challenge...
OSVC_Meta-Data based Simulation Automation to overcome Verification Challenge...
 
VICTOR MAESTRE RAMIREZ - Planetary Defender on NASA's Double Asteroid Redirec...
VICTOR MAESTRE RAMIREZ - Planetary Defender on NASA's Double Asteroid Redirec...VICTOR MAESTRE RAMIREZ - Planetary Defender on NASA's Double Asteroid Redirec...
VICTOR MAESTRE RAMIREZ - Planetary Defender on NASA's Double Asteroid Redirec...
 
Application of Residue Theorem to evaluate real integrations.pptx
Application of Residue Theorem to evaluate real integrations.pptxApplication of Residue Theorem to evaluate real integrations.pptx
Application of Residue Theorem to evaluate real integrations.pptx
 
SPICE PARK APR2024 ( 6,793 SPICE Models )
SPICE PARK APR2024 ( 6,793 SPICE Models )SPICE PARK APR2024 ( 6,793 SPICE Models )
SPICE PARK APR2024 ( 6,793 SPICE Models )
 
What are the advantages and disadvantages of membrane structures.pptx
What are the advantages and disadvantages of membrane structures.pptxWhat are the advantages and disadvantages of membrane structures.pptx
What are the advantages and disadvantages of membrane structures.pptx
 
GDSC ASEB Gen AI study jams presentation
GDSC ASEB Gen AI study jams presentationGDSC ASEB Gen AI study jams presentation
GDSC ASEB Gen AI study jams presentation
 
9953056974 Call Girls In South Ex, Escorts (Delhi) NCR.pdf
9953056974 Call Girls In South Ex, Escorts (Delhi) NCR.pdf9953056974 Call Girls In South Ex, Escorts (Delhi) NCR.pdf
9953056974 Call Girls In South Ex, Escorts (Delhi) NCR.pdf
 

Project

  • 1. plot (gamma, Ex): clc clear all %% inputs %modulus of elasticity (GPa) Em=3.4; Ef=72.345; %thermal expansion coefficient (/c) alpham=54*10^-4; alphaf=-0.9*10^-4; %poisson's ratio neum=0.38; neuf=0.22; %%shear modulus (GPa) Gm=Em/(2*(1+neum)); Gf=Ef/(2*(1+neuf)); %volume fraction Vf=0.5; Vm=1-Vf; theta(1)=0; theta(2)=90; theta(3)=45; theta(4)=theta(3); theta(5)=theta(2); theta(6)=theta(1); z(1)=0; z(2)=1; z(3)=3; z(4)=6; z(5)=9; z(6)=11; z(7)=12; %% outputs E1=Vf*Ef+Vm*Em; E2=(Em*Ef)/(Vm*Ef+Vf*Em); alpha1=(Vf*Ef*alphaf+Vm*Em*alpham)/(Vf*Ef+Vm*Em); alpha2=Vm*alpham+Vf*alphaf; G12=(Gm*Gf)/(Vf*Gm+Vm*Gf); neu12=Vf*neuf+Vm*neum; delta=1-(((neu12)^2)*(E2/E1)); Q=[(E1/delta) ((neu12*E2)/delta) 0; ((neu12*E2)/delta) (E2/delta) 0; 0 0 G12]; t(1)=z(7)-z(6); t(2)=z(6)-z(5); t(3)=z(5)-z(4); t(4)=t(3); t(5)=t(2); t(6)=t(1); t_total=2*t(1)+2*t(2)+2*t(3);
  • 2. t_theta1=t(1)+t(6); t_theta2=t(2)+t(5); t_theta3=t(3)+t(4); A=zeros(3); B=zeros(3); D=zeros(3); alpha=0:0.1:1; gamma=0:0.1:1; beta=0; for i=1:1:6 for L=1:length(alpha) for j=1:1:length(gamma) C(i)=cosd(theta(i)) ; S(i)=sind(theta(i)); T(:,:,i)=[(C(i)^2) (S(i)^2) (2*S(i)*C(i)); (S(i)^2) (C(i)^2) (- 2*S(i)*C(i)); (-C(i)*S(i)) (S(i)*C(i)) ((C(i)^2)-(S(i)^2))]; Q_bar(:,:,i)=inv(T(:,:,i))*Q*T(:,:,i); if i==1|i==6 a(:,:,i)=Q_bar(:,:,i)*((alpha(L)*t_total)/2); b(:,:,i)=Q_bar(:,:,i)*((alpha(L)*t_total)/2)*(z(i+1)+z(i)); d(:,:,i)=Q_bar(:,:,i)*(((alpha(L)*t_total)/2)^3+3*(z(i+1)^2*z(i)- z(i+1)*z(i)^2)); end if i==2|i==5 a(:,:,i)=Q_bar(:,:,i)*((beta*t_total)/2); b(:,:,i)=Q_bar(:,:,i)*((beta*t_total)/2)*(z(i+1)+z(i)); d(:,:,i)=Q_bar(:,:,i)*(((beta*t_total)/2)^3+3*(z(i+1)^2*z(i)- z(i+1)*z(i)^2)); end if i==3|i==4 a(:,:,i)=Q_bar(:,:,i)*((gamma(j)*t_total)/2); b(:,:,i)=Q_bar(:,:,i)*((gamma(j)*t_total)/2)*(z(i+1)+z(i)); d(:,:,i)=Q_bar(:,:,i)*(((gamma(j)*t_total)/2)^3+3*(z(i+1)^2*z(i)- z(i+1)*z(i)^2)); end A(:,:,i)=zeros(3)+a(:,:,i); B(:,:,i)=zeros(3)+b(:,:,i); D(:,:,i)=zeros(3)+d(:,:,i); Ex(j)=((A(1,1)*A(2,2))/(t_theta3*A(2,2)))- (((A(1,2).^2)*gamma(j))/(t_theta3*A(2,2))); neuxy(j)=A(1,2)/A(2,2); Gxy(j)=(gamma(j)*A(3,3))/t_theta3; Exb(j)=(gamma(j)^3*12*(D(1,1)*D(2,2)-D(1,2).^2))/(D(2,2)*t_theta3.^3); neuxyb(j)=D(1,2)/D(2,2); end plot (gamma, Ex) hold on grid on xlabel('gamma') ylabel('Ex') end end