BEM++  2.0
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Groups Pages
Classes | Typedefs | Enumerations | Functions | Variables
Bempp Namespace Reference

Classes

class  AbstractBoundaryOperator
 Abstract (non-discretized) boundary operator. More...
 
class  AbstractBoundaryOperatorComposition
 Composition of two abstract boundary operators. More...
 
class  AbstractBoundaryOperatorId
 Base class for identifiers of an abstract boundary operator. More...
 
class  AbstractBoundaryOperatorPseudoinverseId
 
class  AbstractBoundaryOperatorPseudoinverse
 Inverse or pseudoinverse of an abstract boundary operator. More...
 
class  AbstractBoundaryOperatorSum
 Sum of two abstract boundary operators. More...
 
class  AbstractBoundaryOperatorSuperpositionBase
 Base class for abstract boundary operator superpositions. More...
 
class  AcaApproximateLuInverse
 Approximate LU decomposition of a H-matrix. More...
 
class  AcaGlobalAssembler
 ACA-mode assembler. More...
 
struct  AcaOptions
 Adaptive cross approximation (ACA) parameters. More...
 
class  AdjointAbstractBoundaryOperator
 Adjoint abstract boundary operator. More...
 
struct  AhmedDofWrapper
 An Ahmed-compatible degree-of-freedom type. More...
 
struct  AhmedTypeTraits
 
struct  AhmedTypeTraits< std::complex< float > >
 
struct  AhmedTypeTraits< std::complex< double > >
 
class  AhmedLeafClusterArray
 Encapsulation of an array of pointers to AHMED's blcluster objects. More...
 
class  AhmedMblockArrayDeleter
 
class  DiscreteBoundaryOperator
 Discrete boundary operator. More...
 
class  GridFunction
 Function defined on a grid. More...
 
class  Space
 Function space. More...
 
class  AssembledPotentialOperator
 Assembled potential operator. More...
 
class  AssemblyOptions
 Options determining how weak-form assembly is done. More...
 
class  BlockCoalescer
 
class  BlockedBoundaryOperator
 Boundary operator consisting of multiple blocks arranged in a matrix. More...
 
class  BlockedOperatorStructure
 Helper class used in construction of blocked boundary operators. More...
 
class  BoundaryOperator
 Operator acting on functions defined on a surface. More...
 
struct  ClusterConstructionHelper
 
class  ComplexifiedDiscreteBoundaryOperator
 Complexified discrete boundary operator. More...
 
struct  ComponentLists
 Data used by PotentialOperatorAcaAssemblyHelper to convert between H-matrix indices, point and component indices. More...
 
class  ComponentListsCache
 Cache of ComponentLists objects. More...
 
class  Context
 Assembly context. More...
 
class  DenseGlobalAssembler
 Dense-mode assembler. More...
 
class  DiscreteAcaBoundaryOperator
 Discrete linear operator stored as a H-matrix. More...
 
class  DiscreteBlockedBoundaryOperator
 Discrete boundary operator composed of multiple blocks stored separately. More...
 
class  DiscreteBoundaryOperatorCache
 Cache of discrete boundary operators. More...
 
class  DiscreteBoundaryOperatorComposition
 Composition (product) of discrete linear operators stored separately. More...
 
class  DiscreteBoundaryOperatorSum
 Sum of discrete linear operators stored separately. More...
 
class  DiscreteDenseBoundaryOperator
 Discrete boundary operator stored as a dense matrix. More...
 
class  DiscreteInverseSparseBoundaryOperator
 Discrete boundary operator representing the inverse of another operator and stored as a sparse LU decomposition. More...
 
class  DiscreteNullBoundaryOperator
 Null (zero-valued) discrete boundary operator. More...
 
class  DiscreteSparseBoundaryOperator
 Discrete boundary operator stored as a sparse matrix. More...
 
class  ElementaryIntegralOperator
 Elementary integral boundary operator. More...
 
class  ElementaryIntegralOperatorBase
 Base class of ElementaryIntegralOperator, containing functionality independent from KernelType. More...
 
class  ElementaryLocalOperator
 Abstract base class of local elementary operators. More...
 
class  ElementaryPotentialOperator
 Elementary potential operator. More...
 
class  ElementaryRegularIntegralOperator
 Elementary boundary integral operator with weak form whose integrand is a regular function. More...
 
class  ElementarySingularIntegralOperator
 Elementary boundary integral operator with weak form whose integrand has a singularity at origin. More...
 
class  EvaluationOptions
 Options controlling evaluation of potentials. More...
 
class  ExtendedBemCluster
 
class  GeneralElementaryLocalOperator
 Standard implementation of an elementary local operator. More...
 
class  GeneralElementarySingularIntegralOperator
 Standard implementation of an elementary singular integral operator. More...
 
class  GeneralHypersingularIntegralOperator
 Standard implementation of a hypersingular singular integral operator. More...
 
class  Helmholtz3dDoubleLayerPotentialOperator
 Double-layer potential operator for the Helmholtz equation in 3D. More...
 
class  Helmholtz3dFarFieldDoubleLayerPotentialOperator
 Part of the far-field pattern of a radiating solution of the Helmholtz equation in 3D. More...
 
class  Helmholtz3dFarFieldSingleLayerPotentialOperator
 Part of the far-field pattern of a radiating solution of the Helmholtz equation in 3D. More...
 
class  Helmholtz3dPotentialOperatorBase
 Base class for potential operators for the Helmholtz equation in 3D. More...
 
class  Helmholtz3dSingleLayerPotentialOperator
 Single-layer potential operator for the Helmholtz equation in 3D. More...
 
class  HypersingularIntegralOperator
 Hypersingular integral boundary operator. More...
 
class  IdentityOperatorId
 
class  IdentityOperator
 Identity operator. More...
 
class  IndexPermutation
 Permutation of indices. More...
 
class  InterpolatedFunction
 Function defined by its values at a set of interpolation points and an interpolation method. More...
 
class  Laplace3dDoubleLayerPotentialOperator
 Double-layer potential operator for the Laplace equation in 3D. More...
 
class  Laplace3dPotentialOperatorBase
 Base class for potential operators related to the Laplace equation in 3D. More...
 
class  Laplace3dSingleLayerPotentialOperator
 Single-layer potential operator for the Laplace equation in 3D. More...
 
struct  LocalAssemblerConstructionHelper
 Utility functions used during weak-form assembly. More...
 
struct  LocalDofLists
 Data used by WeakFormAcaAssemblyHelper to convert between H-matrix indices, global and local degrees of freedom. More...
 
class  LocalDofListsCache
 Cache of LocalDofLists objects. More...
 
class  Maxwell3dDoubleLayerPotentialOperator
 Double-layer potential operator for the Maxwell equations in 3D. More...
 
class  Maxwell3dFarFieldDoubleLayerPotentialOperator
 Far-field limit of the double-layer potential operator for the Maxwell equations in 3D. More...
 
