You are on page 1of 18

NUCLEAR ENGINEERING AND DESIGN 25 (1973) 257-274.

© NORTH-HOLLANDPUBLISHINGCOMPANY

SAP - A S T R U C T U R A L A N A L Y S I S P R O G R A M F O R L I N E A R S Y S T E M S

E.L. WILSON, K.J. BATHE, F.E. PETERSON and H.H. DOVEY


Department of Civil Engineering, University of California, Berkeley, California 94 720, USA

Received 22 January 1973

The current version of the computer program SAP for the static and dynamic analysis of linear structural systems
is described. The analysis capabilities of the program, the finite element library, the numerical techniques used, the
logical construction of the program and storage allocations are discussed. The main advantages of the program as a
general purpose code become apparent. Results of analyses as comparisons with other existing solutions are given, and
running times which demonstrate the efficiency of the program are included.

1. Introduction The program SAP, which is written for the linear


elastic analysis of structural systems, is the result of
The development of an effective computer program over ten years of research and development experience.
for structural analysis requires a knowledge of three The program has proven to be a very flexible and ef-
scientific disciplines - structural mechanics, numerical ficient analysis tool. The program is coded in standard
analysis and computer application. The development Fortran IV and operates without modifications on the
of accurate and efficient structural elements requires CDC 6400, 6600 and 7600 computers. The first ver.
a modern background in structural mechanics. The sion of the program was published in September 1970
efficiency of a program depends largely on the nu- [ 1]. Since then a number of improvements have been
merical techniques employed and on their effective achieved; in particular, new elements have been devel,:
computer implementation. With regard to program- oped, some of which are also used in the static analy-
ming techniques, an optimum allocation of high and sis program SOLID SAP [2], an improved equation
low speed storage is necessary. solver is used, efficient eigensolution methods have
A most important aspect of a general purpose com- been incorporated and the dynamic analysis options
puter program is, however, the ease with which it can have been improved.
be modified, extended and updated; otherwise, it may The structural systems to be analyzed may be com-
very well be that the program is obsolete within a few posed of combinations of a number of different struc-
years of completion. This is because new structural tural elements. The program presently contains the fol.
elements are developed, better numerical procedures lowing element types:
are available, or new computer equipment which re- (a) three-dimensional truss element,
quires new coding techniques is produced. (b)three-dimensional beam element,
The structural analysis program SAP was designed (c)plane stress and plane strain element,
to be modified and extended by the user. Additional (d)two-dimensional axisymmetric solid,
options and new elements may easily be added. The (e) three-dimensional solid,
program has the capacity to analyze very large three- (f) thick shell element,
dimensional systems; however, there is no loss in ef- (g)thin plate or thin shell element,
ficiency in the solution of smaller problems. Also, (h)boundary element,
from the complete program, smaller special purpose (i) pipe element (tangent and bend).
programs can easily be assembled by simply using only These structural elements can be used in a static or dy-
those subroutines which are actually needed in the ex- namic analysis. The capacity of the program depends
ecution. This makes the program particularly usable mainly on the total number of nodal points in the sys-
on small size computers. tem, the number of eigenvalues needed in the dynamic
258 ILL. WilsoH et al., Structural analysis program /or linear ,~vstemv

analysis and the computer used. There is practically where M is the mass matrix, Cis ~he damping ;~a~rix
no restriction on the number of elements used, the and K is the stiffness matrix of lhe element a~,seln-
number of load cases or the order and bandwidth of blage; tile vectors u, u,/i and R are {lie nodal displace-
the stiffness matrix. Each nodal point in the system ments, velocities, accelerations and generalized l~)ads.
can have from 0- 6 displacement degrees of freedom. respectively. The structure matrices are formed by
The element stiffness and mass matrices are assembled direct addition of the element matrices: i{)r example
m condensed form; therefore, the program is equally
K = ~K , ~'~
efficient in the analysis of one-, two- or three-dimen-
sional systems. where Ken is the stiffness matrix of the m t h elelnent.
The formation of the structure matrices is carried Although K m is formally of the same order as K, only
out in the same way in a static or dynamic analysis. those terms in K m which pertain to the element de-
The static analysis is continued by solving the equa- grees of freedom are non-zero. The addition of the eIe*
tions of equilibrium followed by the computation of ment matrices can therefore be performed by using the
element stresses. In a dynamic analysis the choice is element matrices in compact form together with iden-
between: ( 1) frequency calculations only; (2) frequen- tification arrays which relate element to structure de-
cy calculations followed by response history analysis; grees of freedom. The algorithm used in the program
and (3) frequency calculations followed by response is described in section 3.3.
spectrum analysis. To obtain the frequencies and vi- In the program the structure stiffness matrix and a
bration mode shapes solution routines are used which diagonal mass matrix are assembled. Therefore, a
calculate the required eigenvalues and eigenvectors lumped mass analysis is assumed, where the structure
directly without a transformation of the structure mass is tile sum of the individual element mass matri-
stiffness matrix and mass matrix to a reduced form. ces plus additional concentrated masses which are
This way the program operation and necessary input specified at selected degrees of freedom. The damping
data for a dynamic analysis is a simple addition to is assumed to be proportional and is specified in the
what is needed for a static analysis. form of modal damping factors. The assumptions
The purpose of this report is to present briefly the used in lumped mass analyses and in the use of pro-
general program organization, the current element portional damping have been discussed on various oc-
library and the numerical techniques used. The dif- casions [5, 9, 10].
ferent options presently available for static and dynam-
ic analyses are described, and the results of several 2,2. B m m d a t 3 , conditions
sample analyses are presented. In the report, emphasis
is directed to the practical aspects of the program. For If a displacement component is zero, the corres-
information on the development of the structural ele- ponding equation is not retained m the structure
ments and the numerical techniques used the reader is equilibrium equations, eq. (1), and the corresponding
referred to appropriate references. element stiffness and mass terms are disregarded. If
a non-zero displacement is to be specified at a degree
of freedom i, say u i = x , the equation
2. The equilibrium equations for complex structural sys-
ku i = kx (3)
tems
is added into eq. (1), where k >> kii. Therefore, the
2.1. E l e m e n t to s t r u c t u r e m a t r i c e s solution of eq. (1) must give u i = x . Physically, this
can be interpreted as adding at the degree of freedom,
The nodal point equilibrium equations for a linear i, a spring of large stiffness k arid specifying a load,
system of structural elements can be derived by sever- which because of the relatively flexible structure at
al different approaches [ 3 - 8 ] . All methods yield a set this degree of freedom, produces the required displace-
of linear equations of the following form ment x. This approach simplifies programming pro-
blems which are normally associated with specifying
M i i + Cit + K u = R , (1) displacements.
E.L. Wilson et aL, Structural analysis program for linear systems 259

