Internet Parallel Structure Analysis Program (IPSAP) User's Guide

Size: px
Start display at page:

Download "Internet Parallel Structure Analysis Program (IPSAP) User's Guide"

Transcription

1 Internet Parallel Structure Analysis Program (IPSAP) User's Guide Version 1.8 Aerospace Structure Laboratory Seoul National University, Korea April 10, 2009

2 Chapter 1 Overview Internet Parallel Structure Analysis Program (IPSAP) is written by C, C++ and MPI. IPSAP is particularly suited for parallel numerical simulations involving large structures. In this type of computation, IPSAP dramatically reduces the time spent and the memory usage by solving a linear algebraic equations efficiently. IPSAP can be used for directly simulating a structural model with an input file written in the given definite form. Two main algorithms implemented in IPSAP are the Multifrontal Algorithm for static analysis and the Block Lanczos Iteration Algorithm with implicit restart out-of-core storage technique for vibration analysis. Both two algorithms are modified ones which are based on the element by element calling sequence which best fits for the well-known finite element method and distributed memory parallel technique based on use of BLAS, LAPACK(CLAPACK), METIS. 1.1 Feature of This Version 1. Element - Hexa8 : 8-node solid - Tetra4 : 4-node solid - Quad4 : 4-node shell - Tri3 : 3-node shell - Beam2 : 2-node beam 2. Property - PropSolid : solid property - PropShell : shell property - PropComp : shell property - PropBeam : beam property - PropBeamL : beam property 3. Material - Elastic3DIsotropic : 3 dimensional isotropic - Elastic3DOrthotropic : 3 dimensional orthotropic - Elastic2DIsotropic : 2 dimensional isotropic 1

3 - Elastic2DOrthotropic : 2 dimensional orthotropic - Elastic1D : 1 dimensional 4. LoadCase 5. Load - Force - Moment - Pressure - Global Acceleration - Nodal Temperature - Nodal Force 6. Analysis Type - LinearStatic : displacement - stress analysis - Vibration : frequency - normal mode analysis 7. ETC - Rigid Connection Element - Material Coordinate System - Many Kinds of Solution Parameters 1.2 Finite element implementation IPSAP provides three types of element - solid, shell, beam. All of them work on three dimensional space for general purpose. Solid element is classified into eight node hexahedron (Hexa8) and four node tetrahedron(tetra4) and shell element is separated three node triangle(tri3) and four node square(quad4). Beam element is Beam2. It will be described in chapter 5. 2

4 Chapter 2 Pre-requirement Depending on the pre-compiled versions of IPSAP, BLAS library may be required. 1 In addition, parallel version requires MPI (Message Passing Interface) such as LAM/MPI, MPICH or MSMPI. Even though IPSAP can be run with various kinds of BLAS library, we recommend for you to use BLAS by Kazushige Goto 2 in linux system and Intel Math Kernel Library(MKL) 3 in windows system for the best performance. In this time of release, for the users who do not have any kind of BLAS, every execution files are compiled statically. 1 LAPACK(CLAPACK) and METIS are statically linked in. 2 In IPSAP execution file for linux OS, GOTO is statically linked in. 3 In IPSAP execution file for windows OS, MKL is statically linked in. 3

5 Chapter 3 How to download The IPSAP can be downloaded from : Note that there are actually several pre-compiled single and parallel IPSAP executable files, depending on your machine architecture, operating system and MPI. See Table 3.1 for Windows and Table 3.2 for Linux operating system. As mentioned in the previous chapter, IPSAP used BLAS library named in the tables. Table 3.1 : IPSAP binary files for Windows CPU architecture BLAS MPI IPSAP executable 32-bit Single Intel MKL - IPSAP_single_x86.exe 64-bit Single Intel MKL - IPSAP_single_x64.exe 32-bit Parallel Intel MKL MS MPI IPSAP_parallel_x86.exe 64-bit Parallel Intel MKL MS MPI IPSAP_parallel_x64.exe Table 3.2 : IPSAP binary files for Linux CPU architecture BLAS MPI IPSAP executable 32-bit Single GOTO - IPSAP_single_x86.run 64-bit Single GOTO - IPSAP_single_x86_64.run 32-bit Parallel GOTO LAM/MPI MPICH2 IPSAP_parallel_x86.run IPSAP_parallel_x86_mpich2.run 64-bit Parallel GOTO LAM/MPI MPICH2 IPSAP_parallel_x86_64.run IPSAP_parallel_x86_64_mpich2.run 4

6 Chapter 4 How to run 4.1 Linux Operating System 1. IPSAP is statically compiled with GOTO blas library and does not require any additional library. 2. run IPSAP with the following command in a terminal $exec path/exec name input file 3. running parallel versions follows the same analogy $mpirun -np (N.P) exec path/exec name input file 4.2 Windows Operating System 1. IPSAP is statically compiled with Intel MKL library and does not require any additional library. 2. In the same way of linux OS as following command, you can run the program. $exec path/exec name input file 3. running parallel versions follows the same analogy $mpirun -np (N.P) exec path/exec name input file 5

7 Chapter 5 Format of Input file IPSAP input file has several control strings to distinguish each data set for finite element method. Table 5.1 shows typical input file. Each control string should be preceded by asterisk and written in uppercase. Brief descriptions are follows. Table 5.1 : The Example of IPSAP Input File TITLE IPSAP Input File Example'' NODE e e e e e e abbreviation -- PROPERTY PropShell MATERIAL Elastic2DIsotrpoic e ANALYSYSTYPE Vibration ELEMENT Quad abbreviation -- NSET NSET 2 81 BOUNDARY LOADCASE LOAD NodalForce ENDDATA OUTOPT default.out 1 END 6

8 5.1 TITLE TITLE string This is for the title or explanation of job and can be continued in new lines until next control string is reached. 5.2 NODE NODE NID X-Coordinate Y-Coordinate Z-Coordinate NID X-Coordinate Y-Coordinate Z-Coordinate NID(node id) does not need to be in order, but each coordinate should be global data. Notice that NID should not be duplicated. 5.3 ELEMENT ELEMENT type Regardless of element type, all elements require EID(element id), PID(property id) and connectivity. Depending on element type, IPSAP requires different information in different format. The format and element coordinate system are as below(see Figure 5.1). The data for one element should be written in one line. 1. Beam2 'Beam2' requires two NID's for connectivity and one vector which is located in the plane made by r-axis and s-axis. It is also with respect to global coordinate system. The vector is used to determine the beam's element coordinate. ELEMENT Beam2 EID PID NID NID X-coord Y-coord Z-coord EID PID NID NID X-coord Y-coord Z-coord 2. Hexa8 'Hexa8' is 8 nodes hexahedron solid element and therefore requires eight NID's for connectivity within one line. ELEMENT Hexa8 EID PID NID NID NID NID EID PID NID NID NID NID 3. Tetra4 'Tetra4' is four nodes tetrahedron element and requires four NID's. 7