class  Maxwell3dFarFieldSingleLayerPotentialOperator
 Far-field limit of the single-layer potential operator for the Maxwell equations in 3D. More...
 
class  Maxwell3dIdentityOperator
 "Identity operator" for Maxwell equations in 3D. More...
 
class  Maxwell3dSingleLayerPotentialOperator
 Single-layer potential operator for the Maxwell equations in 3D. More...
 
class  ModifiedHelmholtz3dDoubleLayerPotentialOperator
 Double-layer potential operator for the modified Helmholtz equation in 3D. More...
 
class  ModifiedHelmholtz3dPotentialOperatorBase
 Base class for potential operators for the modified Helmholtz equation in 3D. More...
 
class  ModifiedHelmholtz3dSingleLayerPotentialOperator
 Single-layer potential operator for the modified Helmholtz equation in 3D. More...
 
class  NullOperatorId
 
class  NullOperator
 Null operator. More...
 
class  NumericalQuadratureStrategy
 Numerical quadrature strategy. More...
 
class  PotentialOperator
 Potential operator. More...
 
class  PotentialOperatorAcaAssemblyHelper
 Class whose methods are called by Ahmed during assembly in the ACA mode. More...
 
class  ScaledAbstractBoundaryOperator
 Scaled abstract boundary operator. More...
 
class  ScaledDiscreteBoundaryOperator
 Scaled discrete boundary operator. More...
 
class  ScatteredRange
 
struct  MblockArrayConverter
 
struct  MblockArrayConverter< Type, Type >
 
struct  SparseToHMatrixConverter
 
class  SyntheticIntegralOperator
 Integral operator with weak form assembled from several pieces. More...
 
class  TransposedDiscreteBoundaryOperator
 Transposed and/or conjugated discrete boundary operator. More...
 
class  Vector
 Encapsulation of a vector. More...
 
class  WeakFormAcaAssemblyHelper
 Class whose methods are called by Ahmed during assembly in the ACA mode. More...
 
class  AutoTimer
 Timer that on destruction outputs the time elapsed since construction. More...
 
class  BoundingBox
 Bounding box with a reference point. More...
 
struct  ChunkStatistics
 Storage of parallel-loop profiling data. More...
 
class  Lazy
 Thread-safe wrapper of a lazily inititialised object. More...
 
class  NotImplementedError
 Exception thrown on attempt to access an unimplemented feature. More...
 
struct  LocalDof
 Local degree of freedom. More...
 
struct  Point3D
 Point in a three-dimensional space. More...
 
class  ConcreteDomainIndex
 
class  ConcreteElementMapper
 An injective mapping from the full set of codimension-0 entities ("elements") of a grid to the integers 0 ... (number of entities - 1). More...
 
class  ConcreteEntity
 Wrapper of a Dune entity of type DuneEntity and codimension codim. More...
 
class  ConcreteEntity< 0, DuneEntity >
 Wrapper of a Dune entity of type DuneEntity and codimension 0. More...
 
class  ConcreteEntityPointer
 Wrapper of a Dune entity pointer of type DuneEntityPointer. More...
 
class  ConcreteGeometry
 Wrapper of a Dune geometry of type DuneGeometry. More...
 
class  ConcreteGeometryFactory
 Factory able to construct an "empty" geometry wrapping a Dune geometry of type DuneGeometry. More...
 
class  ConcreteGrid
 Wrapper of a Dune surface grid of type DuneGrid. More...
 
class  ConcreteGridView
 Wrapper of a Dune grid view of type DuneGridView. More...
 
class  ConcreteIdSet
 Wrapper of a Dune id set of type DuneIdSet providing access to the entities of a Dune grid of type DuneGrid. More...
 
class  ConcreteIndexSet
 Wrapper of the index set specific to a Dune grid view class DuneGridView. More...
 
class  ConcreteRangeEntityIterator
 Iterator over entities referenced by a range of Dune iterators of type DuneEntityIt. More...
 
class  ConcreteSubentityIterator
 Iterator over the subentities of codimension codimSub of a given Dune entity of type DuneEntity. More...
 
class  ConcreteVtkWriter
 Wrapper of a Dune VTK writer for a grid view of type DuneGridView. More...
 
class  DomainIndex
 
class  Entity
 Abstract wrapper of an entity of codimension codim. More...
 
class  Entity< 0 >
 Abstract wrapper of an entity of codimension 0. More...
 
class  EntityIterator
 Abstract base class for iterators over entities. More...
 
class  EntityPointer
 Abstract base class for an object providing read-only access to an entity of codimension codim. More...
 
class  Geometry
 Abstract wrapper of a geometry. More...
 
class  GeometryFactory
 Abstract geometry factory. More...
 
class  Grid
 Abstract wrapper of a grid. More...
 
class  GridFactory
 Grid factory. More...
 
struct  GridParameters
 Grid parameters. More...
 
class  GridSegment
 Segment of a grid. More...
 
class  GridView
 Abstract wrapper of a grid view. More...
 
class  IdSet
 Abstract wrapper of an id set. More...
 
class  IndexSet
 Abstract wrapper of an index set. More...
 
class  Mapper
 Abstract mapper class. More...
 
class  P0VectorVTKFunction
 Take a vector and interpret it as cell data for the VTKWriter. More...
 
class  P1VectorVTKFunction
 Take a vector and interpret it as point data for the VTKWriter. More...
 
class  ReverseElementMapper
 Mapping from codim-0 entity indices to entity pointers. More...
 
class  VtkWriter
 Abstract exporter of data in the vtk format. More...
 
class  BelosSolverWrapper
 
class  BlockedSolution
 This class holds the solution of a block operator system together with various information about the solution. More...
 
class  DefaultDirectSolver
 Default direct dense solver for boundary integral equations. More...
 
class  DefaultIterativeSolver
 Default iterative solver for boundary integral equations. More...
 
class  Preconditioner
 A simple container class to hold pointers to preconditioners. More...
 
class  RealWrapperOfComplexThyraLinearOperator
 
class  RealWrapperOfComplexThyraPreconditioner
 
class  Solution
 This class holds the solution of a BEM computation together with various associated information. More...
 
struct  SolutionStatus
 
class  SolutionBase
 The base class for the Solution and BlockedSolution container classes. More...
 
struct  ConvergenceTestMode
 
class  Solver
 The abstract interface of solvers of boundary integral equations. More...
 
class  PiecewiseConstantDiscontinuousScalarSpaceBarycentric
 Space of piecewise constant scalar functions. More...
 
class  PiecewiseConstantDualGridDiscontinuousScalarSpace
 Space of piecewise constant functions define on the dual grid. More...
 
class  PiecewiseConstantDualGridScalarSpace
 Space of piecewise constant functions define on the dual grid. More...
 
class  PiecewiseConstantScalarSpace
 Space of piecewise constant scalar functions. More...
 
class  PiecewiseConstantScalarSpaceBarycentric
 Space of piecewise constant scalar functions. More...
 