3. Program organization for calculation of the struc-


ture stiffness matrix and mass matrix I&Z TRUSSELEMENT
x ~ y / ,NF,GU,,E3
The calculation of the structure stiffness matrix
and mass matrix is accomplished in three distinct
phases:
(1) The nodal point input data is read and gener-
ated by the program. In this phase the equation
numbers for the degrees of freedom at each nodal
point are established.
(2) The element stiffness and mass matrices are cal- NODAL POINT LAYOUT OF TRUSS

culated together with their connection arrays; the


arrays are stored in sequence on tape (or other low-
speed storage).
(3) The structure stiffness matrix and mass matrix 3 4 5
"~--------"-~ DEGREES
are formed by addition of the element matrices and OF FREEDOI~
1 1 1 1 1 1
stored in block form on tape. 2 1 1 1 1 1
It should be noted that these basic steps are inde- 3 I 0 1 1 1
pendent of the element type used and are the same for ID = 4 1 0 0 I 1 i
either a static or dynamic analysis. 5 1 0 0 1 I 1

6 1 0 0 1 1 1
3.1. Nodal point input data and degrees o f freedom 7 1 0 0 1 1 1

The capacity of the program is controlled by the N O D A L POINT


NUMBERS
number of nodal points of the structural system. For
each nodal point six boundary condition codes Fig. 1. Nodal point layout of the truss example and the ID
(stored in the array ID), three co-ordinates (stored in array as read and/or generated.
the arrays X, Y, Z) and the nodal point temperatures
(stored in the array 7") are required (generation capa-
bility is provided). All nodal point data is retained in 0 0 0 0 0 0
high speed storage during the formation of the ele- 0 0 0 0 0 0
ment stiffness and mass matrices. Since the required
0 1 2 0 0 0
high speed storage for the element subroutines is re-
ID = 0 3 4 0 0 0
latively small, the minimum required storage for a
given problem is a little larger than ten times the num- 0 5 6 0 0 0

ber of nodal points in the system. 0 7 8 0 0 0

It should be noted that the user should allow only 0 9 l0 0 0 0


those degrees of freedom which are compatible with
the elements connected to a nodal point. The program
Fig. 2. ID array of the truss example after allocation of equ-
always deals with six possible degrees of freedom at ation numbers to active degrees of freedom.
each nodal point, and all non-active degrees of free-
dom should be deleted, so as to decrease the order of
the structure matrices. Specifically, a "1" in the ID plete ID and X, Y, Z arrays have been obtained, equ-
array denotes that no equation shall be associated ation numbers are associated with all active degrees
with the degree of freedom, whereas a "0" indicates of freedom, i.e. the zeroes in the ID array are replaced
that this is an active degree of freedom. Fig. 1 shows by corresponding equation numbers, and each one is
for the simple truss structure the 1D array as it was replaced by a zero, as shown in fig. 2 for the simple
read and/or generated by the program. Once the com- truss example.
260 E.L. Wilson et al,, Structural analysis program j b r linear systems

3.2. L7ement mass and stiffness calculanons 3.3. kbrmation o f structure sl(/yhess and mas~

With the co-ordinates of all nodal points known The stiffness matrix and mass matrix of the struc-
and the equation numbers of the degrees of freedom ture are formed in blocks, as shown m fig. 4 for the
having been established, the stiffness, mass and stress truss example. The number of equations per block
displacement transformation matrices for each struc- depends on the available high speed storage and is
tural element in the system are calculated. As pointed calculated in the program as indicated in fig. 5. It is
out earlier, little additional high speed storage is re- noted that on reasonable size computers very large
quired for this phase since these matrice~ are iormed systems can be analyzed for static and dynamic re-
and placed on tape storage at the same time as the sponse. With the number of equations per block
element properties are read. Together with the ma- known, the stiffness and mass matrix are assembled
trices pertaining to the element, the corresponding two blocks at a time by direct addition of the ele-
element connection array, vector LM, is written on ment matrices. In this process it is i]ecessary to pass
tape. The vector LM is established from the ID matrix through the element matrices which are stored on
and the specified structure nodal points pertaining to tape. In order to minimize tape reading in each pass,
the element. The connection array for a typical ele-
ment of the truss example is shown in fig. 3.
The element matrices are calculated in groups, i.e. -] 0
always all elements of one kind together, thus calling TS
3
the corresponding element subroutine only once.
After all element matrices have been established, the .l
1D and X, II, Z arrays are not needed any more, and LM = ] |I

the corresponding storage area is used for the forma- 0 I


5
tion of the structure matrices and later for the solu-
! ,
tion of the equations of equilibrium.
6 i

F i g . 3. Connection array (vector LM) for a typical element


of the truss example.

