References

IFGF.IFGFOpType
struct IFGFOp{T} <: AbstractMatrix{T}

High-level structure representing a linear operator with elements of type T with entry i,j given by K(X[i],Y[j]), where K is the underlying kernel function, and X and Y are the elements of the target_tree and source_tree, respectively.

Fields:

  • kernel : underlying kernel function
  • target_tree : tree structure used for clustering the target points
  • source_tree : tree structure used for clustering the source points
  • p::NTuple: number of chebyshev poins per dimension used in the interpolation of far interactions
  • ds_func : function used to compute and appropriate mesh size in parameter space. See e.g. cone_domain_size_func
  • adm_func : function used to determine if the block with targets on box A and sources on box B admit a low-rank approximation
  • _source_tree_depth_partition : vector with i-th entry containing all nodes of the of depth i-1, where the root is given a depth of 0.
source
IFGF.SourceTreeDataType
mutable struct SourceTreeData{N,T,V}

Struct used to store data associated with a node of the SourceTree. The parametric type N represents the ambient dimension, T represents the primitive type used to represent the points (e.g. Float32 or Float64 for single/double precision), and V is the type of the density that will be interpolated.

Fields:

  • msh: uniform cartesian mesh of the interpolation space, indexable by a CartesianIndex
  • conedatadict: dictionary mapping a cone tag I::CartesianIndex to an Array storing its interpolation values/coefficient.
  • farlist: nodes on the target tree that can be evaluated through interpolation
  • nearlist: nodes on the target tree that must be evaluated by a direct sum.
source
IFGF.TargetTreeType
const TargetTree{N,T}

Type alias for a ClusterTree of points (represented as SVector{N,T}) containing no additional data. See the documentation of ClusterTree in WavePropBase for more information.

source
IFGF._addnewcone!Method
_addnewcone!(node::SourceTree,I::CartesianIndex,p)

If node does not contain cone I, add it to the conedict.

source
IFGF._density_type_from_kernel_typeMethod
_density_type_from_kernel_type(T)

Helper function to compute the expected density V type associated with a kernel type T. For T<:Number, simply return T. For T<:SMatrix, return an SVector with elements of the type eltype(T) and of length size(T,2) so that multiplying an element of type T with an element of type V makes sense.

source
IFGF._init_msh!Method
_init_msh!(node,domain,ds)

Create a uniform cartesian mesh of the interpolation domain of node with element spacing ds.

source
IFGF.allocate_interpolant_data!Method
allocate_interpolant_data!(node::SourceTree,::Val{P},[I])

Allocate the memory necessary to construct the I cone interpolant of node with P points, where P is a tuple of integers. If I is absent, allocate data for all cone interpolants of node.

source
IFGF.assemble_ifgfMethod
assemble_ifgf(K,X,Y;nmax=100,adm=modified_admissibility_condition,order=nothing,tol=1e-4,Δs=1.0,threads=true)

Construct an approximation of the matrix [K(x,y) for x ∈ X, y ∈ Y]. If the kernel function K is oscillatory, you should implement the method wavenumber(::typeof(K)) --> Number to return its wavenumber.

The error in the approximation is controlled by two parameters: Δs and order. These parameters dictate the mesh size and interpolation order of the parametric space used to build the cone interpolants. While the order is held constant across all source cells, the Δs parameter controls only the size of the low-frequency cells; for cells of large acoustic size, the mesh size is adapted so as to keep the interpolation error constant across different levels of the source tree (see cone_domain_size_func for implementation details).

If the keyword order is ommited, a tolerance tol must be passed. It will then be used to estimate an appropriate interpolation order.

nmax can be used to control the maximum number of points contained in the target/source trees.

The adm function gives a criterion to determine if the interaction between a target cell and a source cell should be computed using an interpolation scheme.

source
IFGF.cart2interpMethod
cart2interp(x,c,h)
cart2interp(x,source::SourceTree)