class  PiecewiseLinearContinuousScalarSpace
 Space of continuous, piecewise linear scalar functions. More...
 
class  PiecewiseLinearContinuousScalarSpaceBarycentric
 Space of continuous, piecewise linear scalar functions. More...
 
class  PiecewiseLinearDiscontinuousScalarSpace
 Space of piecewise linear, not necessarily continuous, scalar functions. More...
 
class  PiecewiseLinearDiscontinuousScalarSpaceBarycentric
 Space of piecewise constant functions define on the dual grid. More...
 
class  PiecewiseLinearScalarSpace
 Space of continuous, piecewise linear scalar functions. More...
 
class  PiecewisePolynomialContinuousScalarSpace
 Space of continuous, piecewise polynomial scalar functions. More...
 
class  PiecewisePolynomialDiscontinuousScalarSpace
 Space of discontinuous, piecewise polynomial scalar functions. More...
 
class  RaviartThomas0VectorSpace
 Space spanned by the lowest order Raviart-Thomas functions. More...
 
class  ScalarSpace
 Base class for spaces of scalar-valued functions. More...
 
struct  SpaceHelper
 
class  UnitScalarSpace
 Space consisting of a single scalar function equal to 1 everywhere. More...
 

Typedefs

typedef int ElementVariant
 
typedef int EntityIndex
 
typedef int GlobalDofIndex
 
typedef int FlatLocalDofIndex
 
typedef Fiber::LocalDofIndex LocalDofIndex
 
typedef Dune::FoamGrid< 3 > Default2dIn3dDuneGrid
 Default Dune grid implementation used to represent 2D grids embedded in 3D space.
 
typedef Dune::GeometryType GeometryType
 Identifier of geometry type.
 
typedef ConcreteGrid
< Default2dIn3dDuneGrid
Default2dIn3dGrid
 

Enumerations

enum  Symmetry { NO_SYMMETRY = 0x0000, SYMMETRIC = 0x0001, HERMITIAN = 0x0002, AUTO_SYMMETRY = 0x8000 }
 Set of constants describing the symmetry of an operator.
 
enum  TranspositionMode { NO_TRANSPOSE = Thyra::NOTRANS, CONJUGATE = Thyra::CONJ, TRANSPOSE = Thyra::TRANS, CONJUGATE_TRANSPOSE = Thyra::CONJTRANS }
 Enumeration determining how a discrete boundary operator is transformed before being applied. More...
 
enum  DofAssignmentMode { EDGE_ON_SEGMENT = 1, ELEMENT_ON_SEGMENT = 2, REFERENCE_POINT_ON_SEGMENT = 4 }
 
enum  DofType { GLOBAL_DOFS, FLAT_LOCAL_DOFS }
 

Functions

 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (AbstractBoundaryOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (AbstractBoundaryOperatorComposition)
 
template<typename T >
void tbb_hash_combine (size_t &seed, const T &v)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
pseudoinverse (const BoundaryOperator< BasisFunctionType, ResultType > &boundaryOp)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
pseudoinverse (const BoundaryOperator< BasisFunctionType, ResultType > &boundaryOp, const shared_ptr< const Space< BasisFunctionType > > &dualToRange)
 
 BEMPP_GCC_DIAG_OFF (deprecated-declarations)
 
 BEMPP_GCC_DIAG_ON (deprecated-declarations)
 
 FIBER_ITERATE_OVER_BASIS_AND_RESULT_TYPES (INSTANTIATE_NONMEMBER_CONSTRUCTOR)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (AbstractBoundaryOperatorPseudoinverse)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (AbstractBoundaryOperatorSum)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (AbstractBoundaryOperatorSuperpositionBase)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (AcaApproximateLuInverse)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (AcaGlobalAssembler)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (AdjointAbstractBoundaryOperator)
 
template<typename ValueType >
boost::shared_array< mblock
< typename AhmedTypeTraits
< ValueType >::Type > * > 
allocateAhmedMblockArray (size_t blockCount)
 
template<typename ValueType >
boost::shared_array< mblock
< typename AhmedTypeTraits
< ValueType >::Type > * > 
allocateAhmedMblockArray (const blcluster *cluster)
 
template<typename T >
AhmedTypeTraits< T >::Type * ahmedCast (T *x)
 
float ahmedCast (float x)
 
double ahmedCast (double x)
 
scomp ahmedCast (std::complex< float > x)
 
dcomp ahmedCast (std::complex< double > x)
 
 FIBER_ITERATE_OVER_VALUE_TYPES (INSTANTIATE_OPERATOR_CALL)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (AssembledPotentialOperator)
 
template<typename BasisFunctionType >
bool shouldUseBlasInQuadrature (const AssemblyOptions &assemblyOptions, const Space< BasisFunctionType > &domain, const Space< BasisFunctionType > &dualToRange)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (BlockCoalescer)
 
template<typename BasisFunctionType , typename ResultType >
std::vector< GridFunction
< BasisFunctionType,
ResultType > > 
operator* (const BlockedBoundaryOperator< BasisFunctionType, ResultType > &op, const std::vector< GridFunction< BasisFunctionType, ResultType > > &funs)
 
 FIBER_ITERATE_OVER_BASIS_AND_RESULT_TYPES (INSTANTIATE_NONMEMBER_FUNCTIONS)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (BlockedBoundaryOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (BlockedOperatorStructure)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
operator+ (const BoundaryOperator< BasisFunctionType, ResultType > &op)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
operator- (const BoundaryOperator< BasisFunctionType, ResultType > &op)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
operator+ (const BoundaryOperator< BasisFunctionType, ResultType > &op1, const BoundaryOperator< BasisFunctionType, ResultType > &op2)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
operator- (const BoundaryOperator< BasisFunctionType, ResultType > &op1, const BoundaryOperator< BasisFunctionType, ResultType > &op2)
 
template<typename BasisFunctionType , typename ResultType , typename ScalarType >
boost::enable_if< typename
boost::mpl::has_key
< boost::mpl::set< float,
double, std::complex< float >
, std::complex< double >
>, ScalarType >
, BoundaryOperator
< BasisFunctionType,
ResultType > >::type 
operator* (const BoundaryOperator< BasisFunctionType, ResultType > &op, const ScalarType &scalar)
 
template<typename BasisFunctionType , typename ResultType , typename ScalarType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
operator* (const ScalarType &scalar, const BoundaryOperator< BasisFunctionType, ResultType > &op)
 
template<typename BasisFunctionType , typename ResultType , typename ScalarType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
operator/ (const BoundaryOperator< BasisFunctionType, ResultType > &op, const ScalarType &scalar)
 
template<typename BasisFunctionType , typename ResultType >
GridFunction
< BasisFunctionType,
ResultType > 
operator* (const BoundaryOperator< BasisFunctionType, ResultType > &op, const GridFunction< BasisFunctionType, ResultType > &fun)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
operator* (const BoundaryOperator< BasisFunctionType, ResultType > &op1, const BoundaryOperator< BasisFunctionType, ResultType > &op2)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
adjoint (const BoundaryOperator< BasisFunctionType, ResultType > &op)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
adjoint (const BoundaryOperator< BasisFunctionType, ResultType > &op, const shared_ptr< const Space< BasisFunctionType > > &range)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > & 
throwIfUninitialized (BoundaryOperator< BasisFunctionType, ResultType > &op, std::string message)
 
template<typename BasisFunctionType , typename ResultType >
const BoundaryOperator
< BasisFunctionType,
ResultType > & 
throwIfUninitialized (const BoundaryOperator< BasisFunctionType, ResultType > &op, std::string message)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (BoundaryOperator)
 
 INSTANTIATE_FREE_FUNCTIONS (float, float)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (float, float, float)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (float, float, double)
 
 INSTANTIATE_FREE_FUNCTIONS (float, std::complex< float >)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (float, std::complex< float >, float)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (float, std::complex< float >, double)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (float, std::complex< float >, std::complex< float >)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (float, std::complex< float >, std::complex< double >)
 
 INSTANTIATE_FREE_FUNCTIONS (double, double)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (double, double, float)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (double, double, double)
 
 INSTANTIATE_FREE_FUNCTIONS (double, std::complex< double >)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (double, std::complex< double >, float)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (double, std::complex< double >, double)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (double, std::complex< double >, std::complex< float >)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (double, std::complex< double >, std::complex< double >)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (ClusterConstructionHelper)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT_REAL_ONLY (ComplexifiedDiscreteBoundaryOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (Context)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (DenseGlobalAssembler)
 
void dumpblcluster (const blcluster *bl, const std::string &indent)
 
template<typename ValueType >
shared_ptr< const
DiscreteBoundaryOperator
< ValueType > > 
acaOperatorSum (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op1, const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op2, double eps, int maximumRank)
 
template<typename ValueType >
shared_ptr< const
DiscreteBoundaryOperator
< ValueType > > 
scaledAcaOperator (const ValueType &multiplier, const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op)
 
template<typename ValueType >
shared_ptr< const
DiscreteBoundaryOperator
< ValueType > > 
scaledAcaOperator (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op, const ValueType &multiplier)
 
template<typename ValueType >
shared_ptr< const
DiscreteBoundaryOperator
< ValueType > > 
acaOperatorApproximateLuInverse (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op, double delta)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (DiscreteAcaBoundaryOperator)
 
 INSTANTIATE_FREE_FUNCTIONS (float)
 
 INSTANTIATE_FREE_FUNCTIONS (std::complex< float >)
 
 INSTANTIATE_FREE_FUNCTIONS (double)
 
 INSTANTIATE_FREE_FUNCTIONS (std::complex< double >)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (DiscreteBlockedBoundaryOperator)
 
template<typename ValueType >
shared_ptr< const
DiscreteBoundaryOperator
< ValueType > > 
operator+ (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op)
 
template<typename ValueType >
shared_ptr< const
DiscreteBoundaryOperator
< ValueType > > 
operator- (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op)
 
template<typename ValueType >
shared_ptr
< DiscreteBoundaryOperator
< ValueType > > 
operator+ (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op1, const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op2)
 
template<typename ValueType >
shared_ptr
< DiscreteBoundaryOperator
< ValueType > > 
sum (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op1, const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op2)
 
template<typename ValueType >
shared_ptr
< DiscreteBoundaryOperator
< ValueType > > 
operator- (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op1, const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op2)
 
template<typename ValueType , typename ScalarType >
boost::enable_if< typename
boost::mpl::has_key
< boost::mpl::set< float,
double, std::complex< float >
, std::complex< double >
>, ScalarType >, shared_ptr
< DiscreteBoundaryOperator
< ValueType > > >::type 
operator* (ScalarType scalar, const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op)
 
template<typename ValueType , typename ScalarType >
boost::enable_if< typename
boost::mpl::has_key
< boost::mpl::set< float,
double, std::complex< float >
, std::complex< double >
>, ScalarType >, shared_ptr
< DiscreteBoundaryOperator
< ValueType > > >::type 
operator* (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op, ScalarType scalar)
 
template<typename ValueType >
shared_ptr
< DiscreteBoundaryOperator
< ValueType > > 
operator* (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op1, const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op2)
 
template<typename ValueType >
shared_ptr
< DiscreteBoundaryOperator
< ValueType > > 
mul (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op1, const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op2)
 
template<typename ValueType , typename ScalarType >
shared_ptr
< DiscreteBoundaryOperator
< ValueType > > 
operator/ (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op, ScalarType scalar)
 
template<typename ValueType >
shared_ptr
< DiscreteBoundaryOperator
< ValueType > > 
transpose (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op)
 
template<typename ValueType >
shared_ptr
< DiscreteBoundaryOperator
< ValueType > > 
conjugate (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op)
 
template<typename ValueType >
shared_ptr
< DiscreteBoundaryOperator
< ValueType > > 
conjugateTranspose (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op)
 
template<typename ValueType >
shared_ptr
< DiscreteBoundaryOperator
< ValueType > > 
transpose (TranspositionMode trans, const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &op)
 
template<typename RealType >
shared_ptr
< DiscreteBoundaryOperator
< std::complex< RealType > > > 
complexify (const shared_ptr< const DiscreteBoundaryOperator< RealType > > &op)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (DiscreteBoundaryOperator)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (float, float)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (float, double)
 
 INSTANTIATE_FREE_FUNCTIONS_REAL_ONLY (float)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (std::complex< float >, float)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (std::complex< float >, double)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (std::complex< float >, std::complex< float >)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (std::complex< float >, std::complex< double >)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (double, float)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (double, double)
 
 INSTANTIATE_FREE_FUNCTIONS_REAL_ONLY (double)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (std::complex< double >, float)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (std::complex< double >, double)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (std::complex< double >, std::complex< float >)
 
 INSTANTIATE_FREE_FUNCTIONS_WITH_SCALAR (std::complex< double >, std::complex< double >)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (DiscreteBoundaryOperatorCache)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (DiscreteBoundaryOperatorComposition)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (DiscreteBoundaryOperatorSum)
 
template<typename ValueType >
shared_ptr
< DiscreteDenseBoundaryOperator
< ValueType > > 
discreteDenseBoundaryOperator (const arma::Mat< ValueType > &mat)
 Return a shared pointer to newly constructed DiscreteDenseBoundaryOperator wrapping a specified matrix.
 
 FIBER_ITERATE_OVER_VALUE_TYPES (INSTANTIATE_NONMEMBER_CONSTRUCTOR)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (DiscreteDenseBoundaryOperator)
 
template<typename ValueType >
shared_ptr< const
DiscreteBoundaryOperator
< ValueType > > 
discreteSparseInverse (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &discreteOp)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (DiscreteInverseSparseBoundaryOperator)
 
 FIBER_ITERATE_OVER_VALUE_TYPES (INSTANTIATE_FREE_FUNCTIONS)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (DiscreteNullBoundaryOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (DiscreteSparseBoundaryOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_KERNEL_AND_RESULT (ElementaryIntegralOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (ElementaryIntegralOperatorBase)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (ElementaryLocalOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_KERNEL_AND_RESULT (ElementaryPotentialOperator)
 
template<typename BasisFunctionType , typename ResultType >
GridFunction
< BasisFunctionType,
ResultType > 
operator+ (const GridFunction< BasisFunctionType, ResultType > &g)
 
template<typename BasisFunctionType , typename ResultType >
GridFunction
< BasisFunctionType,
ResultType > 
operator- (const GridFunction< BasisFunctionType, ResultType > &g)
 
template<typename BasisFunctionType , typename ResultType , typename ScalarType >
boost::enable_if< typename
boost::mpl::has_key
< boost::mpl::set< float,
double, std::complex< float >
, std::complex< double >
>, ScalarType >, GridFunction
< BasisFunctionType,
ResultType > >::type 
operator* (const ScalarType &scalar, const GridFunction< BasisFunctionType, ResultType > &g2)
 
template<typename BasisFunctionType , typename ResultType , typename ScalarType >
GridFunction
< BasisFunctionType,
ResultType > 
operator/ (const GridFunction< BasisFunctionType, ResultType > &g1, const ScalarType &scalar)
 
template<typename BasisFunctionType , typename ResultType >
void exportToVtk (const GridFunction< BasisFunctionType, ResultType > &gridFunction, VtkWriter::DataType dataType, const char *dataLabel, const char *fileNamesBase, const char *filesPath, VtkWriter::OutputType outputType)
 
template<typename BasisFunctionType , typename ResultType >
void exportToGmsh (const GridFunction< BasisFunctionType, ResultType > &gridFunction, const char *dataLabel, const char *fileName)
 
template<typename BasisFunctionType , typename ResultType >
GridFunction
< BasisFunctionType,
ResultType > 
operator+ (const GridFunction< BasisFunctionType, ResultType > &g1, const GridFunction< BasisFunctionType, ResultType > &g2)
 
template<typename BasisFunctionType , typename ResultType >
GridFunction
< BasisFunctionType,
ResultType > 
operator- (const GridFunction< BasisFunctionType, ResultType > &g1, const GridFunction< BasisFunctionType, ResultType > &g2)
 
template<typename BasisFunctionType , typename ResultType , typename ScalarType >
GridFunction
< BasisFunctionType,
ResultType > 
operator* (const GridFunction< BasisFunctionType, ResultType > &g1, const ScalarType &scalar)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (GridFunction)
 
template<typename BasisFunctionType >
BoundaryOperator
< BasisFunctionType, typename
ScalarTraits
< BasisFunctionType >
::ComplexType > 
helmholtz3dAdjointDoubleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, typename ScalarTraits< BasisFunctionType >::ComplexType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, typename ScalarTraits< BasisFunctionType >::ComplexType waveNumber, const std::string &label="", int symmetry=NO_SYMMETRY, bool useInterpolation=false, int interpPtsPerWavelength=DEFAULT_HELMHOLTZ_INTERPOLATION_DENSITY)
 Construct a BoundaryOperator object representing the adjoint double-layer boundary operator associated with the Helmholtz equation in 3D. More...
 
 FIBER_ITERATE_OVER_BASIS_TYPES (INSTANTIATE_NONMEMBER_CONSTRUCTOR)
 
template<typename BasisFunctionType >
BoundaryOperator
< BasisFunctionType, typename
ScalarTraits
< BasisFunctionType >
::ComplexType > 
helmholtz3dDoubleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, typename ScalarTraits< BasisFunctionType >::ComplexType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, typename ScalarTraits< BasisFunctionType >::ComplexType waveNumber, const std::string &label="", int symmetry=NO_SYMMETRY, bool useInterpolation=false, int interpPtsPerWavelength=DEFAULT_HELMHOLTZ_INTERPOLATION_DENSITY)
 Construct a BoundaryOperator object representing the double-layer boundary operator associated with the Helmholtz equation in 3D. More...
 
 FIBER_ITERATE_OVER_BASIS_TYPES (INSTANTIATE_BASE_HELMHOLTZ_DOUBLE_POTENTIAL)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (Helmholtz3dDoubleLayerPotentialOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (Helmholtz3dFarFieldDoubleLayerPotentialOperator)
 
 FIBER_ITERATE_OVER_BASIS_TYPES (INSTANTIATE_BASE_HELMHOLTZ_SINGLE_POTENTIAL)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (Helmholtz3dFarFieldSingleLayerPotentialOperator)
 
template<typename BasisFunctionType >
BoundaryOperator
< BasisFunctionType, typename
ScalarTraits
< BasisFunctionType >
::ComplexType > 
helmholtz3dHypersingularBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, typename ScalarTraits< BasisFunctionType >::ComplexType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, typename ScalarTraits< BasisFunctionType >::ComplexType waveNumber, const std::string &label="", int symmetry=NO_SYMMETRY, bool useInterpolation=false, int interpPtsPerWavelength=DEFAULT_HELMHOLTZ_INTERPOLATION_DENSITY)
 Construct a BoundaryOperator object representing the hypersingular boundary operator associated with the Helmholtz equation in 3D. More...
 
template<typename BasisFunctionType >
BoundaryOperator
< BasisFunctionType, typename
ScalarTraits
< BasisFunctionType >
::ComplexType > 
helmholtz3dSingleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, typename ScalarTraits< BasisFunctionType >::ComplexType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, typename ScalarTraits< BasisFunctionType >::ComplexType waveNumber, const std::string &label="", int symmetry=NO_SYMMETRY, bool useInterpolation=false, int interpPtsPerWavelength=DEFAULT_HELMHOLTZ_INTERPOLATION_DENSITY)
 Construct a BoundaryOperator object representing the single-layer boundary operator associated with the Helmholtz equation in 3D. More...
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (Helmholtz3dSingleLayerPotentialOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_KERNEL_AND_RESULT (HypersingularIntegralOperator)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
identityOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, const std::string &label, int symmetry)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (IdentityOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (InterpolatedFunction)
 
template<typename BasisFunctionType , typename ResultType >
ScalarTraits
< BasisFunctionType >
::RealType 
L2NormOfDifference (const GridFunction< BasisFunctionType, ResultType > &gridFunction, const Fiber::Function< ResultType > &refFunction, const Fiber::QuadratureStrategy< BasisFunctionType, ResultType, GeometryFactory > &quadStrategy, const EvaluationOptions &options)
 
template<typename BasisFunctionType , typename ResultType >
void estimateL2Error (const GridFunction< BasisFunctionType, ResultType > &gridFunction, const Fiber::Function< ResultType > &refFunction, const Fiber::QuadratureStrategy< BasisFunctionType, ResultType, GeometryFactory > &quadStrategy, const EvaluationOptions &options, typename ScalarTraits< BasisFunctionType >::RealType &absError, typename ScalarTraits< BasisFunctionType >::RealType &relError)
 
template<typename BasisFunctionType , typename ResultType >
void estimateL2Error (const GridFunction< BasisFunctionType, ResultType > &gridFunction, const Fiber::Function< ResultType > &refFunction, const Fiber::QuadratureStrategy< BasisFunctionType, ResultType, GeometryFactory > &quadStrategy, typename ScalarTraits< BasisFunctionType >::RealType &absError, typename ScalarTraits< BasisFunctionType >::RealType &relError)
 
 FIBER_ITERATE_OVER_BASIS_AND_RESULT_TYPES (INSTANTIATE_FUNCTION)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
laplace3dAdjointDoubleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, const std::string &label="", int symmetry=NO_SYMMETRY)
 Construct a BoundaryOperator object representing the adjoint double-layer boundary operator associated with the Laplace equation in 3D. More...
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
laplace3dDoubleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, const std::string &label="", int symmetry=NO_SYMMETRY)
 Construct a BoundaryOperator object representing the double-layer boundary operator associated with the Laplace equation in 3D. More...
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
laplace3dSyntheticDoubleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, const shared_ptr< const Space< BasisFunctionType > > &internalTrialSpace, const shared_ptr< const Space< BasisFunctionType > > &internalTestSpace, const std::string &label="", int symmetry=NO_SYMMETRY)
 Construct a "synthetic" representation of the double-layer boundary operator associated with the Laplace equation in 3D. More...
 
 FIBER_ITERATE_OVER_BASIS_AND_RESULT_TYPES (INSTANTIATE_BASE_LAPLACE_DOUBLE_POTENTIAL)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (Laplace3dDoubleLayerPotentialOperator)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
laplace3dSyntheticHypersingularBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, std::string label, int internalSymmetry)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
laplace3dHypersingularBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, const std::string &label="", int symmetry=NO_SYMMETRY)
 Construct a BoundaryOperator object representing the hypersingular boundary operator associated with the Laplace equation in 3D. More...
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
laplace3dSingleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, const std::string &label="", int symmetry=NO_SYMMETRY)
 Construct a BoundaryOperator object representing the single-layer boundary operator associated with the Laplace equation in 3D. More...
 
 FIBER_ITERATE_OVER_BASIS_AND_RESULT_TYPES (INSTANTIATE_BASE_LAPLACE_SINGLE_POTENTIAL)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (Laplace3dSingleLayerPotentialOperator)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
laplace3dSyntheticBoundaryOperator (BoundaryOperator< BasisFunctionType, ResultType >(*constructor)(const shared_ptr< const Context< BasisFunctionType, ResultType > > &, const shared_ptr< const Space< BasisFunctionType > > &, const shared_ptr< const Space< BasisFunctionType > > &, const shared_ptr< const Space< BasisFunctionType > > &, const std::string &, int), const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, std::string label, int internalSymmetry, int maximumSyntheseSymmetry)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
laplaceBeltrami3dOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, const std::string &label="", int symmetry=NO_SYMMETRY)
 Construct a BoundaryOperator object representing a Laplace-Beltrami operator in 3D. More...
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (LocalDofListsCache)
 
template<typename BasisFunctionType >
BoundaryOperator
< BasisFunctionType, typename
ScalarTraits
< BasisFunctionType >
::ComplexType > 
maxwell3dDoubleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, typename ScalarTraits< BasisFunctionType >::ComplexType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, typename ScalarTraits< BasisFunctionType >::ComplexType waveNumber, const std::string &label="", int symmetry=NO_SYMMETRY, bool useInterpolation=false, int interpPtsPerWavelength=DEFAULT_HELMHOLTZ_INTERPOLATION_DENSITY)
 Construct a double-layer boundary operator for Maxwell equations in 3D. More...
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (Maxwell3dDoubleLayerPotentialOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (Maxwell3dFarFieldDoubleLayerPotentialOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (Maxwell3dFarFieldSingleLayerPotentialOperator)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
maxwell3dIdentityOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, const std::string &label, int symmetry)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (Maxwell3dIdentityOperator)
 
template<typename BasisFunctionType >
BoundaryOperator
< BasisFunctionType, typename
ScalarTraits
< BasisFunctionType >
::ComplexType > 
maxwell3dSyntheticSingleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, typename ScalarTraits< BasisFunctionType >::ComplexType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, typename ScalarTraits< BasisFunctionType >::ComplexType waveNumber, std::string label, int internalSymmetry, bool useInterpolation, int interpPtsPerWavelength)
 
