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

Functions/Subroutines

subroutine acousticssolver (Model, Solver, dt, TransientSimulation)
 
subroutine monolithicsolve (n, A, x, b, Norm, l)
 
subroutine optimalscaling (n, A, s)
 
subroutine optimalmatrixscaling (n, A, s)
 
subroutine gcrouteriteration (n, A, q, PA, PS, MMatrix, LMatrix, x, b, Rounds, TOL, dim, Norm)
 
subroutine bicgstabouteriteration (n, A, q, PA, PS, MMatrix, LMatrix, x, b, Rounds, TOL, dim, Norm)
 
subroutine bicgstablouteriteration (l, m, A, q, PA, PS, MMatrix, LMatrix, v, f, MaxRounds, Tol, dim, Norm)
 
subroutine innerouteriteration (n, A, q, PA, PS, MMatrix, LMatrix, x, b, Rounds, TOL, dim, Norm)
 
subroutine inneriteration (n, A, q, PA, PS, x, b, Rounds, TOL, dim, MMatrix, LMatrix, SystemScaling, da, dpa, dps)
 
subroutine preconditioningiteration (n, A, q, PA, PS, V, dim, da, dpa, dps, Scaling, MMatrix, LMatrix)
 
real(kind=dp) function stoppingcriterion (n, A, x, b, res, CriterionType)
 
real(kind=dp) function conditionestimate (n, A, x, b)
 
subroutine complexmatrixvectorproduct (A, u, v)
 
real(kind=dp) function complexinfinitynorm (m, x)
 
real(kind=dp) function complexnorm (n, x)
 
complex(kind=dp) function complexdotproduct (n, x, y)
 
subroutine complexbicgstabl (l, n, A, x, b, MaxRounds, Tol, StoppingCriterionType)
 
subroutine complexbicgstab (n, A, x, b, Rounds, TOL, StoppingCriterionType)
 
subroutine crs_complexlusolve2 (N, A, b)
 
subroutine complexlusolve (n, m, Rows, Cols, Diag, Values, b)
 
subroutine complexmatrixvectorproduct2 (A, u, v, dim)
 
subroutine velocitysolve (l, n, A, x, b, dim, MaxRounds, Tol, StoppingCriterionType)
 
subroutine complexmatrixvelocityvectorproduct (K, u, v, dim)
 
subroutine diagonalvelocitypreconditioning (K, v, dim)
 
subroutine coupledvelocitymatrix (StiffMatrix, Viscosity, AngularFrequency, Density, Element, n, dim)
 
subroutine pressurelaplacematrix (StiffMatrix, Viscosity, AngularFrequency, Density, Element, n, dim)
 
subroutine pressuremassmatrix (StiffMatrix, Element, n, dim)
 
subroutine schurcomplementmatrix (StiffMatrix, AngularFrequency, SpecificHeat, HeatRatio, Density, Pressure, Temperature, Conductivity, Viscosity, Lambda, Element, n, dim)
 
subroutine velocityimpedancematrix (StiffMatrix, AngularFrequency, Density, Impedance, Element, n, Nodes, dim)
 
subroutine schurcomplementimpedancematrix (StiffMatrix, Impedance, AngularFrequency, SpecificHeat, HeatRatio, Density, Conductivity, Element, n, Nodes, dim)
 
subroutine velocityslipmatrix (StiffMatrix, SpecificHeat, HeatRatio, Density, Temperature, AngularFrequency, WallTemperature, SlipCoefficient1, Element, n, Nodes, dim)
 
subroutine schurcomplementslipmatrix (StiffMatrix, SpecificHeat, HeatRatio, Density, Temperature, AngularFrequency, Conductivity, WallTemperature, SlipCoefficient2, Element, n, Nodes, dim)
 
subroutine localmatrix (StiffMatrix, Force, AngularFrequency, SpecificHeat, HeatRatio, Density, Temperature, Conductivity, Viscosity, Lambda, HeatSource, Load, Bubbles, Mini_Bubbles, Element, n, Nodes, Dofs, nb)
 
subroutine lcondensatebubbles (n, dim, K, F, nb)
 
subroutine lcondensate (n, dim, K, F)
 
subroutine localmatrixboundary (StiffMatrix, Force, AngularFrequency, SpecificHeat, HeatRatio, Density, Pressure, Temperature, Conductivity, Impedance, Load, Element, n, Nodes, Dofs)
 
subroutine localinterfacematrix (StiffMatrix, Force, AngularFrequency, SpecificHeat, HeatRatio, Density, Pressure, Temperature, Conductivity, Impedance, Load, Element, n, Nodes, Dofs)
 
subroutine slipmatrix (StiffMatrix, Force, SpecificHeat, HeatRatio, Density, Conductivity, Pressure, Temperature, AngularFrequency, WallTemperature, WallVelocity, SlipCoefficient1, SlipCoefficient2, SlipCoefficient3, Element, n, Nodes, Dofs)
 
subroutine updateglobalpreconditioner (StiffMatrix, LocalStiffMatrix, n, NDOFs, NodeIndexes)
 
subroutine setboundaryconditions (Model, StiffMatrix, Name, DOF, NDOFs, Perm)
 
subroutine computeacousticimpedance (AcousticI, Bndries, AcImpedances)
 
subroutine computeaveragevelocity (Element, n, WallVelo, res)
 
subroutine explicitstabilisationmatrix (StiffMatrix, Force, AngularFrequency, SpecificHeat, HeatRatio, Density, Temperature, Conductivity, Viscosity, Lambda, HeatSource, Load, Bubbles, Element, n, Nodes, Dofs, NodeOnBoundary)
 
subroutine surfaceforceintegration (Element, Parent, Traction, Moment, MomentAbout, Area, CalculateMoment, Velo, Pressure, Viscosity, BulkViscosity, Nodes, ParentNodes, np)
 
subroutine surfaceimpedanceintegration (Element, Velo, Pressure, Nodes, n, Impedance1, Impedance2, C3, C4, Area)
 
integer function, dimension(n) discontindexes (Solver, Element, n)
 
subroutine setdirichletpoints (StiffMatrix, ForceVector, DOF, NDOFs, Perm, n, NodeIndexes, NodeValues)
 
subroutine acousticshellinterface ()
 
subroutine fsiintegration (Element, Velo, Pressure, Nodes, n, uf, wf, Area)
 

Function/Subroutine Documentation

subroutine acousticssolver::acousticshellinterface ( )

References defutils::getlogical(), setdirichletpoints(), lists::variableget(), and messages::warn().

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver ( type(model_t)  Model,
type(solver_t)  Solver,
real(kind=dp)  dt,
logical  TransientSimulation 
)

Solve the time-harmonic, generalized NS-equations assuming ideal gas law.

Parameters
solverLinear & nonlinear equation solver options
modelAll model information (mesh, materials, BCs, etc...)
dtTimestep size for time dependent simulations
transientsimulationSteady state or transient simulation

References acousticshellinterface(), defutils::activeboundaryelement(), bicgstablouteriteration(), bicgstabouteriteration(), lists::checkelementequation(), computeacousticimpedance(), computeaveragevelocity(), coordinatesystems::coordinatesystemdimension(), coupledvelocitymatrix(), elementutils::creatematrix(), crsmatrix::crs_zeromatrix(), coordinatesystems::currentcoordinatesystem(), defutils::defaultfinishbulkassembly(), explicitstabilisationmatrix(), messages::fatal(), gcrouteriteration(), defutils::getcreal(), defutils::getelementnofbdofs(), defutils::getelementnofdofs(), messages::info(), solverutils::initializetozero(), innerouteriteration(), lists::listaddconstreal(), lists::listgetconstreal(), lists::listgetinteger(), lists::listgetlogical(), lists::listgetreal(), lists::listgetstring(), localinterfacematrix(), localmatrix(), localmatrixboundary(), monolithicsolve(), defutils::possiblefluxelement(), pressurelaplacematrix(), pressuremassmatrix(), schurcomplementimpedancematrix(), schurcomplementmatrix(), schurcomplementslipmatrix(), setboundaryconditions(), solverutils::setdirichletboundaries(), solverutils::setmatrixelement(), slipmatrix(), solver(), solverutils::solvesystem(), surfaceforceintegration(), solverutils::updateglobalequations(), updateglobalpreconditioner(), lists::variableget(), velocityimpedancematrix(), velocityslipmatrix(), messages::warn(), and solverutils::zerorow().

subroutine acousticssolver::bicgstablouteriteration ( integer  l,
integer  m,
type(matrix_t), pointer  A,
integer  q,
type(matrix_t), pointer  PA,
type(matrix_t), pointer  PS,
type(matrix_t), pointer  MMatrix,
type(matrix_t), pointer  LMatrix,
real(kind=dp), dimension(m)  v,
real(kind=dp), dimension(m)  f,
integer  MaxRounds,
real(kind=dp)  Tol,
integer  dim,
real(kind=dp)  Norm 
)

References complexbicgstab(), complexmatrixvectorproduct(), conditionestimate(), crsmatrix::crs_complexincompletelu(), crs_complexlusolve2(), messages::fatal(), messages::info(), lists::listgetconstreal(), lists::listgetinteger(), lists::listgetlogical(), optimalmatrixscaling(), preconditioningiteration(), solver(), and velocityprecond().

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::bicgstabouteriteration ( integer  n,
type(matrix_t), pointer  A,
integer  q,
type(matrix_t), pointer  PA,
type(matrix_t), pointer  PS,
type(matrix_t), pointer  MMatrix,
type(matrix_t), pointer  LMatrix,
real(kind=dp), dimension(n)  x,
real(kind=dp), dimension(n)  b,
integer  Rounds,
real(kind=dp)  TOL,
integer  dim,
real(kind=dp)  Norm 
)

References complexbicgstab(), complexdotproduct(), complexmatrixvectorproduct(), complexnorm(), conditionestimate(), crsmatrix::crs_complexincompletelu(), messages::info(), lists::listgetconstreal(), lists::listgetinteger(), lists::listgetlogical(), optimalmatrixscaling(), preconditioningiteration(), solver(), stoppingcriterion(), and velocityprecond().

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::complexbicgstab ( integer  n,
type(matrix_t), pointer  A,
complex(kind=dp), dimension(n/2)  x,
complex(kind=dp), dimension(n/2)  b,
integer  Rounds,
real(kind=dp)  TOL,
integer, optional  StoppingCriterionType 
)

References complexdotproduct(), complexmatrixvectorproduct(), complexnorm(), conditionestimate(), crs_complexlusolve2(), and stoppingcriterion().

Referenced by bicgstablouteriteration(), bicgstabouteriteration(), gcrouteriteration(), and preconditioningiteration().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::complexbicgstabl ( integer  l,
integer  n,
type(matrix_t), pointer  A,
complex(kind=dp), dimension(n)  x,
complex(kind=dp), dimension(n)  b,
integer  MaxRounds,
real(kind=dp)  Tol,
integer, optional  StoppingCriterionType 
)

References complexmatrixvectorproduct(), complexnorm(), conditionestimate(), crs_complexlusolve2(), messages::fatal(), and stoppingcriterion().

Here is the call graph for this function:

complex(kind=dp) function acousticssolver::complexdotproduct ( integer  n,
complex(kind=dp), dimension(:)  x,
complex(kind=dp), dimension(:)  y 
)

Referenced by bicgstabouteriteration(), complexbicgstab(), gcrouteriteration(), inneriteration(), and innerouteriteration().

Here is the caller graph for this function:

real(kind=dp) function acousticssolver::complexinfinitynorm ( integer  m,
complex(kind=dp), dimension(m)  x 
)
subroutine acousticssolver::complexlusolve ( integer  n,
integer  m,
integer, dimension(n+1)  Rows,
integer, dimension(m)  Cols,
integer, dimension(n)  Diag,
complex(kind=dp), dimension(m)  Values,
complex(kind=dp), dimension(n)  b 
)
subroutine acousticssolver::complexmatrixvectorproduct ( type(matrix_t), pointer  A,
complex(kind=dp), dimension(*)  u,
complex(kind=dp), dimension(*)  v 
)

Referenced by bicgstablouteriteration(), bicgstabouteriteration(), complexbicgstab(), complexbicgstabl(), gcrouteriteration(), inneriteration(), innerouteriteration(), and preconditioningiteration().

Here is the caller graph for this function:

subroutine acousticssolver::complexmatrixvectorproduct2 ( type(matrix_t), pointer  A,
complex(kind=dp), dimension(*)  u,
complex(kind=dp), dimension(*)  v,
integer  dim 
)

Referenced by preconditioningiteration().

Here is the caller graph for this function:

subroutine acousticssolver::complexmatrixvelocityvectorproduct ( type(matrix_t), pointer  K,
complex(kind=dp), dimension(*)  u,
complex(kind=dp), dimension(*)  v,
integer  dim 
)

Referenced by velocitysolve().

Here is the caller graph for this function:

real(kind=dp) function acousticssolver::complexnorm ( integer  n,
complex(kind=dp), dimension(:)  x 
)

Referenced by bicgstabouteriteration(), complexbicgstab(), complexbicgstabl(), gcrouteriteration(), inneriteration(), innerouteriteration(), and velocitysolve().

Here is the caller graph for this function:

subroutine acousticssolver::computeacousticimpedance ( integer  AcousticI,
integer, dimension(:)  Bndries,
real(kind=dp), dimension(:,:)  AcImpedances 
)

References coordinatesystems::coordinatesysteminfo(), coordinatesystems::currentcoordinatesystem(), elementdescription::elementinfo(), integration::gausspoints(), normal(), elementdescription::normalvector(), and solver().

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::computeaveragevelocity ( type(element_t), pointer  Element,
integer  n,
real(kind=dp), dimension(:,:)  WallVelo,
complex(kind=dp)  res 
)

References elementutils::elementarea(), elementdescription::elementinfo(), integration::gausspoints(), defutils::getelementnodes(), normal(), elementdescription::normalvector(), and solver().

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

real(kind=dp) function acousticssolver::conditionestimate ( integer  n,
type(matrix_t), pointer  A,
complex(kind=dp), dimension(n)  x,
complex(kind=dp), dimension(n)  b 
)

Referenced by bicgstablouteriteration(), bicgstabouteriteration(), complexbicgstab(), complexbicgstabl(), gcrouteriteration(), and innerouteriteration().

Here is the caller graph for this function:

subroutine acousticssolver::coupledvelocitymatrix ( real(kind=dp), dimension(:,:), target  StiffMatrix,
real(kind=dp), dimension(:)  Viscosity,
real(kind=dp)  AngularFrequency,
real(kind=dp), dimension(:)  Density,
type(element_t), pointer  Element,
integer  n,
integer  dim 
)

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

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::crs_complexlusolve2 ( integer  N,
type(matrix_t), pointer  A,
complex(kind=dp), dimension(n)  b 
)

References complexlusolve().

Referenced by bicgstablouteriteration(), complexbicgstab(), and complexbicgstabl().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::diagonalvelocitypreconditioning ( type(matrix_t), pointer  K,
complex(kind=dp), dimension(*)  v,
integer  dim 
)

Referenced by velocitysolve().

Here is the caller graph for this function:

integer function, dimension(n) acousticssolver::discontindexes ( type(solver_t)  Solver,
type(element_t), pointer  Element,
integer  n 
)

References solver().

Here is the call graph for this function:

subroutine acousticssolver::explicitstabilisationmatrix ( real(kind=dp), dimension(:,:)  StiffMatrix,
real(kind=dp), dimension(:)  Force,
real(kind=dp)  AngularFrequency,
real(kind=dp), dimension(:)  SpecificHeat,
real(kind=dp), dimension(:)  HeatRatio,
real(kind=dp), dimension(:)  Density,
real(kind=dp), dimension(:)  Temperature,
real(kind=dp), dimension(:)  Conductivity,
real(kind=dp), dimension(:)  Viscosity,
real(kind=dp), dimension(:)  Lambda,
real(kind=dp), dimension(:,:)  HeatSource,
real(kind=dp), dimension(:,:)  Load,
logical  Bubbles,
type(element_t), pointer  Element,
integer  n,
type(nodes_t)  Nodes,
integer  Dofs,
logical, dimension(:)  NodeOnBoundary 
)

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

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::fsiintegration ( type(element_t), pointer  Element,
real(kind=dp), dimension(:,:)  Velo,
real(kind=dp), dimension(:,:)  Pressure,
type(nodes_t)  Nodes,
integer  n,
complex(kind=dp)  uf,
complex(kind=dp)  wf,
real(kind=dp)  Area 
)

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

Here is the call graph for this function:

subroutine acousticssolver::gcrouteriteration ( integer  n,
type(matrix_t), pointer  A,
integer  q,
type(matrix_t), pointer  PA,
type(matrix_t), pointer  PS,
type(matrix_t), pointer  MMatrix,
type(matrix_t), pointer  LMatrix,
real(kind=dp), dimension(n)  x,
real(kind=dp), dimension(n)  b,
integer  Rounds,
real(kind=dp)  TOL,
integer  dim,
real(kind=dp)  Norm 
)

References complexbicgstab(), complexdotproduct(), complexmatrixvectorproduct(), complexnorm(), conditionestimate(), crsmatrix::crs_complexincompletelu(), messages::info(), lists::listgetconstreal(), lists::listgetinteger(), lists::listgetlogical(), optimalmatrixscaling(), preconditioningiteration(), solver(), and velocityprecond().

Referenced by acousticssolver(), and stokessolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::inneriteration ( integer  n,
type(matrix_t), pointer  A,
integer  q,
type(matrix_t), pointer  PA,
type(matrix_t), pointer  PS,
complex(kind=dp), dimension(n/2)  x,
complex(kind=dp), dimension(n/2)  b,
integer  Rounds,
real(kind=dp)  TOL,
integer  dim,
type(matrix_t), pointer  MMatrix,
type(matrix_t), pointer  LMatrix,
logical, optional  SystemScaling,
complex(kind=dp), dimension(n/2), optional  da,
complex(kind=dp), dimension(dim*q/2), optional  dpa,
complex(kind=dp), dimension(q), optional  dps 
)

References complexdotproduct(), complexmatrixvectorproduct(), complexnorm(), and preconditioningiteration().

Referenced by innerouteriteration().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::innerouteriteration ( integer  n,
type(matrix_t), pointer  A,
integer  q,
type(matrix_t), pointer  PA,
type(matrix_t), pointer  PS,
type(matrix_t), pointer  MMatrix,
type(matrix_t), pointer  LMatrix,
real(kind=dp), dimension(n)  x,
real(kind=dp), dimension(n)  b,
integer  Rounds,
real(kind=dp)  TOL,
integer  dim,
real(kind=dp)  Norm 
)

References complexbicgstabl(), complexdotproduct(), complexmatrixvectorproduct(), complexnorm(), conditionestimate(), crsmatrix::crs_complexincompletelu(), messages::info(), inneriteration(), lists::listgetconstreal(), lists::listgetinteger(), lists::listgetlogical(), optimalmatrixscaling(), solver(), stoppingcriterion(), velocityprecond(), and velocitysolve().

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::lcondensate ( integer  n,
integer  dim,
complex(kind=dp), dimension(:,:)  K,
complex(kind=dp), dimension(:)  F 
)

References linearalgebra::complexinvertmatrix().

Referenced by distancesolver(), and localmatrix().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::lcondensatebubbles ( integer  n,
integer  dim,
complex(kind=dp), dimension(:,:)  K,
complex(kind=dp), dimension(:)  F,
integer  nb 
)

References linearalgebra::complexinvertmatrix().

Referenced by localmatrix().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::localinterfacematrix ( real(kind=dp), dimension(:,:)  StiffMatrix,
real(kind=dp), dimension(:)  Force,
real(kind=dp)  AngularFrequency,
real(kind=dp), dimension(:)  SpecificHeat,
real(kind=dp), dimension(:)  HeatRatio,
real(kind=dp), dimension(:)  Density,
real(kind=dp), dimension(:)  Pressure,
real(kind=dp), dimension(:)  Temperature,
real(kind=dp), dimension(:)  Conductivity,
real(kind=dp), dimension(:,:)  Impedance,
real(kind=dp), dimension(:,:)  Load,
type(element_t), pointer  Element,
integer  n,
type(nodes_t)  Nodes,
integer  Dofs 
)

References coordinatesystems::coordinatesystemdimension(), coordinatesystems::currentcoordinatesystem(), elementdescription::elementinfo(), integration::gausspoints(), normal(), and elementdescription::normalvector().

Referenced by acousticssolver(), and helmholtzsolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::localmatrix ( real(kind=dp), dimension(:,:)  StiffMatrix,
real(kind=dp), dimension(:)  Force,
real(kind=dp)  AngularFrequency,
real(kind=dp), dimension(:)  SpecificHeat,
real(kind=dp), dimension(:)  HeatRatio,
real(kind=dp), dimension(:)  Density,
real(kind=dp), dimension(:)  Temperature,
real(kind=dp), dimension(:)  Conductivity,
real(kind=dp), dimension(:)  Viscosity,
real(kind=dp), dimension(:)  Lambda,
real(kind=dp), dimension(:,:)  HeatSource,
real(kind=dp), dimension(:,:)  Load,
logical  Bubbles,
logical  Mini_Bubbles,
type(element_t), pointer  Element,
integer  n,
type(nodes_t)  Nodes,
integer  Dofs,
integer  nb 
)

References coordinatesystems::coordinatesystemdimension(), elementutils::elementarea(), elementdescription::elementinfo(), messages::error(), integration::gausspoints(), lcondensate(), lcondensatebubbles(), and solver().

Here is the call graph for this function:

subroutine acousticssolver::localmatrixboundary ( real(kind=dp), dimension(:,:)  StiffMatrix,
real(kind=dp), dimension(:)  Force,
real(kind=dp)  AngularFrequency,
real(kind=dp), dimension(:)  SpecificHeat,
real(kind=dp), dimension(:)  HeatRatio,
real(kind=dp), dimension(:)  Density,
real(kind=dp), dimension(:)  Pressure,
real(kind=dp), dimension(:)  Temperature,
real(kind=dp), dimension(:)  Conductivity,
real(kind=dp), dimension(:,:)  Impedance,
real(kind=dp), dimension(:,:)  Load,
type(element_t), pointer  Element,
integer  n,
type(nodes_t)  Nodes,
integer  Dofs 
)

References coordinatesystems::coordinatesystemdimension(), elementdescription::elementinfo(), integration::gausspoints(), normal(), and elementdescription::normalvector().

Here is the call graph for this function:

subroutine acousticssolver::monolithicsolve ( integer  n,
type(matrix_t), pointer  A,
real(kind=dp), dimension(n)  x,
real(kind=dp), dimension(n)  b,
real(kind=dp)  Norm,
integer  l 
)

References complexbicgstabl(), crsmatrix::crs_complexincompletelu(), lists::listgetconstreal(), lists::listgetinteger(), lists::listgetstring(), optimalmatrixscaling(), and solver().

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::optimalmatrixscaling ( integer  n,
type(matrix_t), pointer  A,
complex(kind=dp), dimension(n)  s 
)

References messages::info().

Referenced by bicgstablouteriteration(), bicgstabouteriteration(), gcrouteriteration(), innerouteriteration(), and monolithicsolve().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::optimalscaling ( integer  n,
type(matrix_t), pointer  A,
complex(kind=dp), dimension(n)  s 
)
subroutine acousticssolver::preconditioningiteration ( integer  n,
type(matrix_t), pointer  A,
integer  q,
type(matrix_t), pointer  PA,
type(matrix_t), pointer  PS,
complex(kind=dp), dimension(n/2)  V,
integer  dim,
complex(kind=dp), dimension(n/2), optional  da,
complex(kind=dp), dimension(dim*q/2), optional  dpa,
complex(kind=dp), dimension(q), optional  dps,
logical, optional  Scaling,
type(matrix_t), optional, pointer  MMatrix,
type(matrix_t), optional, pointer  LMatrix 
)

References complexbicgstab(), complexbicgstabl(), complexmatrixvectorproduct(), complexmatrixvectorproduct2(), g(), messages::info(), lists::listgetconstreal(), lists::listgetinteger(), solver(), and velocitysolve().

Referenced by bicgstablouteriteration(), bicgstabouteriteration(), gcrouteriteration(), and inneriteration().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::pressurelaplacematrix ( real(kind=dp), dimension(:,:), target  StiffMatrix,
real(kind=dp), dimension(:)  Viscosity,
real(kind=dp)  AngularFrequency,
real(kind=dp), dimension(:)  Density,
type(element_t), pointer  Element,
integer  n,
integer  dim 
)

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

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::pressuremassmatrix ( real(kind=dp), dimension(:,:), target  StiffMatrix,
type(element_t), pointer  Element,
integer  n,
integer  dim 
)

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

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::schurcomplementimpedancematrix ( real(kind=dp), dimension(:,:), target  StiffMatrix,
real(kind=dp), dimension(:,:)  Impedance,
real(kind=dp)  AngularFrequency,
real(kind=dp), dimension(:)  SpecificHeat,
real(kind=dp), dimension(:)  HeatRatio,
real(kind=dp), dimension(:)  Density,
real(kind=dp), dimension(:)  Conductivity,
type(element_t), pointer  Element,
integer  n,
type(nodes_t)  Nodes,
integer  dim 
)

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

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::schurcomplementmatrix ( real(kind=dp), dimension(:,:), target  StiffMatrix,
real(kind=dp)  AngularFrequency,
real(kind=dp), dimension(:)  SpecificHeat,
real(kind=dp), dimension(:)  HeatRatio,
real(kind=dp), dimension(:)  Density,
real(kind=dp), dimension(:)  Pressure,
real(kind=dp), dimension(:)  Temperature,
real(kind=dp), dimension(:)  Conductivity,
real(kind=dp), dimension(:)  Viscosity,
real(kind=dp), dimension(:)  Lambda,
type(element_t), pointer  Element,
integer  n,
integer  dim 
)

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

Referenced by acousticssolver(), and stokessolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::schurcomplementslipmatrix ( real(kind=dp), dimension(:,:), target  StiffMatrix,
real(kind=dp), dimension(:)  SpecificHeat,
real(kind=dp), dimension(:)  HeatRatio,
real(kind=dp), dimension(:)  Density,
real(kind=dp), dimension(:)  Temperature,
real(kind=dp)  AngularFrequency,
real(kind=dp), dimension(:)  Conductivity,
real(kind=dp), dimension(:)  WallTemperature,
real(kind=dp)  SlipCoefficient2,
type(element_t), pointer  Element,
integer  n,
type(nodes_t)  Nodes,
integer  dim 
)

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

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::setboundaryconditions ( type(model_t)  Model,
type(matrix_t), pointer  StiffMatrix,
character(len=*)  Name,
integer  DOF,
integer  NDOFs,
integer, dimension(:)  Perm 
)

References lists::listgetreal(), solverutils::setmatrixelement(), and solverutils::zerorow().

Here is the call graph for this function:

subroutine acousticssolver::setdirichletpoints ( type(matrix_t), pointer  StiffMatrix,
real(kind=dp), dimension(:)  ForceVector,
integer  DOF,
integer  NDOFs,
integer, dimension(:)  Perm,
integer  n,
integer, dimension(:)  NodeIndexes,
real(kind=dp), dimension(:)  NodeValues 
)

References crsmatrix::crs_setsymmdirichlet(), bandmatrix::sband_setdirichlet(), solverutils::setmatrixelement(), and solverutils::zerorow().

Referenced by acousticshellinterface().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::slipmatrix ( real(kind=dp), dimension(:,:)  StiffMatrix,
real(kind=dp), dimension(:)  Force,
real(kind=dp), dimension(:)  SpecificHeat,
real(kind=dp), dimension(:)  HeatRatio,
real(kind=dp), dimension(:)  Density,
real(kind=dp), dimension(:)  Conductivity,
real(kind=dp), dimension(:)  Pressure,
real(kind=dp), dimension(:)  Temperature,
real(kind=dp)  AngularFrequency,
real(kind=dp), dimension(:)  WallTemperature,
real(kind=dp), dimension(:,:)  WallVelocity,
real(kind=dp)  SlipCoefficient1,
real(kind=dp)  SlipCoefficient2,
real(kind=dp)  SlipCoefficient3,
type(element_t), pointer  Element,
integer  n,
type(nodes_t)  Nodes,
integer  Dofs 
)

References coordinatesystems::coordinatesystemdimension(), coordinatesystems::currentcoordinatesystem(), elementdescription::elementinfo(), integration::gausspoints(), normal(), elementdescription::normalvector(), and elementutils::tangentdirections().

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

real(kind=dp) function acousticssolver::stoppingcriterion ( integer  n,
type(matrix_t), pointer  A,
complex(kind=dp), dimension(n)  x,
complex(kind=dp), dimension(n)  b,
complex(kind=dp), dimension(n)  res,
integer, optional  CriterionType 
)

Referenced by bicgstabouteriteration(), complexbicgstab(), complexbicgstabl(), and innerouteriteration().

Here is the caller graph for this function:

subroutine acousticssolver::surfaceforceintegration ( type(element_t), pointer  Element,
type(element_t), pointer  Parent,
real(kind=dp), dimension(6)  Traction,
real(kind=dp), dimension(6)  Moment,
real(kind=dp), dimension(3)  MomentAbout,
real(kind=dp)  Area,
logical  CalculateMoment,
real(kind=dp), dimension(:,:)  Velo,
real(kind=dp), dimension(:,:)  Pressure,
real(kind=dp), dimension(:)  Viscosity,
real(kind=dp), dimension(:)  BulkViscosity,
type(nodes_t)  Nodes,
type(nodes_t)  ParentNodes,
integer  np 
)

References coordinatesystems::coordinatesystemdimension(), elementutils::elementarea(), elementdescription::elementinfo(), integration::gausspoints(), normal(), elementdescription::normalvector(), and solver().

Referenced by acousticssolver(), and pressuresolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::surfaceimpedanceintegration ( type(element_t), pointer  Element,
real(kind=dp), dimension(:,:)  Velo,
real(kind=dp), dimension(:,:)  Pressure,
type(nodes_t)  Nodes,
integer  n,
complex(kind=dp)  Impedance1,
complex(kind=dp)  Impedance2,
complex(kind=dp)  C3,
complex(kind=dp)  C4,
real(kind=dp)  Area 
)

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

Here is the call graph for this function:

subroutine acousticssolver::updateglobalpreconditioner ( type(matrix_t), pointer  StiffMatrix,
real(kind=dp), dimension(:,:)  LocalStiffMatrix,
integer  n,
integer  NDOFs,
integer, dimension(:)  NodeIndexes 
)

References crsmatrix::crs_gluelocalmatrix().

Referenced by acousticssolver(), optimalsolutionupdate(), and stokessolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::velocityimpedancematrix ( real(kind=dp), dimension(:,:), target  StiffMatrix,
real(kind=dp)  AngularFrequency,
real(kind=dp), dimension(:)  Density,
real(kind=dp), dimension(:,:)  Impedance,
type(element_t), pointer  Element,
integer  n,
type(nodes_t)  Nodes,
integer  dim 
)

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

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::velocityslipmatrix ( real(kind=dp), dimension(:,:), target  StiffMatrix,
real(kind=dp), dimension(:)  SpecificHeat,
real(kind=dp), dimension(:)  HeatRatio,
real(kind=dp), dimension(:)  Density,
real(kind=dp), dimension(:)  Temperature,
real(kind=dp)  AngularFrequency,
real(kind=dp), dimension(:)  WallTemperature,
real(kind=dp)  SlipCoefficient1,
type(element_t), pointer  Element,
integer  n,
type(nodes_t)  Nodes,
integer  dim 
)

References elementdescription::elementinfo(), integration::gausspoints(), normal(), elementdescription::normalvector(), and elementutils::tangentdirections().

Referenced by acousticssolver().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine acousticssolver::velocitysolve ( integer  l,
integer  n,
type(matrix_t), pointer  A,
complex(kind=dp), dimension(n)  x,
complex(kind=dp), dimension(n)  b,
integer  dim,
integer  MaxRounds,
real(kind=dp)  Tol,
integer, optional  StoppingCriterionType 
)

References complexmatrixvelocityvectorproduct(), complexnorm(), diagonalvelocitypreconditioning(), and messages::fatal().

Referenced by innerouteriteration(), and preconditioningiteration().

Here is the call graph for this function:

Here is the caller graph for this function: