SlideShare a Scribd company logo
1 of 14
Download to read offline
I
A Simple Mesh Free Model for Analysis of Smart
Composite Beams
Synopsis submitted to
Indian Institute of Technology, Kharagpur
For the degree
of
Master of Technology
in
Mechanical Systems Design
by
Divyesh Mistry
14ME63R02
Under the guidance of
Dr. Manas Chandra Ray
DEPARTMENT OF MECHANICAL ENGINEERING
INDIAN INSTITUTE OF TECHNOLOGY, KHARAGPUR
KHARAGPUR 721302, INDIA
April 2016
II
Abstract
Piezoelectric laminated beams are common piezoelectric structure. It has been applied
in many fields, such as the driving element of the bimorph and unimorph piezoelectric
actuators bending. For static and dynamic, linear and nonlinear, analytical method
and numerical method, the mechanical behaviors of this structure (including bending,
vibration, buckling and control, etc.) have very comprehensive research. In these
studies, most of the research is to use of laminated beam theory simplified into 1D
control equation. However, here we will adopt a new approximate method based on
Element free Galerkin (EFG) for the numerical simulation of piezoelectric laminated
beam. This new Meshfree method can overcome the material discontinuity between
layer and thickness lock phenomenon. This new method is suitable for thin beam and
thick beam. It can be generalized to the numerical calculation of laminated curved
beam, laminated plate and shell structures. Numerical examples verify the validity
and precision of the proposed method.
KEY WORDS : Piezoelectric; Meshfree method; Element Free Galerkin; Laminated
beam; Moving Least Square Method.
1
1. INTRODUCTION
The development of the MFree methods can be traced
back more than seventy years to the collocation methods (Slater, 1934; Barta,
1937;Frazer et al., 1937; Lanczos, 1938, etc.). Belytschko Lu and Gu in 1994 refined and
modified the method and called their method EFG, element free Galerkin. These
methods do not require a mesh at least for the field variable interpolations. Adaptive
analysis and simulations using MFree methods become very efficient and much easier
to implement, even for problems which pose difficulties for the traditional FEM.
In MFree methods in which the approximate solution
is constructed entirely in terms of a set of nodes, and no elements or characterization
of the interrelationship of the nodes is needed to construct the discrete equations. It is
then possible to develop discrete equations from a set of nodes and a description of
the internal and external surfaces of the model. For the latter purpose, a CAD
description, such as a model in three dimensions, may be used, so Meshfree methods
may overcome many of the difficulties associated with meshing for three-dimensional
analyses.
Objectives
 The main objective of this project is Static analyze of smart composite beam
using Meshfree method.
 To define shape function construction for MFree method and Meshfree
interpolation/approximation techniques.
 To derive the solution for smart composite beam.
 Comparison of Responses of MFree Method for Three Layered (0°/90°/0°)
Composite Beam with Exact Solution Method.
 Comparison of Responses of MFree Method for Four Layered