9 Figure 5.1 : Natural Coordinate System of Element ELEMENT Tetra4 EID PID NID NID NID NID EID PID NID NID NID NID 4. Tri3 'Tri3' is three nodes shell element and requires three NID's. In addition, theta or MCID and offset is defined. theta means material property orientation angle in degrees and MCID means material coordinate system identification number. And offset means offset value from the surface of grid points to the element reference plane. ELEMENT Tri3 EID PID NID NID NID EID PID NID NID NID theta or MCID theta or MCID offset offset 5. Quad4 'Quad4' is 4 nodes shell element and requires four connectivities. There are also defined theta or MCID and offset. The meaning of theta or MCID and offset of Quad4 is same with Tri3. 8

10 ELEMENT Quad4 EID PID NID NID NID NID EID PID NID NID NID NID theta or MCID theta or MCID offset offset 6. Elast0 This defines zero dimensional spring element. 'Elast0' requires one NID and one DOFID of NID. ELEMENT Elast0 EID PID NID DOFID EID PID NID DOFID 7. Elast1 This defines one dimensional spring element. 'Elast1' requires two NIDs and two DOFIDs of NIDs. And PID is related with PropElast in PROPERTY. ELEMENT Elast1 EID PID NID1 DOFID1 NID2 DOFID2 EID PID NID1 DOFID1 NID2 DOFID2 5.4 PROPERTY 'Property' defines geometric features of structures. Regardless of kind of property, all properties require PID(property id) and MID(material id). Depending on structural dimension, IPSAP requires different PROPERTY type information in different format. The data for one property should be written in one line. 1. PropSolid 'PropSolid' requires basically PID and MID because all geometric features of solid elements can be obtained from the locations of nodes. In addition, MCID is required. MCID defines the material property coordinate system. PROPERTY PropSolid PID MID (MCID) PID MID (MCID) 2. PropShell 'PropShell' requires basically two parameters which are MID and thickness. In addition, for considering bending moment and transverse shear, MID1 and MID2 is defined. bfact and sfact each mean the bending moment of inertia ratio and transverse shear thickness ratio and default values are each 1 and

11 And nsm defines nonstructural mass per unit area. PROPERTY PropShell PID MID thickness (MID1) (bfact) (MID2) (sfact) (nsm) PID MID thickness (MID1) (bfact) (MID2) (sfact) (nsm) 3. PropComp 'PropComp' defines the property of n-ply composite material laminate and requires PID, nsm, MIDi, Ti and thetai. PROPERTY PropComp PID nsm MID1 T1 theta1 MID1 T1 theta1 PROPERTY PropComp PID nsm MID1 T1 theta1 MID1 T1 theta1 4. PropBeam 'PropBeam' requires five more parameters which are A(cross-section area), three area moments of inertia(j, I ss, I tt ) and κ (shear effect factor). If I tt is not given, it is assumed to be equal to I ss. κ is generally about 5/6 and if κ is not given, the beam is assumed to be consistent with classical bending theory. And nsm defines nonstructural mass per unit area. PROPERTY PropBeam PID MID A J I ss (I tt ) ( κ ) (nsm) PID MID A J I ss (I tt ) ( κ ) (nsm) 5. PropBeamL 'PropBeam' defines the property of a beam element by cross-sectional dimensions. In IPSAP, six beam libraries are defined and these are ROD, TUBE, BAR, BOX, T1, L. By these dimensions of each beam library, A, J, I ss, and I tt are defined. PROPERTY PropBeamL PID MID DIM1 DIM2 DIM3 ( κ ) (nsm) PID MID DIM1 DIM2 DIM3 ( κ ) (nsm) 10

12 5. PropElast 'PropElast' specifies the stiffness of a scalar elastic(spring) element, Elast0 and Elast1 PROPERTY PID PID PropElast K K 5.5 MATERIAL MATERIAL type IPSAP provides only elastic material which can be classified according to directional symmetry and dimension. The data for one material should be written in one line. All materials have MID(material id), CID(coordinate id), elastic modulus, density and thermal expansion coefficients. If the density is not given, it is set 0.0. Detailed formats are as follows. 1. Elastic3DIsotropic 'Elastic3DIsotropic' is referenced by PropSolid and requires E(Young's modulus), ν (Poisson's ratio), ρ (density) and α (thermal expansion coefficient). MATERIAL Elastic3DIsotropic 11

13 MID E ν ( ρ ) ( α ) MID E ν ( ρ ) ( α ) 2. Elastic3DOrthotropic 'Elastic3DOrthotropic' is referenced also by PropSolid and requires more parameters than the isotropic case due to the directional differences in elastic moduli and thermal characteristics. MATERIAL Elastic3DOrthotropic MID E 1 E 2 E 3 ν 12 ν 23 ν 31 G 12 G 23 G 31 ( ρ ) ( α 1 ) ( α 2 ) ( α ) 3 MID E 1 E 2 E 3 ν ν ν 31 G 12 G 23 G 31 ( ρ ) ( α 1 ) ( α 2 ) ( α ) 3 3. Elastic2DIsotropic 'Elastic2DIsotropic' is a 2-dimensional version of 3D-Isotropic material and therefore referenced by PropShell. MATERIAL Elastic2DIsotropic MID E ν ( ρ ) ( α ) MID E ν ( ρ ) ( α ) 4. Elastic2DOrthotropic 'Elastic2DOrthotropic' is a 2-dimensional version of 3D-Orthotropic material and therefore referenced by PropShell. MATERIAL Elastic2DOrthotropic MID E 1 E 2 12 ν G 12 G 23 G 31 ( ρ ) ( α 1 ) ( α 2 ) MID E 1 E 2 ν 12 G 12 G 23 G 31 ( ρ ) ( α 1 ) ( α 2 ) 5. Elastic1D 'Elastic1D' is referenced by PropBeam. MATERIAL Elastic1DIsotropic MID E ν ( ρ ) ( α ) MID E ν ( ρ ) ( α ) 5.6 COORD Coordinate system in IPSAP is used only for material coordinates. All coordinates have CID(coordinate id) and three directional vectors which de_ne the x, y and z axis of new Cartesian coordinate system. The directional vectors are not required to have the magnitude of unity, but should be orthogonal with each other. It is notable that CID should be larger than zero because zero CID in the material control string designates the global reference coordinate. COORD 12

14 CID CID x X x Y x Z y X y Y y Z z X z Y z Z z x X x Y x Z y X y Y y Z z X z Y Z 5.7 ANALYSISTYPE ANALYSISTYPE LinearStatic integer integer ANALYSISTYPE Vibration integer integer integer integer integer Analysis type is one of LinearStatic and Vibration. According to the analysis type, the number of option is different. 'LinearStatic' need 2 options and 'Vibration' needs 5. The description is as follows: LinearStatic Element Block Size, Communication Block Size Vibration Element Block Size, Communication Block Size, Number of Eigen Value, Lanczos Block Size, Maximum Number of Block. Element Block Size controls the entire performance of solver. Generally one of the values 4, 8, 16, 32 will be moderate. Communication Block Size controls the parallel performance. The performance will be maximized around the value from 64 to 256, but too large value may induce failure of the program during the parallel job. In the case of failure, some smaller values(4,8,16,32) of communication block size is recommended. Vibration analysis mode of IPSAP computes eigenvalues from the first mode to N th mode. N is set by the third option of vibration analysis type, Number of Eigen Value. Lanczos Block Size is the number of Lanczos vectors which is handled during one Lanczos iteration. Commercial codes such as NASTRAN and ABAQUS set the default value of Lanczos block size 7. Maximum Number of Block option in Vibration analysis controls the maximum size of Lanczos block tridiagonal matrix which is defined by Maximum Number of Block x La nczos Block Size. From the experiences, the following condition is recommended for the performance of program. Maximum Number of Block x Lanczos Block Size > 4 x Number of EigenValue 5.8 NSET NSET is to define the boundary condition, nodal force and temperature. If NID's are continuous, TO keyword can be used. For example, may be replaced by 1 TO 4 NSET NSID Node ID NID NID NID NID NID NSET NSID Node ID NID NID NID NID NID. 5.9 BOUNDARY 'Magnitude' can be used for pre-described displacement boundary. For example if it is zero, then it means fixed boundary. 'Direction' is to give direction of displacement. The 13

15 number from 1 to 6 are used to represent translation(1,2,3) and rotation(4,5,6). BOUNDARY BID NSID Magnitude Direction BID NSID Magnitude Direction 5.10 LOADCASE LOADCASE LCID LID LID LID LID This option defines several loads to be used in one load case LOAD LOAD type According to the 'Load type', there are three choices, NodalForce, Acceleration and Temperature as below. 1. Force 'Force' is defined by X, Y and Z directional force. LOAD Force LID NID X-dir. Force Y-dir. Force Z-dir. Force 2. Moment 'Moment' is defined by X, Y and Z rotational force, moment. LOAD Moment LID NID X-dir. Moment Y-dir. Moment Z-dir. Moment 3. Pressure Pressure can be used on 2D Element, Tri3 and Quad4. LOAD Pressure LID EID Magnitude 4. Acceleration Acceleration is used for inertial load acting on the entire model such as the structure is under accelerating condition. LOAD Acceleration X-dir. Acceleration Y-dir. Acceleration Z-dir. Acceleration 5. Temperature Temperature load is active only if the elements which the node set is belonged 14

16 to have thermal expansion coefficients. LOAD Temperature LID NSID Temperature 6. NodalForce 'NodalForce' has the same form as 'BOUNDARY' control string. But, the usage of this keyword is not recommended. Instead of this keyword, Force and Moment keywords are newly involved. LOAD NodalForce LID NSID Magnitude Direction 5.12 RCON 'RCON' is the rigid connection between nodes like a stiff beam. The first IDNID is independent node and CM means component numbers of the dependent degrees of freedom in the global coordinate system at Node ID, DNIDi. Hense the others following DNIDis mean dependent nodes. RCON RCID IDNID CM DNID1 DNID2 RCON RCID IDNID CM DNID1 DNID ENDDATA 'ENDDATA' is a delimiter between model data and additional data. Therefore, additional data control strings follow OUTOPT In LinearStatic analysis, OUTOPT file-name 0 or 1 0 or 1 0 or 1 In Vibration analysis, OUTOPT file-name 0 or 1 0 or 1 This control string provides output format. file-name' designates the name of the output file which IPSAP will generate. The last two or three integers control the kind of output data. If IPSAP runs on LinearStatic analysis mode, information of original finite element model, displacement and stress will be written or not on file you named according to the choice of the field's value(0 or 1). For example, if you choose 0 in the first integer field, it means simply 'Do not write information of initial finite element model'. In the case of Vibration analysis, two fields, information of original finite element model and eigenvector will be referenced and the eigenvectors will be written or not according to the second field's value(0 or 1). If this control string does not appear in the input file, IPSAP generates a file named 'default.out' and assumes that all integer fields are on(1) such that the disp 15

17 lacement and the stress are written in the file EXPOPT EXPOPT Memory1 Memory2 initial shift Convergence criteria IPSAP provides expert user's mode to control memory usage, initial shift and convergence criteria. Memory1 assigns MBytes of memory for factorized frontal data, which will be stored in a disk storage if EXPOPT is not used. In the case of LinearStatic analysis mode, only Memory1 will be referenced. Memory2 assigns memory for Lanczos vectors in the same way of Memory1. Initial Shift will be efficient for a eigenvalue analysis model with insufficient boundary conditions and the recommendation is negative value. For the convergence criteria field, machine precision is used in general. If you are not sure, do not use 'EXPOPT' control string TEMPDIR TEMPDIR Temporary directory path 'TEMPDIR' let you choose temporary directory where IPSAP dump file is written instead of default current directory END 'END' means the end of all data. 16

18 Chapter 6 Format of Output file and Visualization 6.1 Format of Output Figure 6.1 and Figure 6.2 show the example of output file format. IPSAP RESULT FILE - LinearStatic ANALYSIS NID and EID ARE SORTED ONES! NODE 3362 NID X Y Z e e e e e e ELEMENT 1600 EID TYPE NID Tetra Tetra DISPLACEMENT NID U V W Rx Ry Rz e e e e e e NODAL FORCE APPLIED TO 1,2-DIMENSIONAL ELEMENT EID Fz Fy Fz Mx My Mz e e e e e e e e e e e e STRESS AVERAGE AT NODE BELONGING TO 3-DIMENSIONAL ELEMENT NID Sxx Syy Szz Sxy Syz Szx e e e e e e e e e e e e-01 Figure 6.1 : Output file format (Linear Static) 17

19 IPSAP RESULT FILE - Vibration ANALYSIS NID and EID ARE SORTED ONES! NODE 3362 NID X Y Z e e e e e e ELEMENT 1600 EID TYPE NID Tetra Tetra EIGENVALUE ANALYSIS SUMMARY 10 MODE 1 eigenvalue : e+05 MODE 1 eigenvalue : e MODE 1 eigenvalue : e+05 NID U V W Rx Ry Rz e e e e e e e e e e e MODE 2 - eigenvalue : e+05 NID U V W Rx Ry Rz e e e e e e e e e e e Figure 6.2 : Output file format (Vibration) 6.2 Visualization DIMAOND/IPSAP is the own visualization tool of IPSAP. By DIAMOND/IPSAP, you can enjoy the structure analysis. 18

CAEFEM v9.5 Information

CAEFEM v9.5 Information CAEFEM v9.5 Information Concurrent Analysis Corporation, 50 Via Ricardo, Thousand Oaks, CA 91320 USA Tel. (805) 375 1060, Fax (805) 375 1061 email: info@caefem.com or support@caefem.com Web: http://www.caefem.com

More information

3. Overview of MSC/NASTRAN

3. Overview of MSC/NASTRAN 3. Overview of MSC/NASTRAN MSC/NASTRAN is a general purpose finite element analysis program used in the field of static, dynamic, nonlinear, thermal, and optimization and is a FORTRAN program containing

More information

AERSYS KNOWLEDGE UNIT

AERSYS KNOWLEDGE UNIT -7016 1. INTRODUCTION The scope of this document is to provide a clarification and a deeper understanding of the two different ways to move the mid plane of the element out of the nodal plane. Although

More information

Analysis of Planar Truss

Analysis of Planar Truss Analysis of Planar Truss Although the APES computer program is not a specific matrix structural code, it can none the less be used to analyze simple structures. In this example, the following statically

More information

Program System for Machine Dynamics. Abstract. Version 5.0 November 2017

Program System for Machine Dynamics. Abstract. Version 5.0 November 2017 Program System for Machine Dynamics Abstract Version 5.0 November 2017 Ingenieur-Büro Klement Lerchenweg 2 D 65428 Rüsselsheim Phone +49/6142/55951 hd.klement@t-online.de What is MADYN? The program system

More information

Example 37 - Analytical Beam

Example 37 - Analytical Beam Example 37 - Analytical Beam Summary This example deals with the use of RADIOSS linear and nonlinear solvers. A beam submitted to a concentrated load on one extremity and fixed on the other hand is studied.

More information

ME 475 Modal Analysis of a Tapered Beam

ME 475 Modal Analysis of a Tapered Beam ME 475 Modal Analysis of a Tapered Beam Objectives: 1. To find the natural frequencies and mode shapes of a tapered beam using FEA.. To compare the FE solution to analytical solutions of the vibratory

More information

Workshop 8. Lateral Buckling

Workshop 8. Lateral Buckling Workshop 8 Lateral Buckling cross section A transversely loaded member that is bent about its major axis may buckle sideways if its compression flange is not laterally supported. The reason buckling occurs

More information

DISPENSA FEM in MSC. Nastran

DISPENSA FEM in MSC. Nastran DISPENSA FEM in MSC. Nastran preprocessing: mesh generation material definitions definition of loads and boundary conditions solving: solving the (linear) set of equations components postprocessing: visualisation

More information

Linear Static Analysis of a Cantilever Beam (SI Units)

Linear Static Analysis of a Cantilever Beam (SI Units) WORKSHOP 6 Linear Static Analysis of a Cantilever Beam (SI Units) Objectives: Create a geometrical representation of a cantilever beam. Use this geometry model to define an MSC/NASTRAN analysis model comprised

More information

FEM Validation. 12th January David Schmid Teamleader Structural Analysis

FEM Validation. 12th January David Schmid Teamleader Structural Analysis FEM Validation 12th January 2012 David Schmid Teamleader Structural Analysis FEM Validation and Verification Each FE model which is used to substantiate flight material must be verified Depending on the

More information

Response Spectrum Analysis Shock and Seismic. FEMAP & NX Nastran

Response Spectrum Analysis Shock and Seismic. FEMAP & NX Nastran Response Spectrum Analysis Shock and Seismic FEMAP & NX Nastran Table of Contents 1. INTRODUCTION... 3 2. THE ACCELEROGRAM... 4 3. CREATING A RESPONSE SPECTRUM... 5 4. NX NASTRAN METHOD... 8 5. RESPONSE

More information

NX Nastran 10. Rotor Dynamics User s Guide

NX Nastran 10. Rotor Dynamics User s Guide NX Nastran 10 Rotor Dynamics User s Guide Proprietary & Restricted Rights Notice 2014 Siemens Product Lifecycle Management Software Inc. All Rights Reserved. This software and related documentation are

More information

Geometric Nonlinear Analysis of a Cantilever Beam

Geometric Nonlinear Analysis of a Cantilever Beam WORKSHOP PROBLEM 2b Geometric Nonlinear Analysis of a Cantilever Beam Objectives: Demonstrate the use of geometric nonlinear analysis. Observe the behavior of the cantilever beam under four increasing

More information

Quintic beam closed form matrices (revised 2/21, 2/23/12) General elastic beam with an elastic foundation

Quintic beam closed form matrices (revised 2/21, 2/23/12) General elastic beam with an elastic foundation General elastic beam with an elastic foundation Figure 1 shows a beam-column on an elastic foundation. The beam is connected to a continuous series of foundation springs. The other end of the foundation

More information

General elastic beam with an elastic foundation

General elastic beam with an elastic foundation General elastic beam with an elastic foundation Figure 1 shows a beam-column on an elastic foundation. The beam is connected to a continuous series of foundation springs. The other end of the foundation

More information

Introduction to Continuous Systems. Continuous Systems. Strings, Torsional Rods and Beams.

Introduction to Continuous Systems. Continuous Systems. Strings, Torsional Rods and Beams. Outline of Continuous Systems. Introduction to Continuous Systems. Continuous Systems. Strings, Torsional Rods and Beams. Vibrations of Flexible Strings. Torsional Vibration of Rods. Bernoulli-Euler Beams.

More information

Linear Static Analysis of a Simply-Supported Truss (SI)

Linear Static Analysis of a Simply-Supported Truss (SI) APPENDIX C Linear Static Analysis of a Simply-Supported Truss (SI) Objectives: Create a MSC.Nastran model comprised of CROD elements. Prepare a MSC.Nastran input file for a Linear Static analysis. Visualize

More information

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I Institute of Structural Engineering Page 1 Chapter 2 The Direct Stiffness Method Institute of Structural Engineering Page 2 Direct Stiffness Method (DSM) Computational method for structural analysis Matrix

More information

Computational Analysis for Composites

Computational Analysis for Composites Computational Analysis for Composites Professor Johann Sienz and Dr. Tony Murmu Swansea University July, 011 The topics covered include: OUTLINE Overview of composites and their applications Micromechanics

More information

Mechanical Engineering Ph.D. Preliminary Qualifying Examination Solid Mechanics February 25, 2002

Mechanical Engineering Ph.D. Preliminary Qualifying Examination Solid Mechanics February 25, 2002 student personal identification (ID) number on each sheet. Do not write your name on any sheet. #1. A homogeneous, isotropic, linear elastic bar has rectangular cross sectional area A, modulus of elasticity

More information

Advantages, Limitations and Error Estimation of Mixed Solid Axisymmetric Modeling

Advantages, Limitations and Error Estimation of Mixed Solid Axisymmetric Modeling Advantages, Limitations and Error Estimation of Mixed Solid Axisymmetric Modeling Sudeep Bosu TATA Consultancy Services Baskaran Sundaram TATA Consultancy Services, 185 Lloyds Road,Chennai-600086,INDIA

More information

Linear Static Analysis of a Cantilever Beam (CBAR Problem)

Linear Static Analysis of a Cantilever Beam (CBAR Problem) WORKSHOP 17 Linear Static Analysis of a Cantilever Beam (CBAR Problem) Objectives: Create a geometrical representation of a cantilever beam. Use this geometry model to define an MSC.Nastran analysis model

More information

The following syntax is used to describe a typical irreducible continuum element:

The following syntax is used to describe a typical irreducible continuum element: ELEMENT IRREDUCIBLE T7P0 command.. Synopsis The ELEMENT IRREDUCIBLE T7P0 command is used to describe all irreducible 7-node enhanced quadratic triangular continuum elements that are to be used in mechanical

More information

COPYRIGHTED MATERIAL. Index

COPYRIGHTED MATERIAL. Index Index A Admissible function, 163 Amplification factor, 36 Amplitude, 1, 22 Amplitude-modulated carrier, 630 Amplitude ratio, 36 Antinodes, 612 Approximate analytical methods, 647 Assumed modes method,

More information

Matrix Assembly in FEA

Matrix Assembly in FEA Matrix Assembly in FEA 1 In Chapter 2, we spoke about how the global matrix equations are assembled in the finite element method. We now want to revisit that discussion and add some details. For example,

More information

Theoretical Manual Theoretical background to the Strand7 finite element analysis system

Theoretical Manual Theoretical background to the Strand7 finite element analysis system Theoretical Manual Theoretical background to the Strand7 finite element analysis system Edition 1 January 2005 Strand7 Release 2.3 2004-2005 Strand7 Pty Limited All rights reserved Contents Preface Chapter

More information

Leaf Spring (Material, Contact, geometric nonlinearity)

Leaf Spring (Material, Contact, geometric nonlinearity) 00 Summary Summary Nonlinear Static Analysis - Unit: N, mm - Geometric model: Leaf Spring.x_t Leaf Spring (Material, Contact, geometric nonlinearity) Nonlinear Material configuration - Stress - Strain

More information

Plane and axisymmetric models in Mentat & MARC. Tutorial with some Background

Plane and axisymmetric models in Mentat & MARC. Tutorial with some Background Plane and axisymmetric models in Mentat & MARC Tutorial with some Background Eindhoven University of Technology Department of Mechanical Engineering Piet J.G. Schreurs Lambèrt C.A. van Breemen March 6,

More information

TABLE OF CONTENTS. Mechanics of Composite Materials, Second Edition Autar K Kaw University of South Florida, Tampa, USA

TABLE OF CONTENTS. Mechanics of Composite Materials, Second Edition Autar K Kaw University of South Florida, Tampa, USA Mechanics of Composite Materials, Second Edition Autar K Kaw University of South Florida, Tampa, USA TABLE OF CONTENTS 1. INTRODUCTION TO COMPOSITE MATERIALS 1.1 Introduction... 1.2 Classification... 1.2.1

More information

Bending of Simply Supported Isotropic and Composite Laminate Plates

