include("SplineBasisConstruction.jl");
A spline is a piecewise polynomial function, formed by joining together several polynomial segments with specified continuities at the breakpoints. Splines are used in computer-aided design, computer graphics, and higher-order finite element analysis. If you've seen or used workflows that look like this, you've used splines:
Under the hood, splines are represented using a basis. When you drag the control points of a spline (the circles in the above image), you are changing the contributions of each basis function. In order for the spline to have the desired continuity at the breakpoints, this basis must be constructed with the correct continuity. In addition, there are other properties that the basis must posess in order to be useful for design. These properties are summarized in the following table:
Property | Description |
---|---|
Partition of unity | The sum of all basis functions evaluated at any point in the domain is one. |
Positivity | The basis functions are all non-negative over the entire domain. |
Local Support | Each basis function is nonzero on the smallest possible number of contiguous cells. |
These properties make dragging a control point for a spline cause an intuitive change in the spline itself. In other words, the spline "follows" the control points. This notebook will discuss the construction of a basis for a spline that has these desired properties.
Splines may be defined over a set of "elements"; each element is the domain of one of the polynomial segments. The spline is then a map from an element id, coordinate pair to the real numbers. The element ids run from 1 to ne, and the polynomial argument on each element ξ∈[0,1]. The spline map may therefore be written as
N:1,...,ne×[0,1]→IR,or in terms of its basis {NA}nbA=1 (where nb is the number of basis functions) as
N(e,ξ)=∑AdANA(e,ξ)e∈1,...,ne,ξ∈[0,1],where dA∈IR,A=1,...,nb are the control points. The spline may also map to other spaces (e.g. IR2, as in the figure above) by expanding the basis functions with control points from the desired space.
The problem under consideration is this: Given a desired polynomial degree on each element and a desired continuity between each pair of neighboring elements, construct the basis {NA}nbA=1.
To build the basis for the entire spline domain, we must first start with bases for each polynomial element. The spline bases will be built as a linear combination of these basis functions, with appropriate constraints to enforce the continuity between elements. One basis for the space of polynomials of degree at most p are the Bernstein polynomials. The Bernstein polynomials of degree p are defined as Bpi(ξ)=(pi)(1−ξ)p−iξi,i=0,...,p.
and are shown for p=1,2,3,4 here:
b = [ Plots.plot( [ bernstein( p, i ) for i in 0:p ], 0:0.01:1, legend = false ) for p in 1:4 ]
plt = Plots.plot( b[1], b[2], b[3], b[4],
title = ["p=1" "p=2" "p=3" "p=4"],
legend = false, layout = (1,4),
lw = 3, size = [700, 180] )
As an example, a spline with three elements, of degree 2, 3, and 1, respectively, has the following set of Bernstein bases on it:
mesh = Mesh( [2,3,1], [] );
plt = Plots.plot( legend = false, size = [600, 200] );
plotLocalBases!( plt, mesh )
These Bernstein basis functions are numbered in the spline context based on the location of their maximum, from left to right, and are denoted simply as Bi(ξ). We will denote the number of Bernstein functions on the mesh as m=ne∑e=1pe+1.
A Bernstein basis function may be considered to be zero outside of the element over which it is defined. Each spline basis function may be written as a linear combination of these Bernstein functions as
NA(e,ξ)=m∑i=1CAiBi(e,ξ).The continuity constraints between the elements allow us to solve for the coefficients CAi.
At each interface between neighboring elements ej and ej+1, the prescribed continuity is denoted as kj. In order to enforce Ckj continuity the following relationships must hold:
∑iCAiBi(ej,1)=∑iCAiBi(ej+1,0)A=1,...,nb;∑iddξCAiBi(ej,1)=∑iddξCAiBi(ej+1,0)A=1,...,nb;⋮∑idkjdξkjCAiBi(ej,1)=∑idkjdξkjCAiBi(ej+1,0)A=1,...,nb;These constraints may be rewritten as a null space problem as follows:
[B1(1,1)−B1(2,0)B2(1,1)−B2(2,0)⋯Bm(1,1)−Bm(2,0)B′1(1,1)−B′1(2,0)B′2(1,1)−B′2(2,0)⋯B′m(1,1)−B′m(2,0)⋮B(k1)1(1,1)−B(k1)1(2,0)B(k1)2(1,1)−B(k1)2(2,0)⋯B(k1)m(1,1)−B(k1)m(2,0)B1(2,1)−B1(3,0)B2(2,1)−B2(3,0)⋯Bm(2,1)−Bm(3,0)B′1(2,1)−B′1(3,0)B′2(2,1)−B′2(3,0)⋯B′m(2,1)−B′m(3,0)⋮B(k2)1(2,1)−B(k2)1(3,0)B(k2)2(2,1)−B(k2)2(3,0)⋯B(k2)m(2,1)−B(k2)m(3,0)⋮B1(ne−1,1)−B1(ne,0)B2(ne−1,1)−B2(ne,0)⋯Bm(ne−1,1)−Bm(ne,0)B′1(ne−1,1)−B′1(ne,0)B′2(ne−1,1)−B′2(ne,0)⋯B′m(ne−1,1)−B′m(ne,0)⋮B(kne−1)1(ne−1,1)−B(kne−1)1(ne,0)B(kne−1)2(ne−1,1)−B(kne−1)2(ne,0)⋯B(kne−1)m(ne−1,1)−B(kne−1)m(ne,0)](C1C2⋮Cm)=(00⋮0)Note that because each Bernstein function is zero over most of the elements, and because of the root multiplicity property of Berstein polynomials, the matrix will often be mostly zeros. For example, on the mesh pictured in the polynomial basis section, with k1=1 and k2=0, the following matrix encodes the continuity constraints:
mesh = Mesh( [2 3 1], [1 0] )
S = buildS( mesh )
display(S)
3×9 Array{Float64,2}: 0.0 0.0 1.0 -1.0 -0.0 -0.0 -0.0 0.0 0.0 0.0 -2.0 2.0 3.0 -3.0 -0.0 -0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 1.0 -1.0 -0.0
There are plenty of methods for solving nullspace problems, including built in functions in Numpy and Julia. However, these methods do not create a basis with the desired properties listed in the table above. For example, if we compute the nullspace of the matrix S that we just computed, we get basis functions that are negative on some areas of the domain, basis functions that span the entire domain, and the basis as a whole does not satisfy the partition of unity:
N = LinearAlgebra.nullspace( S )
plt = Plots.plot( legend = false, size=[500,200] )
plotSplineBasis!( plt, mesh, N )
plt
Instead, for each basis function we wish to compute we can take the approach of finding the smallest number of rows of the matrix which will create a nullspace of dimension one, and solve for that nullspace. This is equivalent to finding the smallest number of Bernstein functions that must be combined to create a spline basis function, and the resulting spline basis functions will satisfy the Local Support property. Based on the properties of the continuity constraints, the following algorithms will find these minimum sets of Bernstein functions, returning them as a pair of integers, {imin,imax}:
function findSupports( mesh::Mesh )
function findSupport!( mesh::Mesh, localfunc::LocalFunc, corners=[] )
# ----- Helper function -----
# Determines if spline function should extend into next element
function extendIntoNextCell( curr_localfunc::LocalFunc )
return curr_localfunc.elem != length( mesh.degrees ) &&
mesh.degrees[ curr_localfunc.elem ] - curr_localfunc.idx <= mesh.smoothnesses[ curr_localfunc.elem ]
end
# ----- Helper function -----
# Determines how many bernstein coefficients the spline function needs
# from the next element based on already active smoothness constraints
function nextCellExtension( curr_localfunc )
return mesh.smoothnesses[ curr_localfunc.elem ] - ( mesh.degrees[ curr_localfunc.elem ] - curr_localfunc.idx )
end
# ------ findSupport function body -----
curr_localfunc = localfunc
while extendIntoNextCell( curr_localfunc )
curr_localfunc = LocalFunc( curr_localfunc.elem + 1, nextCellExtension( curr_localfunc ) )
append!( corners, localToGlobal( mesh, curr_localfunc ) )
end
return [ localToGlobal( mesh, localfunc ) localToGlobal( mesh, curr_localfunc ) ]
end
corners = [];
supports = zeros( Integer, 0, 2 )
for localfunc in meshLocalFuncs( mesh )
if localToGlobal( mesh, localfunc ) in corners
continue
end
append!( corners, localToGlobal( mesh, localfunc ) )
supports = vcat( supports, findSupport!( mesh, localfunc, corners ) )
end
return supports
end;
supports = findSupports( mesh )
6×2 Array{Integer,2}: 1 1 2 4 3 5 6 6 7 8 9 9
These indices give us the following sub-matrices:
for row in 1:size( supports, 1 )
Ssub = S[:,supports[row,1]:supports[row,2]]
display(Ssub)
end
3×1 Array{Float64,2}: 0.0 0.0 0.0
3×3 Array{Float64,2}: 0.0 1.0 -1.0 -2.0 2.0 3.0 0.0 0.0 0.0
3×3 Array{Float64,2}: 1.0 -1.0 -0.0 2.0 3.0 -3.0 0.0 0.0 0.0
3×1 Array{Float64,2}: -0.0 -0.0 0.0
3×2 Array{Float64,2}: -0.0 0.0 -0.0 0.0 1.0 -1.0
3×1 Array{Float64,2}: 0.0 0.0 -0.0
If we remove the zero rows from each matrix, and add an equation requiring the coefficient corresponding to the first column to be 1, we get full rank systems of the form
[Ssub100⋯0][c]=[00⋮01]which can be solved by inverting the matrix on the left side. Finally, once we have this solution for each subset of S, a partition of unity can be achieved by solving the equation
NTb=1where the columns of N are the solutions of the full-rank systems, using a least-squares solution. The final normalized basis is found by multiplying each column of N by the corresponding coefficient in b. This is implemented in the code below:
function computeCoefficients( S, support )
# Remove columns outside support, and any zero rows
Ssub = S[ vec( mapslices( col -> any( col[ support[1]:support[2] ] .!= 0 ), S, dims = 2 ) ), support[1]:support[2] ]
# Add the row [ 1 0 0 0 ... ] to the matrix to change nullspace problem into a full-rank system
Ssub = vcat( Ssub, hcat( [1.0], zeros( 1, length( support[1]:support[2] ) - 1 ) ) )
# rhs is [ 0 0 ... 0 1 ]'
b = vcat( zeros( size( Ssub, 1 ) - 1, 1 ), [1.0] )
# Solve for the coefficients
coeffs = zeros( size( S, 2 ), 1 )
coeffs[ support[1]:support[2], 1 ] = Ssub\b
return coeffs
end
function buildSplineBasis( mesh::Mesh )
S = buildS( mesh )
supports = findSupports( mesh )
n_lf = numLocalFunctions( mesh )
N = zeros( n_lf, size( supports, 1 ) )
for i in 1:size( supports, 1 )
N[:,i] = computeCoefficients( S, supports[ i, : ] )
end
# Normalize N with least-squares
c = N'*N \ ( N'*ones( n_lf, 1 ) )
return N.*c'
end;
Go ahead and change the values in the first line below to compute a spline basis for arbitrary degrees and continuities.
# Mesh([degrees], [continuities])
mesh = Mesh([4, 3, 2, 4], [2, 1, 2])
N = buildSplineBasis( mesh )
plt = Plots.plot( legend = false )
plotSplineBasis!( plt, mesh, N )
plt