0 = ZERO ELL%{ENT

X = NONZERO ELEMENT

xxOOx ZER~ X I XXOOX X


xOXO0 X I BLOCK 1 XOXO0 X
XXXXX X I XXXXX X
XXXO0 Xl XXXO0 X
XXOOX ,Xl BLOCK 2 XXOOX X
XOXO0 Xl XOXO0 X
XXXX xl X X x X X
S~IETRIC BLOCK 3 X xx X
XXX X I
XX ~% X
XX XI
X Xl x ~
BLOCK 4
• d

STIFFNESS ~ T R I X h~SS STIFFNESS MASS


~TRIX MATRIX MATRIX

BLOCK STORAGE OF STRUCTURE hL~TRICES


ACTUAL STRUCTURE MATRICES

Fig. 4. Storage of the stiffness matrix and mass matrix on tape.


E.L. Wilson et al., Structural analysis program for linear systems 261

USING AVAILABLE NUMBER OF HIGH SPEED STOP,AGE LOCATIONS

I CALCULATEMAXIMUMOBLOCK SIZE' I:K~SIBLE FOH' I


I STRUCTURE STIFFNESS AND MASS FORMATION J

STATIC SOLL'rION : K 6 = 8 CALCULATION OF FREQUENCIES AND MODE SHAPES K ~ = M I ~2

CALCULATE MAXIMUM BLOCK SIZE IFCI.) SHOWS THAT THE EQUATIONS CAN BE FOI~IED IN CORE,

POSSIBLE FOR SOLUTION OF CALCULATE IF DETERMINANT sEARCH SOLUTION IS POSSIBLE

EQUATIONS I I
YES NO

l
MINI,, ,o © AND® ISHE
BLOCK SIZE FOR SOLUTION
ONE BLOCK CASE
CALCULATE

MINIM ©
MAXIMUMBLOCK
POSSIBLE FOR SUBSPACE
ITERATION SOLUTION

AND ©
SIZE

ISTHE
BLOCK SIZE FOR SOLUTION

Fig. 5. Flow chart showing calculation of the number of equations in a block.

element matrices which pertain to the next several 4.2. Three-dimensional beam element
blocks are written on another tape. This way the tape
reading necessary for the formation of these blocks is The beam element included in the program con-
reduced significantly. siders torsion, bending about two axes, axial and
A flow diagram of the program organization for shearing deformations. The element is prismatic. The
the calculation of the structure stiffness matrix and development of its stiffness properties is standard
mass matrix is shown in fig. 6. With the matrices and is given in ref. [7]. Inertia loading in three direc-
stored in block form on tape, either a static or a dy- tions and specified fixed-end forces form the element
namic analysis can now be carried out. load cases. Forces (axial and shear) and moments
(bending and torsion) are calculated in the beam lo-
cal co-ordinate system.
4. The element library A typical beam element is shown in fig. 7b. A
plane which defines the principal bending axis of the
The current element library consists of eight dif- beam is specified by the plane i,/, k. Only the geom-
ferent element types. These elements can be used in etry of nodal point k is needed; therefore, no addi-
either a static or dynamic analysis. They are shown tional degrees of freedom for nodal point k are used
in fig. 7 and are briefly described below. in the computer program. A unique option of the
beam member is that the ends of the beam can be
4.1. Three-dimensional truss element geometrically constrained to a master node. Slave de-
grees of freedom at the end of the beam are elimi-
The derivation of the truss element stiffness is given nated from the formulation and replaced by the
in refs. [I, 7]. The element can be subjected to a uni- transformed degrees of freedom of the master node
form temperature change. [ 1, 11 ]. This technique reduces the total number of
262 L: L. Wilson et aL, Structural analysis program/or lb~ear Zvs'tem,s'

START
...JJ

READAND GENERATE
NODALPOINT DATA
AND ~. y m ~
ESTABLISH EQUATION x
NUMBERS b. THREE DIMENSIONAL
a.TRUSS ELEMENT BEAM ELEMENT
LOW SPEED
STORAGE FILES

STP~ESS-DI SpLACEMENT
c.PLANE STRESS,PLANE STRAIN AND AXISYMMETRIC ELEMENTS
TRANSFORMATION MATRICES
CALL OF ELEb~NT
SUBROUTINES

i
CONME~ ~ S MATRICEs

&THREE DIMENSIONALSOLID
n
e.THICK SHELL ELEMENT

K d

STRUCTURE STIFFNESS
MATRIX, MASSMATRIX
ANF
DOL
I~O
IA
ATD
IO
VN OO
ECTFRS ~ ~STRUCTURE
STIFFNES~SIA n : o=_.
f.THIN SHELL AND BOUNDARY ELEMENT

L~

CONTINUE T O STATIC
OR DYNAMICANALYSIS TANGENT BEND
g. PIPE ELEMENT
l:ig. 6. Flow chart for the calculation of structure stiff-
ness matrix and mass matrix. F'ig. 7. Element library of SAP.

joint equilibrium equations in the system (while y - z plane. Gravity, inertia and temperature loadings
possibly increasing the bandwidth) and greatly re- may be considered. Stresses may be computed at the
duces the possibility of numerical sensitivities in center of the element and at the center of each side.
many types of structures. Also, the method can be The element is based oll an isoparametric formulation
used to specify rigid floor diaphragms in building [8, 12]. Incompatible displacement modes can be in-
analysis. cluded m order to improve the bending properties of
the element [2, 13].
4.3. Plane stress, plane strain and axisymmetric ele-
tnents 4.4. T h r e e - d i m e n s i o n a l solid e l e m e n t

A plane stress quadrilateral (or triangular) element A general eight nodal point "brick" element, with
with orthotropic material properties is available. Each three translational degrees of freedom per nodal
plane stress element may be of different thickness and point can be used, fig. 7d. Isotropic material prop-
may be located in an arbitrary plane with respect to erties are assumed and element loading consists of
the three-dimensional co-ordinate system. The plane temperature, surface pressure and inertia loads in three
strain and axisymmetric elements are restricted to the directions. Stresses (six components) may be computed
E.L. Wilsonet al., Structural analysisprogram for linear systems 263

