33template<
typename Scalar>
59 CubicSpline(
const std::vector<Scalar>& X,
const std::vector<Scalar>& Y,
79 void setPoints(
const std::vector<Scalar>& x,
const std::vector<Scalar>& y)
88 std::vector<Scalar> rhs(n);
89 for (
size_t i = 1; i < n - 1; i++)
91 A(i, i - 1) = 1.0 / 3.0 * (x[i] - x[i - 1]);
92 A(i, i) = 2.0 / 3.0 * (x[i + 1] - x[i - 1]);
93 A(i, i + 1) = 1.0 / 3.0 * (x[i + 1] - x[i]);
94 rhs[i] = (y[i + 1] - y[i]) / (x[i + 1] - x[i]) - (y[i] - y[i - 1]) / (x[i] - x[i - 1]);
108 A(0, 0) = 2.0 * (x[1] - x[0]);
109 A(0, 1) = 1.0 * (x[1] - x[0]);
116 A(0, 0) = -(x[2] - x[1]);
117 A(0, 1) = x[2] - x[0];
118 A(0, 2) = -(x[1] - x[0]);
124 A(n - 1, n - 1) = 2.0;
125 A(n - 1, n - 2) = 0.0;
133 A(n - 1, n - 1) = 2.0 * (x[n - 1] - x[n - 2]);
134 A(n - 1, n - 2) = 1.0 * (x[n - 1] - x[n - 2]);
141 A(n - 1, n - 3) = -(x[n - 1] - x[n - 2]);
142 A(n - 1, n - 2) = x[n - 1] - x[n - 3];
143 A(n - 1, n - 1) = -(x[n - 2] - x[n - 3]);
153 for (
size_t i = 0; i < n - 1; i++)
156 coef_b[i] = (y[i + 1] - y[i]) / (x[i + 1] - x[i])
157 - 1.0 / 3.0 * (2.0 *
coef_c[i] +
coef_c[i + 1]) * (x[i + 1] - x[i]);
161 auto h = x[n - 1] - x[n - 2];
174 [[nodiscard]]
size_t size() const noexcept
205 [[nodiscard]] Scalar
derivative(
size_t order, Scalar x)
const
223 else if (x >
vals_x[n - 1])
230 return 2.0 *
coef_c[n - 1];
267 auto it = std::upper_bound(
vals_x.begin(),
vals_x.end(), x);
268 return static_cast<size_t>(std::max(
static_cast<int>(it -
vals_x.begin()) - 1, 0));
289 [[nodiscard]]
const Scalar&
operator()(
size_t i,
size_t j)
const
298 [[nodiscard]] std::vector<Scalar>
lu_solve(
const std::vector<Scalar>& b,
bool is_lu_decomposed =
false)
300 INS_ASSERT_USER_ERROR(
dim() == b.size(),
"The BandMatrix dimension must be the same as the vector b in the equation Ax = b.");
302 if (!is_lu_decomposed)
313 [[nodiscard]]
size_t dim()
const
333 for (
size_t i = 0; i <
dim(); i++)
335 assert(this->
operator()(i, i) != 0.0);
339 for (
size_t j = j_min; j <= j_max; j++)
347 for (
size_t k = 0; k <
dim(); k++)
350 for (
size_t i = k + 1; i <= i_max; i++)
352 assert(this->
operator()(k, k) != 0.0);
357 for (
size_t j = k + 1; j <= j_max; j++)
367 [[nodiscard]] std::vector<Scalar>
l_solve(
const std::vector<Scalar>& b)
const
369 INS_ASSERT_USER_ERROR(
dim() == b.size(),
"The BandMatrix dimension must be the same as the vector b in the equation Ax = b.");
371 std::vector<Scalar> x(
dim());
372 for (
size_t i = 0; i <
dim(); i++)
376 for (
size_t j = j_start; j < i; j++)
385 [[nodiscard]] std::vector<Scalar>
u_solve(
const std::vector<Scalar>& b)
const
387 INS_ASSERT_USER_ERROR(
dim() == b.size(),
"The BandMatrix dimension must be the same as the vector b in the equation Ax = b.");
389 std::vector<Scalar> x(
dim());
390 for (
size_t i =
dim(); i-- > 0;)
394 for (
size_t j = i + 1; j <= j_stop; j++)
398 x[i] = (b[i] - sum) / this->
operator()(i, i);
#define INS_ASSERT_USER_ERROR(_EXP, _MSG)
Assert function with message.
Definition Assert.h:21
Sparse matrix whose non-zero entries are confined to a diagonal band, comprising the main diagonal an...
Definition CubicSpline.hpp:273
std::vector< Scalar > lu_solve(const std::vector< Scalar > &b, bool is_lu_decomposed=false)
Definition CubicSpline.hpp:298
std::vector< std::vector< Scalar > > upperBand
upper diagonal band
Definition CubicSpline.hpp:403
std::vector< std::vector< Scalar > > lowerBand
lower diagonal band
Definition CubicSpline.hpp:404
BandMatrix(size_t dim, size_t nUpper, size_t nLower)
Constructor.
Definition CubicSpline.hpp:279
size_t dimLowerBand() const
Returns the dimension of the lower band.
Definition CubicSpline.hpp:323
Scalar & operator()(size_t i, size_t j)
Access operator i ∈ [i=0,...,dim()-1].
Definition CubicSpline.hpp:284
size_t dim() const
Returns the matrix dimension.
Definition CubicSpline.hpp:313
std::vector< Scalar > u_solve(const std::vector< Scalar > &b) const
Solves the equation Ux = b for x.
Definition CubicSpline.hpp:385
std::vector< Scalar > l_solve(const std::vector< Scalar > &b) const
Solves the equation Lx = b for x.
Definition CubicSpline.hpp:367
void lu_decompose()
Calculate the LU decomposition.
Definition CubicSpline.hpp:329
size_t dimUpperBand() const
Returns the dimension of the upper band.
Definition CubicSpline.hpp:318
const Scalar & operator()(size_t i, size_t j) const
Access operator i ∈ [i=0,...,dim()-1].
Definition CubicSpline.hpp:289
Cubic Spline class.
Definition CubicSpline.hpp:35
void setPoints(const std::vector< Scalar > &x, const std::vector< Scalar > &y)
Set the points/knots of the spline and calculate the spline coefficients.
Definition CubicSpline.hpp:79
size_t findClosestIdx(Scalar x) const
Finds the closest index so that vals_x[idx] <= x (return 0 if x < vals_x[0])
Definition CubicSpline.hpp:265
std::vector< Scalar > vals_y
y coordinates of the knots
Definition CubicSpline.hpp:253
void setBoundaries(BoundaryCondition leftBoundaryCondition, BoundaryCondition rightBoundaryCondition)
Set the boundaries conditions. Has to be called before setPoints.
Definition CubicSpline.hpp:70
CubicSpline(const std::vector< Scalar > &X, const std::vector< Scalar > &Y, BoundaryCondition leftBoundaryCondition={ BoundaryCondition::SecondDerivative, 0.0 }, BoundaryCondition rightBoundaryCondition={ BoundaryCondition::SecondDerivative, 0.0 })
Constructor.
Definition CubicSpline.hpp:59
std::vector< Scalar > coef_b
Spline coefficients b.
Definition CubicSpline.hpp:254
CubicSpline()=default
Default Constructor.
Scalar derivative(size_t order, Scalar x) const
Calculates the derivative of the spline.
Definition CubicSpline.hpp:205
Scalar coef_c0
Spline coefficient c0 for left extrapolation.
Definition CubicSpline.hpp:257
size_t size() const noexcept
Returns the size of the spline vector.
Definition CubicSpline.hpp:174
BoundaryCondition boundaryConditionRight
Boundary condition for the right knot.
Definition CubicSpline.hpp:260
std::vector< Scalar > coef_d
Spline coefficients d.
Definition CubicSpline.hpp:256
Scalar operator()(Scalar x) const
Interpolates or extrapolates a value on the spline.
Definition CubicSpline.hpp:182
std::vector< Scalar > coef_c
Spline coefficients c.
Definition CubicSpline.hpp:255
BoundaryCondition boundaryConditionLeft
Boundary condition for the left knot.
Definition CubicSpline.hpp:259
std::vector< Scalar > vals_x
x coordinates of the knots
Definition CubicSpline.hpp:252
Boundary conditions for the spline end-points.
Definition CubicSpline.hpp:39
BoundaryType type
Type of the boundary condition.
Definition CubicSpline.hpp:47
Scalar value
Value of the boundary condition.
Definition CubicSpline.hpp:48
BoundaryType
Boundary type.
Definition CubicSpline.hpp:42
@ NotAKnot
not-a-knot: At the first and last interior break, even the third derivative is continuous (up to roun...
Definition CubicSpline.hpp:45
@ FirstDerivative
First derivative has to match a certain value.
Definition CubicSpline.hpp:43
@ SecondDerivative
Second derivative has to match a certain value.
Definition CubicSpline.hpp:44