Map cartesian coordinates x into interpolation coordinates s centered at c and scaled by h. Interpolation coordinates are similar to hyperspherical coordinates (e.g. polar in two-dimensions and spherical in three-dimensions), except that the radial coordinates is replaced by s=h/r.

If passed a SourceTree, use its center and radius as c and h respectively.

source
IFGF.centered_factorMethod
centered_factor(K,x,Y::SourceTree)

Return a representative value of K(x,y) for y ∈ Y. This is used to help the interpolation of I(x) = ∑ᵢ K(x,yᵢ) where yᵢ ∈ Y and points x in the far field of Y. Defaults to K(x,yc) where yc is the center of Y.

source
IFGF.cheb2nodesMethod
cheb2nodes(n,[domain])
cheb2nodes(p::NTuple,[domain])
cheb2nodes(::Val{P},[domain])

Return the n Chebyshev nodes of the second kind on the interval [-1,1].

If passed a tuple p, return the tensor product of one-dimensinal nodes of size p.

If passed a Val{P}, statically compute the tensor product nodes.

Finally, passing a domain::HyperRectangle shifts the interpolation nodes to it.

lb = (0.,0.)
ub = (3.,2.)
domain = HyperRectangle(lb,ub)
cheb2nodes((10,5),domain) # generate `10×5` Chebyshev nodes on the `[0,3]×[0,2]` rectangle.
source
IFGF.cheb_error_estimateMethod
cheb_error_estimate(coefs::AbstractArray{T,N},dim)

Given an N dimensional array of coefficients , estimate the relative error commited by the Chebyshev interpolant along dimension dim.

source
IFGF.compute_cone_list!Method
compute_cone_list!(ifgf::IFGFOperator)

For each node in source_tree(ifgf), compute the cones which are necessary to cover both the target points on its farlist as well as the interpolation points on its parent's cones. The polynomial_order(ifgf) and meshsize_func(ifgf) are used to construct the appropriate interpolation domains and points.

source
IFGF.compute_interaction_list!Function
compute_interaction_list!(ifgf::IFGFOperator,adm)

For each node in source_tree(ifgf), compute its nearlist and farlist. The nearlist contains all nodes in target_tree(ifgf) for which the interaction must be computed using the direct summation. The farlist includes all nodes in target_tree for which an accurate interpolant in available in the source node.

The adm function is called through adm(target,source) to determine if target is in the farlist of source. When that is not the case we recurse on their children unless both are a leaves, in which case target is added to the nearlist of source.

source
IFGF.compute_interpolation_domainMethod
compute_interpolation_domain(source::SourceTree)

Compute the minimal domain (as a HyperRectangle) in interpolation space for which source must provide a covering through its cone interpolants.

source
IFGF.cone_domain_size_funcMethod
cone_domain_size_func(Δs₀::NTuple{N,T},k)

Returns an anonymous function (node) -> Δs that computes an appropriate size Δs for the interpolation domain of node given an intial size Δs₀ and a wavenumber k. The function is constructed so as to scale Δs₀ by the inverse of the acoustic size of node.

source
IFGF.cone_indexMethod
cone_index(x::SVector,tree::SourceTree)

Given a point x in cartesian coordinates, return the index I of the cone in source to whcih x belongs, as well as its parametric coordinate s.

See also: cart2interp

source
IFGF.element_indexMethod
element_index(s::SVector,m::UniformCartesianMesh)

Given a point s ∈ m, return the index I of the element in m containing s.

source
IFGF.free_interpolant_data!Method
free_interpolant_data!(node,[I])

Free the memory used to store the I cone interpolant of node. If I is absent, free data associated to all cone interpolants of node

source
IFGF.initialize_source_treeMethod
initialize_source_tree(;points,datatype,splitter,Xdatatype)

Create the tree-structure for clustering the source points using the splitting strategy of splitter, returning a SourceTree built through the empty constructor (i.e. data = SourceTreeData()).

Arguments

  • points: vector of source points.
  • splitter: splitting strategy.
  • Xdatatype: type container of target points.
  • Vdatatype: type of value stored at interpolation nodes
