 Bempp::AbstractBoundaryOperator< BasisFunctionType, ResultType > | |
  Bempp::ElementaryIntegralOperatorBase< BasisFunctionType, ResultType > | |
   Bempp::ElementaryIntegralOperator< BasisFunctionType, KernelType, ResultType > | |
    Bempp::ElementaryRegularIntegralOperator< BasisFunctionType, KernelType, ResultType > | Elementary boundary integral operator with weak form whose integrand is a regular function |
 array | |
  Dune::BemppStructuredGridFactory< GridType >::MultiIndex | Dim-dimensional multi-index. The range for each component can be set individually |
 bbxbemcluster | |
  Bempp::ExtendedBemCluster< T > | |
 Bempp::AbstractBoundaryOperator< BasisFunctionType_, ResultType_ > | Abstract (non-discretized) boundary operator |
  Bempp::AbstractBoundaryOperatorComposition< BasisFunctionType_, ResultType_ > | Composition of two abstract boundary operators |
  Bempp::AbstractBoundaryOperatorPseudoinverse< BasisFunctionType_, ResultType_ > | Inverse or pseudoinverse of an abstract boundary operator |
  Bempp::AbstractBoundaryOperatorSuperpositionBase< BasisFunctionType_, ResultType_ > | Base class for abstract boundary operator superpositions |
   Bempp::AbstractBoundaryOperatorSum< BasisFunctionType_, ResultType_ > | Sum of two abstract boundary operators |
   Bempp::ScaledAbstractBoundaryOperator< BasisFunctionType_, ResultType_ > | Scaled abstract boundary operator |
  Bempp::AdjointAbstractBoundaryOperator< BasisFunctionType_, ResultType_ > | Adjoint abstract boundary operator |
  Bempp::ElementaryIntegralOperatorBase< BasisFunctionType_, ResultType_ > | Base class of ElementaryIntegralOperator, containing functionality independent from KernelType |
   Bempp::ElementaryIntegralOperator< BasisFunctionType_, KernelType_, ResultType_ > | Elementary integral boundary operator |
    Bempp::ElementarySingularIntegralOperator< BasisFunctionType_, KernelType_, ResultType_ > | Elementary boundary integral operator with weak form whose integrand has a singularity at origin |
     Bempp::GeneralElementarySingularIntegralOperator< BasisFunctionType_, KernelType_, ResultType_ > | Standard implementation of an elementary singular integral operator |
  Bempp::ElementaryLocalOperator< BasisFunctionType_, ResultType_ > | Abstract base class of local elementary operators |
   Bempp::GeneralElementaryLocalOperator< BasisFunctionType_, ResultType_ > | Standard implementation of an elementary local operator |
   Bempp::IdentityOperator< BasisFunctionType_, ResultType_ > | Identity operator |
   Bempp::Maxwell3dIdentityOperator< BasisFunctionType_, ResultType_ > | "Identity operator" for Maxwell equations in 3D |
  Bempp::HypersingularIntegralOperator< BasisFunctionType_, KernelType_, ResultType_ > | Hypersingular integral boundary operator |
   Bempp::GeneralHypersingularIntegralOperator< BasisFunctionType_, KernelType_, ResultType_ > | Standard implementation of a hypersingular singular integral operator |
  Bempp::NullOperator< BasisFunctionType_, ResultType_ > | Null operator |
  Bempp::SyntheticIntegralOperator< BasisFunctionType_, ResultType_ > | Integral operator with weak form assembled from several pieces |
 Bempp::AbstractBoundaryOperatorId | Base class for identifiers of an abstract boundary operator |
  Bempp::AbstractBoundaryOperatorPseudoinverseId< BasisFunctionType, ResultType > | |
  Bempp::IdentityOperatorId< BasisFunctionType, ResultType > | |
  Bempp::NullOperatorId< BasisFunctionType, ResultType > | |
 Bempp::AcaGlobalAssembler< BasisFunctionType, ResultType > | ACA-mode assembler |
 Bempp::AcaOptions | Adaptive cross approximation (ACA) parameters |
 Bempp::AhmedLeafClusterArray | Encapsulation of an array of pointers to AHMED's blcluster objects |
 Bempp::AhmedMblockArrayDeleter | |
 Bempp::AhmedTypeTraits< T > | |
 Bempp::AhmedTypeTraits< std::complex< double > > | |
 Bempp::AhmedTypeTraits< std::complex< float > > | |
 Bempp::AssembledPotentialOperator< BasisFunctionType, ResultType > | Assembled potential operator |
 Bempp::AssemblyOptions | Options determining how weak-form assembly is done |
 Bempp::AutoTimer | Timer that on destruction outputs the time elapsed since construction |
 Bempp::BelosSolverWrapper< ValueType > | |
 Bempp::BlockCoalescer< ValueType > | |
 Bempp::BlockedBoundaryOperator< BasisFunctionType, ResultType > | Boundary operator consisting of multiple blocks arranged in a matrix |
 Bempp::BlockedOperatorStructure< BasisFunctionType, ResultType > | Helper class used in construction of blocked boundary operators |
 Bempp::BoundaryOperator< BasisFunctionType, ResultType > | Operator acting on functions defined on a surface |
 Bempp::BoundingBox< CoordinateType > | Bounding box with a reference point |
  Bempp::AhmedDofWrapper< CoordinateType > | An Ahmed-compatible degree-of-freedom type |
 Bempp::ChunkStatistics | Storage of parallel-loop profiling data |
 Bempp::ClusterConstructionHelper< BasisFunctionType > | |
 Bempp::ComponentLists | Data used by PotentialOperatorAcaAssemblyHelper to convert between H-matrix indices, point and component indices |
 Bempp::ComponentListsCache | Cache of ComponentLists objects |
 Bempp::Context< BasisFunctionType, ResultType > | Assembly context |
 Bempp::ConvergenceTestMode | |
 Bempp::DenseGlobalAssembler< BasisFunctionType, ResultType > | Dense-mode assembler |
 Bempp::DiscreteBoundaryOperatorCache< BasisFunctionType, ResultType > | Cache of discrete boundary operators |
 Bempp::DomainIndex | |
  Bempp::ConcreteDomainIndex< DuneGrid > | |
 Bempp::Entity< codim > | Abstract wrapper of an entity of codimension codim |
  Bempp::ConcreteEntity< codim, DuneEntity > | Wrapper of a Dune entity of type DuneEntity and codimension codim |
  Bempp::ConcreteEntity< Bempp::ConcreteEntityPointer::codimension, DuneEntity > | |
  Bempp::ConcreteEntity< Bempp::ConcreteRangeEntityIterator::codimension, typename DuneEntityIt::Bempp::Entity > | |
  Bempp::ConcreteEntity< Bempp::ConcreteSubentityIterator::codimension, DuneSubentity > | |
 Bempp::Entity< 0 > | Abstract wrapper of an entity of codimension 0 |
  Bempp::ConcreteEntity< 0, DuneEntity > | Wrapper of a Dune entity of type DuneEntity and codimension 0 |
 Bempp::EntityPointer< codim > | Abstract base class for an object providing read-only access to an entity of codimension codim |
  Bempp::EntityIterator< codim > | Abstract base class for iterators over entities |
  Bempp::EntityIterator< codimSub > | |
   Bempp::ConcreteSubentityIterator< DuneEntity, codimSub > | Iterator over the subentities of codimension codimSub of a given Dune entity of type DuneEntity |
  Bempp::EntityIterator< DuneEntityIt::codimension > | |
   Bempp::ConcreteRangeEntityIterator< DuneEntityIt, DuneEntityPointer > | Iterator over entities referenced by a range of Dune iterators of type DuneEntityIt |
 Bempp::EvaluationOptions | Options controlling evaluation of potentials |
 Bempp::Geometry | Abstract wrapper of a geometry |
  Bempp::ConcreteGeometry< DuneGeometry > | Wrapper of a Dune geometry of type DuneGeometry |
  Bempp::ConcreteGeometry< typename DuneEntity::Bempp::Geometry > | |
  Bempp::ConcreteGeometry< typename DuneSubentity::Bempp::Geometry > | |
  Bempp::ConcreteGeometry< typename typename DuneEntityIt::Bempp::Entity::Bempp::Geometry > | |
 Bempp::GeometryFactory | Abstract geometry factory |
  Bempp::ConcreteGeometryFactory< DuneGeometry > | Factory able to construct an "empty" geometry wrapping a Dune geometry of type DuneGeometry |
 Bempp::Grid | Abstract wrapper of a grid |
  Bempp::ConcreteGrid< DuneGrid > | Wrapper of a Dune surface grid of type DuneGrid |
 Bempp::GridFactory | Grid factory |
 Bempp::GridFunction< BasisFunctionType, ResultType > | Function defined on a grid |
 Bempp::GridParameters | Grid parameters |
 Bempp::GridSegment | Segment of a grid |
 Bempp::GridView | Abstract wrapper of a grid view |
  Bempp::ConcreteGridView< DuneGridView > | Wrapper of a Dune grid view of type DuneGridView |
 Bempp::IdSet | Abstract wrapper of an id set |
  Bempp::ConcreteIdSet< DuneGrid, DuneIdSet > | Wrapper of a Dune id set of type DuneIdSet providing access to the entities of a Dune grid of type DuneGrid |
  Bempp::ConcreteIdSet< DuneGrid, typename DuneGrid::Traits::GlobalIdSet > | |
 Bempp::IndexPermutation | Permutation of indices |
 Bempp::IndexSet | Abstract wrapper of an index set |
  Bempp::ConcreteIndexSet< DuneGridView > | Wrapper of the index set specific to a Dune grid view class DuneGridView |
 Bempp::Lazy< T, Initializer, Mutex > | Thread-safe wrapper of a lazily inititialised object |
 Bempp::LocalAssemblerConstructionHelper | Utility functions used during weak-form assembly |
 Bempp::LocalDof | Local degree of freedom |
 Bempp::LocalDofLists< BasisFunctionType > | Data used by WeakFormAcaAssemblyHelper to convert between H-matrix indices, global and local degrees of freedom |
 Bempp::LocalDofListsCache< BasisFunctionType > | Cache of LocalDofLists objects |
 Bempp::Mapper | Abstract mapper class |
  Bempp::ConcreteElementMapper< DuneGridView > | An injective mapping from the full set of codimension-0 entities ("elements") of a grid to the integers 0 ... (number of entities - 1) |
 Bempp::MblockArrayConverter< FromType, ToType > | |
 Bempp::MblockArrayConverter< Type, Type > | |
 Bempp::Point3D< ValueType > | Point in a three-dimensional space |
 Bempp::PotentialOperator< BasisFunctionType_, ResultType_ > | Potential operator |
  Bempp::ElementaryPotentialOperator< BasisFunctionType_, KernelType_, ResultType_ > | Elementary potential operator |
  Bempp::ElementaryPotentialOperator< BasisFunctionType_, ScalarTraits< ResultType_ >::RealType, ResultType_ > | |
   Bempp::Laplace3dPotentialOperatorBase< Impl, BasisFunctionType_, ResultType_ > | Base class for potential operators related to the Laplace equation in 3D |
   Bempp::Laplace3dPotentialOperatorBase< Laplace3dDoubleLayerPotentialOperatorImpl< BasisFunctionType_, ResultType_ >, BasisFunctionType_, ResultType_ > | |
    Bempp::Laplace3dDoubleLayerPotentialOperator< BasisFunctionType_, ResultType_ > | Double-layer potential operator for the Laplace equation in 3D |
   Bempp::Laplace3dPotentialOperatorBase< Laplace3dSingleLayerPotentialOperatorImpl< BasisFunctionType_, ResultType_ >, BasisFunctionType_, ResultType_ > | |
    Bempp::Laplace3dSingleLayerPotentialOperator< BasisFunctionType_, ResultType_ > | Single-layer potential operator for the Laplace equation in 3D |
 Bempp::PotentialOperatorAcaAssemblyHelper< BasisFunctionType, ResultType > | Class whose methods are called by Ahmed during assembly in the ACA mode |
 Bempp::Preconditioner< ValueType > | A simple container class to hold pointers to preconditioners |
 Bempp::ReverseElementMapper | Mapping from codim-0 entity indices to entity pointers |
 Bempp::ScatteredRange | |
 Bempp::ScatteredRange::const_iterator | |
 Bempp::SolutionBase< BasisFunctionType, ResultType > | The base class for the Solution and BlockedSolution container classes |
  Bempp::BlockedSolution< BasisFunctionType, ResultType > | This class holds the solution of a block operator system together with various information about the solution |
  Bempp::Solution< BasisFunctionType, ResultType > | This class holds the solution of a BEM computation together with various associated information |
 Bempp::SolutionStatus | |
 Bempp::Solver< BasisFunctionType, ResultType > | The abstract interface of solvers of boundary integral equations |
  Bempp::DefaultDirectSolver< BasisFunctionType, ResultType > | Default direct dense solver for boundary integral equations |
  Bempp::DefaultIterativeSolver< BasisFunctionType, ResultType > | Default iterative solver for boundary integral equations |
 Bempp::Space< BasisFunctionType > | Function space |
  Bempp::RaviartThomas0VectorSpace< BasisFunctionType > | Space spanned by the lowest order Raviart-Thomas functions |
  Bempp::ScalarSpace< BasisFunctionType > | Base class for spaces of scalar-valued functions |
   Bempp::PiecewiseConstantDiscontinuousScalarSpaceBarycentric< BasisFunctionType > | Space of piecewise constant scalar functions |
   Bempp::PiecewiseConstantDualGridDiscontinuousScalarSpace< BasisFunctionType > | Space of piecewise constant functions define on the dual grid |
   Bempp::PiecewiseConstantDualGridScalarSpace< BasisFunctionType > | Space of piecewise constant functions define on the dual grid |
   Bempp::PiecewiseConstantScalarSpace< BasisFunctionType > | Space of piecewise constant scalar functions |
   Bempp::PiecewiseConstantScalarSpaceBarycentric< BasisFunctionType > | Space of piecewise constant scalar functions |
   Bempp::PiecewiseLinearDiscontinuousScalarSpaceBarycentric< BasisFunctionType > | Space of piecewise constant functions define on the dual grid |
   Bempp::PiecewiseLinearScalarSpace< BasisFunctionType > | Space of continuous, piecewise linear scalar functions |
    Bempp::PiecewiseLinearContinuousScalarSpace< BasisFunctionType > | Space of continuous, piecewise linear scalar functions |
    Bempp::PiecewiseLinearContinuousScalarSpaceBarycentric< BasisFunctionType > | Space of continuous, piecewise linear scalar functions |
    Bempp::PiecewiseLinearDiscontinuousScalarSpace< BasisFunctionType > | Space of piecewise linear, not necessarily continuous, scalar functions |
   Bempp::PiecewisePolynomialContinuousScalarSpace< BasisFunctionType > | Space of continuous, piecewise polynomial scalar functions |
   Bempp::PiecewisePolynomialDiscontinuousScalarSpace< BasisFunctionType > | Space of discontinuous, piecewise polynomial scalar functions |
   Bempp::UnitScalarSpace< BasisFunctionType > | Space consisting of a single scalar function equal to 1 everywhere |
 Bempp::SpaceHelper< BasisFunctionType > | |
 Bempp::SparseToHMatrixConverter< ValueType > | |
 Bempp::VtkWriter | Abstract exporter of data in the vtk format |
  Bempp::ConcreteVtkWriter< DuneGridView > | Wrapper of a Dune VTK writer for a grid view of type DuneGridView |
 Bempp::WeakFormAcaAssemblyHelper< BasisFunctionType, ResultType > | Class whose methods are called by Ahmed during assembly in the ACA mode |
 additive | |
  Fiber::_3dArray< CoordinateType > | |
  Fiber::_3dArray< ValueType > | |
  Fiber::_4dArray< ValueType > | |
  Fiber::_2dArray< T > | Simple implementation of a 2D Fortran-ordered array |
  Fiber::_3dArray< T > | Simple implementation of a 3D Fortran-ordered array |
  Fiber::_4dArray< T > | Simple implementation of a 4D Fortran-ordered array |
 enable_shared_from_this | |
  Bempp::DiscreteBoundaryOperator< ValueType > | Discrete boundary operator |
   Bempp::AcaApproximateLuInverse< ValueType > | Approximate LU decomposition of a H-matrix |
   Bempp::DiscreteAcaBoundaryOperator< ValueType > | Discrete linear operator stored as a H-matrix |
   Bempp::DiscreteBlockedBoundaryOperator< ValueType > | Discrete boundary operator composed of multiple blocks stored separately |
   Bempp::DiscreteBoundaryOperatorComposition< ValueType > | Composition (product) of discrete linear operators stored separately |
   Bempp::DiscreteBoundaryOperatorSum< ValueType > | Sum of discrete linear operators stored separately |
   Bempp::DiscreteDenseBoundaryOperator< ValueType > | Discrete boundary operator stored as a dense matrix |
   Bempp::DiscreteInverseSparseBoundaryOperator< ValueType > | Discrete boundary operator representing the inverse of another operator and stored as a sparse LU decomposition |
   Bempp::DiscreteNullBoundaryOperator< ValueType > | Null (zero-valued) discrete boundary operator |
   Bempp::DiscreteSparseBoundaryOperator< ValueType > | Discrete boundary operator stored as a sparse matrix |
   Bempp::ScaledDiscreteBoundaryOperator< ValueType > | Scaled discrete boundary operator |
   Bempp::TransposedDiscreteBoundaryOperator< ValueType > | Transposed and/or conjugated discrete boundary operator |
  Bempp::DiscreteBoundaryOperator< std::complex< RealType > > | |
   Bempp::ComplexifiedDiscreteBoundaryOperator< RealType > | Complexified discrete boundary operator |
 Fiber::CollectionOf2dArrays< ResultType > | |
 Fiber::CollectionOfKernels< Functor::ValueType > | |
  Fiber::DefaultCollectionOfKernels< Functor > | Default implementation of a collection of kernels |
 Fiber::CollectionOfKernels< KernelType > | |
 Fiber::CollectionOfShapesetTransformations< CoordinateType > | |
 Fiber::CollectionOfShapesetTransformations< Functor::CoordinateType > | |
  Fiber::CollectionOfBasisTransformations< Functor::CoordinateType > | |
   Fiber::DefaultCollectionOfShapesetTransformations< Functor > | Default implementation of a collection of shape function transformations |
    Fiber::DefaultCollectionOfBasisTransformations< Functor > | Default implementation of a collection of shape function transformations |
 Dune::BemppStructuredGridFactory< GridType > | Construct structured cube and simplex grids in unstructured grid managers |
 Dune::BemppStructuredGridFactory< YaspGrid< dim > > | Specialization of the StructuredGridFactory for YaspGrid |
 VTKFunction | |
  Bempp::P0VectorVTKFunction< GV, V > | Take a vector and interpret it as cell data for the VTKWriter |
  Bempp::P1VectorVTKFunction< GV, V > | Take a vector and interpret it as point data for the VTKWriter |
 Fiber::ElementaryShapeTransformationFunctorPairWrapper< HdivFunctionValueElementaryFunctor< CoordinateType_ >, SurfaceDiv3dElementaryFunctor< CoordinateType_ > > | |
  Fiber::ModifiedMaxwell3dSingleLayerOperatorsTransformationFunctor< CoordinateType_ > | Functor calculating shape-function transformations necessary for the implementation of the single-layer potential boundary operator for the modified Maxwell equations in 3D |
 Fiber::ElementaryShapeTransformationFunctorPairWrapper< ScalarFunctionValueElementaryFunctor< CoordinateType_ >, SurfaceCurl3dElementaryFunctor< CoordinateType_ > > | |
  Fiber::ModifiedHelmholtz3dHypersingularTransformationFunctor< CoordinateType_ > | Functor calculating shape-function transformations necessary for the implementation of the hypersingular operator for the modified Helmholtz equation in 3D |
 Fiber::ElementaryShapeTransformationFunctorPairWrapper< SurfaceCurl3dElementaryFunctor< CoordinateType_ >, ScalarFunctionValueTimesNormalElementaryFunctor< CoordinateType_ > > | |
  Fiber::ModifiedHelmholtz3dHypersingularTransformationFunctor2< CoordinateType_ > | Functor calculating shape-function transformations necessary for the implementation of the hypersingular operator for the modified Helmholtz equation in 3D |
 Fiber::ElementaryShapeTransformationFunctorWrapper< HdivFunctionValueElementaryFunctor< CoordinateType_ > > | |
  Fiber::HdivFunctionValueFunctor< CoordinateType_ > | Functor calculating the value of a basis function from H(div) |
 Fiber::ElementaryShapeTransformationFunctorWrapper< ScalarFunctionValueElementaryFunctor< CoordinateType_ > > | |
  Fiber::ScalarFunctionValueFunctor< CoordinateType_ > | Functor calculating the value of a scalar basis function |
 Fiber::ElementaryShapeTransformationFunctorWrapper< ScalarFunctionValueTimesNormalElementaryFunctor< CoordinateType_ > > | |
  Fiber::ScalarFunctionValueTimesNormalFunctor< CoordinateType_ > | Functor calculating the value of a scalar basis function multiplied by the unit vector normal to the surface |
 Fiber::ElementaryShapeTransformationFunctorWrapper< SurfaceCurl3dElementaryFunctor< CoordinateType_ > > | |
  Fiber::SurfaceCurl3dFunctor< CoordinateType_ > | Functor calculating the surface curl of a scalar field in 3D |
 Fiber::ElementaryShapeTransformationFunctorWrapper< SurfaceDiv3dElementaryFunctor< CoordinateType_ > > | |
  Fiber::SurfaceDiv3dFunctor< CoordinateType_ > | Functor calculating the surface div of a scalar field in 3D |
 Fiber::ElementaryShapeTransformationFunctorWrapper< SurfaceGrad3dElementaryFunctor< CoordinateType_ > > | |
  Fiber::SurfaceGrad3dFunctor< CoordinateType_ > | Functor calculating the surface gradient of a scalar field in 3D |
 Bempp::EntityPointer< DuneEntityPointer::codimension > | |
  Bempp::ConcreteEntityPointer< DuneEntityPointer > | Wrapper of a Dune entity pointer of type DuneEntityPointer |
 Fiber::_1dSliceOf2dArray< T > | Lightweight encapsulation of a 1D slice of a 2D array |
 Fiber::_1dSliceOf3dArray< T > | Lightweight encapsulation of a 1D slice of a 3D array |
 Fiber::_1dSliceOf4dArray< T > | Lightweight encapsulation of a 1D slice of a 4d array |
 Fiber::_1dSliceOfConst2dArray< T > | Lightweight encapsulation of a 1D slice of a constant 2D array |
 Fiber::_1dSliceOfConst3dArray< T > | Lightweight encapsulation of a 1D slice of a constant 3D array |
 Fiber::_1dSliceOfConst4dArray< T > | Lightweight encapsulation of a 2D slice of a constant 4d array |
 Fiber::_2dSliceOf3dArray< T > | Lightweight encapsulation of a 2D slice of a 3D array |
 Fiber::_2dSliceOf4dArray< T > | Lightweight encapsulation of a 2D slice of a 4d array |
 Fiber::_2dSliceOfConst3dArray< T > | Lightweight encapsulation of a 2D slice of a constant 3D array |
 Fiber::_2dSliceOfConst4dArray< T > | Lightweight encapsulation of a 2D slice of a constant 4d array |
 Fiber::_3dSliceOf4dArray< T > | Lightweight encapsulation of a 3D slice of a 4D array |
 Fiber::_3dSliceOfConst4dArray< T > | Lightweight encapsulation of a 2D slice of a constant 4d array |
 Fiber::AccuracyOptions | Old-style options controlling quadrature accuracy |
 Fiber::AccuracyOptionsEx | New-style options controlling quadrature accuracy |
 Fiber::BasisData< ValueType > | Storage of values and/or derivatives of shape functions |
 Fiber::Coercion< U, V > | "Larger" of the types U and V |
 Fiber::Coercion< double, double > | |
 Fiber::Coercion< double, std::complex< double > > | |
 Fiber::Coercion< float, float > | |
 Fiber::Coercion< float, std::complex< float > > | |
 Fiber::Coercion< std::complex< double >, double > | |
 Fiber::Coercion< std::complex< double >, std::complex< double > > | |
 Fiber::Coercion< std::complex< float >, float > | |
 Fiber::Coercion< std::complex< float >, std::complex< float > > | |
 Fiber::CollectionOf1dSlicesOf2dArrays< T > | |
 Fiber::CollectionOf1dSlicesOf3dArrays< T > | |
 Fiber::CollectionOf1dSlicesOf4dArrays< T > | |
 Fiber::CollectionOf1dSlicesOfConst2dArrays< T > | |
 Fiber::CollectionOf1dSlicesOfConst3dArrays< T > | |
 Fiber::CollectionOf1dSlicesOfConst4dArrays< T > | |
 Fiber::CollectionOf2dArrays< T > | |
 Fiber::CollectionOf2dSlicesOf3dArrays< T > | |
 Fiber::CollectionOf2dSlicesOf4dArrays< T > | |
 Fiber::CollectionOf2dSlicesOfConst3dArrays< T > | |
 Fiber::CollectionOf2dSlicesOfConst4dArrays< T > | |
 Fiber::CollectionOf3dArrays< T > | |
 Fiber::CollectionOf3dSlicesOf4dArrays< T > | |
 Fiber::CollectionOf3dSlicesOfConst4dArrays< T > | |
 Fiber::CollectionOf4dArrays< T > | |
 Fiber::CollectionOfKernels< ValueType_ > | Collection of kernels |
 Fiber::CollectionOfShapesetTransformations< CoordinateType_ > | Collection of shape function transformations |
  Fiber::CollectionOfBasisTransformations< CoordinateType_ > | Collection of shape function transformations |
 Fiber::ConstBasisDataSlice< ValueType > | Access to values and/or derivatives of shape functions |
 Fiber::ConstGeometricalDataSlice< CoordinateType > | Access to slices of geometrical data |
 Fiber::DefaultLocalAssemblerForOperatorsOnSurfacesUtilities< BasisFunctionType > | |
 Fiber::DoubleQuadratureDescriptor | Parameters of a quadrature rule used in the evaluation of integrals over pairs of elements |
 Fiber::DoubleQuadratureRuleFamily< CoordinateType > | Family of quadrature rules over pairs of elements |
  Fiber::DefaultDoubleQuadratureRuleFamily< CoordinateType > | Default family of quadrature rules over pairs of elements |
 Fiber::ElementaryShapeTransformationFunctorPairWrapper< ElementaryFunctor0, ElementaryFunctor1 > | |
  Fiber::ElementaryBasisTransformationFunctorPairWrapper< ElementaryFunctor0, ElementaryFunctor1 > | |
 Fiber::ElementaryShapeTransformationFunctorWrapper< ElementaryFunctor > | |
  Fiber::ElementaryBasisTransformationFunctorWrapper< ElementaryFunctor > | |
 Fiber::ElementPairTopology | Configuration of a pair of elements |
 Fiber::EvaluatorForIntegralOperators< ResultType > | |
  Fiber::DefaultEvaluatorForIntegralOperators< BasisFunctionType, KernelType, ResultType, GeometryFactory > | |
 Fiber::Function< ValueType > | Function to be used as a source term |
  Bempp::InterpolatedFunction< ValueType > | Function defined by its values at a set of interpolation points and an interpolation method |
 Fiber::GeometricalData< CoordinateType > | Storage of geometrical data |
 Fiber::HdivFunctionValueElementaryFunctor< CoordinateType_ > | |
 Fiber::HermiteInterpolator< ValueType > | |
 Fiber::KernelTrialIntegral< BasisFunctionType_, KernelType_, ResultType_ > | |
 Fiber::KernelTrialIntegrator< BasisFunctionType, KernelType, ResultType > | Integration over pairs of elements |
  Fiber::NumericalKernelTrialIntegrator< BasisFunctionType, KernelType, ResultType, GeometryFactory > | Integration over pairs of elements on tensor-product point grids |
 Fiber::LagrangeScalarBasisTraits< elementVertexCount, CoordinateType, ValueType, polynomialOrder > | |
 Fiber::LagrangeScalarBasisTraits< 3, CoordinateType, ValueType, polynomialOrder > | |
 Fiber::Laplace3dAdjointDoubleLayerPotentialKernelFunctor< ValueType_ > | Adjoint double-layer-potential kernel functor for the Laplace equation in 3D |
 Fiber::Laplace3dDoubleLayerPotentialKernelFunctor< ValueType_ > | Double-layer-potential kernel functor for the Laplace equation in 3D |
 Fiber::Laplace3dHypersingularOffDiagonalKernelFunctor< ValueType_ > | Kernel functor for the hypersingular operator associated with the Laplace equation in 3D, applicable for test and trial points lying on nonadjacent elements |
 Fiber::Laplace3dSingleLayerPotentialKernelFunctor< ValueType_ > | Single-layer-potential kernel functor for the Laplace equation in 3D |
 Fiber::LocalAssemblerForGridFunctions< ResultType > | Local assembler for grid functions |
  Fiber::DefaultLocalAssemblerForGridFunctionsOnSurfaces< BasisFunctionType, UserFunctionType, ResultType, GeometryFactory > | |
 Fiber::LocalAssemblerForIntegralOperators< ResultType > | Abstract interface of a local assembler for integral operators |
  Fiber::DefaultLocalAssemblerForIntegralOperatorsOnSurfaces< BasisFunctionType, KernelType, ResultType, GeometryFactory > | |
 Fiber::LocalAssemblerForLocalOperators< ResultType > | Abstract interface of a local assembler for local operators |
  Fiber::DefaultLocalAssemblerForLocalOperatorsOnSurfaces< BasisFunctionType, ResultType, GeometryFactory > | |
 Fiber::LocalAssemblerForPotentialOperators< ResultType > | Abstract interface of a local assembler for potential operators |
  Fiber::DefaultLocalAssemblerForPotentialOperatorsOnSurfaces< BasisFunctionType, KernelType, ResultType, GeometryFactory > | |
 Fiber::Maxwell3dTestTrialIntegrandFunctor< BasisFunctionType_, ResultType_ > | Functor evaluating the integrand of the identity operator under the pseudo-inner product relevant to Maxwell equations in 3d |
 Fiber::ModifiedHelmholtz3dAdjointDoubleLayerPotentialKernelFunctor< ValueType_ > | Adjoint double-layer-potential kernel functor for the modified Helmholtz equation in 3D |
 Fiber::ModifiedHelmholtz3dAdjointDoubleLayerPotentialKernelInterpolatedFunctor< ValueType_ > | Adjoint double-layer-potential kernel functor for the modified Helmholtz equation in 3D |
 Fiber::ModifiedHelmholtz3dDoubleLayerPotentialKernelFunctor< ValueType_ > | Double-layer-potential kernel functor for the modified Helmholtz equation in 3D |
 Fiber::ModifiedHelmholtz3dDoubleLayerPotentialKernelInterpolatedFunctor< ValueType_ > | Double-layer-potential kernel functor for the modified Helmholtz equation in 3D |
 Fiber::ModifiedHelmholtz3dFarFieldDoubleLayerPotentialKernelFunctor< ValueType_ > | Kernel functor used to calculate part of the far-field pattern of a radiating solution of the modified Helmholtz equation in 3D |
 Fiber::ModifiedHelmholtz3dFarFieldSingleLayerPotentialKernelFunctor< ValueType_ > | Kernel functor used to calculate part of the far-field pattern of a radiating solution of the modified Helmholtz equation in 3D |
 Fiber::ModifiedHelmholtz3dHypersingularIntegrandFunctor< BasisFunctionType_, KernelType_, ResultType_ > | Functor evaluating the integrand of the hypersingular operator for the modified Helmholtz equation in 3D |
 Fiber::ModifiedHelmholtz3dHypersingularIntegrandFunctor2< BasisFunctionType_, KernelType_, ResultType_ > | Functor evaluating the integrand of the hypersingular operator for the modified Helmholtz equation in 3D |
 Fiber::ModifiedHelmholtz3dHypersingularKernelFunctor< ValueType_ > | Hypersingular kernel collection functor for the modified Helmholtz equation in 3D |
 Fiber::ModifiedHelmholtz3dHypersingularKernelInterpolatedFunctor< ValueType_ > | Hypersingular kernel collection functor for the modified Helmholtz equation in 3D |
 Fiber::ModifiedHelmholtz3dHypersingularOffDiagonalInterpolatedKernelFunctor< ValueType_ > | Kernel functor for the hypersingular operator associated with the modified Helmholtz equation in 3D, applicable for test and trial points lying on nonadjacent elements |
 Fiber::ModifiedHelmholtz3dHypersingularOffDiagonalKernelFunctor< ValueType_ > | Kernel functor for the hypersingular operator associated with the modified Helmholtz equation in 3D, applicable for test and trial points lying on nonadjacent elements |
 Fiber::ModifiedHelmholtz3dSingleLayerPotentialKernelFunctor< ValueType_ > | Single-layer-potential kernel functor for the modified Helmholtz equation in 3D |
 Fiber::ModifiedHelmholtz3dSingleLayerPotentialKernelInterpolatedFunctor< ValueType_ > | Single-layer-potential kernel functor for the modified Helmholtz equation in 3D |
 Fiber::ModifiedMaxwell3dDoubleLayerBoundaryOperatorIntegrandFunctor< BasisFunctionType_, KernelType_, ResultType_ > | |
 Fiber::ModifiedMaxwell3dDoubleLayerOperatorsKernelFunctor< ValueType_ > | Kernel collection functor for the DLP of the modified Maxwell equations in 3D |
 Fiber::ModifiedMaxwell3dDoubleLayerOperatorsKernelInterpolatedFunctor< ValueType_ > | Kernel collection functor for the DLP of the modified Maxwell equations in 3D |
 Fiber::ModifiedMaxwell3dDoubleLayerPotentialOperatorIntegrandFunctor< BasisFunctionType_, KernelType_, ResultType_ > | |
 Fiber::ModifiedMaxwell3dFarFieldDoubleLayerPotentialOperatorKernelFunctor< ValueType_ > | Kernel functor used to calculate part of the far-field pattern of a radiating solution of the modified Helmholtz equation in 3D |
 Fiber::ModifiedMaxwell3dFarFieldSingleLayerPotentialOperatorKernelFunctor< ValueType_ > | Kernel collection functor for the far-field single-layer potential operator of the modified Maxwell equations in 3D |
 Fiber::ModifiedMaxwell3dSingleLayerBoundaryOperatorIntegrandFunctor< BasisFunctionType_, KernelType_, ResultType_ > | |
 Fiber::ModifiedMaxwell3dSingleLayerBoundaryOperatorKernelFunctor< ValueType_ > | Kernel collection functor for the SLP of the modified Maxwell equations in 3D |
 Fiber::ModifiedMaxwell3dSingleLayerBoundaryOperatorKernelInterpolatedFunctor< ValueType_ > | Kernel collection functor for the SLP of the modified Maxwell equations in 3D |
 Fiber::ModifiedMaxwell3dSingleLayerPotentialOperatorIntegrandFunctor< BasisFunctionType_, KernelType_, ResultType_ > | |
 Fiber::ModifiedMaxwell3dSingleLayerPotentialOperatorKernelFunctor< ValueType_ > | Kernel collection functor for the single-layer potential operator of the modified Maxwell equations in 3D |
 Fiber::null_deleter | |
 Fiber::OpenClHandler | |
 Fiber::OpenClOptions | |
 Fiber::ParallelizationOptions | Parallel operation settings |
 Fiber::PiecewiseLinearContinuousScalarBasisTraits< elementVertexCount, CoordinateType, ValueType > | |
 Fiber::PiecewiseLinearContinuousScalarBasisTraits< 2, CoordinateType, ValueType > | |
 Fiber::PiecewiseLinearContinuousScalarBasisTraits< 3, CoordinateType, ValueType > | |
 Fiber::PiecewiseLinearContinuousScalarBasisTraits< 4, CoordinateType, ValueType > | |
 Fiber::QuadratureDescriptorSelectorFactory< BasisFunctionType > | Builder of quadrature descriptor selectors |
  Fiber::DefaultQuadratureDescriptorSelectorFactory< BasisFunctionType > | |
 Fiber::QuadratureDescriptorSelectorForGridFunctions< CoordinateType > | Quadrature descriptor selector used during the discretization of functions |
 Fiber::QuadratureDescriptorSelectorForIntegralOperators< CoordinateType > | Quadrature descriptor selector used during the discretization of boundary integral operators |
 Fiber::QuadratureDescriptorSelectorForLocalOperators< CoordinateType > | Quadrature descriptor selector used during the discretization of local boundary operators |
 Fiber::QuadratureDescriptorSelectorForPotentialOperators< CoordinateType > | Quadrature descriptor selector used during the evaluation on potentials |
 Fiber::QuadratureOptions | Options controlling the order of numerical quadrature |
 Fiber::QuadratureStrategyBase< BasisFunctionType, ResultType, GeometryFactory > | |
  Fiber::QuadratureStrategy< BasisFunctionType, ResultType, GeometryFactory, Enable > | Base class for quadrature strategies |
   Fiber::NumericalQuadratureStrategyBase< BasisFunctionType, ResultType, GeometryFactory, Enable > | Base class for NumericalQuadratureStrategy |
    Fiber::NumericalQuadratureStrategy< BasisFunctionType, ResultType, GeometryFactory, Enable > | Quadrature strategy according to which integrals are evaluated by numerical quadrature |
  Fiber::QuadratureStrategy< BasisFunctionType, ResultType, GeometryFactory, void > | |
   Fiber::NumericalQuadratureStrategyBase< BasisFunctionType, ResultType, GeometryFactory, void > | |
    Fiber::NumericalQuadratureStrategy< BasisFunctionType, ResultType, GeometryFactory > | |
     Bempp::NumericalQuadratureStrategy< BasisFunctionType, ResultType > | Numerical quadrature strategy |
 Fiber::RaviartThomas0BasisTraits< elementVertexCount, CoordinateType, ValueType > | |
 Fiber::RaviartThomas0BasisTraits< 3, CoordinateType, ValueType > | |
 Fiber::RawGridGeometry< CoordinateType > | |
 Fiber::ScalarFunctionValueElementaryFunctor< CoordinateType_ > | |
 Fiber::ScalarFunctionValueTimesNormalElementaryFunctor< CoordinateType_ > | |
 Fiber::ScalarTraits< T > | Traits of scalar types |
 Fiber::ScalarTraits< double > | |
 Fiber::ScalarTraits< float > | |
 Fiber::ScalarTraits< std::complex< double > > | |
 Fiber::ScalarTraits< std::complex< float > > | |
 Fiber::SerialBlasRegion | Management of the number of threads used by BLAS and LAPACK |
 Fiber::Shapeset< BasisFunctionType > | Collection of shape functions defined on a reference element |
  Fiber::Basis< BasisFunctionType > | |
   Fiber::ConstantScalarShapeset< BasisFunctionType > | |
 Fiber::SimpleScalarKernelTrialIntegrandFunctor< BasisFunctionType_, KernelType_, ResultType_ > | |
 Fiber::SimpleTestScalarKernelTrialIntegrandFunctor< BasisFunctionType_, KernelType_, ResultType_ > | Functor evaluating the integrand of the simplest boundary integral operator |
 Fiber::SimpleTestScalarKernelTrialIntegrandFunctorExt< BasisFunctionType_, KernelType_, ResultType_, transformationDim > | |
 Fiber::SimpleTestTrialIntegrandFunctor< BasisFunctionType_, ResultType_ > | Functor evaluating the integrand of the standard identity operator |
 Fiber::SingleComponentTestTrialIntegrandFunctor< BasisFunctionType_, ResultType_ > | This functor evaluates the integrand having the form of the product of a single component of a test function transformation and a single component of a trial function transformation |
 Fiber::SingleQuadratureDescriptor | Parameters of a quadrature rule used in the evaluation of integrals over single elements |
 Fiber::SingleQuadratureRuleFamily< CoordinateType > | Family of quadrature rules over single elements |
  Fiber::DefaultSingleQuadratureRuleFamily< CoordinateType > | Default family of quadrature rules over single elements |
 Fiber::SurfaceCurl3dElementaryFunctor< CoordinateType_ > | |
 Fiber::SurfaceDiv3dElementaryFunctor< CoordinateType_ > | |
 Fiber::SurfaceGrad3dElementaryFunctor< CoordinateType_ > | |
 Fiber::TestFunctionIntegrator< BasisFunctionType, ResultType > | Integration of products of test functions and arbitrary functions over elements |
  Fiber::NumericalTestFunctionIntegrator< BasisFunctionType, UserFunctionType, ResultType, GeometryFactory > | Integration over pairs of elements on tensor-product point grids |
 Fiber::TestKernelTrialIntegral< BasisFunctionType_, KernelType_, ResultType_ > | An integral representing the weak form of an integral operator |
  Fiber::TypicalTestScalarKernelTrialIntegralBase< BasisFunctionType_, KernelType_, ResultType_ > | |
   Fiber::TypicalTestScalarKernelTrialIntegral< BasisFunctionType_, KernelType_, ResultType_ > | Implementation of the TestKernelTrialIntegral interface for "typical" integrals, taking advantage of BLAS during quadrature |
 Fiber::TestKernelTrialIntegrator< BasisFunctionType, KernelType, ResultType > | Integration over pairs of elements |
  Fiber::NonseparableNumericalTestKernelTrialIntegrator< BasisFunctionType, KernelType, ResultType, GeometryFactory > | Integration over pairs of elements on non-tensor-product point grids |
  Fiber::SeparableNumericalTestKernelTrialIntegrator< BasisFunctionType, KernelType, ResultType, GeometryFactory > | Integration over pairs of elements on tensor-product point grids |
 Fiber::TestScalarKernelTrialIntegrandFunctor< BasisFunctionType_, KernelType_, ResultType_ > | Functor evaluating the integrand of most standard boundary integral operators |
 Fiber::TestTrialIntegral< BasisFunctionType_, ResultType_ > | |
 Fiber::TestTrialIntegrator< BasisFunctionType, ResultType > | Integration of products of test and trial functions over elements |
  Fiber::NumericalTestTrialIntegrator< BasisFunctionType, ResultType, GeometryFactory > | Integration over pairs of elements on tensor-product point grids |
 Fiber::VerbosityLevel | Verbosity level |
 Fiber::Function< Functor::ValueType > | |
  Fiber::SurfaceNormalDependentFunction< Functor > | Function defined via a user-supplied functor, depending on global coordinates and on the surface normal |
  Fiber::SurfaceNormalIndependentFunction< Functor > | Function defined via a user-supplied functor, depending only on global coordinates |
 Fiber::Function< UserFunctionType > | |
 Fiber::KernelTrialIntegral< IntegrandFunctor::BasisFunctionType, IntegrandFunctor::KernelType, IntegrandFunctor::ResultType > | |
  Fiber::DefaultKernelTrialIntegral< IntegrandFunctor > | |
 Fiber::ModifiedHelmholtz3dSingleLayerPotentialKernelFunctor< ValueType > | |
 Bempp::Point3D< CoordinateType > | |
 Bempp::PotentialOperator< BasisFunctionType_, ScalarTraits< BasisFunctionType_ >::ComplexType > | |
  Bempp::ElementaryPotentialOperator< BasisFunctionType_, ScalarTraits< BasisFunctionType_ >::ComplexType, ScalarTraits< BasisFunctionType_ >::ComplexType > | |
   Bempp::Helmholtz3dPotentialOperatorBase< Impl, BasisFunctionType_ > | Base class for potential operators for the Helmholtz equation in 3D |
   Bempp::ModifiedHelmholtz3dPotentialOperatorBase< Impl, BasisFunctionType_ > | Base class for potential operators for the modified Helmholtz equation in 3D |
   Bempp::Helmholtz3dPotentialOperatorBase< Helmholtz3dDoubleLayerPotentialOperatorImpl< BasisFunctionType_ >, BasisFunctionType_ > | |
    Bempp::Helmholtz3dDoubleLayerPotentialOperator< BasisFunctionType_ > | Double-layer potential operator for the Helmholtz equation in 3D |
   Bempp::Helmholtz3dPotentialOperatorBase< Helmholtz3dFarFieldDoubleLayerPotentialOperatorImpl< BasisFunctionType_ >, BasisFunctionType_ > | |
    Bempp::Helmholtz3dFarFieldDoubleLayerPotentialOperator< BasisFunctionType_ > | Part of the far-field pattern of a radiating solution of the Helmholtz equation in 3D |
   Bempp::Helmholtz3dPotentialOperatorBase< Helmholtz3dFarFieldSingleLayerPotentialOperatorImpl< BasisFunctionType_ >, BasisFunctionType_ > | |
    Bempp::Helmholtz3dFarFieldSingleLayerPotentialOperator< BasisFunctionType_ > | Part of the far-field pattern of a radiating solution of the Helmholtz equation in 3D |
   Bempp::Helmholtz3dPotentialOperatorBase< Helmholtz3dSingleLayerPotentialOperatorImpl< BasisFunctionType_ >, BasisFunctionType_ > | |
    Bempp::Helmholtz3dSingleLayerPotentialOperator< BasisFunctionType_ > | Single-layer potential operator for the Helmholtz equation in 3D |
   Bempp::Helmholtz3dPotentialOperatorBase< Maxwell3dDoubleLayerPotentialOperatorImpl< BasisFunctionType_ >, BasisFunctionType_ > | |
    Bempp::Maxwell3dDoubleLayerPotentialOperator< BasisFunctionType_ > | Double-layer potential operator for the Maxwell equations in 3D |
   Bempp::Helmholtz3dPotentialOperatorBase< Maxwell3dFarFieldDoubleLayerPotentialOperatorImpl< BasisFunctionType_ >, BasisFunctionType_ > | |
    Bempp::Maxwell3dFarFieldDoubleLayerPotentialOperator< BasisFunctionType_ > | Far-field limit of the double-layer potential operator for the Maxwell equations in 3D |
   Bempp::Helmholtz3dPotentialOperatorBase< Maxwell3dFarFieldSingleLayerPotentialOperatorImpl< BasisFunctionType_ >, BasisFunctionType_ > | |
    Bempp::Maxwell3dFarFieldSingleLayerPotentialOperator< BasisFunctionType_ > | Far-field limit of the single-layer potential operator for the Maxwell equations in 3D |
   Bempp::Helmholtz3dPotentialOperatorBase< Maxwell3dSingleLayerPotentialOperatorImpl< BasisFunctionType_ >, BasisFunctionType_ > | |
    Bempp::Maxwell3dSingleLayerPotentialOperator< BasisFunctionType_ > | Single-layer potential operator for the Maxwell equations in 3D |
   Bempp::ModifiedHelmholtz3dPotentialOperatorBase< ModifiedHelmholtz3dDoubleLayerPotentialOperatorImpl< BasisFunctionType_ >, BasisFunctionType_ > | |
    Bempp::ModifiedHelmholtz3dDoubleLayerPotentialOperator< BasisFunctionType_ > | Double-layer potential operator for the modified Helmholtz equation in 3D |
   Bempp::ModifiedHelmholtz3dPotentialOperatorBase< ModifiedHelmholtz3dSingleLayerPotentialOperatorImpl< BasisFunctionType_ >, BasisFunctionType_ > | |
    Bempp::ModifiedHelmholtz3dSingleLayerPotentialOperator< BasisFunctionType_ > | Single-layer potential operator for the modified Helmholtz equation in 3D |
 Fiber::QuadratureDescriptorSelectorForGridFunctions< ScalarTraits< BasisFunctionType >::RealType > | |
  Fiber::DefaultQuadratureDescriptorSelectorForGridFunctions< BasisFunctionType > | Default implementation of a quadrature descriptor selector used during the discretization of functions |
 Fiber::QuadratureDescriptorSelectorForIntegralOperators< ScalarTraits< BasisFunctionType >::RealType > | |
  Fiber::DefaultQuadratureDescriptorSelectorForIntegralOperators< BasisFunctionType > | Default implementation of a quadrature descriptor selector used during the discretization of boundary integral operators |
 Fiber::QuadratureDescriptorSelectorForLocalOperators< ScalarTraits< BasisFunctionType >::RealType > | |
  Fiber::DefaultQuadratureDescriptorSelectorForLocalOperators< BasisFunctionType > | Default implementation of a quadrature descriptor selector used during the discretization of local boundary operators |
 Fiber::QuadratureDescriptorSelectorForPotentialOperators< BasisFunctionType > | |
  Fiber::DefaultQuadratureDescriptorSelectorForPotentialOperators< BasisFunctionType > | Default implementation of a quadrature descriptor selector used during the evaluation of potentials |
 Fiber::ScalarTraits< ResultType > | |
 Fiber::Shapeset< ValueType > | |
  Fiber::Basis< ValueType > | Collection of shape functions defined on a reference element |
   Fiber::ConstantScalarShapeset< ValueType > | A shapeset containing only one function: the constant function |
    Fiber::PiecewiseConstantScalarBasis< ValueType > | A shapeset containing only one function: the constant function |
   Fiber::LagrangeScalarShapeset< elementVertexCount, ValueType, polynomialOrder > | Shapeset composed of the Lagrange polynomials up to a specified order |
    Fiber::LagrangeScalarBasis< elementVertexCount, ValueType, polynomialOrder > | Shapeset composed of the Lagrange polynomials up to a specified order |
   Fiber::LinearScalarShapeset< elementVertexCount, ValueType > | Shapeset composed of the linear nodal functions |
    Fiber::PiecewiseLinearContinuousScalarBasis< elementVertexCount, ValueType > | Shapeset composed of the linear nodal functions |
    Fiber::PiecewiseLinearContinuousScalarBasis< 3, ValueType > | |
   Fiber::LinearScalarShapesetBarycentric< ValueType > | |
   Fiber::RaviartThomas0Shapeset< elementVertexCount, ValueType > | Shapeset composed of the lowest-order Raviart-Thomas functions |
    Fiber::RaviartThomas0Basis< elementVertexCount, ValueType > | Shapeset composed of the lowest-order Raviart-Thomas functions |
 exception | |
  Bempp::NotImplementedError | Exception thrown on attempt to access an unimplemented feature |
 Fiber::TestKernelTrialIntegral< BasisFunctionType, KernelType, ResultType > | |
 Fiber::TestKernelTrialIntegral< BasisFunctionType_, BasisFunctionType_, ResultType_ > | |
  Fiber::TypicalTestScalarKernelTrialIntegralBase< BasisFunctionType_, BasisFunctionType_, ResultType_ > | |
   Fiber::TypicalTestScalarKernelTrialIntegral< BasisFunctionType_, BasisFunctionType_, ResultType_ > | |
 Fiber::TestKernelTrialIntegral< CoordinateType_, std::complex< CoordinateType_ >, std::complex< CoordinateType_ > > | |
  Fiber::TypicalTestScalarKernelTrialIntegralBase< CoordinateType_, std::complex< CoordinateType_ >, std::complex< CoordinateType_ > > | |
   Fiber::TypicalTestScalarKernelTrialIntegral< CoordinateType_, std::complex< CoordinateType_ >, std::complex< CoordinateType_ > > | |
 Fiber::TestKernelTrialIntegral< std::complex< CoordinateType_ >, CoordinateType_, std::complex< CoordinateType_ > > | |
  Fiber::TypicalTestScalarKernelTrialIntegralBase< std::complex< CoordinateType_ >, CoordinateType_, std::complex< CoordinateType_ > > | |
   Fiber::TypicalTestScalarKernelTrialIntegral< std::complex< CoordinateType_ >, CoordinateType_, std::complex< CoordinateType_ > > | |
 Fiber::TestTrialIntegral< BasisFunctionType, ResultType > | |
 Fiber::TestTrialIntegral< IntegrandFunctor::BasisFunctionType, IntegrandFunctor::ResultType > | |
  Fiber::DefaultTestTrialIntegral< IntegrandFunctor > | |
 DefaultSpmdVector | |
  Bempp::Vector< ValueType > | Encapsulation of a vector |
 LinearOpDefaultBase | |
  Bempp::DiscreteBoundaryOperator< ValueType > | Discrete boundary operator |
  Bempp::RealWrapperOfComplexThyraLinearOperator< ValueType > | |
  Bempp::DiscreteBoundaryOperator< std::complex< RealType > > | |
 PreconditionerBase | |
  Bempp::RealWrapperOfComplexThyraPreconditioner< ValueType > | |