std.numeric
Source std/numeric.d
- enum
CustomFloatFlags
: int; - Format flags for CustomFloat.
signed
- Adds a sign bit to allow for signed numbers.
storeNormalized
- Store values in normalized form by default. The actual precision of the significand is extended by 1 bit by assuming an implicit leading bit of 1 instead of 0. i.e. 1.nnnn instead of 0.nnnn. True for all IEE754 types
allowDenorm
- Stores the significand in IEEE754 denormalized form when the exponent is 0. Required to express the value 0.
infinity
- Allows the storage of IEEE754 infinity values.
nan
- Allows the storage of IEEE754 Not a Number values.
probability
- If set, select an exponent bias such that max_exp = 1. i.e. so that the maximum value is >= 1.0 and < 2.0. Ignored if the exponent bias is manually specified.
negativeUnsigned
- If set, unsigned custom floats are assumed to be negative.
allowDenormZeroOnly
- If set, 0 is the only allowed IEEE754 denormalized number. Requires allowDenorm and storeNormalized.
ieee
- Include all of the IEEE754 options.
none
- Include none of the above options.
- template
CustomFloat
(uint bits) if (bits == 8 || bits == 16 || bits == 32 || bits == 64 || bits == 80)
templateCustomFloat
(uint precision, uint exponentWidth, CustomFloatFlags flags = CustomFloatFlags.ieee) if (((flags & flags.signed) + precision + exponentWidth) % 8 == 0 && (precision + exponentWidth > 0))
structCustomFloat
(uint precision, uint exponentWidth, CustomFloatFlags flags, uint bias) if (isCorrectCustomFloat(precision, exponentWidth, flags)); - Allows user code to define custom floating-point formats. These formats are for storage only; all operations on them are performed by first implicitly extracting them to real first. After the operation is completed the result can be stored in a custom floating-point value via assignment.Examples:
import std.math.trigonometry : sin, cos; // Define a 16-bit floating point values CustomFloat!16 x; // Using the number of bits CustomFloat!(10, 5) y; // Using the precision and exponent width CustomFloat!(10, 5,CustomFloatFlags.ieee) z; // Using the precision, exponent width and format flags CustomFloat!(10, 5,CustomFloatFlags.ieee, 15) w; // Using the precision, exponent width, format flags and exponent offset bias // Use the 16-bit floats mostly like normal numbers w = x*y - 1; // Functions calls require conversion z = sin(+x) + cos(+y); // Use unary plus to concisely convert to a real z = sin(x.get!float) + cos(y.get!float); // Or use get!T z = sin(cast(float) x) + cos(cast(float) y); // Or use cast(T) to explicitly convert // Define a 8-bit custom float for storing probabilities alias Probability = CustomFloat!(4, 4, CustomFloatFlags.ieee^CustomFloatFlags.probability^CustomFloatFlags.signed ); auto p = Probability(0.5);
- template
FPTemporary
(F) if (isFloatingPoint!F) - Defines the fastest type to use when storing temporaries of a calculation intended to ultimately yield a result of type F (where F must be one of float, double, or real). When doing a multi-step computation, you may want to store intermediate results as
FPTemporary
!F.The necessity ofFPTemporary
stems from the optimized floating-point operations and registers present in virtually all processors. When adding numbers in the example above, the addition may in fact be done in real precision internally. In that case, storing the intermediate result in double format is not only less precise, it is also (surprisingly) slower, because a conversion from real to double is performed every pass through the loop. This being a lose-lose situation,FPTemporary
!F has been defined as the fastest type to use for calculations at precision F. There is no need to define a type for the most accurate calculations, as that is always real. Finally, there is no guarantee that usingFPTemporary
!F will always be fastest, as the speed of floating-point calculations depends on very many factors.Examples:import std.math.operations : isClose; // Average numbers in an array double avg(in double[] a) { if (a.length == 0) return 0; FPTemporary!double result = 0; foreach (e; a) result += e; return result / a.length; } auto a = [1.0, 2.0, 3.0]; assert(isClose(avg(a), 2));
- template
secantMethod
(alias fun) - Implements the secant method for finding a root of the function fun starting from points [xn_1, x_n] (ideally close to the root). Num may be float, double, or real.Examples:
import std.math.operations : isClose; import std.math.trigonometry : cos; float f(float x) { return cos(x) - x*x*x; } auto x = secantMethod!(f)(0f, 1f); assert(isClose(x, 0.865474));
- T
findRoot
(T, DF, DT)(scope DFf
, const Ta
, const Tb
, scope DTtolerance
)
if (isFloatingPoint!T && is(typeof(tolerance
(T.init, T.init)) : bool) && is(typeof(f
(T.init)) == R, R) && isFloatingPoint!R);
TfindRoot
(T, DF)(scope DFf
, const Ta
, const Tb
); - Find a real root of a real function f(x) via bracketing.Given a function
f
and a range [a
..b
] such thatf
(a
) andf
(b
) have opposite signs or at least one of them equals ±0, returns the value of x in the range which is closest to a root off
(x). Iff
(x) has more than one root in the range, one will be chosen arbitrarily. Iff
(x) returns NaN, NaN will be returned; otherwise, this algorithm is guaranteed to succeed. Uses an algorithm based on TOMS748, which uses inverse cubic interpolation whenever possible, otherwise reverting to parabolic or secant interpolation. Compared to TOMS748, this implementation improves worst-case performance by a factor of more than 100, and typical performance by a factor of 2. For 80-bit reals, most problems require 8 to 15 calls tof
(x) to achieve full machine precision. The worst-case performance (pathological cases) is approximately twice the number of bits.References "On Enclosing Simple Roots of Nonlinear Equations", G. Alefeld, F.A. Potra, Yixun Shi, Mathematics of Computation 61, pp733-744 (1993). Fortran code available from www.netlib.org as algorithm TOMS478.
- Tuple!(T, T, R, R)
findRoot
(T, R, DF, DT)(scope DFf
, const Tax
, const Tbx
, const Rfax
, const Rfbx
, scope DTtolerance
)
if (isFloatingPoint!T && is(typeof(tolerance
(T.init, T.init)) : bool) && is(typeof(f
(T.init)) == R) && isFloatingPoint!R);
Tuple!(T, T, R, R)findRoot
(T, R, DF)(scope DFf
, const Tax
, const Tbx
, const Rfax
, const Rfbx
);
TfindRoot
(T, R)(scope R delegate(T)f
, const Ta
, const Tb
, scope bool delegate(T lo, T hi)tolerance
= (Ta
, Tb
) => false); - Find root of a real function f(x) by bracketing, allowing the termination condition to be specified.Parameters:
DF f
Function to be analyzed T ax
Left bound of initial range of f
known to contain the root.T bx
Right bound of initial range of f
known to contain the root.R fax
Value of f
(ax
).R fbx
Value of f
(bx
).fax
andfbx
should have opposite signs. (f
(ax
) andf
(bx
) are commonly known in advance.)DT tolerance
Defines an early termination condition. Receives the current upper and lower bounds on the root. The delegate must return true when these bounds are acceptable. If this function always returns false, full machine precision will be achieved. Returns:A tuple consisting of two ranges. The first two elements are the range (in x) of the root, while the second pair of elements are the corresponding function values at those points. If an exact root was found, both of the first two elements will contain the root, and the second pair of elements will be 0. - Tuple!(T, "x", Unqual!(ReturnType!DF), "y", T, "error")
findLocalMin
(T, DF)(scope DFf
, const Tax
, const Tbx
, const TrelTolerance
= sqrt(T.epsilon), const TabsTolerance
= sqrt(T.epsilon))
if (isFloatingPoint!T && __traits(compiles, () { T _ = DF.init(T.init); } )); - Find a real minimum of a real function
f
(x) via bracketing. Given a functionf
and a range (ax
..bx
), returns the value of x in the range which is closest to a minimum off
(x).f
is never evaluted at the endpoints ofax
andbx
. Iff
(x) has more than one minimum in the range, one will be chosen arbitrarily. Iff
(x) returns NaN or -Infinity, (x,f
(x), NaN) will be returned; otherwise, this algorithm is guaranteed to succeed.Parameters:DF f
Function to be analyzed T ax
Left bound of initial range of f known to contain the minimum. T bx
Right bound of initial range of f known to contain the minimum. T relTolerance
Relative tolerance. T absTolerance
Absolute tolerance. Preconditions
ax
andbx
shall be finite reals.
relTolerance
shall be normal positive real.
absTolerance
shall be normal positive real no less then T.epsilon*2.Returns:A tuple consisting of x, y =f
(x) and error = 3 * (absTolerance
* fabs(x) +relTolerance
). The method used is a combination of golden section search and successive parabolic interpolation. Convergence is never much slower than that for a Fibonacci search.References "Algorithms for Minimization without Derivatives", Richard Brent, Prentice-Hall, Inc. (1973)
See Also:Examples:import std.math.operations : isClose; auto ret = findLocalMin((double x) => (x-4)^^2, -1e7, 1e7); assert(ret.x.isClose(4.0)); assert(ret.y.isClose(0.0, 0.0, 1e-10));
- CommonType!(ElementType!Range1, ElementType!Range2)
euclideanDistance
(Range1, Range2)(Range1a
, Range2b
)
if (isInputRange!Range1 && isInputRange!Range2);
CommonType!(ElementType!Range1, ElementType!Range2)euclideanDistance
(Range1, Range2, F)(Range1a
, Range2b
, Flimit
)
if (isInputRange!Range1 && isInputRange!Range2); - Computes Euclidean distance between input ranges
a
andb
. The two ranges must have the same length. The three-parameter version stops computation as soon as the distance is greater than or equal tolimit
(this is useful to save computation if a small distance is sought). - CommonType!(ElementType!Range1, ElementType!Range2)
dotProduct
(Range1, Range2)(Range1a
, Range2b
)
if (isInputRange!Range1 && isInputRange!Range2 && !(isArray!Range1 && isArray!Range2));
CommonType!(F1, F2)dotProduct
(F1, F2)(in F1[]avector
, in F2[]bvector
);
FdotProduct
(F, uint N)(ref scope const F[N]a
, ref scope const F[N]b
)
if (N <= 16); - Computes the dot product of input ranges
a
and b. The two ranges must have the same length. If both ranges define length, the check is done once; otherwise, it is done at each iteration. - CommonType!(ElementType!Range1, ElementType!Range2)
cosineSimilarity
(Range1, Range2)(Range1a
, Range2b
)
if (isInputRange!Range1 && isInputRange!Range2); - Computes the cosine similarity of input ranges
a
and b. The two ranges must have the same length. If both ranges define length, the check is done once; otherwise, it is done at each iteration. If either range has all-zero elements, return 0. - bool
normalize
(R)(Rrange
, ElementType!Rsum
= 1)
if (isForwardRange!R); - Normalizes values in
range
by multiplying each element with a number chosen such that values sum up tosum
. If elements in range sum to zero, assigns sum / range.length to all. Normalization makes sense only if all elements inrange
are positive.normalize
assumes that is the case without checking it.Returns:true if normalization completed normally, false if all elements inrange
were zero or ifrange
is empty.Examples:double[] a = []; assert(!normalize(a)); a = [ 1.0, 3.0 ]; assert(normalize(a)); writeln(a); // [0.25, 0.75] assert(normalize!(typeof(a))(a, 50)); // a = [12.5, 37.5] a = [ 0.0, 0.0 ]; assert(!normalize(a)); writeln(a); // [0.5, 0.5]
- ElementType!Range
sumOfLog2s
(Range)(Ranger
)
if (isInputRange!Range && isFloatingPoint!(ElementType!Range)); - Compute the sum of binary logarithms of the input range
r
. The error of this method is much smaller than with a naive sum of log2.Examples:import std.math.traits : isNaN; writeln(sumOfLog2s(new double[0])); // 0 writeln(sumOfLog2s([0.0L])); // -real.infinity writeln(sumOfLog2s([-0.0L])); // -real.infinity writeln(sumOfLog2s([2.0L])); // 1 assert(sumOfLog2s([-2.0L]).isNaN()); assert(sumOfLog2s([real.nan]).isNaN()); assert(sumOfLog2s([-real.nan]).isNaN()); writeln(sumOfLog2s([real.infinity])); // real.infinity assert(sumOfLog2s([-real.infinity]).isNaN()); writeln(sumOfLog2s([0.25, 0.25, 0.25, 0.125])); // -9
- ElementType!Range
entropy
(Range)(Ranger
)
if (isInputRange!Range);
ElementType!Rangeentropy
(Range, F)(Ranger
, Fmax
)
if (isInputRange!Range && !is(CommonType!(ElementType!Range, F) == void)); - Computes entropy of input range
r
in bits. This function assumes (without checking) that the values inr
are all in [0, 1]. For the entropy to be meaningful, oftenr
should be normalized too (i.e., its values should sum to 1). The two-parameter version stops evaluating as soon as the intermediate result is greater than or equal tomax
. - CommonType!(ElementType!Range1, ElementType!Range2)
kullbackLeiblerDivergence
(Range1, Range2)(Range1a
, Range2b
)
if (isInputRange!Range1 && isInputRange!Range2); - Computes the Kullback-Leibler divergence between input ranges
a
andb
, which is the sum ai * log(ai / bi). The base of logarithm is 2. The ranges are assumed to contain elements in [0, 1]. Usually the ranges are normalized probability distributions, but this is not required or checked by kullbackLeiblerDivergence. If any element bi is zero and the corresponding element ai nonzero, returns infinity. (Otherwise, if ai == 0 && bi == 0, the term ai * log(ai / bi) is considered zero.) If the inputs are normalized, the result is positive.Examples:import std.math.operations : isClose; double[] p = [ 0.0, 0, 0, 1 ]; writeln(kullbackLeiblerDivergence(p, p)); // 0 double[] p1 = [ 0.25, 0.25, 0.25, 0.25 ]; writeln(kullbackLeiblerDivergence(p1, p1)); // 0 writeln(kullbackLeiblerDivergence(p, p1)); // 2 writeln(kullbackLeiblerDivergence(p1, p)); // double.infinity double[] p2 = [ 0.2, 0.2, 0.2, 0.4 ]; assert(isClose(kullbackLeiblerDivergence(p1, p2), 0.0719281, 1e-5)); assert(isClose(kullbackLeiblerDivergence(p2, p1), 0.0780719, 1e-5));
- CommonType!(ElementType!Range1, ElementType!Range2)
jensenShannonDivergence
(Range1, Range2)(Range1a
, Range2b
)
if (isInputRange!Range1 && isInputRange!Range2 && is(CommonType!(ElementType!Range1, ElementType!Range2)));
CommonType!(ElementType!Range1, ElementType!Range2)jensenShannonDivergence
(Range1, Range2, F)(Range1a
, Range2b
, Flimit
)
if (isInputRange!Range1 && isInputRange!Range2 && is(typeof(CommonType!(ElementType!Range1, ElementType!Range2).init >= F.init) : bool)); - Computes the Jensen-Shannon divergence between
a
and b, which is the sum (ai * log(2 * ai / (ai + bi)) + bi * log(2 * bi / (ai + bi))) / 2. The base of logarithm is 2. The ranges are assumed to contain elements in [0, 1]. Usually the ranges are normalized probability distributions, but this is not required or checked byjensenShannonDivergence
. If the inputs are normalized, the result is bounded within [0, 1]. The three-parameter version stops evaluations as soon as the intermediate result is greater than or equal tolimit
.Examples:import std.math.operations : isClose; double[] p = [ 0.0, 0, 0, 1 ]; writeln(jensenShannonDivergence(p, p)); // 0 double[] p1 = [ 0.25, 0.25, 0.25, 0.25 ]; writeln(jensenShannonDivergence(p1, p1)); // 0 assert(isClose(jensenShannonDivergence(p1, p), 0.548795, 1e-5)); double[] p2 = [ 0.2, 0.2, 0.2, 0.4 ]; assert(isClose(jensenShannonDivergence(p1, p2), 0.0186218, 1e-5)); assert(isClose(jensenShannonDivergence(p2, p1), 0.0186218, 1e-5)); assert(isClose(jensenShannonDivergence(p2, p1, 0.005), 0.00602366, 1e-5));
- F
gapWeightedSimilarity
(alias comp = "a == b", R1, R2, F)(R1s
, R2t
, Flambda
)
if (isRandomAccessRange!R1 && hasLength!R1 && isRandomAccessRange!R2 && hasLength!R2); - The so-called "all-lengths gap-weighted string kernel" computes a similarity measure between
s
andt
based on all of their common subsequences of all lengths. Gapped subsequences are also included.To understand what gapWeightedSimilarity(s, t, lambda) computes, consider first the case lambda = 1 and the strings s = ["Hello", "brave", "new", "world"] and t = ["Hello", "new", "world"]. In that case,gapWeightedSimilarity
counts the following matches:- three matches of length 1, namely "Hello", "new", and "world";
- three matches of length 2, namely ("Hello", "new"), ("Hello", "world"), and ("new", "world");
- one match of length 3, namely ("Hello", "new", "world").
string[] s = ["Hello", "brave", "new", "world"]; string[] t = ["Hello", "new", "world"]; assert(gapWeightedSimilarity(s, t, 1) == 7);
Note how the gaps in matching are simply ignored, for example ("Hello", "new") is deemed as good a match as ("new", "world"). This may be too permissive for some applications. To eliminate gapped matches entirely, use lambda = 0:string[] s = ["Hello", "brave", "new", "world"]; string[] t = ["Hello", "new", "world"]; assert(gapWeightedSimilarity(s, t, 0) == 4);
The call above eliminated the gapped matches ("Hello", "new"), ("Hello", "world"), and ("Hello", "new", "world") from the tally. That leaves only 4 matches. The most interesting case is when gapped matches still participate in the result, but not as strongly as ungapped matches. The result will be a smooth, fine-grained similarity measure between the input strings. This is where values oflambda
between 0 and 1 enter into play: gapped matches are exponentially penalized with the number of gaps with baselambda
. This means that an ungapped match adds 1 to the return value; a match with one gap in either string addslambda
to the return value; ...; a match with a total of n gaps in both strings adds pow(lambda, n) to the return value. In the example above, we have 4 matches without gaps, 2 matches with one gap, and 1 match with three gaps. The latter match is ("Hello", "world"), which has two gaps in the first string and one gap in the second string, totaling to three gaps. Summing these up we get 4 + 2 * lambda + pow(lambda, 3).string[] s = ["Hello", "brave", "new", "world"]; string[] t = ["Hello", "new", "world"]; assert(gapWeightedSimilarity(s, t, 0.5) == 4 + 0.5 * 2 + 0.125);
gapWeightedSimilarity
is useful wherever a smooth similarity measure between sequences allowing for approximate matches is needed. The examples above are given with words, but any sequences with elements comparable for equality are allowed, e.g. characters or numbers.gapWeightedSimilarity
uses a highly optimized dynamic programming implementation that needs 16 * min(s.length, t.length) extra bytes of memory and Ο(s.length * t.length) time to complete. - Select!(isFloatingPoint!F, F, double)
gapWeightedSimilarityNormalized
(alias comp = "a == b", R1, R2, F)(R1s
, R2t
, Flambda
, FsSelfSim
= F.init, FtSelfSim
= F.init)
if (isRandomAccessRange!R1 && hasLength!R1 && isRandomAccessRange!R2 && hasLength!R2); - The similarity per gapWeightedSimilarity has an issue in that it grows with the lengths of the two strings, even though the strings are not actually very similar. For example, the range ["Hello", "world"] is increasingly similar with the range ["Hello", "world", "world", "world",...] as more instances of "world" are appended. To prevent that,
gapWeightedSimilarityNormalized
computes a normalized version of the similarity that is computed as gapWeightedSimilarity(s, t, lambda) / sqrt(gapWeightedSimilarity(s, t, lambda) * gapWeightedSimilarity(s, t, lambda)). The functiongapWeightedSimilarityNormalized
(a so-called normalized kernel) is bounded in [0, 1], reaches 0 only for ranges that don't match in any position, and 1 only for identical ranges.The optional parameterssSelfSim
andtSelfSim
are meant for avoiding duplicate computation. Many applications may have already computed gapWeightedSimilarity(s, s, lambda) and/or gapWeightedSimilarity(t, t, lambda). In that case, they can be passed assSelfSim
andtSelfSim
, respectively.Examples:import std.math.operations : isClose; import std.math.algebraic : sqrt; string[] s = ["Hello", "brave", "new", "world"]; string[] t = ["Hello", "new", "world"]; writeln(gapWeightedSimilarity(s, s, 1)); // 15 writeln(gapWeightedSimilarity(t, t, 1)); // 7 writeln(gapWeightedSimilarity(s, t, 1)); // 7 assert(isClose(gapWeightedSimilarityNormalized(s, t, 1), 7.0 / sqrt(15.0 * 7), 0.01));
- struct
GapWeightedSimilarityIncremental
(Range, F = double) if (isRandomAccessRange!Range && hasLength!Range);
GapWeightedSimilarityIncremental!(R, F)gapWeightedSimilarityIncremental
(R, F)(Rr1
, Rr2
, Fpenalty
); - Similar to gapWeightedSimilarity, just works in an incremental manner by first revealing the matches of length 1, then gapped matches of length 2, and so on. The memory requirement is Ο(s.length * t.length). The time complexity is Ο(s.length * t.length) time for computing each step. Continuing on the previous example:The implementation is based on the pseudocode in Fig. 4 of the paper "Efficient Computation of Gapped Substring Kernels on Large Alphabets" by Rousu et al., with additional algorithmic and systems-level optimizations.Examples:
string[] s = ["Hello", "brave", "new", "world"]; string[] t = ["Hello", "new", "world"]; auto simIter = gapWeightedSimilarityIncremental(s, t, 1.0); assert(simIter.front == 3); // three 1-length matches simIter.popFront(); assert(simIter.front == 3); // three 2-length matches simIter.popFront(); assert(simIter.front == 1); // one 3-length match simIter.popFront(); assert(simIter.empty); // no more match
- this(Range
s
, Ranget
, Flambda
); - Constructs an object given two ranges
s
andt
and a penaltylambda
. Constructor completes in Ο(s.length * t.length) time and computes all matches of length 1. - ref GapWeightedSimilarityIncremental
opSlice
(); - Returns:this.
- void
popFront
(); - Computes the match of the popFront length. Completes in Ο(s.length * t.length) time.
- @property F
front
(); - Returns:The gapped similarity at the current match length (initially 1, grows with each call to popFront).
- @property bool
empty
(); - Returns:Whether there are more matches.
- typeof(Unqual!T.init % Unqual!U.init)
gcd
(T, U)(Ta
, Ub
)
if (isIntegral!T && isIntegral!U);
autogcd
(T)(Ta
, Tb
)
if (!isIntegral!T && is(typeof(T.init % T.init)) && is(typeof(T.init == 0 || T.init > 0))); - Computes the greatest common divisor of
a
andb
by using an efficient algorithm such as Euclid's or Stein's algorithm.Parameters:T a
Integer value of any numerical type that supports the modulo operator %. If bit-shifting << and >> are also supported, Stein's algorithm will be used; otherwise, Euclid's algorithm is used as a fallback. U b
Integer value of any equivalent numerical type. Returns:The greatest common divisor of the given arguments. - typeof(Unqual!T.init % Unqual!U.init)
lcm
(T, U)(Ta
, Ub
)
if (isIntegral!T && isIntegral!U);
autolcm
(T)(Ta
, Tb
)
if (!isIntegral!T && is(typeof(T.init % T.init)) && is(typeof(T.init == 0 || T.init > 0))); - Returns:The least common multiple of the given arguments.Examples:
writeln(lcm(1, 2)); // 2 writeln(lcm(3, 4)); // 12 writeln(lcm(5, 6)); // 30
- class
Fft
; - A class for performing fast Fourier transforms of power of two sizes. This class encapsulates a large amount of state that is reusable when performing multiple FFTs of sizes smaller than or equal to that specified in the constructor. This results in substantial speedups when performing multiple FFTs with a known maximum size. However, a free function API is provided for convenience if you need to perform a one-off FFT.
- this(size_t
size
); - Create an Fft object for computing fast Fourier transforms of power of two sizes of
size
or smaller.size
must be a power of two. - const Complex!F[]
fft
(F = double, R)(Rrange
)
if (isFloatingPoint!F && isRandomAccessRange!R); - Compute the Fourier transform of range using the Ο(N log N) Cooley-Tukey Algorithm.
range
must be a random-access range with slicing and a length equal to size as provided at the construction of this object. The contents of range can be either numeric types, which will be interpreted as pure real values, or complex types with properties or members .re and .im that can be read.Note Pure real FFTs are automatically detected and the relevant optimizations are performed.
Returns:An array of complex numbers representing the transformed data in the frequency domain.Conventions The exponent is negative and the factor is one, i.e., output[j] := sum[ exp(-2 PI i j k / N) input[k] ].
- const void
fft
(Ret, R)(Rrange
, Retbuf
)
if (isRandomAccessRange!Ret && isComplexLike!(ElementType!Ret) && hasSlicing!Ret); - Same as the overload, but allows for the results to be stored in a user- provided buffer. The buffer must be of the same length as range, must be a random-access range, must have slicing, and must contain elements that are complex-like. This means that they must have a .re and a .im member or property that can be both read and written and are floating point numbers.
- const Complex!F[]
inverseFft
(F = double, R)(Rrange
)
if (isRandomAccessRange!R && isComplexLike!(ElementType!R) && isFloatingPoint!F); - Computes the inverse Fourier transform of a range. The range must be a random access range with slicing, have a length equal to the size provided at construction of this object, and contain elements that are either of type std.complex.Complex or have essentially the same compile-time interface.Returns:The time-domain signal.
Conventions The exponent is positive and the factor is 1/N, i.e., output[j] := (1 / N) sum[ exp(+2 PI i j k / N) input[k] ].
- const void
inverseFft
(Ret, R)(Rrange
, Retbuf
)
if (isRandomAccessRange!Ret && isComplexLike!(ElementType!Ret) && hasSlicing!Ret); - Inverse FFT that allows a user-supplied buffer to be provided. The buffer must be a random access range with slicing, and its elements must be some complex-like type.
- Complex!F[]
fft
(F = double, R)(Rrange
);
voidfft
(Ret, R)(Rrange
, Retbuf
);
Complex!F[]inverseFft
(F = double, R)(Rrange
);
voidinverseFft
(Ret, R)(Rrange
, Retbuf
); - Convenience functions that create an Fft object, run the FFT or inverse FFT and return the result. Useful for one-off FFTs.
Note In addition to convenience, these functions are slightly more efficient than manually creating an Fft object for a single use, as the Fft object is deterministically destroyed before these functions return.
- pure nothrow @nogc @safe size_t
decimalToFactorial
(ulongdecimal
, ref ubyte[21]fac
); - This function transforms
decimal
value into a value in the factorial number system stored infac
.A factorial number is constructed as: fac[0] * 0! + fac[1] * 1! + ... fac[20] * 20!Parameters:ulong decimal
The decimal value to convert into the factorial number system. ubyte[21] fac
The array to store the factorial number. The array is of size 21 as ulong.max requires 21 digits in the factorial number system. Returns:A variable storing the number of digits of the factorial number stored infac
.Examples:ubyte[21] fac; size_t idx = decimalToFactorial(2982, fac); writeln(fac[0]); // 4 writeln(fac[1]); // 0 writeln(fac[2]); // 4 writeln(fac[3]); // 1 writeln(fac[4]); // 0 writeln(fac[5]); // 0 writeln(fac[6]); // 0