Elmer FEM solver
Elmer is an open source finite element software for multiphysical problems
 All Classes Files Functions Variables Typedefs Macros Groups Pages
ShellSolve.src File Reference

Functions/Subroutines

subroutine shellsolver_init (Model, Solver, dt, Transient)
 
subroutine shellsolver (Model, Solver, dt, TransientSimulation)
 
subroutine solvenonlinear
 
subroutine bulkassembly
 
subroutine bcassembly ()
 
subroutine concentratedloads ()
 
subroutine setdirichletbcs ()
 
subroutine calculatestresses ()
 
subroutine stressboundary (STIFF, FORCE, LOAD, Element, n, Nodes)
 
subroutine localmatrix (STIFF, DAMP, MASS, FORCE, NodalLoadX, NodalLoadY, NodalLoadZ, NodalLoadN, Element, N, Nodes, StabParam1, StabParam2, ElementNumber, NodalPoisson, NodalYoung, LocalDeflection, LargeDeflection, StabilityAnalysis, Nvector)
 
subroutine localstress (Element, n, Nodes, StabParam1, StabParam2, LocalDeflection, Weight3, Weight4, Eps, Kap, Nten, NtenMaterial, Mten, MtenMaterial, NodalYoung, NodalPoisson, NodalThickness, LargeDeflection)
 
subroutine averagingweights3 (Nodes, Weight3)
 
subroutine averagingweights4 (Nodes, Weight4)
 
subroutine switchtolocal (Nodes, CopyOfNodes, Transformation, n)
 
real(kind=dp) function,
dimension(3, 3) 
localbasis (Nodes, n)
 
subroutine isotropicelasticity (Ematrix, Gmatrix, Poisson, Young, Thickness, Basis, n)
 
subroutine isotropicinplaneelasticity (Ematrix, Poisson, Young, Thickness, Basis, n)
 
subroutine shearcorrectionfactor (Kappa, Thickness, x, y, n, StabParam)
 
subroutine addenergy (A, B, C, m, n, s)
 
subroutine addinnerproducts (A, B, C, D, m, n, s)
 
subroutine covariantinterpolation (ShearStrain, Basis, X, Y, U, V, n)
 
subroutine jacobi3 (Jmat, invJ, detJ, x, y)
 
subroutine jacobi4 (Jmat, invJ, detJ, xi, eta, x, y)
 
real(kind=dp) function,
dimension(3) 
crossproductl (v1, v2)
 

Function/Subroutine Documentation

subroutine shellsolver::addenergy ( real(kind=dp), dimension(:,:)  A,
real(kind=dp), dimension(:,:)  B,
real(kind=dp), dimension(:,:)  C,
integer  m,
integer  n,
real(kind=dp)  s 
)

Referenced by localmatrix().

Here is the caller graph for this function:

subroutine shellsolver::addinnerproducts ( real(kind=dp), dimension(:,:)  A,
real(kind=dp), dimension(:,:)  B,
real(kind=dp), dimension(:,:)  C,
real(kind=dp), dimension(:,:)  D,
integer  m,
integer  n,
real(kind=dp)  s 
)

Referenced by localmatrix().

Here is the caller graph for this function:

subroutine shellsolver::averagingweights3 ( type( nodes_t )  Nodes,
real( kind=dp ), dimension(:)  Weight3 
)

Referenced by localstress().

Here is the caller graph for this function:

subroutine shellsolver::averagingweights4 ( type( nodes_t )  Nodes,
real( kind=dp ), dimension(:)  Weight4 
)

Referenced by localstress().

Here is the caller graph for this function:

subroutine shellsolver::bcassembly ( )

References defutils::activeboundaryelement(), defutils::getbc(), defutils::getboundaryelement(), defutils::getelementnofnodes(), defutils::getreal(), solver(), and stressboundary().

Referenced by solvenonlinear(), and stresssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine shellsolver::bulkassembly ( )
subroutine shellsolver::calculatestresses ( )

References defutils::getactiveelement(), defutils::getelementnodes(), defutils::getelementnofnodes(), messages::info(), lists::listgetlogical(), localstress(), solver(), lists::variableadd(), and lists::variableget().

Referenced by solvenonlinear().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine shellsolver::concentratedloads ( )

References fx, messages::info(), lists::listgetconstrealarray(), lists::listgetinteger(), and solver().

Referenced by solvenonlinear().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine shellsolver::covariantinterpolation ( real(kind=dp), dimension(:,:)  ShearStrain,
real(kind=dp), dimension(:)  Basis,
real(kind=dp), dimension(:)  X,
real(kind=dp), dimension(:)  Y,
real(kind=dp)  U,
real(kind=dp)  V,
integer  n 
)

References messages::fatal(), jacobi3(), and jacobi4().

Referenced by localmatrix(), and localstress().

Here is the call graph for this function:

Here is the caller graph for this function:

real(kind=dp) function, dimension(3) shellsolver::crossproductl ( real(kind=dp), dimension(3)  v1,
real(kind=dp), dimension(3)  v2 
)

Referenced by localbasis().

Here is the caller graph for this function:

subroutine shellsolver::isotropicelasticity ( real(kind=dp), dimension(:,:)  Ematrix,
real(kind=dp), dimension(:,:)  Gmatrix,
real(kind=dp), dimension(:)  Poisson,
real(kind=dp), dimension(:)  Young,
real(kind=dp), dimension(:)  Thickness,
real(kind=dp), dimension(:)  Basis,
integer  n 
)

Referenced by localmatrix(), and localstress().

Here is the caller graph for this function:

subroutine shellsolver::isotropicinplaneelasticity ( real(kind=dp), dimension(:,:)  Ematrix,
real(kind=dp), dimension(:)  Poisson,
real(kind=dp), dimension(:)  Young,
real(kind=dp), dimension(:)  Thickness,
real(kind=dp), dimension(:)  Basis,
integer  n 
)

Referenced by localmatrix(), and localstress().

Here is the caller graph for this function:

subroutine shellsolver::jacobi3 ( real(kind=dp), dimension(:,:)  Jmat,
real(kind=dp), dimension(:,:)  invJ,
real(kind=dp)  detJ,
real(kind=dp), dimension(:)  x,
real(kind=dp), dimension(:)  y 
)

Referenced by covariantinterpolation().

Here is the caller graph for this function:

subroutine shellsolver::jacobi4 ( real(kind=dp), dimension(:,:)  Jmat,
real(kind=dp), dimension(:,:)  invJ,
real(kind=dp)  detJ,
real(kind=dp)  xi,
real(kind=dp)  eta,
real(kind=dp), dimension(:)  x,
real(kind=dp), dimension(:)  y 
)

Referenced by covariantinterpolation().

Here is the caller graph for this function:

real(kind=dp) function, dimension(3,3) shellsolver::localbasis ( type(nodes_t)  Nodes,
integer  n 
)

References crossproductl().

Referenced by localmatrix(), and localstress().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine shellsolver::localmatrix ( real(kind=dp), dimension(:,:)  STIFF,
real(kind=dp), dimension(:,:)  DAMP,
real(kind=dp), dimension(:,:)  MASS,
real(kind=dp), dimension(:)  FORCE,
real(kind=dp), dimension(:)  NodalLoadX,
real(kind=dp), dimension(:)  NodalLoadY,
real(kind=dp), dimension(:)  NodalLoadZ,
real(kind=dp), dimension(:)  NodalLoadN,
type(element_t), pointer  Element,
integer  N,
type(nodes_t)  Nodes,
real(kind=dp)  StabParam1,
real(kind=dp)  StabParam2,
integer  ElementNumber,
real(kind=dp), dimension(:)  NodalPoisson,
real(kind=dp), dimension(:)  NodalYoung,
real(kind=dp), dimension(:)  LocalDeflection,
logical  LargeDeflection,
logical  StabilityAnalysis,
real(kind=dp), dimension(:)  Nvector 
)

References addenergy(), addinnerproducts(), covariantinterpolation(), elementdescription::elementinfo(), integration::gausspoints(), isotropicelasticity(), isotropicinplaneelasticity(), localbasis(), localstress(), shearcorrectionfactor(), and switchtolocal().

Here is the call graph for this function:

subroutine shellsolver::localstress ( type(element_t), pointer  Element,
integer  n,
type(nodes_t)  Nodes,
real(kind=dp)  StabParam1,
real(kind=dp)  StabParam2,
real(kind=dp), dimension(:)  LocalDeflection,
real(kind=dp), dimension(:)  Weight3,
real(kind=dp), dimension(:)  Weight4,
real(kind=dp), dimension(3,3)  Eps,
real(kind=dp), dimension(3,3)  Kap,
real(kind=dp), dimension(3,3)  Nten,
real(kind=dp), dimension(2,2)  NtenMaterial,
real(kind=dp), dimension(3,3)  Mten,
real(kind=dp), dimension(2,2)  MtenMaterial,
real(kind=dp), dimension(:)  NodalYoung,
real(kind=dp), dimension(:)  NodalPoisson,
real(kind=dp), dimension(:)  NodalThickness,
logical  LargeDeflection 
)

References averagingweights3(), averagingweights4(), covariantinterpolation(), elementdescription::elementinfo(), isotropicelasticity(), isotropicinplaneelasticity(), localbasis(), shearcorrectionfactor(), and switchtolocal().

Referenced by calculatestresses(), computestress(), localmatrix(), localreleaserate(), releaseratesolver(), stressboundaryresidual(), stresslocal::stresscompose(), stressedgeresidual(), and stressinsideresidual().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine shellsolver::setdirichletbcs ( )

References defutils::defaultdirichletbcs().

Referenced by solvenonlinear().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine shellsolver::shearcorrectionfactor ( real(kind=dp)  Kappa,
real(kind=dp)  Thickness,
real(kind=dp), dimension(:)  x,
real(kind=dp), dimension(:)  y,
integer  n,
real(kind=dp)  StabParam 
)

References messages::fatal(), and elementdescription::stabparam().

Referenced by localmatrix(), and localstress().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine shellsolver::solvenonlinear ( )

References bcassembly(), bulkassembly(), calculatestresses(), concentratedloads(), defutils::defaultfinishassembly(), defutils::defaultfinishbulkassembly(), defutils::defaultinitialize(), defutils::defaultsolve(), defutils::eigenorharmonicanalysis(), defutils::getlogical(), messages::info(), setdirichletbcs(), and solver().

Referenced by shellsolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine shellsolver::stressboundary ( real(kind=dp), dimension(:,:)  STIFF,
real(kind=dp), dimension(:)  FORCE,
real(kind=dp), dimension(:,:)  LOAD,
type(element_t), pointer  Element,
integer  n,
type(nodes_t)  Nodes 
)

References elementdescription::elementinfo(), and integration::gausspoints().

Referenced by bcassembly().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine shellsolver::switchtolocal ( type(nodes_t)  Nodes,
real(kind=dp), dimension(:,:)  CopyOfNodes,
real(kind=dp), dimension(:,:)  Transformation,
integer  n 
)

Referenced by localmatrix(), and localstress().

Here is the caller graph for this function: