G+Smo
24.08.0
Geometry + Simulation Modules
|
Eigen | |
BlockDiag | Expression for block diagonal replication of a matrix or vector |
BlockTranspose | Expression of block-wise transposition of a tiled matrix |
VecAsSymmMatrix | Expression for presenting a vector as a DimxDim symmetric matrix |
gismo | The G+Smo namespace, containing all definitions for the library |
bspline | This namespace contains implementation of B-spline related algorithms |
expr | This namespace contains expressions used for FE computations |
_expr< E, false > | Base class for all expressions |
asdiag_expr | |
cartconinv_expr | |
cartcovinv_expr | |
constMat_expr | |
deriv2_expr | Computes the second derivative of an expression |
deriv2dot_expr | Expression that takes the second derivative of an expression and multiplies it with a row vector |
exp_expr | |
flat_expr | |
flatdot2_expr | Computes the product of expressions E1 and E2 and multiplies with a vector E3 in voight notation |
flatdot_expr | Computes the product of expressions E1 and E2 and multiplies with a vector E3 in voight notation |
gsFeSpace | |
gsFeVariable | |
idMat_expr | |
integral_expr | |
lapl_expr | |
matrix_by_space_expr | |
matrix_by_space_expr_tr | |
normal_expr | |
onormal_expr | |
ovar1_expr | Expression for the first variation of the outer normal |
ovar2dot_expr | Expression for the second variation of the outer normal times a vector |
pow_expr | |
ppart_expr | |
ppartval_expr | |
sign_expr | |
tangent_expr | |
tvar1_expr | Expression for the first variation of the outer tangent |
unitVec_expr | Simple expression for the unit vector of length dim and with value 1 on index |
var1_expr | Expression for the first variation of the surface normal |
var2_expr | Second variation of the normal |
var2deriv2dot_expr | Second variation of the surface normal times the second derivative of the geometry map times a vector |
var2dot_expr | Second variation of the surface normal times a vector |
internal | This namespace contains functionalities that are internal to the library |
math | This namespace contains common mathematical functions |
numeric_limits | |
memory | This namespace contains functions related to memory management |
preAApp | |
AndersonAcceleration | Anderson acceleration solver and its (preconditioned) variants |
trilinos | This namespace contains wrappers for the Trilinos library |
solver | This namespace contains wrappers for Trilinos linear system solvers and eigenvalue solvers |
AbstractDirectSolver | Abstract direct solver base class |
AbstractIterativeSolver | Abstract iterative solver base class |
AbstractSolver | Abstract solver base class |
AmesosSolver | Amesos solver class |
AmesosSolvers | Amesos sparse direct solvers |
AztecPreconds | Aztec preconditioners |
AztecSolver | Actez solver class |
AztecSolvers | Aztec solvers |
AztecSubdomainSolvers | Aztec subdomain solver |
BelosSolver | Belos solver class |
BelosSolvers | Belos solvers |
EigenProblem | Computes the eigenvalues of largest magnitude of an eigenvalue problem $A x = x$, using Anasazi's implementation of the Block Davidson method |
MLSolver | ML solver class |
util | GsFuncData is a cache of pre-computed function sets values |
is_complex | Type trait is_complex<T> checks if type T is of type std::complex<...> |
remove_pointer | Remove pointer from type |
type | Print name of template type as a string |
ale_method | Specifies method used for mesh deformation in fluid-structure interaction |
Base64 | Encode for base64 export |
boundary | Struct that defines the boundary sides and corners and types of a geometric object |
boundary_condition | Class that defines a boundary condition for a side of a patch for some unknown variable of a PDE |
boundaryInterface | Struct which represents an interface between two patches |
boxComponent | Struct which represents a certain component (interior, face, egde, corner) |
boxCorner | Struct which represents a certain corner of a hyper-cube |
boxSide | Struct which represents a certain side of a box |
condition_type | Specifies the type of boundary condition |
corner_value | Class prescribing a value related to a corner of a patch |
coupled_boundary | Class prescribing a value related to a corner of a patch |
decodeMat_id | Decodes the material model and implementation |
encodeMat_id | Encodes the material model and implementation |
gsAABB | Struct of for an Axis-aligned bounding box |
gsAbsError | Generates a field with value the absolute difference (error) between and isogeometric function and a function defined on the physical domain |
gsAdaptiveMeshing | Provides adaptive meshing routines |
gsAdditiveOp | Generic preconditioner which applies an arbitrary linear operator to the residual |
gsAffineFunction | Representation of an affine function |
gsALMBase | Performs the arc length method to solve a nonlinear system of equations |
gsALMConsistentCrisfield | Performs the Consistent Crisfield arc length method to solve a nonlinear equation system |
gsALMCrisfield | Performs the Crisfield arc length method to solve a nonlinear equation system |
angmethod | Angle determination method option |
gsALMLoadControl | Performs the load-controlled arc length method to solve a nonlinear equation system |
gsAlmostC1 | Constructs the D-Patch, from which the transformation matrix can be called |
gsALMRiks | Performs the Riks arc length method to solve a nonlinear equation system |
gsApproxC1Spline | Class describing the approximate \(C^1\) spline |
gsAsConstMatrix | Creates a mapped object or data pointer to a const matrix without copying data |
gsAsConstVector | Creates a mapped object or data pointer to a const vector without copying data |
gsAsMatrix | Creates a mapped object or data pointer to a matrix without copying data |
gsAssembler | The assembler class provides generic routines for volume and boundary integrals that are used for for matrix and right-hand side generation |
gsAssemblerOptions | |
gsAsVector | Creates a mapped object or data pointer to a vector without copying data |
gsBarrierCore | GsBarrierCore |
gsBarrierPatch | Computes a patch parametrization given a set of boundary geometries. Parametrization is not guaranteed to be non-singular. Works for planar surfaces and volumes |
gsBaseAssembler | Extends the gsAssembler class by adding functionality necessary for a general nonlinear solver. Potentially, can be merged back into gsAssembler |
gsBasis | A basis represents a family of scalar basis functions defined over a common parameter domain |
gsBasisFun | Represents an individual function in a function set, or a certain component of a vector-valued function |
gsBasisRefs | Simple class to hold a list of gsBasis which discretize a PDE system on a given patch |
gsBiCgStab | Biconjugate gradient stabilized solver |
gsBiharmonicAssembler | Implementation of a homogeneous Biharmonic Assembler |
gsBiharmonicPde | A Biharmonic PDE |
gsBlockOp | Simple class create a block operator structure |
gsBoundaryConditions | Class containing a set of boundary conditions |
gsBoundedPriorityQueue | An implementation of the bounded priority queue abstraction |
gsBoxTopology | Defines a topological arrangement of a collection of "boxes" (e.g., parameter domains that map to physical-domain patches) |
gsBSpline | A B-spline function of one argument, with arbitrary target dimension |
gsBSplineBasis | A univariate B-spline basis |
gsBSplineSolver | |
gsBSplineTraits | Traits for BSplineBasis in more dimensions |
gsBucklingSolver | Performs linear buckling analysis given a matrix or functions of a matrix |
gsBulk | Abstract base class representing a 4D bulk |
gsCauchyStressFunction | Compute Cauchy stresses for a previously computed/defined displacement field. Can be pushed into gsPiecewiseFunction to construct gsField for visualization in Paraview |
gsCDRAssembler | Implementation of an (multiple righ-hand side) Poisson solver |
gsCmdLine | Class for command-line argument parsing |
gsCompositePrecOp | This class represents the composition of preconditioners of type gsPreconditionerOp |
gsConjugateGradient | The conjugate gradient method |
gsConstantBasis | Class defining a dummy basis of constant functions. This is used for compatibility reasons |
gsConstantFunction | Class defining a globally constant function |
gsContinuationBase | Base class for simple continuation schemes |
gsControlDisplacement | Simple class for displacement control given a static solver |
gsConvDiffRePde | A convection-diffusion-reaction PDE, including source term on the right-hand side |
gsCoonsPatch | Computes a Coons' patch parametrization given a set of boundary geometries. Parametrization is not guaranteed to be non-singular. Works for surface, volumes, or any dimension |
gsCPPInterface | Provides a mapping between the corresponding sides of two patches sharing an interface, by means of a closest point projection |
gsCrossApPatch | Computes a parametrization based on low rank cross approximation, given a set of boundary geometries |
gsCurvatureSmoothing | Class for computing a closed B-spline curve with a smaller number of curvature extrema compared to a given closed B-spline curve |
gsCurve | Abstract base class representing a curve |
gsCurveFitting | Class for performing a least squares fit to get a open/closed B-Spline curve for some given data |
gsCurveLoop | A closed loop given by a collection of curves |
gsDetFunction | Compute jacobian determinant of the geometry mapping. Can be pushed into gsPiecewiseFunction to construct gsField for visualization in Paraview |
gsDofMapper | Maintains a mapping from patch-local dofs to global dof indices and allows the elimination of individual dofs |
gsDomain | Class representing a domain. i.e. a collection of elements (triangles, rectangles, cubes, simplices |
gsDomainIterator | Class which enables iteration over all elements of a parameter domain |
gsDPatch | Constructs the D-Patch, from which the transformation matrix can be called |
gsDPatchBase | Constructs the D-Patch, from which the transformation matrix can be called |
gsDynamicBase | Performs the arc length method to solve a nonlinear system of equations |
gsDynamicBathe | Performs the arc length method to solve a nonlinear system of equations |
gsDynamicExplicitEuler | Performs the arc length method to solve a nonlinear system of equations |
gsDynamicImplicitEuler | Performs the arc length method to solve a nonlinear system of equations |
gsDynamicLibrary | Class defining a dynamic library |
gsDynamicNewmark | Performs the arc length method to solve a nonlinear system of equations |
gsDynamicRK4 | Performs the arc length method to solve a nonlinear system of equations |
gsDynamicWilson | Performs the arc length method to solve a nonlinear system of equations |
gsDynamicXBraid | Performs the arc length method to solve a nonlinear system of equations |
gsEigenAdaptor | Adaptor for Eigen types |
gsEigenProblemBase | Base class for buckling and modal analyses |
gsElasticityAssembler | Assembles the stiffness matrix and the right-hand side vector for linear and nonlinear elasticity for 2D plain stress and 3D continua. The matrix and vector have a block structure associated with components of the displacement vector, each block corresponding to one component. Supports mixed displacement-pressure formulation |
gsElementErrorPlotter | This class provides a function that returns a constant error on each element |
gsElTimeIntegrator | Time integation for equations of dynamic elasticity with implicit schemes |
gsEulerBernoulliBeamPde | The differential equation describing the linear Euler-Bernoulli beam |
gsExprAssembler | |
gsExprEvaluator | Generic evaluator of isogeometric expressions |
gsExprHelper | |
gsFeSpaceData | Struct containing information for matrix assembly |
gsField | A scalar of vector field defined on a m_parametric geometry |
gsFieldCreator | Class that creates standard fields on a given parametric (multipatch) geometry |
gsFileData | This class represents an XML data tree which can be read from or written to a (file) stream |
gsFileManager | File-system related functionality |
gsFitting | Class for performing a least squares fit of a parametrized point cloud with a gsGeometry |
gsFsiLoad | Loading function to transfer fluid action to the solid. Used in Fluid-Structure Interaction simulation. Different parametrizations can be used for the geometry+ALE and velocity+pressure |
gsFuncCoordinate | Represents a certain component of a vector-valued function |
gsFunction | A function \(f:\mathbb{R}^n\rightarrow\mathbb{R}^m\) from a n-dimensional domain to an m-dimensional image |
gsFunctionAdaptor | Adaptor to see a given gsFunction as (the objective of) an unconstrained optimization problem |
gsFunctionExpr | Class defining a multivariate (real or vector) function given by a string mathematical expression |
gsFunctionSet | Interface for the set of functions defined on a domain (the total number of functions in the set equals to \(S\) ) |
gsGaussRule | Class that represents the (tensor) Gauss-Legendre quadrature rule |
gsGaussSeidelOp | Gauss-Seidel preconditioner |
gsGenericAssembler | Assembles mass and stiffness matrices and right-hand sides on a given domain |
gsGenericStopwatch | A Stopwatch object can be used to measure execution time of code, algorithms, etc |
gsGenericTensorBasis | Class for a quasi-tensor B-spline basis |
gsGeometry | Abstract base class representing a geometry map |
gsGeometrySlice | GsGeometrySlice is a class representing an iso parametric slice of a geometry object. It stores a pointer to the geometry object, which is only valid as long as this object is alive. Methods for printing to paraview are available in gsWriteToParaview.h |
gsGeometryTransform | Representation of a transformed geometry |
gsGMRes | The generalized minimal residual (GMRES) method |
gsGradientDescent | This class describes the gradient descent method |
gsGradientField | Generates a field with value being the gradient of an isogeometric function |
gsGradientMethod | The gradient method |
gsGridHierarchy | Grid Hierarchy |
gsGridIterator< T, CWISE, d, false > | Iterator over a Cartesian product of points, which is given by coordinate-wise point sets |
gsGridIterator< T, mode, d, false > | Iterator over a Cartesian product of uniformly distributed numeric points inside a (hyper-)cube |
gsGridIterator< Z, mode, d, true > | Iterator over the Cartesian product of integer points in a tensor-product grid |
gsHalfEdgeMesh | GsHalfEdgeMesh is a gsMesh implementation that handles Halfedges |
Boundary | Class that maintains boundary of triangle mesh |
Chain | Class that maintains chain of halfedges |
Halfedge | Class that maintains directed halfedges in any dimension |
gsHBox | This class provides a Hierarchical Box (gsHBox) |
gsHBoxCheck | Base class for performing checks on gsHBox objects |
gsHBoxContainer | The Hierarchical Box Container provides a container for gsHBox objects |
gsHBoxUtils | The gsHBoxUtils provide basic utilities to modify HBoxes |
gsHBSpline | A hierarchical B-Spline function, in d dimensions |
gsHBSplineBasis | A hierarchical B-spline basis of parametric dimension d |
gsHDomain | Class with a hierarchical domain structure represented by a box k-d-tree |
get_cell_visitor | Returns an cell/element box of a requested level |
levelDown_visitor | Decreases the level by 1 for all leaves |
levelUp_visitor | Increases the level by 1 for all leaves |
liftCoordsOneLevel_visitor | Multiplies everything by 2 |
maxLevel_visitor | Decreases the level by 1 for all leaves |
numLeaves_visitor | Counts number of nodes in the tree |
numNodes_visitor | Counts number of nodes in the tree |
printLeaves_visitor | Counts number of nodes in the tree |
reduceCoordsOneLevel_visitor | Multiplies everything by 2 |
gsHDomainBoundaryIterator | Re-implements gsDomainIterator for iteration over all boundary elements of a hierarchical parameter domain |
gsHDomainIterator | Re-implements gsDomainIterator for iteration over all boundary elements of a hierarchical parameter domain |
gsHDomainLeafIter | Iterates over the leaves of an gsHDomain (tree) |
gsHDomainSliceIter | Iterates over the leaves of an gsHDomain (tree) that intersect with a slice position |
gsHeatEquation | Constructs the assembler for the discretized isogeometric heat equation |
gsHFitting | This class applies hierarchical fitting of parametrized point clouds |
gsHTensorBasis | Class representing a (scalar) hierarchical tensor basis of functions \( \mathbb R^d \to \mathbb R \) |
gsIdentityOp | Identity operator |
gsIetiMapper | Ieti Mapper |
gsIetiSystem | This class represents a IETI system |
gsIncompleteLUOp | Incomplete LU with thresholding preconditioner |
gsIpOpt | Class defining an optimization problem |
gsIterative | A general iterative solver for nonlinear problems. An equation to solve is specified by an assembler class which provides the following interfaces: |
gsIterativeSolver | Abstract class for iterative solvers |
gsIterativeSolverOp | This wrapper class allows gsIterativeSolver to be used as gsLinearOperator |
gsJacDetField | Generates a field with value the Jacobian determinant of a geometry |
gsJacobiOp | Jacobi preconditioner |
gsJITCompiler | Class defining a just-in-time compiler |
gsJITCompilerConfig | Struct definig a compiler configuration |
gsJITLang | Supported languages |
gsKdNode | Struct representing a kd-tree node |
gsKDTree | An interface representing a kd-tree in some number of dimensions |
gsKnotVector | Class for representing a knot vector |
gsKroneckerOp | Class for representing a Kronecker product of operators of type gsLinearOperator |
gsL2Projection | Class that performs an L2 projection |
gsLagrangeBasis | A univariate Lagrange basis |
gsLagrangePoly | The geometry class of a Lagrange Polyomial curve |
gsLanczosMatrix | Class for representing a Lanczos matrix and calculating its eigenvalues |
gsLaplacePde | The Laplace equation |
gsLargerErrCompare | Checks if the error of a gsHBox is larger than a threshold |
gsLegendreBasis | A univariate Legendre basis |
gsLinearLambdaOp | Wrapper that allows to use lambdas as a gsLinearOperator |
gsLinearOperator | Simple abstract class for discrete operators |
gsLineSegment | Represents a line segment in d dimensions |
gsLobattoRule | Class that represents the (tensor) Gauss-Lobatto quadrature rule |
gsMapData | GsMapData is a cache of pre-computed function (map) values |
gsMappedSingleBasis | Class gsMappedSingleBasis represents an indivisual .....of a |
gsMappedSingleSpline | Class gsMappedSingleSpline represents an individual .....of a |
gsMassAssembler | Assembles the mass matrix and right-hand side vector for linear and nonlinear elasticity for 2D plain stress and 3D continua. The matrix has a block structure associated with components of the displacement vector, each block corresponding to one component. Supports mixed displacement-pressure formulation |
gsMaterialMatrixBase | This class defines the base class for material matrices |
gsMaterialMatrixBaseDim | This class defines the base class for material matrices |
gsMaterialMatrixComposite | This class defines a linear material laminate |
gsMaterialMatrixContainer | This class serves as the evaluator of material matrices, based on gsMaterialMatrixBase |
gsMaterialMatrixEvalSingle | This class serves as the evaluator of material matrices, based on gsMaterialMatrixBase |
gsMaterialMatrixIntegrateSingle | This class serves as the integrator of material matrices, based on gsMaterialMatrixBase |
gsMaterialMatrixLinear | This class defines a linear material |
gsMaterialMatrixNonlinear | This class defines hyperelastic material matrices |
gsMaterialMatrixTFT | This class defines a linear material |
gsMatrix | A matrix with arbitrary coefficient type and fixed or dynamic size |
gsMatrixBlockView | Represents a block-view of the given matrix |
gsMatrixOp | Simple adapter class to use a matrix (or matrix-like object) as a linear operator. Needed for the iterative method classes |
gsMaxLvlCompare | Checks if the level of a gsHBox is smaller than a maximum level |
gsMesh | Class Representing a triangle mesh with 3D vertices |
gsMinimalResidual | The minimal residual (MinRes) method |
gsMinLvlCompare | Checks if the level of a gsHBox is bigger than a minimum level |
gsMinResQLP | The minimal residual (MinRes-QLP) method |
gsModalSolver | Performs linear modal analysis given a matrix or functions of a matrix |
gsMonomialBasis | An univariate monomial polynomial basis. If the degree is p the basis is given by: [ 1, x, x^2, ..., x^p ] The basis functions are numbered, starting from zero, as stated above |
gsMPBESBasis | Purely abstract class gsMappedBasis, which gives means of combining basis functions to new, global ones |
distances | Private stract that has the purpose of storing distance information of c^0 parts around special vertices |
gsMPBESBSplineBasis | A univariate Lagrange basis |
gsMPBESHSplineBasis | A univariate Lagrange basis |
gsMPBESMapB2D | A univariate Lagrange basis |
gsMPBESMapHB2D | A univariate Lagrange basis |
gsMPBESMapTensor | A univariate Lagrange basis |
gsMultiBasis | Holds a set of patch-wise bases and their topology information |
gsMultiGridOp | Multigrid preconditioner |
gsMultiPatch | Container class for a set of geometry patches and their topology, that is, the interface connections and outer boundary faces |
gsMuscleAssembler | Assembler for incompressible nonlinear elasticity problem with a muscle material model. The material model is based on the paper by M.H.Gfrerer and B.Simeon "Fiber-based modeling and simulation of skeletal muscles" |
gsMvLegendreBasis | A multivariate Legendre basis |
gsNewtonCotesRule | Class that represents the (tensor) Newton-Cotes quadrature rule |
gsNewtonIterator | Performs Newton iterations to solve a nonlinear system of PDEs |
gsNormalField | Generates the normal field of a geometry |
gsNsAssembler | TODO: write |
gsNsTimeIntegrator | Time integation for incompressible Navier-Stokes equations |
gsNurbs | A NURBS function of one argument, with arbitrary target dimension |
gsNurbsBasis | A univariate NURBS basis |
gsNurbsCreator | Class gsNurbsCreator provides some simple examples of Nurbs Geometries |
gsOptim | Base class for the Optim wrapper |
gsOptimBFGS | Binding to Optim's BFGS solver |
gsOptimCG | Binding to Optim's CG solver |
gsOptimDE | Binding to Optim's DE solver |
gsOptimDEPRMM | Binding to Optim's DEPRMM solver |
gsOptimGD | Binding to Optim's GD solver |
gsOptimizer | Class defining an optimizer |
gsOptimLBFGS | Binding to Optim's LBFGS solver |
gsOptimNM | Binding to Optim's NM solver |
gsOptimPSO | Binding to Optim's PSO solver |
gsOptimPSODV | Binding to Optim's PSODV solver |
gsOptimSUMT | Binding to Optim's SUMT solver |
gsOptimWrapper | Wraps the objective of an optimization problem to a function accepted by Optim |
gsOptimWrapperConstraint | Wraps the constraint of an optimization problem to a function accepted by Optim |
gsOptionList | Class which holds a list of parameters/options, and provides easy access to them |
OptionListEntry | |
gsOptProblem | Class defining an optimization problem |
gsOptProblemStatic | [OptProblemExample Class] |
gsOverIntegrateRule | Class that defines a mixed quadrature rule with different rules for the interior and the boundaries |
gsOverlapCompare | Checks if the coarsening neighborhood of a box is empty and if it overlaps with a refinement mask |
gsPanelCreator | Class gsPanelCreator provides some simple examples of Nurbs Geometries |
gsParametrization | Class that maintains parametrization This class Parametrization stores the mesh information and the two-dimensional parameter points. The parameter points are stored in a vector, where the i-th vector element is the parameter point for the vertex with index i. This means that the first n elements in the vector are the inner parameter points, the rest of them are the boundary parameter points |
LocalNeighbourhood | Class that maintains the local neighbourhood properties |
LocalParametrization | Class maintains local parametrization This class represents a local parametrization for a point in the triangle mesh, which is identified by the vertex index. The parametrization is given by the weights lambda(i,j) which is the weight of vertex x(i) regarding x(j) according to Floater's algorithm |
Neighbourhood | Class that maintains neighbourhood information of triangle mesh. Represents the neighbourhood properties of a vertex in the triangle mesh |
gsParamField | Generates a field that attaches the parameter values on each physical point |
gsParaviewCollection | This class is used to create a Paraview .pvd (collection) file |
gsParaviewDataSet | This class represents a group of vtk (Paraview) files that refer to one multiPatch, for one timestep |
gsPatchGenerator | Abstract class that accepts a set of input boundaries and computes a new geometry |
gsPatchIdField | Generates a field that indicates the boundary sides on the geometry |
gsPatchPreconditionersCreator | Provides robust preconditioners for single patch geometries |
gsPatchRule | Class that represents the (tensor) patch quadrature rule |
gsPatchwiseFunction | A function depending on an index i, typically referring to a patch/sub-domain |
gsPde | Abstract class representing a PDE (partial differential equation) |
gsPeriodicOverlap | |
gsPeriodicStitch | |
Neighbourhood | |
gsPiecewiseFunction | A function depending on an index i, typically referring to a patch/sub-domain. On each patch a different gsFunction object is used |
gsPlanarDomain | Class representing a Planar domain with an outer boundary and a number of holes |
gsPoint | A Point in T^d, with an index number |
gsPointLoads | Class containing a set of points on a multi-patch isogeometric domain, together with boundary conditions |
gsPoissonAssembler | Implementation of an (multiple right-hand side) Poisson assembler |
gsPoissonPde | A Poisson PDE |
gsPreCICEFunction | Class defining a gsFunction that reads from the precice::SolverInterface |
gsPreconditionerFromOp | Simple class allowing to construct a preconditioner from a linear operator |
gsPreconditionerOp | Simple abstract class for perconditioners |
gsPrimalSystem | This class represents the primal system for a IETI-DP algorithm |
gsProductOp | Class for representing the product of objects of type gsLinearOperator as gsLinearOperator |
gsProgressBar | Simple progress bar class |
gsQuadrature | Helper class for obtaining a quadrature rule |
gsQuadRule | Class representing a reference quadrature rule |
gsQuasiInterpolate | Quasi-interpolation operators |
gsRationalBasis | Class that creates a rational counterpart for a given basis |
gsReadFile | Reads an object from a data file, if such the requested object exists in the file |
gsRemapInterface | Provides a mapping between the corresponding sides of two patches sharing an interface |
gsRichardsonOp | Richardson preconditioner |
gsScaledDirichletPrec | This class represents the scaled Dirichlet preconditioner for a IETI problem |
Blocks | |
gsScaledOp | Allows an operator to be multiplied with a scalar |
gsSerialComm | A serial communication class |
gsSerialGroup | A sequential communicator group class |
gsSerialRequest | A sequential communicator request class |
gsSerialStatus | A sequential communicator status class |
gsShellStressFunction | Compute Cauchy stresses for a previously computed/defined displacement field. Can be pushed into gsPiecewiseFunction to construct gsField for visualization in Paraview |
gsSmallerErrCompare | Checks if the error of a gsHBox is smaller than a threshold |
gsSmoothInterfaces | Constructs the D-Patch, from which the transformation matrix can be called |
gsSolid | Class for representing a solid made up of vertices, edges, faces, and volumes |
gsSolverOp | Simple adapter class to use an Eigen solver (having a compute() and a solve() method) as a linear operator |
gsSolverUtils | Utility class for PDE's solver related utils |
gsSortedVector | This class is derived from std::vector, and adds sort tracking |
gsSparseEntries | Class that provides a container for triplets (i,j,value) to be filled in a sparse matrix |
gsSparseMatrix | Sparse matrix class, based on gsEigen::SparseMatrix |
gsSparseMatrixIter | Iterator over the non-zero entries of a sparse matrix |
gsSparseRows | A specialized sparse matrix class which stores each row as a separate sparse vector |
gsSparseSolver | Abstract class for solvers. The solver interface is base on 3 methods: -compute set the system matrix (possibly compute the factorization or preconditioners) -solve solves for a given right hand side -succeed returns true if solving succeded according to solver dependent criteria (usually tolerance based) So in order to solve \( A x = b \) with a solver s two functions must be called: s.compute(A) and s.solve(b). The calls can be chained as in s.compute(A).solve(b) |
gsSparseSystem | A sparse linear system indexed by sets of degrees of freedom |
gsSparseVector | Sparse vector class, based on gsEigen::SparseVector |
gsSpectraGenSymShiftSolver | |
gsSpectraGenSymSolver | |
gsSpectraSolver | Eigenvalue solver for general real matrices |
gsSpectraSymShiftSolver | Shifted Eigenvalue solver for real symmetric matrices |
gsSpectraSymSolver | Eigenvalue solver for real symmetric matrices |
gsSpringPatch | Computes a parametrization based on the spring patch technique, given a set of boundary geometries |
gsSquaredDistance | Squared distance function from a fixed point to a gsGeometry |
gsStaticBase | Base class for static solvers |
gsStaticComposite | Static solver using a newton method |
gsStaticDR | Static solver using the Dynamic Relaxation method |
gsStaticNewton | Static solver using a newton method |
gsStaticOpt | Static solver using the Dynamic Relaxation method |
gsStdVectorRef | Simple wrapper class for a vector of objects |
gsStokesPde | A stationary Stokes PDE |
gsStructuralAnalysisOps | Operators for the gsStructuralAnalysis module |
gsSumOp | Class for representing the sum of objects of type gsLinearOperator as gsLinearOperator |
gsSurface | Abstract base class representing a surface |
gsSurfMesh | A halfedge data structure for polygonal meshes |
Base_handle | |
Edge | |
Edge_container | |
Edge_iterator | |
Edge_property | |
Face | |
Face_around_vertex_circulator | |
Face_connectivity | |
Face_container | |
Face_iterator | |
Face_property | |
Halfedge | |
Halfedge_around_face_circulator | |
Halfedge_around_vertex_circulator | |
Halfedge_connectivity | |
Halfedge_container | |
Halfedge_iterator | |
Halfedge_property | |
Mesh_property | |
Vertex | |
Vertex_around_face_circulator | |
Vertex_around_vertex_circulator | |
Vertex_connectivity | |
Vertex_container | |
Vertex_iterator | |
Vertex_property | |
gsTemplate | Class gsTemplate object |
gsTensorBasis | Abstract base class for tensor product bases |
gsTensorBSpline | A tensor product of d B-spline functions, with arbitrary target dimension |
gsTensorBSplineBasis | A tensor product B-spline basis |
gsTensorBSplineBasis< 1, T > | A univariate B-spline basis |
gsTensorDomainBoundaryIterator | Re-implements gsDomainIterator for iteration over all elements of the boundary of a tensor product parameter domain. See gsDomainIterator for more detailed documentation and an example of the typical use!!! |
gsTensorDomainIterator | Re-implements gsDomainIterator for iteration over all elements of a tensor product parameter domain. See gsDomainIterator for more detailed documentation and an example of the typical use!!! |
gsTensorNurbs | A tensor product Non-Uniform Rational B-spline function (NURBS) of parametric dimension d, with arbitrary target dimension |
gsTensorNurbsBasis | A tensor product Non-Uniform Rational B-spline (NURBS) basis |
gsTHBSpline | A truncated hierarchical B-Spline function, in d dimensions |
gsTHBSplineBasis | Truncated hierarchical B-spline basis |
gsThermoAssembler | Assembles stiffness and mass matrices and right-hand side vector for linear and nonlinear elasticity for 2D plain stress and 3D continua. Matrices and vector have a block structure associated with components of the displacement vector, each block corresponding to one component |
gsThinShellAssembler | Assembles the system matrix and vectors for 2D and 3D shell problems, including geometric nonlinearities and loading nonlinearities. The material nonlinearities are handled by the gsMaterialMatrixIntegrate class |
gsThinShellAssemblerBase | Base class for the gsThinShellAssembler |
gsThinShellAssemblerDWRBase | Base class for the gsThinShellAssembler |
gsTriMeshToSolid | Class gsTriMeshToSolid object |
gsTrimSurface | Class for a trim surface |
gsVector | A vector with arbitrary coefficient type and fixed or dynamic size |
gsVector3d | A fixed-size, statically allocated 3D vector |
gsVertex | GsVertex class that represents a 3D vertex for a gsMesh |
gsVisitorBiharmonic | Visitor for the biharmonic equation |
gsVisitorCDR | Visitor for the convection-diffusion-reaction equation |
gsVisitorDg | Visitor for adding the interface conditions for the interior penalty methods of the Poisson problem |
gsVisitorGradGrad | The visitor computes element grad-grad integrals |
gsVisitorMass | The visitor computes element mass integrals |
gsVisitorMoments | Visitor for the moment vector of a function |
gsVisitorNeumann | Implementation of a Neumann BC for elliptic assemblers |
gsVisitorNeumannBiharmonic | Visitor for Neumann boundary condition for the biharmonic equation |
gsVisitorNitsche | Visitor for adding the terms associated to weak (Nitsche-type) imposition of the Dirichlet boundary conditions |
gsVisitorNitscheBiharmonic | Visitor for the weak imposition of the first-type dirichlet boundary condition |
gsVisitorPoisson | Visitor for the Poisson equation |
gsVolume | Provides declaration of Volume abstract interface |
gsVSegment | Class for representing a vertical line segment in 2D. Helper for the class gsAAPolyline |
gsXBraid | Class defining the XBraid wrapper |
gsXBraid< gsMatrix< T > > | Specializations for gsXBraid<gsMatrix<T>> |
gsXBraid< gsVector< T > > | Specializations for gsXBraid<gsVector<T>> |
gsXBraidAccessStatus | Class defining the XBraid access status wrapper |
gsXBraidBufferStatus | Class defining the XBraid buffer status wrapper |
gsXBraidCoarsenRefStatus | Class defining the XBraid coarsen and refinement status wrapper |
gsXBraidMultigrid | The p-multigrid class implements a generic p-multigrid solver that can be customized by passing assembler and coarse solver as template arguments |
gsXBraidMultigridBase | The p-multigrid base class provides the basic methods (smoothing, prolongation, restriction) for implementing p-multigrid methods |
gsXBraidObjectiveStatus | Class defining the XBraid step objective wrapper |
gsXBraidStepStatus | Class defining the XBraid step status wrapper |
gsXBraidSyncStatus | Class defining the XBraid sync status wrapper |
iteration_type | Specifies iteration type for an iterative solver |
linear_solver | Specifies linear solver to use if it is hidden within some other class (like Newton's method or time integrators) |
material_law | Specifies the material law to use |
MPITraits | A traits class describing the mapping of types onto MPI_Datatypes |
MPITraits< gsMatrix< T, _Rows, _Cols, _Options > > | Specialization for fixed-size gsMatrix class |
MPITraits< gsVector< T, _Rows, _Options > > | Specialization for fixed-size gsVector class |
ns_assembly | Specifies the iteration type used to solve nonlinear systems |
patchComponent | Struct which represents a certain component (interior, face, egde, corner) of a particular patch |
patchCorner | Struct which represents a certain corner of a patch |
patchSide | Struct which represents a certain side of a patch |
point_load | Struct defining a point together with a scalar or vector load |
preAAParam | |
shell_coupling | Defines the coupling type over interfaces |
solver_verbosity | Specifies the verbosity of the iterative solver |
SpectraOps | |
SpectraOps< MatrixType, Spectra::GEigsMode::RegularInverse > | |
SpectraShiftOps | |
SpectraShiftOps< MatrixType, Spectra::GEigsMode::Buckling > | |
stabilizerCDR | Stabililzer for the CDR discretization |
stress_components | Method was interrupted because the current solution is invalid |
stress_type | Specifies the type of stresses to compute |
submoduleClass | I am an example how to use the class in submodules |
submoduleClass2 | I am an example how to use the class in submodules |
time_integration | Specifies the time integration scheme, see Wriggers, Nonlinear FEM, p. 205 |
util | This namespace gathers several utility functions for miscellaneous tasks |