source
IFGF.initialize_target_treeMethod
initialize_target_tree(;points,splitter)

Create the tree-structure for clustering the target points using the splitting strategy of splitter. Returns a TargetTree.

source
IFGF.interp2cartMethod
interp2cart(s,xc,h)
interp2cart(s,source::SourceTree)

Map interpolation coordinate s into the corresponding cartesian coordinates.

Interpolation coordinates are similar to polar (in 2d) or spherical (in 3d) coordinates centered at the xc, except that the radial coordinate r is replaced by s = h/r.

If passed a SourceTree as second argument, call interp2cart(s,xc,h) with xc the center of the SourceTree and h its radius.

source
IFGF.modified_admissibility_conditionMethod
modified_admissible_condition(target,source,[η])

A target and source are admissible under the modified admissiblility condition (MAC) if the target box lies farther than r*η away, where r is the radius of the source box and η >= 1 is an adjustable parameter. By default, η = N / √N, where N is the ambient dimension.

source
IFGF.near_interaction!Method
near_interaction!(C,K,X,Y,σ,I,J)

Compute C[i] <-- C[i] + ∑ⱼ K(X[i],Y[j])*σ[j] for i ∈ I, j ∈ J. The default implementation simply does a double loop over all i ∈ I and j ∈ J, but you override this method for the type of your own custom kernel K if you have a fast way of computing the full product in-place (e.g. using SIMD instructions).

source
IFGF.transfer_factorMethod
transfer_factor(K,x,Y::SourceTree)

Ratio between the centered factor of Y and the centered factor of its parent.

source
IFGF.wavenumberFunction
wavenumber(K::Function)

For oscillatory kernels, return the characteristic wavenumber (i.e divided by he wavelength). For non-oscillatory kernels, return 0.

source
LinearAlgebra.mul!Method
mul!(y,A::IFGFOp,x,a,b;global_index=true,threads=true)

Like the mul! function from LinearAlgebra. Setting global_index=false uses the internal indexing system of the IFGFOp, and therefore does not permute the vectors x and y to perform the multiplication.

source
IFGF.@hprofileMacro
@hprofile

A macro which

  • resets the default TimerOutputs.get_defaulttimer to zero
  • execute the code block
  • print the profiling details

This is useful as a coarse-grained profiling strategy to get a rough idea of where time is spent. Note that this relies on TimerOutputs annotations manually inserted in the code.

source
WavePropBase.Trees.ClusterTreeType
mutable struct ClusterTree{T,S,D}

Tree structure used to cluster elements of type V = eltype(T) into containers of type S. The method center(::V)::SVector is required for the clustering algorithms. An additional data field of type D can be associated with each node to store node-specific information (it defaults to D=Nothing).

Fields:

  • _elements::T : vector containing the sorted elements.
  • container::S : container for the elements in the current node.
  • index_range::UnitRange{Int} : indices of elements contained in the current node.
  • loc2glob::Vector{Int} : permutation from the local indexing system to the original (global) indexing system used as input in the construction of the tree.
  • children::Vector{ClusterTree{N,T,D}}
  • parent::ClusterTree{N,T,D}
  • data::D : generic data field of type D.
WavePropBase.Trees.AbstractSplitterType
abstract type AbstractSplitter

An AbstractSplitter is used to split a ClusterTree. The interface requires the following methods:

  • should_split(clt,splitter) : return a Bool determining if the ClusterTree should be further divided
  • split!(clt,splitter) : perform the splitting of the ClusterTree handling the necessary data sorting.

See GeometricSplitter for an example of an implementation.

WavePropBase.Trees.CardinalitySplitterType
struct CardinalitySplitter <: AbstractSplitter

Used to split a ClusterTree along the largest dimension if length(tree)>nmax. The split is performed so the data is evenly distributed amongst all children.

See also: AbstractSplitter

Missing docstring.

Missing docstring for mul!. Check Documenter's build log for details.