at the center of the element and at the center of each (4) to eliminate the numerical difficulty associated
face. The accuracy of the basic isoparametric element with the "sixth" degree of freedom in the analysis
mag be improved by the addition of incompatible dis- of shells.
placement modes [2, 13]. The element is one-dimensional with an axial or tor-
sional stiffness. The element stiffness coefficients are
4.5. Thick shell element added directly to the total stiffness matrix (see section
2.2).
A 16 node curved isoparametric solid element can
be used for the analysis of thick plates or shells [2]. 4.8. Pipe element
The use of pure translational displacements avoids the
difficulties associated with the rotational degrees of The pipe element (fig. 7g) can represent a straight
freedom in the normal thin shell formulation [14]. segment (tangent) or a circularly curved segment (bend);
The element may approximately be combined with both require a uniform section and material properties.
the eight node solid element; therefore, structures Elements can be directed arbitrarily in space. The mem-
such as arch dams and their foundations can be con- ber stiffness matrices account for bending, torsional,
sidered with a minimum of modeling difficulty. axial and shearing deformations. In addition, the ef-
fect of internal pressure on the stiffness of curved
4.6. Thin plate and shell element pipe elements is considered.
The types of structure loads contributed by the
The thin shell element available in the program is pipe elements include gravity loading in the global di-
a quadrilateral of arbitrary geometry formed from rections; thermal distortion or deformations induced
four compatible triangles. The bending and plane stress by internal pressure. Forces and moments acting at
properties of the element are described in refs. [15, 16]. the members' ends (i,j) and the center of each bend
The element employs a constant strain triangle to re- are calculated in co-ordinate systems aligned with the
present the membrane behavior. The central node is member's cross section.
located at the average of the co-ordinates of the four The pipe element stiffness matrix is formed by first
corner nodes. The element has six interior degrees of evaluating the flexibility matrix corresponding to the
freedom which are eliminated at the element level prior six degrees of freedom at end/' as given by [17]. With
to assembly; therefore, the resulting quadrilateral ele- the corresponding stiffness matrix the equilibrium
ment has 24 degrees of freedom, i.e. six degrees of transformations outlined in [18] are used to form the
freedom per node in the global co-ordinate system. complete element stiffness matrix. Distortions due to
For flat plates the stiffness associated with the element loads are premultiplied by the stiffness matrix
rotation normal to the shell surface is not defined; to compute restrained nodal forces due to thermal,
therefore, the appropriate boundary condition must pressure or gravity loads.
be specified. For curved shells, the normal rotation
can be included as an extra degree of freedom or, it
can be restrained by the addition of a "boundary ele- 5. Static analysis
ment" which would add normal rotational stiffness
to the node [14]. A static analysis involves the solution of the equili-
brium equations
4. 7. Boundary element
Xu = R, (4)
The boundary element, shown in fig. 7f, can be followed by the calculation of element stresses.
used as follows:
(1) in the idealization of an external elastic support 5.1. Solution o f equilibrium equations
at a node;
(2) in the idealization of an inclined roller support; The load vectors R have been assembled at the same
(3) to specify a displacement, or time as the structure stiffness matrix and mass matrix
264 ILL. Wilson et al., Structural analysis program ]or linear systems

were formed. The solution of the equations is ob- 5.2. Ev-'~,matron" o f e l e m e n t stresses
tained using the large capacity linear equation solver
SESOL [ 19]. This subroutine uses Gauss elimination After the nodal point displacements have been ew~J-
on the positive-definite symmetrical system of equa- uated sequentially, the element stress-displacement
tions. The algorithm performs a minimunt number of matrices are read from low speed storage and the ele-
operations, i.e. there are no operations with zero ele- ment stresses are calculated.
ments. In the program, the L T D L decomposition of
K is used, hence eq. (4) can be written as
LTv = R, (5) 6. Calculation of frequencies and mode shapes

and The dynamic analysis of a structural systenr using


mode superposition requires as the first step the solu-
v = DLu, (6)
tion of the generalized eigenvalue problem
where the solution for v in eq. (5) is obtained by a re-
K qb = co2M ~b, (7)
duction of the load vectors; the displacement vectors
u are then calculated by a back substitution. where co and q5 are free vibration frequency and mode
In the solution, the load vectors are reduced at the shape, respectively. As was described in section 3.3 the
same time as K is decomposed. In all operations it is progrant stores the stiffness and mass matrix in blocks
necessary to have at any one time the required matrix on tape, fig. 4. The mass matrix is diagonal with partly
elements in high speed storage. In the reduction, two zero diagonal elements. The program assumes that only
blocks are in high speed storage (as was also the case the lowest p eigenvalues and corresponding eigenvec-
in the formation of the stiffness matrix and mass ma- tors are needed. The solution of eq. (7) can therefore
trix), i.e. the "leading" block, which finally stores the be written as
elements of L and D, and in succession those blocks K qb = M qb gl 2 , (8)
which are affected by the decomposition of the lead-
ing block. Table 1 gives some typical solution times. where ~ 2 is a diagonal matrix with the p smallest eigen-

Table 1
Solution of equations using SESOL.

NUMBER OF HALF CENTRAL COMPUTER


EQUATIONS BANDWIDTH PROCESSOR USED
SEC

8036 544 1786 t CDC 6600

2696 488 1260 CDC 6600