Bending of Simply Supported Isotropic and Composite Laminate Plates Bending of Simply Supported Isotropic and Composite Laminate Plates Ernesto Gutierrez-Miravete 1 Isotropic Plates Consider simply a supported rectangular plate of isotropic material (length a, width b,

More information

Results Combination Using Restart

Results Combination Using Restart WORKSHOP PROBLEM 8 Results Combination Using Restart Objectives: Using the model from Workshop 2, create two additional load cases for the truss using a combination of three previous load cases on a restart

More information

Dynamic Response Of Laminated Composite Shells Subjected To Impulsive Loads

Dynamic Response Of Laminated Composite Shells Subjected To Impulsive Loads IOSR Journal of Mechanical and Civil Engineering (IOSR-JMCE) e-issn: 2278-1684,p-ISSN: 2320-334X, Volume 14, Issue 3 Ver. I (May. - June. 2017), PP 108-123 www.iosrjournals.org Dynamic Response Of Laminated

More information

A two-dimensional FE truss program

A two-dimensional FE truss program A two-dimensional FE truss program 4M020: Design Tools Eindhoven University of Technology Introduction The Matlab program fem2d allows to model and analyze two-dimensional truss structures, where trusses

More information

DYNAMIC RESPONSE OF THIN-WALLED GIRDERS SUBJECTED TO COMBINED LOAD

DYNAMIC RESPONSE OF THIN-WALLED GIRDERS SUBJECTED TO COMBINED LOAD DYNAMIC RESPONSE OF THIN-WALLED GIRDERS SUBJECTED TO COMBINED LOAD P. WŁUKA, M. URBANIAK, T. KUBIAK Department of Strength of Materials, Lodz University of Technology, Stefanowskiego 1/15, 90-924 Łódź,

More information

Structural Dynamics. Spring mass system. The spring force is given by and F(t) is the driving force. Start by applying Newton s second law (F=ma).

Structural Dynamics. Spring mass system. The spring force is given by and F(t) is the driving force. Start by applying Newton s second law (F=ma). Structural Dynamics Spring mass system. The spring force is given by and F(t) is the driving force. Start by applying Newton s second law (F=ma). We will now look at free vibrations. Considering the free

More information

CHAPTER 4 DESIGN AND ANALYSIS OF CANTILEVER BEAM ELECTROSTATIC ACTUATORS

CHAPTER 4 DESIGN AND ANALYSIS OF CANTILEVER BEAM ELECTROSTATIC ACTUATORS 61 CHAPTER 4 DESIGN AND ANALYSIS OF CANTILEVER BEAM ELECTROSTATIC ACTUATORS 4.1 INTRODUCTION The analysis of cantilever beams of small dimensions taking into the effect of fringing fields is studied and

More information

Iraq Ref. & Air. Cond. Dept/ Technical College / Kirkuk

Iraq Ref. & Air. Cond. Dept/ Technical College / Kirkuk International Journal of Scientific & Engineering Research, Volume 6, Issue 4, April-015 1678 Study the Increasing of the Cantilever Plate Stiffness by Using s Jawdat Ali Yakoob Iesam Jondi Hasan Ass.

More information

Release Notes Digimat 6.0.1

Release Notes Digimat 6.0.1 Release Notes Digimat 6.0.1 May 2015 p. 2 p. 3 p.4 p. 6 p. 7 p. 9 - p.10 1 P a g e C o p y r i g h t M S C S o f t w a r e B e l g i u m, 2015 New Capabilities Failure indicators o Temperature dependent

More information

Chapter 2 Finite Element Formulations

Chapter 2 Finite Element Formulations Chapter 2 Finite Element Formulations The governing equations for problems solved by the finite element method are typically formulated by partial differential equations in their original form. These are

More information

Module 10: Free Vibration of an Undampened 1D Cantilever Beam

Module 10: Free Vibration of an Undampened 1D Cantilever Beam Module 10: Free Vibration of an Undampened 1D Cantilever Beam Table of Contents Page Number Problem Description Theory Geometry 4 Preprocessor 6 Element Type 6 Real Constants and Material Properties 7

More information

Parallelization of the Molecular Orbital Program MOS-F

Parallelization of the Molecular Orbital Program MOS-F Parallelization of the Molecular Orbital Program MOS-F Akira Asato, Satoshi Onodera, Yoshie Inada, Elena Akhmatskaya, Ross Nobes, Azuma Matsuura, Atsuya Takahashi November 2003 Fujitsu Laboratories of

More information

prepared checked approved Date: Date: Date: S. Fahrendholz/R.Geiger Dr.-Ing. Jürgen Bellmann Dr.-Ing.

prepared checked approved Date: Date: Date: S. Fahrendholz/R.Geiger Dr.-Ing. Jürgen Bellmann Dr.-Ing. Verification Manual Version 12.2 2009 prepared checked approved Date: 01.08.2003 Date: 19.01.2009 Date: 22.01.2009 S. Fahrendholz/R.Geiger Dr.Ing. Jürgen Bellmann Dr.Ing. Casimir Katz Document name: q:\dok\qs\verification.doc

More information

Advanced Vibrations. Elements of Analytical Dynamics. By: H. Ahmadian Lecture One

Advanced Vibrations. Elements of Analytical Dynamics. By: H. Ahmadian Lecture One Advanced Vibrations Lecture One Elements of Analytical Dynamics By: H. Ahmadian ahmadian@iust.ac.ir Elements of Analytical Dynamics Newton's laws were formulated for a single particle Can be extended to

More information

MESH MODELING OF ANGLE-PLY LAMINATED COMPOSITE PLATES FOR DNS AND IPSAP

MESH MODELING OF ANGLE-PLY LAMINATED COMPOSITE PLATES FOR DNS AND IPSAP 16 TH INTERNATIONAL CONFERENCE ON COMPOSITE MATERIALS MESH MODELING OF ANGLE-PLY LAMINATED COMPOSITE PLATES FOR DNS AND IPSAP Wanil Byun*, Seung Jo Kim*, Joris Wismans** *Seoul National University, Republic

More information

ME FINITE ELEMENT ANALYSIS FORMULAS

ME FINITE ELEMENT ANALYSIS FORMULAS ME 2353 - FINITE ELEMENT ANALYSIS FORMULAS UNIT I FINITE ELEMENT FORMULATION OF BOUNDARY VALUE PROBLEMS 01. Global Equation for Force Vector, {F} = [K] {u} {F} = Global Force Vector [K] = Global Stiffness

More information

CHAPTER 5. Beam Theory

CHAPTER 5. Beam Theory CHPTER 5. Beam Theory SangJoon Shin School of Mechanical and erospace Engineering Seoul National University ctive eroelasticity and Rotorcraft Lab. 5. The Euler-Bernoulli assumptions One of its dimensions

More information

SDLV302 Modal analysis by under-structuring: bi-- supported beam

SDLV302 Modal analysis by under-structuring: bi-- supported beam Titre : SDLV302 Analyse modale par sous-structuration : [...] Date : 21/07/2017 age : 1/10 SDLV302 Modal analysis by under-structuring: bi-- supported beam Summary: This test validates the modal analysis

More information

Technical Specifications

Technical Specifications Technical Specifications Analysis Type Supported Static Analysis Linear static analysis Nonlinear static analysis (Nonlinear elastic or Elastoplastic analysis) Construction Stage Analysis StressSlope Sl

More information

Effect of Mass Matrix Formulation Schemes on Dynamics of Structures

Effect of Mass Matrix Formulation Schemes on Dynamics of Structures Effect of Mass Matrix Formulation Schemes on Dynamics of Structures Swapan Kumar Nandi Tata Consultancy Services GEDC, 185 LR, Chennai 600086, India Sudeep Bosu Tata Consultancy Services GEDC, 185 LR,

More information

Stretching of a Prismatic Bar by its Own Weight

Stretching of a Prismatic Bar by its Own Weight 1 APES documentation (revision date: 12.03.10) Stretching of a Prismatic Bar by its Own Weight. This sample analysis is provided in order to illustrate the correct specification of the gravitational acceleration

More information

CIVL 8/7117 Chapter 12 - Structural Dynamics 1/75. To discuss the dynamics of a single-degree-of freedom springmass

CIVL 8/7117 Chapter 12 - Structural Dynamics 1/75. To discuss the dynamics of a single-degree-of freedom springmass CIV 8/77 Chapter - /75 Introduction To discuss the dynamics of a single-degree-of freedom springmass system. To derive the finite element equations for the time-dependent stress analysis of the one-dimensional

More information

UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES

UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES A Thesis by WOORAM KIM Submitted to the Office of Graduate Studies of Texas A&M University in partial fulfillment of the

More information

Numerical simulation of the coil spring and investigation the impact of tension and compression to the spring natural frequencies

Numerical simulation of the coil spring and investigation the impact of tension and compression to the spring natural frequencies Numerical simulation of the coil spring and investigation the impact of tension and compression to the spring natural frequencies F. D. Sorokin 1, Zhou Su 2 Bauman Moscow State Technical University, Moscow,

More information

Thermal Stress Analysis of a Bi- Metallic Plate

Thermal Stress Analysis of a Bi- Metallic Plate WORKSHOP 10 Thermal Stress Analysis of a Bi- Metallic Plate MSC.Nastran 104 Exercise Workbook 10-1 10-2 MSC.Nastran 104 Exercise Workbook WORKSHOP 10 Thermal Stress Analysis of a Bi-Metallic Plate Model

More information

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I Institute of Structural Engineering Page 1 Chapter 2 The Direct Stiffness Method Institute of Structural Engineering Page 2 Direct Stiffness Method (DSM) Computational method for structural analysis Matrix

More information

Analyses of rubber parts in LS-DYNA implicit. Anders Jonsson,

Analyses of rubber parts in LS-DYNA implicit. Anders Jonsson, Analyses of rubber parts in LS-DYNA implicit Anders Jonsson, anders.jonsson@dynamore.se Overview Rubber Appendix A of the Guideline for implicit analyses Background / theory LS-DYNA material models Recommended

More information

ACCURATE MODELLING OF STRAIN DISCONTINUITIES IN BEAMS USING AN XFEM APPROACH

ACCURATE MODELLING OF STRAIN DISCONTINUITIES IN BEAMS USING AN XFEM APPROACH VI International Conference on Adaptive Modeling and Simulation ADMOS 213 J. P. Moitinho de Almeida, P. Díez, C. Tiago and N. Parés (Eds) ACCURATE MODELLING OF STRAIN DISCONTINUITIES IN BEAMS USING AN

More information

Plate Forces and Moments Blog Post pdf

Plate Forces and Moments Blog Post pdf Plate Forces and Moments Blog Post pdf Author: Surya Batchu Senior Stress Engineer Founder, STRESS EBOOK LLC. http://www.stressebook.com 1 P a g e Plate Forces and Moments - Intro: You may have heard these

More information

INTERNATIONAL JOURNAL OF APPLIED ENGINEERING RESEARCH, DINDIGUL Volume 2, No 1, 2011

INTERNATIONAL JOURNAL OF APPLIED ENGINEERING RESEARCH, DINDIGUL Volume 2, No 1, 2011 Interlaminar failure analysis of FRP cross ply laminate with elliptical cutout Venkateswara Rao.S 1, Sd. Abdul Kalam 1, Srilakshmi.S 1, Bala Krishna Murthy.V 2 1 Mechanical Engineering Department, P. V.

More information

Mechanics PhD Preliminary Spring 2017

Mechanics PhD Preliminary Spring 2017 Mechanics PhD Preliminary Spring 2017 1. (10 points) Consider a body Ω that is assembled by gluing together two separate bodies along a flat interface. The normal vector to the interface is given by n

More information

Non-linear and time-dependent material models in Mentat & MARC. Tutorial with Background and Exercises

Non-linear and time-dependent material models in Mentat & MARC. Tutorial with Background and Exercises Non-linear and time-dependent material models in Mentat & MARC Tutorial with Background and Exercises Eindhoven University of Technology Department of Mechanical Engineering Piet Schreurs July 7, 2009

More information

Optimum Height of Plate Stiffener under Pressure Effect

Optimum Height of Plate Stiffener under Pressure Effect The st Regional Conference of Eng. Sci. NUCEJ Spatial ISSUE vol., No.3, 8 pp 459-468 Optimum Height of Plate Stiffener under Pressure Effect Mazin Victor Yousif M.Sc Production Engineering University of

More information

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Module - 01 Lecture - 13

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Module - 01 Lecture - 13 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras (Refer Slide Time: 00:25) Module - 01 Lecture - 13 In the last class, we have seen how

More information

Project. First Saved Monday, June 27, 2011 Last Saved Wednesday, June 29, 2011 Product Version 13.0 Release

Project. First Saved Monday, June 27, 2011 Last Saved Wednesday, June 29, 2011 Product Version 13.0 Release Project First Saved Monday, June 27, 2011 Last Saved Wednesday, June 29, 2011 Product Version 13.0 Release Contents Units Model (A4, B4) o Geometry! Solid Bodies! Parts! Parts! Body Groups! Parts! Parts

More information

"C:\Program Files\ANSYS Inc\v190\CFX\bin\perllib\cfx5solve.pl" -batch -ccl runinput.ccl -fullname "Fluid Flow CFX_002"

C:\Program Files\ANSYS Inc\v190\CFX\bin\perllib\cfx5solve.pl -batch -ccl runinput.ccl -fullname Fluid Flow CFX_002 This run of the CFX Release 19.0 Solver started at 19:06:17 on 05 Jun 2018 by user ltval on DESKTOP-JCG0747 (intel_xeon64.sse2_winnt) using the command: "C:\Program Files\ANSYS Inc\v190\CFX\bin\perllib\cfx5solve.pl"

More information

CHAPTER 3 MODELING AND ANALYSIS

CHAPTER 3 MODELING AND ANALYSIS CHAPTER 3 MODELING AND ANALYSIS 3.1 BASICS OF MODELING AND ANALYSIS The main objective of this study was to explore weight and cost reduction opportunities for a production of connecting rod small end

More information

Vibrationdata FEA Matlab GUI Package User Guide Revision A

Vibrationdata FEA Matlab GUI Package User Guide Revision A Vibrationdata FEA Matlab GUI Package User Guide Revision A By Tom Irvine Email: tom@vibrationdata.com March 25, 2014 Introduction Matlab Script: vibrationdata_fea_preprocessor.zip vibrationdata_fea_preprocessor.m

More information

D : SOLID MECHANICS. Q. 1 Q. 9 carry one mark each. Q.1 Find the force (in kn) in the member BH of the truss shown.

D : SOLID MECHANICS. Q. 1 Q. 9 carry one mark each. Q.1 Find the force (in kn) in the member BH of the truss shown. D : SOLID MECHANICS Q. 1 Q. 9 carry one mark each. Q.1 Find the force (in kn) in the member BH of the truss shown. Q.2 Consider the forces of magnitude F acting on the sides of the regular hexagon having

More information

USER S MANUAL. 1D Seismic Site Response Analysis Example. University of California: San Diego.

USER S MANUAL. 1D Seismic Site Response Analysis Example.  University of California: San Diego. USER S MANUAL 1D Seismic Site Response Analysis Example http://www.soilquake.net/ucsdsoilmodels/ University of California: San Diego August 2, 2017 Table of Contents USER'S MANUAL TABLE OF CONTENTS Page

More information

. D CR Nomenclature D 1

. D CR Nomenclature D 1 . D CR Nomenclature D 1 Appendix D: CR NOMENCLATURE D 2 The notation used by different investigators working in CR formulations has not coalesced, since the topic is in flux. This Appendix identifies the

More information

σ = F/A ε = L/L σ ε a σ = Eε

σ = F/A ε = L/L σ ε a σ = Eε Material and Property Information This chapter includes material from the book Practical Finite Element Analysis. It also has been reviewed and has additional material added by Sascha Beuermann. Hooke

More information

Module 2: Thermal Stresses in a 1D Beam Fixed at Both Ends

Module 2: Thermal Stresses in a 1D Beam Fixed at Both Ends Module 2: Thermal Stresses in a 1D Beam Fixed at Both Ends Table of Contents Problem Description 2 Theory 2 Preprocessor 3 Scalar Parameters 3 Real Constants and Material Properties 4 Geometry 6 Meshing

More information

Composite models 30 and 131: Ply types 0 and 8 calibration

Composite models 30 and 131: Ply types 0 and 8 calibration Model calibration Composite Bi-Phase models 30 and 3 for elastic, damage and failure PAM-CRASH material model 30 is for solid and 3 for multi-layered shell elements. Within these models different ply types

More information

Parametric study on the transverse and longitudinal moments of trough type folded plate roofs using ANSYS

Parametric study on the transverse and longitudinal moments of trough type folded plate roofs using ANSYS American Journal of Engineering Research (AJER) e-issn : 2320-0847 p-issn : 2320-0936 Volume-4 pp-22-28 www.ajer.org Research Paper Open Access Parametric study on the transverse and longitudinal moments

More information

FLEXIBILITY METHOD FOR INDETERMINATE FRAMES

FLEXIBILITY METHOD FOR INDETERMINATE FRAMES UNIT - I FLEXIBILITY METHOD FOR INDETERMINATE FRAMES 1. What is meant by indeterminate structures? Structures that do not satisfy the conditions of equilibrium are called indeterminate structure. These

More information

Finite element method based analysis and modeling in rotordynamics

Finite element method based analysis and modeling in rotordynamics Finite element method based analysis and modeling in rotordynamics A thesis submitted to the Graduate School of the University of Cincinnati in partial fulfillment of the requirements for the degree of

More information

Anisotropic modeling of short fibers reinforced thermoplastics materials with LS-DYNA

Anisotropic modeling of short fibers reinforced thermoplastics materials with LS-DYNA Anisotropic modeling of short fibers reinforced thermoplastics materials with LS-DYNA Alexandre Hatt 1 1 Faurecia Automotive Seating, Simplified Limited Liability Company 1 Abstract / Summary Polymer thermoplastics

More information

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Module - 01 Lecture - 11

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Module - 01 Lecture - 11 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras Module - 01 Lecture - 11 Last class, what we did is, we looked at a method called superposition

More information

Using MATLAB and. Abaqus. Finite Element Analysis. Introduction to. Amar Khennane. Taylor & Francis Croup. Taylor & Francis Croup,

Using MATLAB and. Abaqus. Finite Element Analysis. Introduction to. Amar Khennane. Taylor & Francis Croup. Taylor & Francis Croup, Introduction to Finite Element Analysis Using MATLAB and Abaqus Amar Khennane Taylor & Francis Croup Boca Raton London New York CRC Press is an imprint of the Taylor & Francis Croup, an informa business

More information

Software Verification

Software Verification EXAMPLE 16 racked Slab Analysis RAKED ANALYSIS METHOD The moment curvature diagram shown in Figure 16-1 depicts a plot of the uncracked and cracked conditions, Ψ 1 State 1, and, Ψ State, for a reinforced

More information

Lecture 27: Structural Dynamics - Beams.

Lecture 27: Structural Dynamics - Beams. Chapter #16: Structural Dynamics and Time Dependent Heat Transfer. Lectures #1-6 have discussed only steady systems. There has been no time dependence in any problems. We will investigate beam dynamics

More information

Presented By: EAS 6939 Aerospace Structural Composites

Presented By: EAS 6939 Aerospace Structural Composites A Beam Theory for Laminated Composites and Application to Torsion Problems Dr. BhavaniV. Sankar Presented By: Sameer Luthra EAS 6939 Aerospace Structural Composites 1 Introduction Composite beams have

More information

Lecture 8. Stress Strain in Multi-dimension

Lecture 8. Stress Strain in Multi-dimension Lecture 8. Stress Strain in Multi-dimension Module. General Field Equations General Field Equations [] Equilibrium Equations in Elastic bodies xx x y z yx zx f x 0, etc [2] Kinematics xx u x x,etc. [3]

More information

SECTION 1. Introduction to MD NASTRAN SOL 400

SECTION 1. Introduction to MD NASTRAN SOL 400 SECTION 1 Introduction to MD NASTRAN SOL 400 S1-1 S1-2 What is "MD NASTRAN"? Evolution of engineering challenges: Complex systems vs. "just parts" Interacting environments Disparate tools and databases

More information

D && 9.0 DYNAMIC ANALYSIS

D && 9.0 DYNAMIC ANALYSIS 9.0 DYNAMIC ANALYSIS Introduction When a structure has a loading which varies with time, it is reasonable to assume its response will also vary with time. In such cases, a dynamic analysis may have to

More information

Sparse solver 64 bit and out-of-core addition

Sparse solver 64 bit and out-of-core addition Sparse solver 64 bit and out-of-core addition Prepared By: Richard Link Brian Yuen Martec Limited 1888 Brunswick Street, Suite 400 Halifax, Nova Scotia B3J 3J8 PWGSC Contract Number: W7707-145679 Contract

More information

Composite Structural Mechanics using MATLAB

Composite Structural Mechanics using MATLAB Session 2520 Composite Structural Mechanics using MATLAB Oscar Barton, Jr., Jacob B. Wallace United States Naval Academy Annapolis, Md 21402 Abstract In this paper MATLAB is adopted as the programming

More information

International Journal of Advanced Engineering Technology E-ISSN

International Journal of Advanced Engineering Technology E-ISSN Research Article INTEGRATED FORCE METHOD FOR FIBER REINFORCED COMPOSITE PLATE BENDING PROBLEMS Doiphode G. S., Patodi S. C.* Address for Correspondence Assistant Professor, Applied Mechanics Department,

More information

FEA A Guide to Good Practice. What to expect when you re expecting FEA A guide to good practice

FEA A Guide to Good Practice. What to expect when you re expecting FEA A guide to good practice FEA A Guide to Good Practice What to expect when you re expecting FEA A guide to good practice 1. Background Finite Element Analysis (FEA) has transformed design procedures for engineers. Allowing more

More information

Structural Dynamics Lecture Eleven: Dynamic Response of MDOF Systems: (Chapter 11) By: H. Ahmadian

Structural Dynamics Lecture Eleven: Dynamic Response of MDOF Systems: (Chapter 11) By: H. Ahmadian Structural Dynamics Lecture Eleven: Dynamic Response of MDOF Systems: (Chapter 11) By: H. Ahmadian ahmadian@iust.ac.ir Dynamic Response of MDOF Systems: Mode-Superposition Method Mode-Superposition Method:

More information

Technical Specifications

Technical Specifications Technical Specifications Static Analysis Linear static analysis Analysis Type Supported Nonlinear static analysis (Nonlinear elastic or Elastoplastic analysis) Construction Stage Analysis StressSlope Slope

More information

PRACTICE 2 PROYECTO Y CONSTRUCCIÓN DE PUENTES. 1º Máster Ingeniería de Caminos. E.T.S.I. Caminos, canales y puertos (Ciudad Real) 01/06/2016

PRACTICE 2 PROYECTO Y CONSTRUCCIÓN DE PUENTES. 1º Máster Ingeniería de Caminos. E.T.S.I. Caminos, canales y puertos (Ciudad Real) 01/06/2016 PRACTICE 2 PROYECTO Y CONSTRUCCIÓN DE PUENTES 1º Máster Ingeniería de Caminos E.T.S.I. Caminos, canales y puertos (Ciudad Real) 01/06/2016 AUTHOR: CONTENT 1. INTRODUCTION... 3 2. BRIDGE GEOMETRY AND MATERIAL...

More information

Multi Linear Elastic and Plastic Link in SAP2000

Multi Linear Elastic and Plastic Link in SAP2000 26/01/2016 Marco Donà Multi Linear Elastic and Plastic Link in SAP2000 1 General principles Link object connects two joints, i and j, separated by length L, such that specialized structural behaviour may

More information

Fractal two-level finite element method for free vibration of cracked beams

Fractal two-level finite element method for free vibration of cracked beams 61 Fractal two-level finite element method for free vibration of cracked beams A.Y.T. Leung School of Engineering, University of Manchester, Manchester M13 9PL, UK R.K.L. Su Ove Arup & Partners, Hong Kong

More information

202 Index. failure, 26 field equation, 122 force, 1

202 Index. failure, 26 field equation, 122 force, 1 Index acceleration, 12, 161 admissible function, 155 admissible stress, 32 Airy's stress function, 122, 124 d'alembert's principle, 165, 167, 177 amplitude, 171 analogy, 76 anisotropic material, 20 aperiodic

More information

EFFECTIVE MODAL MASS & MODAL PARTICIPATION FACTORS Revision F

EFFECTIVE MODAL MASS & MODAL PARTICIPATION FACTORS Revision F EFFECTIVE MODA MASS & MODA PARTICIPATION FACTORS Revision F By Tom Irvine Email: tomirvine@aol.com March 9, 1 Introduction The effective modal mass provides a method for judging the significance of a vibration

More information

midas Civil Dynamic Analysis

midas Civil Dynamic Analysis Edgar De Los Santos Midas IT August 23 rd 2017 Contents: Introduction Eigen Value Analysis Response Spectrum Analysis Pushover Analysis Time History Analysis Seismic Analysis Seismic Analysis The seismic

More information

As an example we consider the stacking and analysis of a 2-ply symmetric laminate. First we clear the Matlab space and close figures.

As an example we consider the stacking and analysis of a 2-ply symmetric laminate. First we clear the Matlab space and close figures. Program Lam 1 Introduction The collection of Matlab command and function files in the package lam allows the stacking and analysis of a laminate. In fact only a representative piece of a laminate is considered,

More information

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics SPARSE SOLVERS FOR THE POISSON EQUATION Margreet Nool CWI, Multiscale Dynamics November 9, 2015 OUTLINE OF THIS TALK 1 FISHPACK, LAPACK, PARDISO 2 SYSTEM OVERVIEW OF CARTESIUS 3 POISSON EQUATION 4 SOLVERS

More information