template<typename BasisFunctionType >
BoundaryOperator
< BasisFunctionType, typename
ScalarTraits
< BasisFunctionType >
::ComplexType > 
maxwell3dSingleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, typename ScalarTraits< BasisFunctionType >::ComplexType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, typename ScalarTraits< BasisFunctionType >::ComplexType waveNumber, const std::string &label="", int symmetry=NO_SYMMETRY, bool useInterpolation=false, int interpPtsPerWavelength=DEFAULT_HELMHOLTZ_INTERPOLATION_DENSITY)
 Construct a single-layer boundary operator associated with the Maxwell equations in 3D. More...
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (Maxwell3dSingleLayerPotentialOperator)
 
template<class abs_T >
bool select_pivot_with_min_norm2 (unsigned n, const abs_T *norm2, const int *apprx_times, unsigned &pivot)
 
template<class T , class MATGEN_T >
bool ACAs (MATGEN_T &MatGen, unsigned b1, unsigned n1, unsigned b2, unsigned n2, double eps, unsigned kmax, unsigned i0, unsigned &k, T *&U, T *&V, const cluster *c1, const cluster *c2)
 
template<class T , class T1 , class T2 , class MATGEN_T >
void apprx_unsym_shooting (MATGEN_T &MatGen, mblock< T > *&mbl, bbxbemblcluster< T1, T2 > *bl, double eps, unsigned rankmax)
 
template<typename BasisFunctionType , typename KernelType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
modifiedHelmholtz3dAdjointDoubleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, KernelType waveNumber, const std::string &label="", int symmetry=NO_SYMMETRY, bool useInterpolation=false, int interpPtsPerWavelength=DEFAULT_HELMHOLTZ_INTERPOLATION_DENSITY)
 Construct a BoundaryOperator object representing the adjoint double-layer boundary operator associated with the modified Helmholtz equation in 3D. More...
 
 FIBER_ITERATE_OVER_BASIS_KERNEL_AND_RESULT_TYPES (INSTANTIATE_NONMEMBER_CONSTRUCTOR)
 
template<typename BasisFunctionType , typename KernelType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
modifiedHelmholtz3dDoubleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, KernelType waveNumber, const std::string &label="", int symmetry=NO_SYMMETRY, bool useInterpolation=false, int interpPtsPerWavelength=DEFAULT_HELMHOLTZ_INTERPOLATION_DENSITY)
 Construct a BoundaryOperator object representing the double-layer boundary operator associated with the modified Helmholtz equation in 3D. More...
 
 FIBER_ITERATE_OVER_BASIS_TYPES (INSTANTIATE_BASE_MODIFIED_HELMHOLTZ_DOUBLE_POTENTIAL)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (ModifiedHelmholtz3dDoubleLayerPotentialOperator)
 
template<typename BasisFunctionType , typename KernelType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
modifiedHelmholtz3dSyntheticHypersingularBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, KernelType waveNumber, std::string label, int internalSymmetry, bool useInterpolation, int interpPtsPerWavelength)
 
template<typename BasisFunctionType , typename KernelType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
modifiedHelmholtz3dHypersingularBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, KernelType waveNumber, const std::string &label="", int symmetry=NO_SYMMETRY, bool useInterpolation=false, int interpPtsPerWavelength=DEFAULT_HELMHOLTZ_INTERPOLATION_DENSITY)
 Construct a BoundaryOperator object representing the hypersingular operator associated with the modified Helmholtz equation in 3D. More...
 
template<typename BasisFunctionType , typename KernelType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
modifiedHelmholtz3dSingleLayerBoundaryOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, KernelType waveNumber, const std::string &label="", int symmetry=NO_SYMMETRY, bool useInterpolation=false, int interpPtsPerWavelength=DEFAULT_HELMHOLTZ_INTERPOLATION_DENSITY)
 Construct a BoundaryOperator object representing the single-layer boundary operator associated with the modified Helmholtz equation in 3D. More...
 
 FIBER_ITERATE_OVER_BASIS_TYPES (INSTANTIATE_BASE_MODIFIED_HELMHOLTZ_SINGLE_POTENTIAL)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (ModifiedHelmholtz3dSingleLayerPotentialOperator)
 
template<typename BasisFunctionType , typename KernelType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
modifiedHelmholtz3dSyntheticBoundaryOperator (BoundaryOperator< BasisFunctionType, ResultType >(*constructor)(const shared_ptr< const Context< BasisFunctionType, ResultType > > &, const shared_ptr< const Space< BasisFunctionType > > &, const shared_ptr< const Space< BasisFunctionType > > &, const shared_ptr< const Space< BasisFunctionType > > &, KernelType, const std::string &, int, bool, int), const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, KernelType waveNumber, std::string label, int internalSymmetry, bool useInterpolation, int interpPtsPerWavelength, int maximumSyntheseSymmetry)
 
 FIBER_ITERATE_OVER_BASIS_KERNEL_AND_RESULT_TYPES (INSTANTIATE_FUNCTION)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
nullOperator (const shared_ptr< const Context< BasisFunctionType, ResultType > > &context, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, const std::string &label, int symmetry)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (NullOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (NumericalQuadratureStrategy)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (PotentialOperatorAcaAssemblyHelper)
 
template<typename BasisFunctionType , typename ResultType >
shared_ptr< const Context
< BasisFunctionType,
ResultType > > 
sanitizedContext (shared_ptr< const Context< BasisFunctionType, ResultType > > context, bool localModeSupported, bool hybridModeSupported, const std::string &label)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (ScaledAbstractBoundaryOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (ScaledDiscreteBoundaryOperator)
 
shared_ptr< Epetra_CrsMatrix > sparseCholesky (const Epetra_CrsMatrix &mat)
 
shared_ptr< Epetra_CrsMatrix > sparseInverse (const Epetra_CrsMatrix &mat)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (SparseToHMatrixConverter)
 
template<typename Functor >
SurfaceNormalDependentFunction
< Functor > 
surfaceNormalDependentFunction (const Functor &functor)
 Construct a SurfaceNormalDependentFunction object from a given functor. More...
 
template<typename Functor >
SurfaceNormalIndependentFunction
< Functor > 
surfaceNormalIndependentFunction (const Functor &functor)
 Construct a SurfaceNormalIndependentFunction object from a given functor. More...
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (SyntheticIntegralOperator)
 
template<typename BasisFunctionType , typename ResultType >
BoundaryOperator
< BasisFunctionType,
ResultType > 
syntheticNonhypersingularIntegralOperator (const BoundaryOperator< BasisFunctionType, ResultType > &internalOp, const shared_ptr< const Space< BasisFunctionType > > &domain, const shared_ptr< const Space< BasisFunctionType > > &range, const shared_ptr< const Space< BasisFunctionType > > &dualToRange, const shared_ptr< const Space< BasisFunctionType > > &internalTrialSpace, const shared_ptr< const Space< BasisFunctionType > > &internalTestSpace, std::string label, int symmetry)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (TransposedDiscreteBoundaryOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (Vector)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (WeakFormAcaAssemblyHelper)
 
template<typename Container >
Container::reference acc (Container &v, typename Container::size_type i)
 Returns i'th element of the container v, optionally checking bounds. More...
 
template<typename Container >
Container::const_reference acc (const Container &v, typename Container::size_type i)
 Returns i'th element of the container v, optionally checking bounds. More...
 
template<typename PointerType >
PointerType ensureNotNull (PointerType p)
 
template<typename Source >
std::string toString (const Source &arg)
 Convert arg to std::string.
 
template<typename DuneGeometry >
DuneGeometry setupDuneGeometry (const GeometryType &type, const std::vector< Dune::FieldVector< double, DuneGeometry::dimensionworld > > &corners)
 
std::vector< bool > areInside (const Grid &grid, const arma::Mat< double > &points)
 
std::vector< bool > areInside (const Grid &grid, const arma::Mat< float > &points)
 
GridSegment gridSegmentWithPositiveX (const Grid &grid, int level)
 
double maxDistance (const Grid &grid1, const Grid &grid2)
 
double zRayIntersectsTriangle (const double *p, const double *v0, const double *v1, const double *v2, double *intersection)
 
template<typename ResultType >
boost::enable_if
< boost::is_complex
< ResultType >, void >::type 
exportSingleDataSetToVtk (VtkWriter &vtkWriter, const arma::Mat< ResultType > &data, VtkWriter::DataType dataType, const char *dataLabel, const char *fileNamesBase, const char *filesPath, VtkWriter::OutputType outputType)
 
template<typename ResultType >
boost::disable_if
< boost::is_complex
< ResultType >, void >::type 
exportSingleDataSetToVtk (VtkWriter &vtkWriter, const arma::Mat< ResultType > &data, VtkWriter::DataType dataType, const char *dataLabel, const char *fileNamesBase, const char *filesPath, VtkWriter::OutputType outputType)
 
template void exportSingleDataSetToVtk (VtkWriter &vtkWriter, const arma::Mat< float > &data, VtkWriter::DataType dataType, const char *dataLabel, const char *fileNamesBase, const char *filesPath, VtkWriter::OutputType outputType)
 
template void exportSingleDataSetToVtk (VtkWriter &vtkWriter, const arma::Mat< std::complex< float > > &data, VtkWriter::DataType dataType, const char *dataLabel, const char *fileNamesBase, const char *filesPath, VtkWriter::OutputType outputType)
 
template void exportSingleDataSetToVtk (VtkWriter &vtkWriter, const arma::Mat< double > &data, VtkWriter::DataType dataType, const char *dataLabel, const char *fileNamesBase, const char *filesPath, VtkWriter::OutputType outputType)
 
template void exportSingleDataSetToVtk (VtkWriter &vtkWriter, const arma::Mat< std::complex< double > > &data, VtkWriter::DataType dataType, const char *dataLabel, const char *fileNamesBase, const char *filesPath, VtkWriter::OutputType outputType)
 
Teuchos::RCP
< Teuchos::ParameterList > 
defaultGmresParameterList (double tol, int maxIterationCount)
 
Teuchos::RCP
< Teuchos::ParameterList > 
defaultGmresParameterList (float tol, int maxIterationCount)
 
Teuchos::RCP
< Teuchos::ParameterList > 
defaultCgParameterList (double tol, int maxIterationCount)
 
Teuchos::RCP
< Teuchos::ParameterList > 
defaultCgParameterList (float tol, int maxIterationCount)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (BelosSolverWrapper)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (BlockedSolution)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (DefaultDirectSolver)
 
template<typename ValueType >
Teuchos::RCP
< Thyra::DefaultSpmdVector
< ValueType > > 
wrapInTrilinosVector (arma::Col< ValueType > &col)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (DefaultIterativeSolver)
 
template<typename ValueType >
Preconditioner< ValueType > discreteOperatorToPreconditioner (const shared_ptr< const DiscreteBoundaryOperator< ValueType > > &discreteOperator)
 Create a preconditioner from a discrete operator.
 
template<typename ValueType >
Preconditioner< ValueType > discreteBlockDiagonalPreconditioner (const std::vector< shared_ptr< const DiscreteBoundaryOperator< ValueType > > > &opVector)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT (Preconditioner)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT_REAL_ONLY (RealWrapperOfComplexThyraLinearOperator)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_RESULT_REAL_ONLY (RealWrapperOfComplexThyraPreconditioner)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (Solution)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (SolutionBase)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS_AND_RESULT (Solver)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (PiecewiseConstantDiscontinuousScalarSpaceBarycentric)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (PiecewiseConstantDualGridDiscontinuousScalarSpace)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (PiecewiseConstantDualGridScalarSpace)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (PiecewiseConstantScalarSpace)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (PiecewiseConstantScalarSpaceBarycentric)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (PiecewiseLinearContinuousScalarSpace)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (PiecewiseLinearContinuousScalarSpaceBarycentric)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (PiecewiseLinearDiscontinuousScalarSpace)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (PiecewiseLinearDiscontinuousScalarSpaceBarycentric)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (PiecewiseLinearScalarSpace)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (PiecewisePolynomialContinuousScalarSpace)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (PiecewisePolynomialDiscontinuousScalarSpace)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (RaviartThomas0VectorSpace)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (ScalarSpace)
 
template<typename BasisFunctionType >
void getAllShapesets (const Space< BasisFunctionType > &space, std::vector< const Fiber::Shapeset< BasisFunctionType > * > &shapesets)
 
template<typename BasisFunctionType >
void getAllBases (const Space< BasisFunctionType > &space, std::vector< const Fiber::Basis< BasisFunctionType > * > &bases)
 
template<typename BasisFunctionType >
int maximumShapesetOrder (const Space< BasisFunctionType > &space)
 
template<typename BasisFunctionType , typename ResultType >
shared_ptr
< DiscreteSparseBoundaryOperator
< ResultType > > 
constructOperatorMappingGlobalToFlatLocalDofs (const Space< BasisFunctionType > &space)
 
template<typename BasisFunctionType , typename ResultType >
shared_ptr
< DiscreteSparseBoundaryOperator
< ResultType > > 
constructOperatorMappingFlatLocalToGlobalDofs (const Space< BasisFunctionType > &space)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (Space)
 
 FIBER_ITERATE_OVER_BASIS_TYPES (INSTANTIATE_FUNCTIONS_DEPENDENT_ON_BASIS)
 
 FIBER_ITERATE_OVER_BASIS_AND_RESULT_TYPES (INSTANTIATE_constructOperators)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (SpaceHelper)
 
 FIBER_INSTANTIATE_CLASS_TEMPLATED_ON_BASIS (UnitScalarSpace)
 

Variables

const int DEFAULT_HELMHOLTZ_INTERPOLATION_DENSITY = 5000
 

Detailed Description

Function Documentation

template<typename Container >
Container::reference Bempp::acc ( Container &  v,
typename Container::size_type  i 
)
inline

Returns i'th element of the container v, optionally checking bounds.

If NDEBUG is not defined, this function returns v.at(i), otherwise v[i].

Referenced by Bempp::GridSegment::closedDomain(), Bempp::RaviartThomas0VectorSpace< BasisFunctionType >::flatLocal2localDofs(), Bempp::PiecewiseConstantDualGridDiscontinuousScalarSpace< BasisFunctionType >::getFlatLocalDofBoundingBoxes(), Bempp::PiecewiseConstantDualGridScalarSpace< BasisFunctionType >::getFlatLocalDofBoundingBoxes(), Bempp::PiecewiseLinearContinuousScalarSpace< BasisFunctionType >::getFlatLocalDofBoundingBoxes(), Bempp::PiecewiseLinearDiscontinuousScalarSpaceBarycentric< BasisFunctionType >::getFlatLocalDofBoundingBoxes(), Bempp::PiecewiseLinearContinuousScalarSpaceBarycentric< BasisFunctionType >::getFlatLocalDofBoundingBoxes(), Bempp::RaviartThomas0VectorSpace< BasisFunctionType >::getFlatLocalDofBoundingBoxes(), Bempp::RaviartThomas0VectorSpace< BasisFunctionType >::getFlatLocalDofPositions(), Bempp::PiecewiseConstantScalarSpace< BasisFunctionType >::getGlobalDofBoundingBoxes(), Bempp::RaviartThomas0VectorSpace< BasisFunctionType >::getGlobalDofNormals(), Bempp::PiecewisePolynomialContinuousScalarSpace< BasisFunctionType >::getGlobalDofPositions(), Bempp::PiecewisePolynomialDiscontinuousScalarSpace< BasisFunctionType >::getGlobalDofPositions(), Bempp::RaviartThomas0VectorSpace< BasisFunctionType >::getGlobalDofPositions(), Bempp::RaviartThomas0VectorSpace< BasisFunctionType >::getGlobalDofs(), Bempp::GridSegment::markExcludedEntities(), and Bempp::GridSegment::openDomain().

template<typename Container >
Container::const_reference Bempp::acc ( const Container &  v,
typename Container::size_type  i 
)
inline

Returns i'th element of the container v, optionally checking bounds.

If NDEBUG is not defined, this function returns v.at(i), otherwise v[i].