4214 205 31 CDC 7600

] The inner DO-loop in the factorization of the stiffness matrix has been coded in machine language for this solution.
E.L. Wilson et aL, Structural analysis program [or linear systems 265

values, i.e. fl 2 diag (~.2), and ¢ stores the corres-


=
ation procedure which operates on the characteristic
ponding M-orthonormalized eigenvectors ¢1, q~2. . . . ep" polynomial
Two different solution procedures are used in the pro-
gram: a determinant search technique or a subspace p (w 2) = det (K - 6o2M) (9)
iteration solution. The determinant search solution is used to obtain a shift near the next unknown eigen-
is carried out when the stiffness matrix can be con- value. The eigenvalue separation theorem (Sturm se-
tained in high-speed storage in one block. Therefore, quence property) is used in this iteration. Each deter-
for systems of large order and bandwidth the sub- minant evaluation requires a triangular factorization
space iteration method is used. Both solution tech- of the matrix K - ~o2M. Once a shift near the unknown
niques solve the generalized eigenvalue problem direct- eigenvalue has been obtained, inverse iteration is used
ly without a transformation to the standard form to calculate the eigenvector; the eigenvalue is obtained
[20,211. by adding the Rayleigh quotient correction to the
shift value. Table 2 shows typical solution times.
6.1. The determinant search solution
6.2. The subspace iteration solution
The determinant search technique is best suited
for the analysis of large systems in which K and M When the system is too large to be completely con-
have small bandwidths. Basically, the solution algo- tained in high speed storage, i.e. more blocks than one
rithm combines triangular factorization and vector are used, the subspace iteration solution is carried out.
inverse iteration in an optimum manner to calculate The iteration can be interpreted as a repeated appli-
the required eigenvalues and eigenvectors; these are cation of the Ritz method [5, 21 ], in which the com-
obtained in sequence starting from the least dominant puted eigenvectors from one step are used as the trial
eigenpalr w~, ~1" An efficient accelerated secant iter- basis vectors for the next iteration until convergence

Table 2
Calculation of frequencies and mode shapes using the determinant search method.

MAXM
I UM NUMBER OF CENTRAL
SYSTEM HALF BAND !
REQ D. FREQN. COMPUTER
SYSTEM PROCESSOR
ORDER n WIDTH AND MODE SHAPES p USED SEC

PLANE
297 30 CDC 6 4 0 0 40
FRAME

PIPING
566 12 CDC 6600 11
SYSTEM

BUILDING 340 32 CDC 6600 20

CONTAINER 265 65 40 CDC 7600 58


266 filL. Wilson et al., Structural analysis program ]br linear systems

to the requiredp eigenvalues and eigenvectors is ob- and calculate the kth improved apl)roximation to the
tained. eigenvectors
The solution is carried out by iterating simulta-
vk = v k o k i ~4)
neously with q linearly independent vectors, where
q > p . In the kth iteration the vectors span the q- Provided that the starting subspace is not orthogonat
dimensional subspace Ck and "best" eigenvalue and to any of the required eigenvectors, the iteration con-
eigenvector approximations are calculated;i.e, when verges to the desired result, i.e. 1-12 -+ ~ 2 and ![k -~ (l~
the vectors span the p-dimensional least dominant ask-~ ~
subspace, the required eigenvalues and eigenvectors The number of vectors q used in the iteration is
are obtained. taken greater than the desired number of eigenvectors
Let V0 store the starting vectors, then the kth iter- in order to accelerate the convergence of the process.
ation is described as follows: The number of iterations required to achieve satis-
Solve for vectors Vk which span ~'k factory convergence depends, of course, on the qual-
ity of the starting vectors V0. Unless requested other-
KV k = MVk_ 1 . (10)
wise (see section 6.3), the program generates q start-
Calculate the projections of K and M onto ~k ing vectors where q = rain (2p, p + 8), which has
proven to be effective in general applications. At con-
vergence a Sturm sequence check can be requested to
verify that the lowest p eigenvalues have been found.
M k = VIk'MV k . (12)
Table 3 lists a few typical solution times using the
Solve for the eigensystem o f K k and M k program-generated starting vectors.

KkQk=MkQka2 , (13)

Table 3
Calculation of frequencies and mode shapes using the subspace iteration method.
MAXIMUM NUMBER OF CENTRAL
SYSTEM SYSTEM HALF BAND REQ' D. FREQN. COMPUTER PROCESSOR
ORDER n WIDTH AND MODE S H A P E S p USED SEC

PLANE CDC 6400 25


297 30
FRAME

PIPING 566 12 28 CDC 6600 142


S YSTEM

BLDG. WITH
1174 138 45 CDC 6600 890
FOUNDATI ON

3-DIM
I
BLDG 468 156 CDC 6400 160

FRAME
E.L. Wilson et al., Structural analysis program for linear systems 267

6.3. Dynamic optimization


dpT cd#] = 0 (i~=]). (19)

The solution of the eigenvalue problem may be re~ Eq. (17) therefore represents p uncoupled second-
quired when a good estimate of the required eigen- order differential equations. These are solved in the
system is already known, such as in dynamic optimi- program using the Wilson 0-method,which is an un-
zation. In this case the subspace iteration method is conditionally stable step-by-step integration scheme
ideally suited for solution. The number of iteration [22]. The same time step is used in the integration of
vectors q and the vectors V0 together with the maxi- all equations to simplify the calculation of stress com-
mum number of iterations can in this case be speci- ponents at preselected times.
fied by the user. There is essentially no difference in the analysis
procedure when ground motion is prescribed. In this
case u r = qbX and in eq. (17) the right-hand side is
7. Dynamic analyses given by _qbT M//g, with//g being prescribed as a
function of time.
In dynamic response analysis the solution of the e-
quations 7.2. Response spectrum analysis
Mii + Cfi + Ku = g ( t ) , (15)
In this analysis the ground acceleration vector in
is required, where R (t) can be a vector of arbitrary eq. (16) is written as
time varying loads or of effective loads which result
from ground motion. Specifically, in the case of i/g = i/gx + h"gY + iig z , (20)
ground motion, if it is assumed that the structure is where//gx,/igy and//-zg
are the ground accelerations
uniformly subjected to Ug, the ground acceleration in the x, y and z directions, respectively. The equation
[5], the equilibrium equations considered are for the response in the rth mode is therefore
Mii r + Cil r + Ku r = - M / / g , (16) 5c"r + 2~rWr2 r + 6OrX
2 r = rrx + rry + rrz , (21)
where u r is the relative displacement of the structure where x r is the rth element in X and
with respect to the ground, i.e. u r = u - Ug.
The program can carry out a history analysis for rrx = - $ f Miigx rry - $ f Mk'gy; rrz
"" ; = = - ¢TM//g~22)
solution of eqs. (15) or (16), or a response spectrum
analysis for solution of eq. (16). Both analyses are Using the definition of the spectral displacement [23],
performed using mode superposition. the maximum absolute modal displacements of the
structure subjected to an acceleration in the x direc:
7.1. Response history analysis tion are

In the mode superposition analysis, it is assumed u(maX)rx= (~rI¢TrMlx ISx(Wr) , (23)


that the structural response can be described adequate- where Sx(W r) is the spectral displacement in the x di-
ly by the p lowest vibration modes, where p < n. rection corresponding to the frequency wrand I x is a
Using the transformation u = ~X, where the columns null vector except that those elements are equal to
in ~ are the p M-orthonormalize~l eigenvectors, eq. one which correspond to the x translational degrees
(15) can be written as of freedom. Similarly, for the responses due to a
£ + AfY + n 2 X = rbTR, (17) ground acceleration into the y and z directions
u(max)_
ry .kr i w
- ,e , hr rsr,, [Sy(¢Or) .
u iy
where
(24)
A = diag(2¢oi~i); [12 = diag(6o2). (18) Urz(max)= $r IdpTrMlz [Sz(¢°r)
In eq. (18) it is assumed that the damping matrix C satis- and the total maximum response in the rth mode is
fies the modal orthogonality condition assumed to be
268 k:L. Wilson et aL, Structural analysis program for linear wstems

u(max) (max)+ it(max)+ u(max) (25) ical tape. This tape may then be used to plot the fi-
r = //rx ry /'2 ' nite element mesh.
Program SAP calculates the maximum responses in
each of the p lowest modes, where the spectra (dis-
placements or accelerations) in the x, y and z direc-
9. Sample analyses
tions are assumed to be proportional to each other. This section presents brief problem descriptions
The total response for displacements and stress resul- for a set of standard data cases available with the
tants is calculated as the square root of the sum of the program. Naturally, the few sample analyses can only
squares of the modal maximum responses [23, 24]. demonstrate to some degree the capabilities of the
program. In general, detailed problem descriptions
7.3. Restart capability can be found in the references from which the sample
analyses have been taken.
The most expensive phase in mode superposition
analysis is usually the calculation of frequencies and 9.1. Static analysis o f pipe network
mode shapes. However, once the required eigensystem The pipe network shown in fig. 8 corresponds to a
has been solved for, it can be used to analyze the struc- sample problem solution presented in the user's manu-
ture for different loading conditions. Also, in a design al for the ADLPIPE piping analysis computer code
process the history or spectrum analysis for the same [25]. The purpose of this analysis is to predict the
loading can be carried out economically a few times, static response of the system under the combined ef-
for example, to study the stress history in different fects of: (1) concentrated loads, (2) vertical (y direc-
parts of the structure. tion) gravity loads, (3) uniform temperature increase,
In the program, at completion of the eigensystem and (4) non-zero displacements imposed at one sup-
solution, all variables required for a response history port point.
or response spectrum analysis together with the fre- Table 4 compares the reactions printed in the SAP
quencies and mode shapes are written on low speed and ADLPIPE solutions. The two solutions are in fair
storage. The program execution may be stopped at agreement; the SAP results satisfy equilibrium to all
this stage and the information on low speed storage six digits, appearing in the printed output. In the table
copied to a physical tape. Later, this tape would of applied loads, a total weight of 6284.03 lb. results
be copied back to low speed storage before starting from 950.686 in. of pipe weighing 6.61 Ib/in.
a response analysis. If after a number of response anal-
yses using the eigensystem on the tape, it is decided 9.2. Static' shell analysis
that more frequencies and mode shapes need be cal-
culated, the information on the tape can be used to The clamped spherical shell shown in fig. 9 is anal-
reduce the cost of the new eigensystem solution as yzed for stresses produced by a uniform pressure ap-
described in section 6.3. plied on its outside surface. The SAP model represents
a 5 ° wedge of the shell with 18 thin shell elements
along the 39 ° meridian. The curves drawn in fig. 9 are
8. Data check run plots of meridian (¢) and circumferential (40 direction
surface stresses predicted by the SAP program at the
In the analysis of large structures it is important to element centroids.
be able to check the data read and generated by the The solution of this problem is given in [26], where
program. For this purpose an option is given in which the stress distribution of fig. 9 may be found for com-
the program simply reads and generates all data, prints parison. It should be noted that program SAP calculates
it and also writes the full data on low speed storage. membrane stresses (force per unit area) and bending re-
At completion of data read and generation the infor- sultants (moment per unit length) from which the sur-
mation on low speed storage can be copied to a phys- face stresses in the figure have been evaluated.
E.L. Wilsonet aL, Structuralanalysisprogramfor linearsystems 269

5 0 0 0 , ~ ~ l l kI000
~ l bIbs
s Z~ X

20001ha

2251n

15In
SPRING
( K=IO4 LN~n
ROD HANGER r I
\ + I,oo,n
h IO00 Ibll ~CONSTANT
FORCEHANGER

67 In

200 Iba
DEADWEIGHT 15In
NON-ZEROTRANSLATIONS
IMPOSEDAT NODE12
105in

Fig 8. SAP model of pipe network given in the ADLPIPE manual.

h = 2.:56 i n ! j ~ p=2841bs/in2
o
9.3. Frequency and mode shape analysis of plane frame

The lowest three frequencies and corresponding


mode shapes of the plane frame shown in fig. 10 are
calculated. The results can be compared with the so.
lutions published in refs. [20, 21 ]. Note that, depen-
ding on the high speed storage available, either a deter.
o'* DEG 2 *
' !
~ *
minant search or a subspace iteration solution may be
4' - _c~ / " / / , performed. The three lowest vibration periods of the
to • ,
,., - 2 o o o - ~0 - ' ~ / frame are given in table 5.
w
o
9.4. Response spectrum analysis of pipe network
~ -4000

A response spectrum analysis of the pipe assem-


blage shown in fig. 11 is carried out. This is example
1 in the user's manual for the PIPDYN computer
program [24]. Good correspondence between the
(el = E X r ~ SURVACE
(i) = INTERIORSURFACE SAP and PIPDYN solutions is obtained. Table 6 com-
- 8000 -- pares local z direction member end moments pre-
Fig. 9. Distribution of surface stresses in a clamped spherical dicted by the two programs. In the analysis the low-
shell under external pressure. est five modes are considered. Both, horizontal and
270 £'.L. Wilson et al., Structural analysis program ]or linear systems

'Fable 4
Force e q u i l i b r i u m s u m m a r y (SAP analysis of ADLPIPE exampl e 1): A. reactions, B. applied loads,

A.

NODE
SAP ADLPI PE
FX FY FZ I,.'X FY EZ

9 5643.51 5659.
11 -4044.59 l -t052.
12 2350.08 4023.01 -4960.70 2361. t026. ---t 96
13 -i0993.59 4505.61 2960.70 -11021. 1509. 2 96

TOTAL -3000.00 4484.03 -2000.00 -3001. 4483. -200

B.

D I R E C T I ON
LOADING TYPE

CONCENTRATED:

at node 3 1000.00
at node 4 -200,00
at node 8 3000. 1000.00 2000.

DISTRIBUTED
WEIGHT: -6284.03

TOTAL 3000. -4484.03 2000.

vertical (proportional) spectra are simultaneously by SAP. Fig. 13 shows the variation of the transverse
specified. displacements and of the fixed-end moment calculated
by SAP. The DRA2 predictions agree with the SAP re-
9.5. Time history response analysis of cantilever sults to five or more digits and. consequently, are
not shown for comparison.
The cantilever beam shown in fig. 12 is analyzed
for the ground acceleration shown in the same figure. 9. 6 Time history response analysis of <vlindrical tube
The solution to this problem is obtained independent-
ly using the DRA2 computer code [27]. This program The response of the simply supported cylindrical
calculates the dynamic response by direct integration tube shown in fig. 14 for a suddenly applied load is
of the (coupled) equations of motion using the Wilson calculated. Using symmetry one-half of the tube is
0-algorithm [22]. idealized as an assemblage of axisymmetric elements
The response history of the beam model is evalu- with a total of 61 degrees of freedom. In the mode
ated in SAP using mode superposition including all superposition analysis only the lowest 20 modes are
eight flexural modes developed in the cantilever; considered; some of the vibration periods are listed in
table 7 lists the periods of these eight modes computed table 8. Fig. 14 shows a comparison of tile radial dis-
E.L. Wilson et aL, Structural analysis program for linear systems 271

Table 6
Comparison o f m o m e n t predictions (SAP analysis of PIPDYN example 1).

M O M E N T MZ(Kip in) IN ELEMENT LOCAL


COORDINATES (at element ends i, see
ELEMENT R e f . 24 pp. 54)
NUMBE R
SAP PIPDYN

I 376.9 377.0
2 30.67 30.68
3 152.9 152.9
4 100.6 i00.6
5 83.27 83.27
6 46.17 46.19
7 1.081 1.082
8 21.59 21.81
9 7.052 7.038
i0 7. 537 7,571
ii 160.3 160.4
12 78.07 78.09
13 26,08 25.80

LY
/" J" j
~lz

so'
I 5Y _
;'/t
I0 AT 20'
200'
(O) ELEVATION OF F R A M E
DATA : YOUNG'S MODULUS : 4 3 2 0 0 0 , MASS DENSITY : 1.0
FOR ALL BEAMS AND COLUMNS AI= 3.0, 11= [2 = 13 = 1.0
UNITS : FT, KIPS
Fig. 11. SAP model of PIPDYN example 1, response spec-
t r u m analysis.
52

? J/' Table 5
Periods o f plane frame.
y
MODE PE RI OD

NUMBER (SEC)

(b) B E A M E L E M E N T D E F I N I T I O N 8.183
SllS 2 AND S5 = BEAM LOCAL AXES
l I ,I 2 AND 13 =FLEXURAL INERTIA ABOUT S 11S2,AND S 3
2.673
A I = AREA ASSOCIATED WITH S I
I . 543
Fig. 10. SAPmodelof planeframe.
272 E.L Wilson et al., Structural analysis program/br linear sS'stems

X . ~ I : 1.0 in4; A : I00.0 in2 IO0,O00


Z
E : 30 xlO61bs/In2
Y 80,000-
p = 1.0 Ib- sec2/tn 4 W

i 60,000-
NODE 5 - -
I 2 3 4 5 6 7 8 9 40,000-
9
~ 2o,o o o -

o I ~ I I I I
1I o 2 4 6 8 I0 I2 14 16 18
TI ME (SEC)
8 a t 50' = 4 0 0 ' I
/a) TRANSVERSE DEFLECTIONS

(0) NODE AND BEAM NUMBER ASSIGNMENTS FOR THE


CANTILEVER MODEL 60 E+7

5o

40
i __]
!
v

~z so
W
o
2O
5
d
8 tO
I0 20~",..
TIME (sec)
0 2 4 6 8 I0 12 14 16 18
TIME (SEC)
Fig. 12. R e s p o n s e h i s t o r y a n a l y s i s of a c a n t i l e v e r b e a m .
(bl M O M E N T AT NODE l
(FIXED END OF CANTILEVER)

Fig. 13. C a n t i l e v e r response.


Table 7
C a n t i l e v e r b e a m a n a l y s i s - n a t u r a l p e r i o d s for the e i g h t
(lowest) flexural modes.

MODE PE RI OD Table 8
NUMBER (SEC) C y l i n d r i c a l t u b e analysis - some n a t u r a l periods.

1 525.79
MODE PE RT OD
2 85. 368
NUMBER (SEC × 10 - 3 )
3 30. 965
I 1.2788
4 16.059
5 0.62140
5 9. 9006
i0 () ° 3 2 9 8 3
6 6.8276
15 0. 17463
7 5. 1865
20 0. 11497
8 4. 3777
E.L. Wilson et al., Structural analysis program for linear systems 273

References
[
[ 1] E.L. Wilson, SAP - A general structural analysis program,
SEgM Report, Dept. of Civil Engineering, University of
California, Berkeley, 70-20 (1970).
[2] E.L. Wilson, SOLID SAP - A static analysis program for
~'o three-dimensional solid structures, SESM Report, Dept.
E=3OxlO Ib~/ifl2 of Civil Engineering, University of California, Berkeley
I/= 0.3
p =3.663 1(~2Ibs 71-19 (1971.
14¢2/in 4 [3] J.H. Argyris and A. Kelsey, Energy theorems and struc-
o) CYLINDRICAL TUBE tural analysis, Aircraft Eng. 31, Oct. and Nov. (1954)
and Feb.-May (1955). Also published by Butterworth's
P Ibs/In Scientific Publications, London (1960).
j / [4] J.H. Argyris, Continua and Discontinua, Proceedings 1st
Conference on Matrix Methods in Structural Mechanics,
I0001
Wright Patterson AFB, Ohio, 1965.
[5] R.W. Clough, Analysis of Structural Vibrations and Dy-
TIMEIb namic Response, Proceedings 1st US-Japan Symposium
b) TIME VARIATION on Recent Advances in Matrix Methods of Structural
ok/ I I I OF LOAD
0 2 4 6 Analysis and Design, Tokyo, Japan, 1968.
TIME ( SEC x 10"41 [6] C.A. Felippa and R.W. Clough, The Finite Element
C) RADIAL DISPLACEMENT VERSUS TIME Method in Solid Mechanics, Proceedings Symposium
on Numerical Solutions of Field Problems in Conti-
Fig. 14. Response history analysis of a cylindrical tube. nuum Mechanics, Durham, North Carolina, 1968.
[7] J.S. Przemieniecki, Theory of Matrix Structural Anal-
ysis, McGraw-Hill, New York (1968).
[8] O.C. Zienkiewicz, The Finite Element Method in Engi-
placements calculated by the program with a Timosh-
neering Science, McGraw-Hill, New York (1971).
e n k o - L o v e solution [28]. [9] R.W. Clough and K.J. Bathe, Finite Element Analysis
of Dynamic Response, Proceedings 2rid US-Japan
Symposium on Recent Advances in Computational
Methods of Structural Analysis and Design, Berkeley,
10. Concluding remarks California, 1972.
[10] E.L. Wilson and J. Penzien, Evaluation of Orthogonal
The objective of this report was to present a brief Damping Matrices, Int. J. Numer. MethodsEng. 4 (1972).
[11] E.L. Wilson, Earthquake Analysis of Reactor Struc-
description of the current version of the computer
tures, Proceedings Symposium on Seismic Analysis of
program SAP. The program is a general analysis tool Pressure Vessels and Piping Components, The American
for the linear static and dynamic analysis of complex Society of Mechanical Engineers (1971).
structures. [12] B.M. Irons, Numerical Integration Applied to Finite
With regard to the future of the program, it should Element Methods, Conference on Use of Digital Com-
puters in Structural Engineering, University of New-
be pointed out that the program is continuously im-
castle, England, July 1966.
proved in an effort to use the best element library and [13] E.L. Wilson, R.L. Taylor, W.P. Doherty and J. Ghabous-
numerical analysis procedures available. While very ef- si, Incompatible Displacement Models, ONR Symposium
ficient in the solution process, however, it should be on Matrix Methods in Structural Mechanics, University
mentioned, that pre- and post-processing options have of Illinois, Urbana, Illinois, Sept. 1971.
to a large extent not been developed; mainly, because [14] R.W. Clough and E.L. Wilson. Dynamic finite element
analysis of arbitrary thin shells, Comput. Struct. 1
the user is restricted to the particular peripheral equip- (1971).
ment available to him. [ 15 ] C.A. Felippa, Refined finite element analysis of linear
A number o f developments are currently envisaged. and nonlinear two-dimensional structures, SESM Re-
For dynamic analysis an out-of-core direct integration port, Dept. of Civil Engineering, University of Cali-
routine will be incorporated. The element routines fornia, Berkeley 66-2 (1966).
[161 R.W. Clough and C.A. Felippa, A Refined Quadrilateral
will further be improved. Finally, it should be men- Element for Analysis of Plate Bending, Proceedings 2nd
tioned that a general non-linear static and dynamic Conference on Matrix Methods in Structural Mechanics,
analysis program is presently being developed. Wright Patterson AFB, Ohio, 1968.
274 E.L. Wilson et al., Structural analysis program jbr linear O'stems

[17] S. Poley, Mesh analysis of piping systems, IBM New [23] R.W. Clough, Earthquake analysis by response spc~:-
York Scientific Center Technical Report, No. 320 trum superposition, Btdl. Seismol. Soc. Amer. 52, J tli~
2939, March (1968). (1962),
[18] A.S. Hall, S.S. Tezcgn and D. Bulent, Discussion of [2:4] Construction Industry Programs, PIPDYN: Dynami~
paper "Curved Beam Stiffness Coefficients", Amer. Analysis of Piping Systems, Computer Sciences C¢>r
Soc. Civ. Eng. J. Struct. Div., Feb. (1969). potation, Los Angeles, California.
[ 19] E.L. Wilson, K.J. Bathe and W.P. Doherty, Direct solu- [25] ADL Pipe Static-Thermal-Dynamic Pipe Stress Anal-
tion of large systems of linear equations, Comput. Struct. ysis, Arthur D. Little, Inc., Cambridge, Massachusetts,
(to be published). January ( 1971).
[20] K.J. Bathe, Solution methods for large generalized eigen- [26] S. Timoshenko, Theory <71"Plates and Shells, 2nd edn.,
value problems in structural engineering, SESM Report, McGraw-Hill, New York (1959) 544.
Dept. of Civil Engineering, University of Calitbrnia, [271 F.E. Peterson and K.J. Bathe, Nonlinear dynamic anal-
Berkeley, 71 20 (1971). }'sis of reactor core components, Engineering/Analysis
[211 K.J. Bathe and E.L. Wilson, Large eigenvalue problems Corporation Report, Berkeley, Calif(Jrnia 5-104.3
in dynamic analysis, Amer, Soc. Cir. Eng. J. Eng. Mech. March (1972).
Div., Dec. (1972). [28] ft. Reismann and J. Padlog, F¢~rced axisymmetric moti-
[22] K.J. Bathe and E.L. Wilson, Stability and accuracy anal- ons of cylindrical shells, J. Franklin Inst. 284 (5) Nov.
ysis of direct integration methods, Int. J. Earthquake (1967).
Eng. Struct. Dyn. 1 (1973).

You might also like