(0°/90°/0°/90°) Composite Beam with Exact Solution Method
2
Shape functions based on a
pre-defined element
Mesh generation Node generation
Shape functions based
on a nodes in support domain
Solution for field variables
Post-processing
2. MESHFREE METHOD
FEM has the inherent shortcomings of numerical
methods that rely on meshes or elements that are connected together by nodes in a
properly predefined manner. The following limitations of FEM are becoming
increasingly evident:
1) High cost in creating an FEM mesh
2) Low accuracy of stress
3) Limitation in the analyses of some problems
4) Difficulty in adaptive analysis
2.1 Definition of Meshfree Methods
The definition of an MFree method (GR Liu, 2002) is:
“An MFree method is a method used to establish
system algebraic equations for the whole problem domain without the use of a
predefined mesh for the domain discretization.”
2.2.1 Solution Procedure of MFree Methods
FEM MFree
`
Fig. (2.1) Flow chart for FEM and MFree method
Geometry creation
Discretized system
equatons
3
2.2 Moving Least Squares Shape Functions
The moving least squares (MLS) approximation was devised by
mathematicians in data fitting and surface construction (Lancaster and Salkausdas
1981; Cleveland 1993). It can be categorized as a method of series representation of
functions. The MLS approximation is now widely used in MFree methods for
constructing MFree shape functions.
2.2.1 Formulation of MLS shape functions
Consider an unknown scalar function of a field variable 𝑢(𝑥) in the
domain: The MLS approximation of 𝑢(𝑥) is defined at 𝑥 as,
𝒖 𝒉(𝒙) = ∑ 𝒑𝒋(𝒙) 𝒂𝒋
𝒎
𝒋=𝟏 (𝒙) = 𝑷 𝑻
(𝒙)𝒂(𝒙) (1)
Where 𝑃(𝑥) is the basis function of the spatial coordinates, 𝑋 𝑇
= [𝑥, 𝑦] for two
dimensional problems, and m is the number of the basis functions. The basis function
𝑃(𝑥) is often built using monomials from the Pascal triangle to ensure minimum
completeness. 𝑎(𝑥) is a vector of coefficients given by,
𝒂 𝑻(𝒙) = {𝒂 𝟏(𝒙) 𝒂 𝟐(𝒙) 𝒂 𝟑(𝒙) … … … . 𝒂 𝒏(𝒙)} (2)
Note that the coefficient vector 𝑎(𝑥) in Equation (2) is a function of 𝑥.
The shape function 𝝍𝒊(𝒙) for the 𝑖 𝑡ℎ
node is defined by,
𝝍𝒊(𝒙) = ∑ 𝒑𝒋
𝒎
𝒋=𝟏 (𝑨−𝟏 (𝒙) 𝑯 (𝒙))𝒋𝒊 = 𝑷 𝑻
(𝒙)(𝑨−𝟏
𝑯)𝒊
Where,
𝑨(𝒙) = ∑ 𝑾𝒊
̂ (𝒙)𝒏
𝒊=𝟏 𝑷(𝒙𝒊)𝑷 𝑻
(𝒙𝒊)
𝑯(𝒙) = [ 𝑾 𝟏
̂ (𝒙)𝑷(𝒙 𝟏) 𝑾 𝟐
̂(𝒙)𝑷(𝒙 𝟐) … … … . . 𝑾 𝒏
̂ (𝒙)𝑷(𝒙 𝒏) ]
In the MLS, the coefficient 𝐚 is the function of 𝑥 which makes the approximation of
weighted least squares move continuously. Therefore, the MLS shape function will be
continuous in the entire global domain, as long as the weight functions are chosen
properly.
4
3. ANALYSIS OF SMART COMPOSITE BEAM
Fig.3.1 Schematic diagrams of smart cantilevered laminated composite
beams
The governing stress equilibrium equations and the charge equilibrium equation for
an electro-mechanical solid are
0j,ij  and 0D i,i  ; xj,i  and z (3)
where ij is the component of Cauchy stress tensor at any point in the solid, iD is the
electric displacement at the point along the direction denoted by i , S is the boundary
of the solid and  is the volume of the solid. A weak form of the variational principle
which would yield the above equilibrium equations is given by
0dEDddSnDdSun iiijij
S
ii
S
ijij     

(4)
in which  is the symbol of variational operator and executes the first variation of a
dependent variable, iu and iE are the displacements and electric field, respectively
at any point in the solid along the direction represented by i , ij is the linear strain
tensor at the point and  is the electric potential. The reduced constitutive relations
appropriate for the beam analysis and representing the converse and the direct
piezoelectric effects are given by
}E](e[}]{C[}{ ppp
 , (5)
}E]([}{]e[}D{ pT
 (6)
In Eqs. (5) and (6), the state of stresses }{ p
 , the state of strains }{ p
 , the electric field
vector }E{ , the electric displacement vector }D{ , the elastic coefficient matrix ]C[ p
,
the piezoelectric constant matrix ]e[ and the dielectric constant matrix ][ .
The constitutive relations for the k -th orthotropic
composite layer of the substrate beam are
}]{C[}{ kkk
 ; N,,3,2,1k  (7)
5
The state of stresses }{ k
 , the state of strains }{ k
 at any point in the k -th layer of the
substrate beam and the elastic coefficient matrix ]C[ k
. Two compatible displacement
fields are considered for deriving the present mesh free model (MFM) of the smart
composite beams. For the substrate beam, an equivalent single layer first order shear
deformation theory (FSDT) describing the axial displacements u and w at any point
in the substrate beam along the x and z directions, respectively is considered as
x0 zuu  and z0 zww  (8)
in which 0u and 0w are the translational displacements of any point on the mid-plane
( z =0) of the substrate beam along x and z directions, respectively; x is the rotation
of the normal to the mid-plane of the substrate beam with respect to the z -axis and
z is the gradient of the transverse displacement w with respect to z . The
corresponding axial displacements p
u and p
w at any point in the piezoelectric layer
are considered as follows:
xx0
p
)2/hz(
2
h
uu  and zz0
p
)2/hz(
2
h
ww  (9)
in which x is the rotation of the transverse normal to the piezoelectric layer across
its thickness with respect to the z -axis and z is gradient of the transverse
displacement p
w with respect to the z -axis. The generalized displacement
coordinates at any point in the overall beam are expressed in a vector form as follows:
T
zxzx00 ]wu[}d{  (10)
The variation of electric potential across the thickness of the piezoelectric layer is linear
[12]. Thus the electric potential function which is zero at the interface between the
piezoelectric layer and the substrate beam may be assumed as
)x(
h
)2/hz(
)z,x( 0
p


 (11)
wherein 0 is the electric potential distribution at the top surface of the piezoelectric
layer. Accordingly, using Eqs. (8)-(11), the states of strains in the substrate beam and
the piezoelectric layer and the electric potential field in the piezoelectric layer can
expressed as
  }]{Z[
x
w
z
u
z
w
x
u
}{ 1
T
Tk
xz
k
z
k
x
k















 ,
  }]{Z[
x
w
z
u
z
w
x
u
}{ 2
T
pppp
Tp
xz
p
z
p
x
p















 ,
  }E]{Z[
zx
EE}E{ p
T
T
zx 










In which the matrices ]Z[ 1 , ]Z[ 2 and ]Z[ p , the generalized strain vector }{ and the
generalized electric field vector.
6
From the weak form of the variational principle, it is
to be noted that the z coordinates of the top and bottom surfaces of the k -th layer of
the substrate beam are denoted by 1kh  and kh , respectively. The essential boundary
conditions of the present overall smart beams can be derived from the variational
principle given by as follows:
simply supported smart beams:
T
0x
T
zz000xb ]0000[]wu[}d{ 

and 0)0(0 
T
Lx
T
zz0Lxb ]000[]w[}d{ 

and 0)L(0  (12)
Clamped-free smart beams:
T
0x
T
zzxx000xb ]000000[]wu[}d{ 

(13)
The variational principle also yields the following interface continuity conditions and
prescribed boundary conditions:
)h,x()h,x( 1k
1k
xz1k
k
xz 

  , )h,x()h,x( 1k
1k
z1k
k
z 

  ; 1N,,3,2,1k   ,
)h,x()h,x( 1N
p
xz1N
N
xz   , )h,x()h,x( 1N
p
z1N
N
z   , 0)h2/h,x( p
p
xz 
3.1 ELEMENT FREE GALERKIN METHOD
The element-free Galerkin (EFG) method is a
meshless method uses the moving least squares (MLS) shape functions, Because the
MLS approximation lacks the Kronecker delta function property, The EFG method
employs moving least-square (MLS) approximants to approximate the function 𝑢(𝑥)
with 𝑢ℎ
( 𝑥). These approximants are constructed from three components: a weight
function of compact support associated with each node, a basis, usually consisting of
a polynomial, and a set of coefficients that depend on position. The element free
Galerkin method is implemented to derive the smart mesh free model (MFM). Any
generalized displacement say 0u at any point (x ) can be approximated by the moving
least squares (MLS) approximation as,
}a{}P{u T
0  (14)
where }P{ is a column vector constructed from a basis function and }a{ is a column
vector of coefficients of the basis function. The linear basis function for one
dimensional problem is considered here.
7
T
]x1[}P{  and T
10 ])x(a)x(a[}a{  (15)
Substituting for the approximation of )x(u0 at any point can be expressed in terms of
the nodal parameters of )x(u0 as,
}d]{[u 00  (16)
in which
]H[]A[}P{]....[][ 1TT
n321


with i being the shape function associated with the i -th node. It is evident that the
MLS approximations of other generalized displacement variables yields the same
shape functions associated with the i -th node. Thus the generalized displacement
vector }d{ and the electric potential 0 at any point can be expressed in terms of the
nodal generalized displacement parameter vector and the nodal electric potential
vector, respectively as follows:
}X]{N[}d{  and }]{[0  (17)
Since the mesh free shape function does not satisfy the property of the Kronecker delta
function, the essential boundary conditions are satisfied using Lagrange multipliers.
Also, electric potential at the top surface of the piezoelectric layer will be prescribed.
In which }{ 0 and }{ L are the vectors of Lagrange multipliers for the essential
displacement boundary conditions at x =0 and L , respectively. The moment
resultants xM and p
xM .
The following discrete governing equations of the overall smart composite beams can
be derived:
}F{}]{F[}]{G[}X]{K[ p  and }X{}X{]G[ b
T
 (18)
in which the overall stiffness matrix ]K[ , the matrix ]G[ , the electro-elastic coupling
matrix ]F[ p , the mechanical load vector }F{ , the Lagrange multiplier vector }{ and
the vector of essential displacement boundary conditions }X{ b .
8
4. NUMERICAL RESULTS AND CONCLUSION
The following material properties for the layers of the substrates are considered for
evaluating the numerical results:
𝑬 𝟏 = 𝟏𝟕𝟐. 𝟓 × 𝟏𝟎 𝟗
; 𝑬 𝟐 =
𝑬 𝟏
𝟐𝟓
; 𝑬 𝟑 = 𝑬 𝟐; 𝑮 𝟏𝟐 = 𝟎. 𝟓 × 𝑬 𝟐;
𝑮 𝟏𝟐 = 𝑮 𝟐𝟑; 𝑮 𝟏𝟐 = 𝟎. 𝟐 × 𝟏𝟎 𝟐
; 𝝁 𝟏𝟐 = 𝟎. 𝟐𝟓; 𝝁 𝟏𝟑 = 𝟎. 𝟐𝟓; 𝝁 𝟐𝟑 = 𝟎. 𝟐𝟓
The results are evaluated with and without applying the
electrical potential distribution on the actuator surface for different values of length to
thickness ratios s(=a/h) and m=n=1 in the definition of p and q. The following non-
dimensional parameters are used for presenting the numerical results.
)0,x(w
aq
hE100
w 4
0
3
T

, where s =50, ph =250 m, h=0.005m
A program was made in MATLAB to calculate axial stresses and shear stresses across
the thickness for three layer composite beam and four layer composite beam. The
results are as shown in figure. stresses in the cross-ply substrates (0-90-0) is computed
with and without applying the externally applied voltage to the piezo layer.
4.1 Comparison of Responses of MFree Method for Three Layered (0/90/0)
Composite Beam with Exact Solution Method.
Fig. (4.1) Active static control of shape of a three layered composite beam (s =50,
ph =250 m, h=0.005m, )0,x(w
aq
hE100
w 4
0
3
T

, 0q =50N/m
2
)
9
Fig. (4.2) Distribution of the axial stress across the thickness of the three layered
(
000
0/90/0 ) composite beam with and without actuated by a piezoelectric layer
Fig. (4.3) Distribution of the transverse stress across the thickness of the three
layered (
000
0/90/0 ) composite beam with and without actuated by a
piezoelectric layer 0q =50N/m
2
)
10
4.2 Natural Frequencies of for Three Layered (0°/90°/0°) Composite Beam
Beam
0°/90°/0°
Source 1st mode 2nd mode 3rd mode
S=100
Present
[MFree] 32 204 557
FEM[Ref.20] 35 210 564
Table 1. Natural frequencies of the substrate beam with negligible thickness (Hz)
4.3 Conclusion
In the present work, a new layer wise laminated beam theory based
on element free Galerkin (EFG) is proposed to analyze the numerical simulation of
piezoelectric laminated beam have been used to verify the validity and precision of
the proposed method. It only needs nodes distributed on the upper and lower surfaces
of each layer, which avoids the troublesome in generating mesh and saves much
preprocess time MLS approximants, which constitute the back bone of the method
were described, including several examples. The convergence characteristic and
accuracy of the method are validated with exact solution. In all the simulations,
numeric solutions are insensitive to the EFG-related parameters, which demonstrate
the stability of the proposed method. With MFree methods like EFG it is possible to
review developments and applications for various types of structure mechanics and
fracture mechanics applications like bending, buckling, free vibration analysis,
sensitivity analysis and topology optimization, single and mixed mode crack
problems, fatigue crack growth, and dynamic crack analysis and some typical
applications like vibration of cracked structures, thermoselastic crack problems, and
failure transition in impact problems. Meshfree methods is the possibility of
simplifying adaptively and problems with moving boundaries and discontinuities,
such as phase changes or cracks.
11
REFERENCES
[ 1 ] Belytschko, T., Y.Y. Lu, and L.Gu (1994), Element Free Galerkin Methods",
International Journal for Numeric al Methods in Engineering, 37, 229-256.
[ 2 ] Belytschko, T., D. Organ, and Y. Krongauz (1995), A Coupled Finite Element-
Element free Galerkin Method", Computational Mechanics, 17, 186-195.
[ 3 ] Belytschko, T., Y. Krongauz, M. Fleming, D. Organ and W.K. Liu (1996),
Smoothing and Accelerated Computations in the Element-free Galerkin Method",
Journal of Computational and Applied Mechanics, 74, 111-126.
[ 4 ] Belytschko, T., Y. Krongauz, D. Organ, M. Fleming and P. Krysl (1996), Meshless
Methods: An Overview and Recent Developments", Computer Methods in Applied
Mechanics and Engineering, 139, 3-47.
[ 5 ] Beissel, S. and Belytschko, T. (1996) “Nodal integration of the element-free
Galerkin method,” Computational Methods Appl. Mech. Eng. 139, 49–74.
[ 6 ] Duarte, C.A.M. and Oden, J.T. (1995) “Hp clouds-A meshless method to solve
boundary value problems,” TICAM Report, 95-05.3
[ 7 ] J. Dolbow and T. Belytschko, (1998) “An Introduction to Programming the
Meshless Element Free Galerkin Method”, Vol. 5, 3, 207-241
[ 8 ] Duarte, C.A. and J.T. Oden (1996), H-p Clouds - an h-p Meshless Method, Numeric
al Methods for Partial Differential Equations, 1-34.
[ 9 ] Lancaster, P. and K. Salkauskas (1981), Surfaces Generated by Moving Least
Squares Methods", Mathematics of Computation, 37, 141-158.
[ 10 ] Liu,W.K., S. Jun, and Y.F. Zhang (1995), Reproducing Kernel P article Methods",
International Journal for Numerical Methods in Engineering, 20 , 1081-1106.
[ 11 ] Lu,Y.Y., T. Belytschko and L. Gu (1994), A New Implementation of the Element
Free Galerkin Method", Computer Methods in Applied Mechanics and Engineering,
113, 397-414.
[ 12 ] Timoshenko, S.P .and J.N. Goodier (1970),Theory of Elasticity (Third ed.). New
York, McGraw Hill.
12
[ 13 ] Ray M. C., Mallik N. (2004), “Finite Element Solutions for Static Analysis of Smart
Structures With a Layer of Piezoelectric Fiber Reinforced Composites”, AIAA Journal,
vol. 42, no. 7, 2004, pp. 1398-1405.
[ 14 ] Anderson EH, Hagood(1994), Simultaneous piezoelectric sensingactuation:
analysis and application to controlled structures. Sound Vibration.
[ 15 ] Donthireddy P, Chandrashekhara K (1996), Modeling and shape control of
composite beams with embedded piezoelectric actuators.
[ 16 ] Kapuria S, Sengupta S, Dumir PC (1997), Three-dimensional piezothermoelastic
solution for shape control of cylindrical panel. J Thermal Stresses.
[ 17 ] Crawley, E.F. and Luis, J.D. (1987), Use of piezoelectric actuators as elements of
intelligent structures, American Institute of Aeronautics and Astronautics Journal
25(10), 1373–1385.
[ 18 ] Lee, C.K., Chiang, W.W. and Sulivan (1991), Piezoelectric modal sensor/actuator
pairs for critical active damping vibration control, Journal of the Acoustical Society of
America 90, 374–384.
[ 19 ] J.N. Reddy, (1999) On laminated composite plates with integrated sensors and
actuators. Engineer structure.; 21: 568-593.
[ 20 ] Ray M C and Mallik N (2004) Active control of laminated composite beams using
piezoelectric fiber reinforced composite layer Smart Material Structure. 13 146–52.

More Related Content

What's hot

Finite Element Analysis of Truss Structures
Finite Element Analysis of Truss StructuresFinite Element Analysis of Truss Structures
Finite Element Analysis of Truss StructuresMahdi Damghani
 
Coupling_of_IGA_plates_and_3D_FEM_domain
Coupling_of_IGA_plates_and_3D_FEM_domainCoupling_of_IGA_plates_and_3D_FEM_domain
Coupling_of_IGA_plates_and_3D_FEM_domainNguyen Vinh Phu
 
Basics of finite element method 19.04.2018
Basics of finite element method 19.04.2018Basics of finite element method 19.04.2018
Basics of finite element method 19.04.2018Dr. Mohd Zameeruddin
 
2-Dimensional and 3-Dimesional Electromagnetic Fields Using Finite element me...
2-Dimensional and 3-Dimesional Electromagnetic Fields Using Finite element me...2-Dimensional and 3-Dimesional Electromagnetic Fields Using Finite element me...
2-Dimensional and 3-Dimesional Electromagnetic Fields Using Finite element me...IOSR Journals
 
Effect of Piezoelectric Layer on Beam Parameters using Zigzag Theory
Effect of Piezoelectric Layer on Beam Parameters using Zigzag TheoryEffect of Piezoelectric Layer on Beam Parameters using Zigzag Theory
Effect of Piezoelectric Layer on Beam Parameters using Zigzag TheoryIDES Editor
 
Numerical simulation of electromagnetic radiation using high-order discontinu...
Numerical simulation of electromagnetic radiation using high-order discontinu...Numerical simulation of electromagnetic radiation using high-order discontinu...
Numerical simulation of electromagnetic radiation using high-order discontinu...IJECEIAES
 
Stages of fea in cad environment
Stages of fea in cad environmentStages of fea in cad environment
Stages of fea in cad environmentrashmi322
 
Finite Element Analysis
Finite Element Analysis Finite Element Analysis
Finite Element Analysis Yousef Abujubba
 
Fem class notes
Fem class notesFem class notes
Fem class notesDrASSayyad
 
Introduction to finite element method 19.04.2018
Introduction to finite element method 19.04.2018Introduction to finite element method 19.04.2018
Introduction to finite element method 19.04.2018Dr. Mohd Zameeruddin
 
A Numerical Method for Modelling Discontinuous Mechanics of Asphalt Mixture
A Numerical Method for Modelling Discontinuous Mechanics of Asphalt MixtureA Numerical Method for Modelling Discontinuous Mechanics of Asphalt Mixture
A Numerical Method for Modelling Discontinuous Mechanics of Asphalt MixtureIDES Editor
 
Optimal Design of Hysteretic Dampers Connecting 2-MDOF Adjacent Structures fo...
Optimal Design of Hysteretic Dampers Connecting 2-MDOF Adjacent Structures fo...Optimal Design of Hysteretic Dampers Connecting 2-MDOF Adjacent Structures fo...
Optimal Design of Hysteretic Dampers Connecting 2-MDOF Adjacent Structures fo...CSCJournals
 

What's hot (20)

Finite Element Analysis of Truss Structures
Finite Element Analysis of Truss StructuresFinite Element Analysis of Truss Structures
Finite Element Analysis of Truss Structures
 
Coupling_of_IGA_plates_and_3D_FEM_domain
Coupling_of_IGA_plates_and_3D_FEM_domainCoupling_of_IGA_plates_and_3D_FEM_domain
Coupling_of_IGA_plates_and_3D_FEM_domain
 
solution for 2D truss1
solution for 2D truss1solution for 2D truss1
solution for 2D truss1
 
Basics of finite element method 19.04.2018
Basics of finite element method 19.04.2018Basics of finite element method 19.04.2018
Basics of finite element method 19.04.2018
 
Aj4301193196
Aj4301193196Aj4301193196
Aj4301193196
 
Finite element analysis qb
Finite element analysis qbFinite element analysis qb
Finite element analysis qb
 
2-Dimensional and 3-Dimesional Electromagnetic Fields Using Finite element me...
2-Dimensional and 3-Dimesional Electromagnetic Fields Using Finite element me...2-Dimensional and 3-Dimesional Electromagnetic Fields Using Finite element me...
2-Dimensional and 3-Dimesional Electromagnetic Fields Using Finite element me...
 
1 d analysis
1 d analysis1 d analysis
1 d analysis
 
Finite Element Method
Finite Element MethodFinite Element Method
Finite Element Method
 
Effect of Piezoelectric Layer on Beam Parameters using Zigzag Theory
Effect of Piezoelectric Layer on Beam Parameters using Zigzag TheoryEffect of Piezoelectric Layer on Beam Parameters using Zigzag Theory
Effect of Piezoelectric Layer on Beam Parameters using Zigzag Theory
 
Numerical simulation of electromagnetic radiation using high-order discontinu...
Numerical simulation of electromagnetic radiation using high-order discontinu...Numerical simulation of electromagnetic radiation using high-order discontinu...
Numerical simulation of electromagnetic radiation using high-order discontinu...
 
Introduction to FEA
Introduction to FEAIntroduction to FEA
Introduction to FEA
 
Stages of fea in cad environment
Stages of fea in cad environmentStages of fea in cad environment
Stages of fea in cad environment
 
Finite Element Analysis
Finite Element Analysis Finite Element Analysis
Finite Element Analysis
 
Fem class notes
Fem class notesFem class notes
Fem class notes
 
Introduction to finite element method 19.04.2018
Introduction to finite element method 19.04.2018Introduction to finite element method 19.04.2018
Introduction to finite element method 19.04.2018
 
Fea 2 mark
Fea 2 markFea 2 mark
Fea 2 mark
 
A Numerical Method for Modelling Discontinuous Mechanics of Asphalt Mixture
A Numerical Method for Modelling Discontinuous Mechanics of Asphalt MixtureA Numerical Method for Modelling Discontinuous Mechanics of Asphalt Mixture
A Numerical Method for Modelling Discontinuous Mechanics of Asphalt Mixture
 
Fem 1
Fem 1Fem 1
Fem 1
 
Optimal Design of Hysteretic Dampers Connecting 2-MDOF Adjacent Structures fo...
Optimal Design of Hysteretic Dampers Connecting 2-MDOF Adjacent Structures fo...Optimal Design of Hysteretic Dampers Connecting 2-MDOF Adjacent Structures fo...
Optimal Design of Hysteretic Dampers Connecting 2-MDOF Adjacent Structures fo...
 

Viewers also liked

Columbus 2020 Investor Update | March 2016 | Panelists
Columbus 2020 Investor Update | March 2016 | PanelistsColumbus 2020 Investor Update | March 2016 | Panelists
Columbus 2020 Investor Update | March 2016 | PanelistsOne Columbus
 
Велосипедна інфраструктура Одеси_Констянтин Ємельянов, "Urban institute"
Велосипедна інфраструктура Одеси_Констянтин Ємельянов, "Urban institute"Велосипедна інфраструктура Одеси_Констянтин Ємельянов, "Urban institute"
Велосипедна інфраструктура Одеси_Констянтин Ємельянов, "Urban institute"veloforum
 
Audience theories
Audience theoriesAudience theories
Audience theoriesMsackfield
 
Oleksiy Kushka - Nextbike in Lviv Presentation
Oleksiy Kushka - Nextbike in Lviv PresentationOleksiy Kushka - Nextbike in Lviv Presentation
Oleksiy Kushka - Nextbike in Lviv Presentationveloforum
 
Unit 9 sturcture, organisation and ownership
Unit 9 sturcture, organisation and ownershipUnit 9 sturcture, organisation and ownership
Unit 9 sturcture, organisation and ownershipJosh Rothwell
 
Big Data - Olena Tokmylenko
Big Data - Olena TokmylenkoBig Data - Olena Tokmylenko
Big Data - Olena Tokmylenkoveloforum
 
Велоініціативи Миколаєва
Велоініціативи МиколаєваВелоініціативи Миколаєва
Велоініціативи Миколаєваveloforum
 
Personal branding
Personal brandingPersonal branding
Personal brandingavietzke
 
Filmmaking Logistics and Production for High School Classes
Filmmaking Logistics and Production for High School ClassesFilmmaking Logistics and Production for High School Classes
Filmmaking Logistics and Production for High School ClassesAntonio Manriquez
 
Fri. Nov. 25th Pine River Announcements
Fri. Nov. 25th Pine River Announcements  Fri. Nov. 25th Pine River Announcements
Fri. Nov. 25th Pine River Announcements Pine River
 
Ecologia y Educacion Ambiental
Ecologia y Educacion Ambiental Ecologia y Educacion Ambiental
Ecologia y Educacion Ambiental SaraGonzalez1505
 
SunRaising, in-kind donations from solar energy.
SunRaising, in-kind donations from solar energy. SunRaising, in-kind donations from solar energy.
SunRaising, in-kind donations from solar energy. Blake Jackson
 
Literature review Table. how to write a research paper's review.
Literature review Table. how to write a research paper's review.Literature review Table. how to write a research paper's review.
Literature review Table. how to write a research paper's review.Telenor
 
14lesson5 body systems part3
14lesson5 body systems part314lesson5 body systems part3
14lesson5 body systems part3omneya_ghis ghis
 

Viewers also liked (20)

N.Dip 3D Design
N.Dip 3D DesignN.Dip 3D Design
N.Dip 3D Design
 
Columbus 2020 Investor Update | March 2016 | Panelists
Columbus 2020 Investor Update | March 2016 | PanelistsColumbus 2020 Investor Update | March 2016 | Panelists
Columbus 2020 Investor Update | March 2016 | Panelists
 
Rulx Jean Baptiste
Rulx Jean BaptisteRulx Jean Baptiste
Rulx Jean Baptiste
 
Велосипедна інфраструктура Одеси_Констянтин Ємельянов, "Urban institute"
Велосипедна інфраструктура Одеси_Констянтин Ємельянов, "Urban institute"Велосипедна інфраструктура Одеси_Констянтин Ємельянов, "Urban institute"
Велосипедна інфраструктура Одеси_Констянтин Ємельянов, "Urban institute"
 
Audience theories
Audience theoriesAudience theories
Audience theories
 
Alycia CV
Alycia CVAlycia CV
Alycia CV
 
Oleksiy Kushka - Nextbike in Lviv Presentation
Oleksiy Kushka - Nextbike in Lviv PresentationOleksiy Kushka - Nextbike in Lviv Presentation
Oleksiy Kushka - Nextbike in Lviv Presentation
 
Unit 9 sturcture, organisation and ownership
Unit 9 sturcture, organisation and ownershipUnit 9 sturcture, organisation and ownership
Unit 9 sturcture, organisation and ownership
 
Big Data - Olena Tokmylenko
Big Data - Olena TokmylenkoBig Data - Olena Tokmylenko
Big Data - Olena Tokmylenko
 
Велоініціативи Миколаєва
Велоініціативи МиколаєваВелоініціативи Миколаєва
Велоініціативи Миколаєва
 
Personal branding
Personal brandingPersonal branding
Personal branding
 
Icd
IcdIcd
Icd
 
Filmmaking Logistics and Production for High School Classes
Filmmaking Logistics and Production for High School ClassesFilmmaking Logistics and Production for High School Classes
Filmmaking Logistics and Production for High School Classes
 
Fri. Nov. 25th Pine River Announcements
Fri. Nov. 25th Pine River Announcements  Fri. Nov. 25th Pine River Announcements
Fri. Nov. 25th Pine River Announcements
 
Ecologia y Educacion Ambiental
Ecologia y Educacion Ambiental Ecologia y Educacion Ambiental
Ecologia y Educacion Ambiental
 
SunRaising, in-kind donations from solar energy.
SunRaising, in-kind donations from solar energy. SunRaising, in-kind donations from solar energy.
SunRaising, in-kind donations from solar energy.
 
Synchronous generator
Synchronous generatorSynchronous generator
Synchronous generator
 
Literature review Table. how to write a research paper's review.
Literature review Table. how to write a research paper's review.Literature review Table. how to write a research paper's review.
Literature review Table. how to write a research paper's review.
 
18 earth's movement part1
18 earth's movement part118 earth's movement part1
18 earth's movement part1
 
14lesson5 body systems part3
14lesson5 body systems part314lesson5 body systems part3
14lesson5 body systems part3
 

Similar to synopsis_divyesh

Investigation on EM radiations from interconnects in integrated circuits
Investigation on EM radiations from interconnects in integrated circuitsInvestigation on EM radiations from interconnects in integrated circuits
Investigation on EM radiations from interconnects in integrated circuitsTELKOMNIKA JOURNAL
 
MODELING OF PLANAR METAMATERIAL STRUCTURE AND ITS EFFECTIVE PARAMETER EXTRACTION
MODELING OF PLANAR METAMATERIAL STRUCTURE AND ITS EFFECTIVE PARAMETER EXTRACTIONMODELING OF PLANAR METAMATERIAL STRUCTURE AND ITS EFFECTIVE PARAMETER EXTRACTION
MODELING OF PLANAR METAMATERIAL STRUCTURE AND ITS EFFECTIVE PARAMETER EXTRACTIONIAEME Publication
 
Expert system of single magnetic lens using JESS in Focused Ion Beam
Expert system of single magnetic lens using JESS in Focused Ion BeamExpert system of single magnetic lens using JESS in Focused Ion Beam
Expert system of single magnetic lens using JESS in Focused Ion Beamijcsa
 
Algorithm for the Dynamic Analysis of Plane Rectangular Rigid Frame Subjected...
Algorithm for the Dynamic Analysis of Plane Rectangular Rigid Frame Subjected...Algorithm for the Dynamic Analysis of Plane Rectangular Rigid Frame Subjected...
Algorithm for the Dynamic Analysis of Plane Rectangular Rigid Frame Subjected...Oyeniyi Samuel
 
Efficient mode-matching analysis of 2-D scattering by periodic array of circu...
Efficient mode-matching analysis of 2-D scattering by periodic array of circu...Efficient mode-matching analysis of 2-D scattering by periodic array of circu...
Efficient mode-matching analysis of 2-D scattering by periodic array of circu...Yong Heui Cho
 
Qiu2004 curved-bistable
Qiu2004 curved-bistableQiu2004 curved-bistable
Qiu2004 curved-bistableHo Linh
 
DWS MODELING OF MULTICONDUCTOR TRANSMISSION LINES
DWS MODELING OF MULTICONDUCTOR TRANSMISSION LINESDWS MODELING OF MULTICONDUCTOR TRANSMISSION LINES
DWS MODELING OF MULTICONDUCTOR TRANSMISSION LINESPiero Belforte
 
Optimization of Surface Impedance for Reducing Surface Waves between Antennas
Optimization of Surface Impedance for Reducing Surface Waves between AntennasOptimization of Surface Impedance for Reducing Surface Waves between Antennas
Optimization of Surface Impedance for Reducing Surface Waves between AntennasIJMER
 
Radiation patterns account of a circular microstrip antenna loaded two annular
Radiation patterns account of a circular microstrip antenna  loaded two annularRadiation patterns account of a circular microstrip antenna  loaded two annular
Radiation patterns account of a circular microstrip antenna loaded two annularwailGodaymi1
 
ACME2016-extendedAbstract
ACME2016-extendedAbstractACME2016-extendedAbstract
ACME2016-extendedAbstractZhaowei Liu
 
finite element method for waveguide
finite element method for waveguidefinite element method for waveguide
finite element method for waveguideAnuj012
 
Anuj 10mar2016
Anuj 10mar2016Anuj 10mar2016
Anuj 10mar2016Anuj012
 
Relevance Vector Machines for Earthquake Response Spectra
Relevance Vector Machines for Earthquake Response Spectra Relevance Vector Machines for Earthquake Response Spectra
Relevance Vector Machines for Earthquake Response Spectra drboon
 
Relevance Vector Machines for Earthquake Response Spectra
Relevance Vector Machines for Earthquake Response Spectra Relevance Vector Machines for Earthquake Response Spectra
Relevance Vector Machines for Earthquake Response Spectra drboon
 
International journal of applied sciences and innovation vol 2015 - no 1 - ...
International journal of applied sciences and innovation   vol 2015 - no 1 - ...International journal of applied sciences and innovation   vol 2015 - no 1 - ...
International journal of applied sciences and innovation vol 2015 - no 1 - ...sophiabelthome
 
Bg2420212027
Bg2420212027Bg2420212027
Bg2420212027IJMER
 
Inversion of Magnetic Anomalies Due to 2-D Cylindrical Structures – By an Art...
Inversion of Magnetic Anomalies Due to 2-D Cylindrical Structures – By an Art...Inversion of Magnetic Anomalies Due to 2-D Cylindrical Structures – By an Art...
Inversion of Magnetic Anomalies Due to 2-D Cylindrical Structures – By an Art...ijsc
 
INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...
INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...
INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...ijsc
 
INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...
INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...
INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...ijsc
 
Static and Dynamic Reanalysis of Tapered Beam
Static and Dynamic Reanalysis of Tapered BeamStatic and Dynamic Reanalysis of Tapered Beam
Static and Dynamic Reanalysis of Tapered BeamIJERA Editor
 

Similar to synopsis_divyesh (20)

Investigation on EM radiations from interconnects in integrated circuits
Investigation on EM radiations from interconnects in integrated circuitsInvestigation on EM radiations from interconnects in integrated circuits
Investigation on EM radiations from interconnects in integrated circuits
 
MODELING OF PLANAR METAMATERIAL STRUCTURE AND ITS EFFECTIVE PARAMETER EXTRACTION
MODELING OF PLANAR METAMATERIAL STRUCTURE AND ITS EFFECTIVE PARAMETER EXTRACTIONMODELING OF PLANAR METAMATERIAL STRUCTURE AND ITS EFFECTIVE PARAMETER EXTRACTION
MODELING OF PLANAR METAMATERIAL STRUCTURE AND ITS EFFECTIVE PARAMETER EXTRACTION
 
Expert system of single magnetic lens using JESS in Focused Ion Beam
Expert system of single magnetic lens using JESS in Focused Ion BeamExpert system of single magnetic lens using JESS in Focused Ion Beam
Expert system of single magnetic lens using JESS in Focused Ion Beam
 
Algorithm for the Dynamic Analysis of Plane Rectangular Rigid Frame Subjected...
Algorithm for the Dynamic Analysis of Plane Rectangular Rigid Frame Subjected...Algorithm for the Dynamic Analysis of Plane Rectangular Rigid Frame Subjected...
Algorithm for the Dynamic Analysis of Plane Rectangular Rigid Frame Subjected...
 
Efficient mode-matching analysis of 2-D scattering by periodic array of circu...
Efficient mode-matching analysis of 2-D scattering by periodic array of circu...Efficient mode-matching analysis of 2-D scattering by periodic array of circu...
Efficient mode-matching analysis of 2-D scattering by periodic array of circu...
 
Qiu2004 curved-bistable
Qiu2004 curved-bistableQiu2004 curved-bistable
Qiu2004 curved-bistable
 
DWS MODELING OF MULTICONDUCTOR TRANSMISSION LINES
DWS MODELING OF MULTICONDUCTOR TRANSMISSION LINESDWS MODELING OF MULTICONDUCTOR TRANSMISSION LINES
DWS MODELING OF MULTICONDUCTOR TRANSMISSION LINES
 
Optimization of Surface Impedance for Reducing Surface Waves between Antennas
Optimization of Surface Impedance for Reducing Surface Waves between AntennasOptimization of Surface Impedance for Reducing Surface Waves between Antennas
Optimization of Surface Impedance for Reducing Surface Waves between Antennas
 
Radiation patterns account of a circular microstrip antenna loaded two annular
Radiation patterns account of a circular microstrip antenna  loaded two annularRadiation patterns account of a circular microstrip antenna  loaded two annular
Radiation patterns account of a circular microstrip antenna loaded two annular
 
ACME2016-extendedAbstract
ACME2016-extendedAbstractACME2016-extendedAbstract
ACME2016-extendedAbstract
 
finite element method for waveguide
finite element method for waveguidefinite element method for waveguide
finite element method for waveguide
 
Anuj 10mar2016
Anuj 10mar2016Anuj 10mar2016
Anuj 10mar2016
 
Relevance Vector Machines for Earthquake Response Spectra
Relevance Vector Machines for Earthquake Response Spectra Relevance Vector Machines for Earthquake Response Spectra
Relevance Vector Machines for Earthquake Response Spectra
 
Relevance Vector Machines for Earthquake Response Spectra
Relevance Vector Machines for Earthquake Response Spectra Relevance Vector Machines for Earthquake Response Spectra
Relevance Vector Machines for Earthquake Response Spectra
 
International journal of applied sciences and innovation vol 2015 - no 1 - ...
International journal of applied sciences and innovation   vol 2015 - no 1 - ...International journal of applied sciences and innovation   vol 2015 - no 1 - ...
International journal of applied sciences and innovation vol 2015 - no 1 - ...
 
Bg2420212027
Bg2420212027Bg2420212027
Bg2420212027
 
Inversion of Magnetic Anomalies Due to 2-D Cylindrical Structures – By an Art...
Inversion of Magnetic Anomalies Due to 2-D Cylindrical Structures – By an Art...Inversion of Magnetic Anomalies Due to 2-D Cylindrical Structures – By an Art...
Inversion of Magnetic Anomalies Due to 2-D Cylindrical Structures – By an Art...
 
INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...
INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...
INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...
 
INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...
INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...
INVERSIONOF MAGNETIC ANOMALIES DUE TO 2-D CYLINDRICAL STRUCTURES –BY AN ARTIF...
 
Static and Dynamic Reanalysis of Tapered Beam
Static and Dynamic Reanalysis of Tapered BeamStatic and Dynamic Reanalysis of Tapered Beam
Static and Dynamic Reanalysis of Tapered Beam
 

synopsis_divyesh

  • 1. I A Simple Mesh Free Model for Analysis of Smart Composite Beams Synopsis submitted to Indian Institute of Technology, Kharagpur For the degree of Master of Technology in Mechanical Systems Design by Divyesh Mistry 14ME63R02 Under the guidance of Dr. Manas Chandra Ray DEPARTMENT OF MECHANICAL ENGINEERING INDIAN INSTITUTE OF TECHNOLOGY, KHARAGPUR KHARAGPUR 721302, INDIA April 2016
  • 2. II Abstract Piezoelectric laminated beams are common piezoelectric structure. It has been applied in many fields, such as the driving element of the bimorph and unimorph piezoelectric actuators bending. For static and dynamic, linear and nonlinear, analytical method and numerical method, the mechanical behaviors of this structure (including bending, vibration, buckling and control, etc.) have very comprehensive research. In these studies, most of the research is to use of laminated beam theory simplified into 1D control equation. However, here we will adopt a new approximate method based on Element free Galerkin (EFG) for the numerical simulation of piezoelectric laminated beam. This new Meshfree method can overcome the material discontinuity between layer and thickness lock phenomenon. This new method is suitable for thin beam and thick beam. It can be generalized to the numerical calculation of laminated curved beam, laminated plate and shell structures. Numerical examples verify the validity and precision of the proposed method. KEY WORDS : Piezoelectric; Meshfree method; Element Free Galerkin; Laminated beam; Moving Least Square Method.
  • 3. 1 1. INTRODUCTION The development of the MFree methods can be traced back more than seventy years to the collocation methods (Slater, 1934; Barta, 1937;Frazer et al., 1937; Lanczos, 1938, etc.). Belytschko Lu and Gu in 1994 refined and modified the method and called their method EFG, element free Galerkin. These methods do not require a mesh at least for the field variable interpolations. Adaptive analysis and simulations using MFree methods become very efficient and much easier to implement, even for problems which pose difficulties for the traditional FEM. In MFree methods in which the approximate solution is constructed entirely in terms of a set of nodes, and no elements or characterization of the interrelationship of the nodes is needed to construct the discrete equations. It is then possible to develop discrete equations from a set of nodes and a description of the internal and external surfaces of the model. For the latter purpose, a CAD description, such as a model in three dimensions, may be used, so Meshfree methods may overcome many of the difficulties associated with meshing for three-dimensional analyses. Objectives  The main objective of this project is Static analyze of smart composite beam using Meshfree method.  To define shape function construction for MFree method and Meshfree interpolation/approximation techniques.  To derive the solution for smart composite beam.  Comparison of Responses of MFree Method for Three Layered (0°/90°/0°) Composite Beam with Exact Solution Method.  Comparison of Responses of MFree Method for Four Layered (0°/90°/0°/90°) Composite Beam with Exact Solution Method
  • 4. 2 Shape functions based on a pre-defined element Mesh generation Node generation Shape functions based on a nodes in support domain Solution for field variables Post-processing 2. MESHFREE METHOD FEM has the inherent shortcomings of numerical methods that rely on meshes or elements that are connected together by nodes in a properly predefined manner. The following limitations of FEM are becoming increasingly evident: 1) High cost in creating an FEM mesh 2) Low accuracy of stress 3) Limitation in the analyses of some problems 4) Difficulty in adaptive analysis 2.1 Definition of Meshfree Methods The definition of an MFree method (GR Liu, 2002) is: “An MFree method is a method used to establish system algebraic equations for the whole problem domain without the use of a predefined mesh for the domain discretization.” 2.2.1 Solution Procedure of MFree Methods FEM MFree ` Fig. (2.1) Flow chart for FEM and MFree method Geometry creation Discretized system equatons
  • 5. 3 2.2 Moving Least Squares Shape Functions The moving least squares (MLS) approximation was devised by mathematicians in data fitting and surface construction (Lancaster and Salkausdas 1981; Cleveland 1993). It can be categorized as a method of series representation of functions. The MLS approximation is now widely used in MFree methods for constructing MFree shape functions. 2.2.1 Formulation of MLS shape functions Consider an unknown scalar function of a field variable 𝑢(𝑥) in the domain: The MLS approximation of 𝑢(𝑥) is defined at 𝑥 as, 𝒖 𝒉(𝒙) = ∑ 𝒑𝒋(𝒙) 𝒂𝒋 𝒎 𝒋=𝟏 (𝒙) = 𝑷 𝑻 (𝒙)𝒂(𝒙) (1) Where 𝑃(𝑥) is the basis function of the spatial coordinates, 𝑋 𝑇 = [𝑥, 𝑦] for two dimensional problems, and m is the number of the basis functions. The basis function 𝑃(𝑥) is often built using monomials from the Pascal triangle to ensure minimum completeness. 𝑎(𝑥) is a vector of coefficients given by, 𝒂 𝑻(𝒙) = {𝒂 𝟏(𝒙) 𝒂 𝟐(𝒙) 𝒂 𝟑(𝒙) … … … . 𝒂 𝒏(𝒙)} (2) Note that the coefficient vector 𝑎(𝑥) in Equation (2) is a function of 𝑥. The shape function 𝝍𝒊(𝒙) for the 𝑖 𝑡ℎ node is defined by, 𝝍𝒊(𝒙) = ∑ 𝒑𝒋 𝒎 𝒋=𝟏 (𝑨−𝟏 (𝒙) 𝑯 (𝒙))𝒋𝒊 = 𝑷 𝑻 (𝒙)(𝑨−𝟏 𝑯)𝒊 Where, 𝑨(𝒙) = ∑ 𝑾𝒊 ̂ (𝒙)𝒏 𝒊=𝟏 𝑷(𝒙𝒊)𝑷 𝑻 (𝒙𝒊) 𝑯(𝒙) = [ 𝑾 𝟏 ̂ (𝒙)𝑷(𝒙 𝟏) 𝑾 𝟐 ̂(𝒙)𝑷(𝒙 𝟐) … … … . . 𝑾 𝒏 ̂ (𝒙)𝑷(𝒙 𝒏) ] In the MLS, the coefficient 𝐚 is the function of 𝑥 which makes the approximation of weighted least squares move continuously. Therefore, the MLS shape function will be continuous in the entire global domain, as long as the weight functions are chosen properly.
  • 6. 4 3. ANALYSIS OF SMART COMPOSITE BEAM Fig.3.1 Schematic diagrams of smart cantilevered laminated composite beams The governing stress equilibrium equations and the charge equilibrium equation for an electro-mechanical solid are 0j,ij  and 0D i,i  ; xj,i  and z (3) where ij is the component of Cauchy stress tensor at any point in the solid, iD is the electric displacement at the point along the direction denoted by i , S is the boundary of the solid and  is the volume of the solid. A weak form of the variational principle which would yield the above equilibrium equations is given by 0dEDddSnDdSun iiijij S ii S ijij       (4) in which  is the symbol of variational operator and executes the first variation of a dependent variable, iu and iE are the displacements and electric field, respectively at any point in the solid along the direction represented by i , ij is the linear strain tensor at the point and  is the electric potential. The reduced constitutive relations appropriate for the beam analysis and representing the converse and the direct piezoelectric effects are given by }E](e[}]{C[}{ ppp  , (5) }E]([}{]e[}D{ pT  (6) In Eqs. (5) and (6), the state of stresses }{ p  , the state of strains }{ p  , the electric field vector }E{ , the electric displacement vector }D{ , the elastic coefficient matrix ]C[ p , the piezoelectric constant matrix ]e[ and the dielectric constant matrix ][ . The constitutive relations for the k -th orthotropic composite layer of the substrate beam are }]{C[}{ kkk  ; N,,3,2,1k  (7)
  • 7. 5 The state of stresses }{ k  , the state of strains }{ k  at any point in the k -th layer of the substrate beam and the elastic coefficient matrix ]C[ k . Two compatible displacement fields are considered for deriving the present mesh free model (MFM) of the smart composite beams. For the substrate beam, an equivalent single layer first order shear deformation theory (FSDT) describing the axial displacements u and w at any point in the substrate beam along the x and z directions, respectively is considered as x0 zuu  and z0 zww  (8) in which 0u and 0w are the translational displacements of any point on the mid-plane ( z =0) of the substrate beam along x and z directions, respectively; x is the rotation of the normal to the mid-plane of the substrate beam with respect to the z -axis and z is the gradient of the transverse displacement w with respect to z . The corresponding axial displacements p u and p w at any point in the piezoelectric layer are considered as follows: xx0 p )2/hz( 2 h uu  and zz0 p )2/hz( 2 h ww  (9) in which x is the rotation of the transverse normal to the piezoelectric layer across its thickness with respect to the z -axis and z is gradient of the transverse displacement p w with respect to the z -axis. The generalized displacement coordinates at any point in the overall beam are expressed in a vector form as follows: T zxzx00 ]wu[}d{  (10) The variation of electric potential across the thickness of the piezoelectric layer is linear [12]. Thus the electric potential function which is zero at the interface between the piezoelectric layer and the substrate beam may be assumed as )x( h )2/hz( )z,x( 0 p    (11) wherein 0 is the electric potential distribution at the top surface of the piezoelectric layer. Accordingly, using Eqs. (8)-(11), the states of strains in the substrate beam and the piezoelectric layer and the electric potential field in the piezoelectric layer can expressed as   }]{Z[ x w z u z w x u }{ 1 T Tk xz k z k x k                 ,   }]{Z[ x w z u z w x u }{ 2 T pppp Tp xz p z p x p                 ,   }E]{Z[ zx EE}E{ p T T zx            In which the matrices ]Z[ 1 , ]Z[ 2 and ]Z[ p , the generalized strain vector }{ and the generalized electric field vector.
  • 8. 6 From the weak form of the variational principle, it is to be noted that the z coordinates of the top and bottom surfaces of the k -th layer of the substrate beam are denoted by 1kh  and kh , respectively. The essential boundary conditions of the present overall smart beams can be derived from the variational principle given by as follows: simply supported smart beams: T 0x T zz000xb ]0000[]wu[}d{   and 0)0(0  T Lx T zz0Lxb ]000[]w[}d{   and 0)L(0  (12) Clamped-free smart beams: T 0x T zzxx000xb ]000000[]wu[}d{   (13) The variational principle also yields the following interface continuity conditions and prescribed boundary conditions: )h,x()h,x( 1k 1k xz1k k xz     , )h,x()h,x( 1k 1k z1k k z     ; 1N,,3,2,1k   , )h,x()h,x( 1N p xz1N N xz   , )h,x()h,x( 1N p z1N N z   , 0)h2/h,x( p p xz  3.1 ELEMENT FREE GALERKIN METHOD The element-free Galerkin (EFG) method is a meshless method uses the moving least squares (MLS) shape functions, Because the MLS approximation lacks the Kronecker delta function property, The EFG method employs moving least-square (MLS) approximants to approximate the function 𝑢(𝑥) with 𝑢ℎ ( 𝑥). These approximants are constructed from three components: a weight function of compact support associated with each node, a basis, usually consisting of a polynomial, and a set of coefficients that depend on position. The element free Galerkin method is implemented to derive the smart mesh free model (MFM). Any generalized displacement say 0u at any point (x ) can be approximated by the moving least squares (MLS) approximation as, }a{}P{u T 0  (14) where }P{ is a column vector constructed from a basis function and }a{ is a column vector of coefficients of the basis function. The linear basis function for one dimensional problem is considered here.
  • 9. 7 T ]x1[}P{  and T 10 ])x(a)x(a[}a{  (15) Substituting for the approximation of )x(u0 at any point can be expressed in terms of the nodal parameters of )x(u0 as, }d]{[u 00  (16) in which ]H[]A[}P{]....[][ 1TT n321   with i being the shape function associated with the i -th node. It is evident that the MLS approximations of other generalized displacement variables yields the same shape functions associated with the i -th node. Thus the generalized displacement vector }d{ and the electric potential 0 at any point can be expressed in terms of the nodal generalized displacement parameter vector and the nodal electric potential vector, respectively as follows: }X]{N[}d{  and }]{[0  (17) Since the mesh free shape function does not satisfy the property of the Kronecker delta function, the essential boundary conditions are satisfied using Lagrange multipliers. Also, electric potential at the top surface of the piezoelectric layer will be prescribed. In which }{ 0 and }{ L are the vectors of Lagrange multipliers for the essential displacement boundary conditions at x =0 and L , respectively. The moment resultants xM and p xM . The following discrete governing equations of the overall smart composite beams can be derived: }F{}]{F[}]{G[}X]{K[ p  and }X{}X{]G[ b T  (18) in which the overall stiffness matrix ]K[ , the matrix ]G[ , the electro-elastic coupling matrix ]F[ p , the mechanical load vector }F{ , the Lagrange multiplier vector }{ and the vector of essential displacement boundary conditions }X{ b .
  • 10. 8 4. NUMERICAL RESULTS AND CONCLUSION The following material properties for the layers of the substrates are considered for evaluating the numerical results: 𝑬 𝟏 = 𝟏𝟕𝟐. 𝟓 × 𝟏𝟎 𝟗 ; 𝑬 𝟐 = 𝑬 𝟏 𝟐𝟓 ; 𝑬 𝟑 = 𝑬 𝟐; 𝑮 𝟏𝟐 = 𝟎. 𝟓 × 𝑬 𝟐; 𝑮 𝟏𝟐 = 𝑮 𝟐𝟑; 𝑮 𝟏𝟐 = 𝟎. 𝟐 × 𝟏𝟎 𝟐 ; 𝝁 𝟏𝟐 = 𝟎. 𝟐𝟓; 𝝁 𝟏𝟑 = 𝟎. 𝟐𝟓; 𝝁 𝟐𝟑 = 𝟎. 𝟐𝟓 The results are evaluated with and without applying the electrical potential distribution on the actuator surface for different values of length to thickness ratios s(=a/h) and m=n=1 in the definition of p and q. The following non- dimensional parameters are used for presenting the numerical results. )0,x(w aq hE100 w 4 0 3 T  , where s =50, ph =250 m, h=0.005m A program was made in MATLAB to calculate axial stresses and shear stresses across the thickness for three layer composite beam and four layer composite beam. The results are as shown in figure. stresses in the cross-ply substrates (0-90-0) is computed with and without applying the externally applied voltage to the piezo layer. 4.1 Comparison of Responses of MFree Method for Three Layered (0/90/0) Composite Beam with Exact Solution Method. Fig. (4.1) Active static control of shape of a three layered composite beam (s =50, ph =250 m, h=0.005m, )0,x(w aq hE100 w 4 0 3 T  , 0q =50N/m 2 )
  • 11. 9 Fig. (4.2) Distribution of the axial stress across the thickness of the three layered ( 000 0/90/0 ) composite beam with and without actuated by a piezoelectric layer Fig. (4.3) Distribution of the transverse stress across the thickness of the three layered ( 000 0/90/0 ) composite beam with and without actuated by a piezoelectric layer 0q =50N/m 2 )
  • 12. 10 4.2 Natural Frequencies of for Three Layered (0°/90°/0°) Composite Beam Beam 0°/90°/0° Source 1st mode 2nd mode 3rd mode S=100 Present [MFree] 32 204 557 FEM[Ref.20] 35 210 564 Table 1. Natural frequencies of the substrate beam with negligible thickness (Hz) 4.3 Conclusion In the present work, a new layer wise laminated beam theory based on element free Galerkin (EFG) is proposed to analyze the numerical simulation of piezoelectric laminated beam have been used to verify the validity and precision of the proposed method. It only needs nodes distributed on the upper and lower surfaces of each layer, which avoids the troublesome in generating mesh and saves much preprocess time MLS approximants, which constitute the back bone of the method were described, including several examples. The convergence characteristic and accuracy of the method are validated with exact solution. In all the simulations, numeric solutions are insensitive to the EFG-related parameters, which demonstrate the stability of the proposed method. With MFree methods like EFG it is possible to review developments and applications for various types of structure mechanics and fracture mechanics applications like bending, buckling, free vibration analysis, sensitivity analysis and topology optimization, single and mixed mode crack problems, fatigue crack growth, and dynamic crack analysis and some typical applications like vibration of cracked structures, thermoselastic crack problems, and failure transition in impact problems. Meshfree methods is the possibility of simplifying adaptively and problems with moving boundaries and discontinuities, such as phase changes or cracks.
  • 13. 11 REFERENCES [ 1 ] Belytschko, T., Y.Y. Lu, and L.Gu (1994), Element Free Galerkin Methods", International Journal for Numeric al Methods in Engineering, 37, 229-256. [ 2 ] Belytschko, T., D. Organ, and Y. Krongauz (1995), A Coupled Finite Element- Element free Galerkin Method", Computational Mechanics, 17, 186-195. [ 3 ] Belytschko, T., Y. Krongauz, M. Fleming, D. Organ and W.K. Liu (1996), Smoothing and Accelerated Computations in the Element-free Galerkin Method", Journal of Computational and Applied Mechanics, 74, 111-126. [ 4 ] Belytschko, T., Y. Krongauz, D. Organ, M. Fleming and P. Krysl (1996), Meshless Methods: An Overview and Recent Developments", Computer Methods in Applied Mechanics and Engineering, 139, 3-47. [ 5 ] Beissel, S. and Belytschko, T. (1996) “Nodal integration of the element-free Galerkin method,” Computational Methods Appl. Mech. Eng. 139, 49–74. [ 6 ] Duarte, C.A.M. and Oden, J.T. (1995) “Hp clouds-A meshless method to solve boundary value problems,” TICAM Report, 95-05.3 [ 7 ] J. Dolbow and T. Belytschko, (1998) “An Introduction to Programming the Meshless Element Free Galerkin Method”, Vol. 5, 3, 207-241 [ 8 ] Duarte, C.A. and J.T. Oden (1996), H-p Clouds - an h-p Meshless Method, Numeric al Methods for Partial Differential Equations, 1-34. [ 9 ] Lancaster, P. and K. Salkauskas (1981), Surfaces Generated by Moving Least Squares Methods", Mathematics of Computation, 37, 141-158. [ 10 ] Liu,W.K., S. Jun, and Y.F. Zhang (1995), Reproducing Kernel P article Methods", International Journal for Numerical Methods in Engineering, 20 , 1081-1106. [ 11 ] Lu,Y.Y., T. Belytschko and L. Gu (1994), A New Implementation of the Element Free Galerkin Method", Computer Methods in Applied Mechanics and Engineering, 113, 397-414. [ 12 ] Timoshenko, S.P .and J.N. Goodier (1970),Theory of Elasticity (Third ed.). New York, McGraw Hill.
  • 14. 12 [ 13 ] Ray M. C., Mallik N. (2004), “Finite Element Solutions for Static Analysis of Smart Structures With a Layer of Piezoelectric Fiber Reinforced Composites”, AIAA Journal, vol. 42, no. 7, 2004, pp. 1398-1405. [ 14 ] Anderson EH, Hagood(1994), Simultaneous piezoelectric sensingactuation: analysis and application to controlled structures. Sound Vibration. [ 15 ] Donthireddy P, Chandrashekhara K (1996), Modeling and shape control of composite beams with embedded piezoelectric actuators. [ 16 ] Kapuria S, Sengupta S, Dumir PC (1997), Three-dimensional piezothermoelastic solution for shape control of cylindrical panel. J Thermal Stresses. [ 17 ] Crawley, E.F. and Luis, J.D. (1987), Use of piezoelectric actuators as elements of intelligent structures, American Institute of Aeronautics and Astronautics Journal 25(10), 1373–1385. [ 18 ] Lee, C.K., Chiang, W.W. and Sulivan (1991), Piezoelectric modal sensor/actuator pairs for critical active damping vibration control, Journal of the Acoustical Society of America 90, 374–384. [ 19 ] J.N. Reddy, (1999) On laminated composite plates with integrated sensors and actuators. Engineer structure.; 21: 568-593. [ 20 ] Ray M C and Mallik N (2004) Active control of laminated composite beams using piezoelectric fiber reinforced composite layer Smart Material Structure. 13 146–52.