Class |
Description |
AbsoluteDeviations |
A statistical optimality criterion relying on absolute deviations or the L1
norm condition.
|
AbsorptionModel |
|
AbstractData |
A named collection of time and temperature values, with user-adjustable
number of entries.
|
AbstractHandler |
There are two types of AbstractHandler s, which are used to either
update/populate existing objects or convert data into new objects of a given
type.
|
AbstractIntegrator |
An AbstractIntegrator serves to calculate the definite integral of a
function.
|
AbstractLogger |
|
AbstractPopulator<T> |
An AbstractPopulator provides the ability to add extra content to an
object by modifying its internal structure to make it compliant with an
external file.
|
AbstractReader<T> |
Basic interface for readers in PULsE .
|
AbstractResult |
An AbstractResult is either an individual, independent
Result , a Result that forms a part of the
AverageResult , or the AverageResult , which combines other
Result s.
|
Accessible |
An Accessible provides Reflection-based read- and write-access to the
underlying (usually declared as its own fields - but not necessarily)
instances of Property and a recursive access to other
Accessible , which may have a family relationship with this
Accessible via the UpwardsNavigable implementation.
|
AccessibleTableRenderer |
|
ActiveFlags |
|
AdaptiveIntegrator |
An ODE integrator with an adaptive step size.
|
AdiabaticSolution |
|
ADILinearisedSolver |
An alternating direction implicit (ADI) solver for a classical
two-dimensional linearised problem.
|
ADIScheme |
An ADIScheme uses a Grid2D to provide numerical capabilities
needed to solve a Problem .
|
AdjustableBaseline |
A baseline that can shift in the vertical direction.
|
AICStatistic |
AIC algorithm: Banks, H.
|
AndersonDarlingTest |
The Anderson-Darling normality test.
|
AssignmentListener |
|
AtanhTransform |
Hyper-tangent parameter transform allowing to set an upper bound for a
parameter.
|
AuxPlotter<T> |
|
AverageResult |
An AverageResult is obtained by averaging a list of
AbstractResult s and calculating the associated errors of averaging.
|
Baseline |
An abstract class for baseline calculations.
|
BeerLambertAbsorption |
|
BFGSOptimiser |
The 'advanced' PathSolver implementing the variable-metric
(quasi-Newton) search method.
|
BICStatistic |
Bayesian Information Criterion (BIC) algorithm formulated for the Gaussian
distribution of residuals.
|
BlackbodySpectrum |
Contains methods for calculating the integral spectral characteristics of a
black body with a specific spatial temperature profile.
|
BlockMatrixAlgorithm |
A modification of the algorithm for solving a system of linear equations,
where the first and last equation contains references to the last and first
elements of the solution, respectively.
|
BoundedParameterTransform |
An abstract Transformable where the bounds of the parameter is
manually set.
|
Buffer |
A Buffer is used to estimate the convergence of the reverse problem
solution, by comparing the variance of the properties to a pre-specified
error tolerance.
|
ButcherTableau |
The Butcher tableau coefficients used by the explicit Runge-Kutta solvers.
|
ButcherTableauReader |
Provides a reader class for Butcher tableaux.
|
ButtonEditor |
|
Calculation |
|
CalculationTable |
|
ChandrasekharsQuadrature |
This quadrature methods of evaluating the composition product of the
exponential integral and blackbody spectral power spectrum has been given by
Chandrasekhar and is based on constructing a moment matrix.
|
Chart |
|
ChartToolbar |
|
ClassicalProblem |
The simplest problem statement supported in PULsE , which is
formulated in the dimensionless form and with linearised boundary conditions.
|
ClassicalProblem2D |
The complete problem statement for a fully two-dimensional problem, which
includes side heat losses, a variable field of view and variable
pulse-to-diameter ratio.
|
ColorGenerator |
|
ComplexPath |
A more complex version of Path , which in addition to other variables
stores the Hessian matrix at the current step.
|
CompositeGaussianQuadrature |
A composite Gaussian quadrature for numerical evaluation of the scattering
integral in one-dimensional heat transfer.
|
CompositePathOptimiser |
|
CompositionProduct |
A class for evaluating the definite integral
ab f(x) En
(α + β x) dx}.
|
ConfirmAction |
|
ConstrictionMover |
|
CornetteSchanksPF |
The single-parameter Cornette-Schanks scattering phase function.
|
CorrelationBuffer |
|
CorrelationLogEntry |
|
CorrelationTest |
|
CoupledImplicitScheme |
|
CurveEvent |
A CurveEvent is associated with an HeatingCurve object.
|
CurveEventType |
An event type associated with an HeatingCurve object.
|
CurveExporter |
A singleton exporter allows writing the data contained in a
AbstractData object in a two-column format to create files conforming
to either csv or html extension.
|
CurveReader |
Basic interface for reading ExperimentalData (which extends
HeatingCurve -- hence the name).
|
DataCollectionListener |
|
DataEvent |
A DataEvent is used to track changes happening with a
ExperimentalData .
|
DataEventType |
An event type that is associated with an ExperimentalData object.
|
DataFrame |
|
DataListener |
A listener interface, which is used to listen to DataEvent s occurring
with an ExperimentalData object.
|
DataLoader |
Manages loading the experimental time-temperature profiles, metadata files
and InterpolationDataset s.
|
DataLogEntry |
A LogEntry with a list of NumericPropert ies.
|
DatasetReader |
An AbstractReader for reading tabular datasets and enhancing them
with an interpolation algorithm.
|
DATReader |
A specific implementation of CurveReader used to read .dat
files.
|
DerivativeCalculator |
This is basically a coupling interface between a Solver and a
RadiativeTransferSolver .
|
Descriptive |
Provides the describe() functionality.
|
DescriptorChangeListener |
|
Details |
An enum which lists different possible problems wit the SearchTask .
|
DiathermicMedium |
The diathermic model is based on the following propositions: - A
cylindrically shaped sample is completely transparent to thermal radiation; -
The front~(laser-facing) and rear (detector-facing) sides of the sample are
coated by a thin grey absorber; - The coatings are in perfect thermal contact
with the bulk material; - The side surface is free from any coating.
|
DiathermicProperties |
|
DifferenceScheme |
A DifferenceScheme is an abstract class that declares general methods
for converting a Problem to a set of algebraic operations on a
Grid .
|
DirectionSolver |
|
DiscreteInput |
|
DiscreteOrdinatesMethod |
A class that manages the solution of the radiative transfer equation using
the discrete ordinates method.
|
DiscretePulse |
A DiscretePulse is an object that acts as a medium between the
physical Pulse and the respective DifferenceScheme used to
process the solution of a Problem .
|
DiscretePulse2D |
The discrete pulse on a Grid2D .
|
DiscreteQuantities |
Defines the main quantities calculated within the discrete ordinates method.
|
DiscreteSelector<T extends Descriptive> |
|
Discretisation |
A class specifying the discretisation (both spatial and angular) scheme used
to solve the radiative transfer equation with the discrete ordinates method.
|
DistributedDetection |
An interface providing the ability to calculate the integral signal out from
a finite-depth material layer.
|
DoubleTablePanel |
|
EmptyCorrelationTest |
|
EmptyTest |
|
ExecutionButton |
|
ExecutionButton.ExecutionState |
|
ExitRequestListener |
|
ExperimentalData |
An ExperimentalData object is essentially a AbstractData with
adjustable range and linked Metadata .
|
ExplicitCoupledSolver |
|
ExplicitCoupledSolverNL |
|
ExplicitLinearisedSolver |
Performs a fully-dimensionless calculation for the LinearisedProblem .
|
ExplicitNonlinearSolver |
|
ExplicitRungeKutta |
Explicit Runge-Kutta integrator with Hermite interpolation for the solution
of one-dimensional radiative transfer problems.
|
ExplicitScheme |
This class provides the necessary framework to enable a simple explicit
finite-difference scheme (also called the forward-time centred space scheme)
for solving the one-dimensional heat conduction problem.
|
ExplicitTranslucentSolver |
|
ExponentialIntegrals |
A factory class for creating and evaluating ExponentialIntegral s of
orders from 1 to 4.
|
ExponentiallyModifiedGaussian |
Represents the exponentially modified Gaussian function, which is given by
three independent parameters (μ, σ and λ).
|
ExportDialog |
|
Exporter<T extends Descriptive> |
An Exporter defines a set of rules to enable exporting of a certain
type of PULsE objects (typically, instances of the PropertyHolder class).
|
ExportManager |
Manages export operations.
|
ExpressionParser |
Original source:
https://stackoverflow.com/questions/3422673/how-to-evaluate-a-math-expression-given-in-string-form#3423360
|
ExtendedThermalProperties |
|
Extension |
Describes the available extensions for the exported files.
|
ExternalDatasetListener |
A listener associated with the InterpolationDataset static repository
of interpolations.
|
ExternalGraphFrame<T> |
|
FFTTransformer |
|
Filter |
|
FIPSMover |
|
FixedIntervalIntegrator |
A fixed-interval integrator implements a numerical scheme in which the domain
within the integration bounds is divided into equal intervals of a
sufficiently small (and fixed) length.
|
FixedIterations |
|
FixedPointIterations |
|
Flag |
A Flag is a Property that has a type represented by a
NumericPropertyKeyword , a boolean value , and a String
with a short abbreviation describing the type of this flag (this is usually
defined by the corresponding NumericProperty ).
|
FlatBaseline |
A flat baseline.
|
Fluxes |
|
FluxesAndExplicitDerivatives |
|
FluxesAndImplicitDerivatives |
|
FormattedInputDialog |
|
FrameVisibilityRequestListener |
|
FTest |
A static class for testing two calculations based on the Fischer test
(F-Test) implemented in Apache Commons Math.
|
FunctionSerializer |
|
FunctionWithInterpolation |
An abstract class for univariate functions with the capacity of spline
interpolation.
|
Gas |
|
GeneralTask<I extends DiscreteInput,R extends Response> |
|
GoldenSectionOptimiser |
The golden-section search is a simple dichotomy search for finding the
minimum of strictly unimodal functions by successively narrowing the domain
of the search using the golden ratio partitioning.
|
GradientBasedOptimiser |
|
GradientGuidedPath |
A Path stores information relevant to the selected
PathSolver , which is related to a specific SearchTask .
|
GraphicalLogPane |
|
Grid |
A Grid is used to partition the space and time domain of a
Problem to allow a numeric solution with a DifferenceScheme .
|
Grid2D |
A Grid2D is used to partition the space and time domain of a
Problem2D to allow a numeric solution with a
DifferenceScheme .
|
Group |
|
HalfTimeCalculator |
|
Harmonic |
Harmonic class.
|
HeatingCurve |
The HeatingCurve represents a time-temperature profile (a
AbstractData instance) generated using a calculation algorithm
implemented by a Problem 's Solver .
|
HeatingCurveListener |
An interface used to listen to data events related to HeatingCurve .
|
Helium |
|
HenyeyGreensteinPF |
The single-parameter Henyey-Greenstein scattering phase function.
|
HermiteInterpolator |
A globally C1 Hermite interpolator used to interpolate intensities
and derivatives in discrete ordinates method when solving the radiative
transfer equation with a Runge-Kutta solver (either implicit or explicit).
|
HessianDirectionSolver |
|
HierarchyListener |
An hierarchy listener, which listens to any changes happening with the
children of an UpwardsNavigable .
|
HistogramFrame |
|
IconCheckBox |
|
Identifier |
An Identifier is used to identify SearchTask s.
|
ImageUtils |
|
ImmutableDataEntry<T,R> |
A DataEntry is an immutable ordered pair of an instance of T ,
which is considered to be the 'key', and an instance of R , which is
considered to be the 'value'.
|
ImmutablePair<T> |
|
ImplicitCoupledSolver |
|
ImplicitCoupledSolverNL |
|
ImplicitDiathermicSolver |
|
ImplicitLinearisedSolver<T extends ClassicalProblem> |
Performs a fully-dimensionless calculation for the LinearisedProblem .
|
ImplicitNonlinearSolver |
|
ImplicitScheme |
An abstract implicit finite-difference scheme for solving one-dimensional
heat conduction problems.
|
ImplicitTranslucentSolver |
|
ImplicitTwoTemperatureSolver |
|
IndexRange |
Provides a way to define the indices corresponding to a certain range of
data.
|
InstanceCellEditor |
|
InstanceDescriptor<T extends Reflexive> |
|
Insulator |
|
InternalGraphFrame<T> |
|
InterpolationDataset |
An InterpolationDataset stores data in a List of
DataEntry<Double,Double> objects (each containing a 'key' and a
'value') and provides means to interpolate between the 'values' using the
'keys'.
|
InvDiamTransform |
A transform that simply divides the value by the squared length of the
sample.
|
IterativeSolver |
Used to iteratively solve the radiative transfer problem.
|
IterativeState |
|
KSTest |
The Kolmogorov-Smirnov normality test as implemented in
ApacheCommonsMath .
|
Launcher |
This is the main class used to launch PULsE and start the GUI.
|
LegendrePoly |
A utility class represents the Legendre polynomial of a given order.
|
LFRReader |
A CurveReader capable of reading ASCII master-files generated by the
Linseis software.
|
LinearAnisotropicPF |
The linear-anisotropic scattering phase function.
|
LinearBaseline |
A linear Baseline which specifies the intercept and
slope parameters.
|
LinearOptimiser |
The most basic LinearSolver class, which defines the notion of the
linear resolution, defines the method signature for estimating the step of
the linear search (i.e., the position of the minimum), and provides a simple
algorithm to initialise the calculation domain.
|
LMOptimiser |
Given an objective function equal to the sum of squared residuals,
iteratively approaches the minimum of this function by applying the
Levenberg-Marquardt formulas.
|
LoaderButton |
|
LoaderButton.DataType |
|
Log |
A Log is used to track changes for a specific SearchTask ,
such as changes of status and/or data collection events.
|
LogChart |
|
LogEntry |
An abstract class for LogEntr ies created for a specific
SearchTask .
|
LogEntryListener |
|
LogExporter |
A singleton LogExporter works on Log objects to write html
files containing the full contents of the Log .
|
LogFrame |
|
LogListener |
|
LogToolbar |
|
MainGraphFrame |
|
MathUtils |
A utility class containing some common methods potentially enhancing the
performance of standard mathematical operations.
|
Matrices |
A static factory class used to create matrices.
|
Messages |
|
Metadata |
Metadata is the information relating to a specific experiment, which
can be used by a SearchTask to process an instance of
ExperimentalData .
|
MetadataExporter |
A singleton class used to export Metadata objects in a html format.
|
MetaFilePopulator |
An AbstractPopulator capable of handling metafiles.
|
MidpointIntegrator |
Implements the midpoint integration scheme for the evaluation of definite
integrals.
|
MixedCoupledSolver |
|
MixedCoupledSolverNL |
|
MixedLinearisedSolver |
Performs a fully-dimensionless calculation for the LinearisedProblem .
|
MixedScheme |
An abstraction describing a weighted semi-implicit finite-difference scheme
for solving the one-dimensional heat conduction problem.
|
ModelSelectionCriterion |
An abstract superclass for the BIC and AIC statistics.
|
ModelSelectionFrame |
|
ModelToolbar |
|
MouseOnMarkerListener |
|
MovableValueMarker |
|
MovableValueMarker.State |
|
Mover |
|
NeighbourhoodTopology |
|
NetzschCSVReader |
Reads the .CSV files exported from Proteus LFA Analysis software.
|
NetzschPulseCSVReader |
Reads numeric pulse data generated by the Proteus LFA Analysis export tool.
|
NewtonCotesQuadrature |
A class for evaluating the composition product using a simple Newton-Cotes
quadrature with a cutoff.
|
Nitrogen |
|
NonlinearProblem |
|
NonscatteringAnalyticalDerivatives |
A solver of the radiative transfer equation for an absorbing-emitting medium
where the fluxes and their derivatives are calculated using analytical
formulae with the selected numerical quadrature.
|
NonscatteringDiscreteDerivatives |
A solver of the radiative transfer equation for an absorbing-emitting medium
where the fluxes are calculated using analytical formulae while their
derivatives are calculated using the central-difference approximation.
|
NonscatteringRadiativeTransfer |
|
NormalityTest |
A normality test is invoked after a task finishes, to validate its result.
|
NumberEditor |
|
NumericProperties |
Default operations with NumericProperties
|
NumericProperty |
A Property that has a numeric value , an error
associated with this value, a definition domain defining sensible value, and
a dimensionFactor used to convert the value to SI.
|
NumericPropertyComparator |
|
NumericPropertyFormatter |
|
NumericPropertyKeyword |
Contains a list of NumericProperty types recognised by the constituent
modules of PULsE.
|
NumericPropertyRenderer |
|
NumericPulse |
A numeric pulse is given by a set of discrete NumericPulseData
measured independently using a pulse diode.
|
NumericPulseData |
An instance of the AbstractData class, which also declares an
externalID .
|
ODEIntegrator |
|
OneDimensionalScheme |
|
OpacitySlider |
|
Optimisable |
An interface for dealing with optimisation variables.
|
OptimisablePolyline |
|
OptimisedRunningAverage |
|
OptimiserStatistic |
An Optimiser statistic is simply the objective function that is calculated by
the Optimiser.
|
OrdinateSet |
A fixed set of discrete cosine nodes and weights for the angular
discretisation of a radiative transfer equation.
|
Parameter |
Parameter class
|
ParameterIdentifier |
|
ParameterTableModel |
|
ParameterVector |
A wrapper subclass that assigns ParameterIdentifier s to specific
components of the vector.
|
ParticipatingMedium |
|
Particle |
Class defining a particle - the basic unit of a swarm.
|
ParticleState |
|
ParticleSwarmOptimiser |
|
PathOptimiser |
An abstract class that defines the mathematical basis of solving the reverse
heat conduction problem.
|
PearsonCorrelation |
Wrapper CorrelationTest class for ApacheCommonsMath Pearson
Correlation.
|
PenetrationProblem |
|
PeriodicTransform |
|
PhaseFunction |
|
PlotRequestListener |
|
PolylineOptimiser |
|
PreviewFrame |
|
PreviewFrameCreationListener |
|
Problem |
A Problem is an abstract class defining the general rules for
handling heat conduction problems, and also providing access to the basic
properties used in the calculation with one of the DifferenceScheme s.
|
ProblemCellRenderer |
|
ProblemComplexity |
|
ProblemSelectionEvent |
|
ProblemSelectionListener |
|
ProblemStatementFrame |
|
ProblemToolbar |
|
ProblemTree |
|
ProgressDialog |
|
ProgressDialog.ProgressWorker |
|
Property |
The basic interface for properties.
|
PropertyEvent |
An event which is created to signal about the changes with a
PropertyHolder .
|
PropertyHolder |
An Accessible that has a list of parameters it accepts as its own and
a list of PropertyHolderListener that track changes with all
properties of the Accessible .
|
PropertyHolderListener |
A listener used by PropertyHolder s to track changes with the
associated Propert ies.
|
PropertyHolderTable |
|
Pulse |
A Pulse stores the parameters of the laser pulse, but does not
provide the calculation facilities.
|
Pulse2D |
|
PulseChart |
|
PulseDataReader |
A reader for importing numeric pulse data -- if available.
|
PulseMainMenu |
|
PulseTemporalShape |
An abstract time-dependent pulse shape.
|
QuadratureReader |
A reader, which converts quad files into instances
OrdinateSet .
|
RadiativeTransferCoupling |
|
RadiativeTransferSolver |
Manages processes to solve the radiative transfer equation and generate the
input needed by the heat problem, i.e.
|
Randomiser |
|
Range |
The actual physical range defined as a Segment with minimum and
maximum values.
|
RangePenalisedLeastSquares |
This is an experimental feature.
|
RangeTextFields |
Two JFormattedTextFields used to display the range of the currently selected
task.
|
RawDataExporter |
A wrapper singleton class that is made specifically to handle export requests
of ExperimentalData .
|
ReaderManager |
A ReaderManager is a single class that manages most input operations.
|
RectangularMatrix |
|
RectangularPulse |
The simplest pulse shape defined as tpulse - t)), where
is the signum function, pulse is the pulse width.
|
Reflexive |
An object is declared Reflexive if PULsE needs to know all
its available subclasses.
|
ReflexiveFinder |
Provides utility methods for finding classes and instances of
Reflexive in a PULsE package.
|
RegularisedLeastSquares |
This is an experimental feature.
|
ResidualsChart |
|
ResidualStatistic |
An abstract statistic (= a numeric value resulting from a statistical
procedure) that operates with model residuals.
|
ResidualStatisticExporter |
Exports the residuals, where each residual value refers to a specific point
in time.
|
ResourceMonitor |
Provides unified means of storage and methods of access to runtime system
information, such as CPU usage, memory usage, an number of available threads.
|
Response |
|
Result |
The individual Result that is associated with a SearchTask .
|
ResultChangeDialog |
|
ResultExporter |
Provides export capabilities, for instances, of the Result class both
in the csv and html formats.
|
ResultFormat |
A singleton ResultFormat , which contains a list of
NumericPropertyKeyword s used for identification of
NumericPropert ies.
|
ResultFormatEvent |
|
ResultFormatListener |
|
ResultFrame |
|
ResultListener |
|
ResultRequestListener |
|
ResultTable |
|
ResultTableExporter |
A singleton Exporter which can process the results table.
|
ResultTableModel |
|
ResultToolbar |
|
RSquaredTest |
The coefficient of determination represents the goodness of fit that a
HeatingCurve provides for the ExperimentalData
|
RTECalculationListener |
Used to listed to status updates in RadiativeTransferSolver
subclasses.
|
RTECalculationStatus |
A measure of health for radiative transfer calculations.
|
RunningAverage |
|
SampleName |
|
ScientificFormat |
|
SearchListRenderer |
|
SearchOptionsFrame |
|
SearchTask |
A SearchTask is the most important class in PULsE .
|
Segment |
A Segment is simply a pair of values a and b such
that a < b .
|
SelectedKeysModel |
|
Serializer |
|
SessionListener |
|
SettingsToolBar |
|
SimpleOptimisationTask<T extends PropertyHolder & Optimisable> |
Generic optimisation class.
|
SimpleResponse |
|
SimpsonIntegrator |
Implements the Simpson's integration rule for the evaluation of definite
integrals.
|
SinusoidalBaseline |
A multiple-harmonic baseline.
|
Solver<T extends Problem> |
A solver interface which provides the capability to use the solve
method on a Problem .
|
SolverException |
|
SolverException.SolverExceptionType |
|
SpearmansCorrelationTest |
Wrapper CorrelationTest class for ApacheCommonsMath Spearmans
Correlation.
|
SpectralRange |
|
SquareMatrix |
The matrix class.
|
SR1Optimiser |
|
StandardTransformations |
A utility class containing standard mathematical transforms and their
inverses for non-bounded parameters.
|
StateEntry |
|
StaticTopologies |
|
Statistic |
A statistic is an abstract class that hosts the evaluate method to
validate the results of a SearchTask .
|
Status |
An enum that represents the different states in which a SearchTask
can be.
|
StatusChangeListener |
|
SteepestDescentOptimiser |
The simplest possible PathSolver , which assumes that the minimum
direction coincides with the inverted gradient.
|
StickTransform |
A simple bounded transform which makes the parameter stick to the boundaries
upon reaching them.
|
StoredCalculationTableModel |
|
StretchedGrid |
|
SuccessiveOverrelaxation |
|
SumOfSquares |
The standard optimality criterion of the L2 norm condition, or simply
ordinary least squares.
|
SwarmState |
|
SystemPanel |
|
TaskActionListener |
|
TaskBox |
|
TaskBoxModel |
|
TaskControlFrame |
|
TaskControlFrame.Mode |
|
TaskManager |
The TaskManager is a high-level class for dealing with operations of
creation, removal, storage, and execution of SearchTask s, as well as
with the associated Result s and InterpolationDataset s.
|
TaskManagerFrame |
|
TaskPopupMenu |
|
TaskRepositoryEvent |
|
TaskRepositoryEvent.State |
|
TaskRepositoryListener |
|
TaskSelectionEvent |
|
TaskSelectionListener |
|
TaskTable |
|
TaskTableModel |
|
TaskTableRenderer |
|
TaskToolbar |
|
TBLReader |
A DatasetReader capable of reading .tbl files.
|
TextLogPane |
|
TextLogPaneExporter |
Similar to a LogExporter , except that it works only on the contents
of a LogPane currently being displayed to the user.
|
ThermalProperties |
|
ThermoOpticalProperties |
|
Transformable |
An interface for performing reversible one-to-one mapping of the model
parameters.
|
TrapezoidalPulse |
A trapezoidal pulse shape, which combines a rise segment, a constant-power
segment, and a fall segment.
|
TRBDF2 |
TRBDF2 (Trapezoidal Backward Differencing Second Order) Scheme for the
solution of one-dimensional radiative transfer problems.
|
TridiagonalMatrixAlgorithm |
Implements the tridiagonal matrix algorithm (Thomas algorithms) for solving
systems of linear equations.
|
TwoTemperatureModel |
|
TwoTemperatureProperties |
|
UpwardsNavigable |
An UpwardsNavigable provides a two-way connection with the other
Describable in an asymmetric (upwards-oriented) manner (hence its
name).
|
Vector |
This is a general class for Vector operations useful for optimisers
and ODE solvers.
|
Version |
|
Window |
|
WolfeOptimiser |
This is the implementation of the strong Wolfe conditions for performing
inexact linear search.
|
XMLConverter |
Used to read and write XML files containing information about the default
NumericPropert ies.
|
ZScore |
This class finds peaks in data using the Z-score algorithm:
https://en.wikipedia.org/wiki/Standard_score This splits the data into a
number of population defined by the 'lag' number.
|