A B C D E F G H I J K L M N O P Q R S T U V W X Y Z _ 
All Classes All Packages

A

a - Variable in class pulse.problem.schemes.rte.dom.HermiteInterpolator
 
abbreviation(boolean) - Method in class pulse.properties.Flag
 
abbreviations() - Method in class pulse.tasks.processing.ResultFormat
Creates a List<String> of default abbreviations corresponding to the list of keywords specific to NumericProperty objects.
ABNORMAL_DISTRIBUTION_OF_RESIDUALS - pulse.tasks.logs.Details
 
ABS - Static variable in class pulse.math.transforms.StandardTransformations
 
AbsoluteDeviations - Class in pulse.search.statistics
A statistical optimality criterion relying on absolute deviations or the L1 norm condition.
AbsoluteDeviations() - Constructor for class pulse.search.statistics.AbsoluteDeviations
 
AbsoluteDeviations(AbsoluteDeviations) - Constructor for class pulse.search.statistics.AbsoluteDeviations
 
absorption(SpectralRange, double) - Method in class pulse.problem.statements.model.AbsorptionModel
 
absorption(SpectralRange, double) - Method in class pulse.problem.statements.model.BeerLambertAbsorption
 
absorption(SpectralRange, double) - Method in class pulse.problem.statements.model.Insulator
 
AbsorptionModel - Class in pulse.problem.statements.model
 
AbsorptionModel() - Constructor for class pulse.problem.statements.model.AbsorptionModel
 
AbsorptionModel(AbsorptionModel) - Constructor for class pulse.problem.statements.model.AbsorptionModel
 
AbstractData - Class in pulse
A named collection of time and temperature values, with user-adjustable number of entries.
AbstractData() - Constructor for class pulse.AbstractData
Creates an AbstractData with the default number of points (set in the corresponding XML file).
AbstractData(List<Double>, String) - Constructor for class pulse.AbstractData
 
AbstractData(AbstractData) - Constructor for class pulse.AbstractData
Copy constructor.
AbstractData(NumericProperty) - Constructor for class pulse.AbstractData
Creates a AbstractData, where the number of elements in the time and temperature collections are set to count.getValue().
AbstractHandler - Interface in pulse.io.readers
There are two types of AbstractHandlers, which are used to either update/populate existing objects or convert data into new objects of a given type.
AbstractIntegrator - Class in pulse.math
An AbstractIntegrator serves to calculate the definite integral of a function.
AbstractIntegrator(Segment) - Constructor for class pulse.math.AbstractIntegrator
Creates an AbstractIntegrator with the specified integration bounds.
AbstractLogger - Class in pulse.tasks.logs
 
AbstractLogger() - Constructor for class pulse.tasks.logs.AbstractLogger
 
AbstractPopulator<T> - Interface in pulse.io.readers
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> - Interface in pulse.io.readers
Basic interface for readers in PULsE.
AbstractResult - Class in pulse.tasks.processing
An AbstractResult is either an individual, independent Result, a Result that forms a part of the AverageResult, or the AverageResult, which combines other Results.
AbstractResult(AbstractResult) - Constructor for class pulse.tasks.processing.AbstractResult
 
AbstractResult(ResultFormat) - Constructor for class pulse.tasks.processing.AbstractResult
Constructs an AbstractResult with the list of properties specified by format.
access(String) - Method in class pulse.util.Group
Searches for a specific Accessible with a simpleName.
Accessible - Class in pulse.util
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.
Accessible() - Constructor for class pulse.util.Accessible
 
accessibleChildren() - Method in class pulse.util.Accessible
Selects only those Accessibles, the parent of which is this.
accessibleRange() - Method in interface pulse.Response
 
accessibleRange() - Method in class pulse.search.SimpleResponse
 
accessibleRange() - Method in class pulse.tasks.Calculation
 
AccessibleTableRenderer - Class in pulse.ui.components.controllers
 
AccessibleTableRenderer() - Constructor for class pulse.ui.components.controllers.AccessibleTableRenderer
 
action() - Method in interface pulse.ui.frames.dialogs.ProgressDialog.ProgressWorker
 
ActiveFlags - Class in pulse.search.direction
 
activeParameters() - Method in class pulse.search.GeneralTask
 
activeParameters() - Method in class pulse.search.SimpleOptimisationTask
 
activeParameters() - Method in class pulse.tasks.SearchTask
Finds what properties are being altered in the search of this SearchTask.
actualNumPoints() - Method in class pulse.AbstractData
The actual number of points, explicitly calculated as the size of the internal lists.
AdaptiveIntegrator - Class in pulse.problem.schemes.rte.dom
An ODE integrator with an adaptive step size.
AdaptiveIntegrator(Discretisation) - Constructor for class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
add(Parameter) - Method in class pulse.math.ParameterVector
 
add(ParameterIdentifier, int) - Method in class pulse.ui.components.LogChart
 
add(ImmutableDataEntry<Double, Double>) - Method in class pulse.input.InterpolationDataset
Adds entry to this InterpolationDataset.
addAssignmentListener(AssignmentListener) - Method in class pulse.math.filters.OptimisablePolyline
 
addDataListener(DataListener) - Method in class pulse.input.ExperimentalData
 
addElement(NumericPropertyKeyword) - Method in class pulse.ui.components.models.SelectedKeysModel
 
addExitRequestListener(ExitRequestListener) - Method in class pulse.ui.components.PulseMainMenu
 
addExternalDatasetListener(ExternalDatasetListener) - Method in class pulse.tasks.TaskManager
 
addFrameCreationListener(PreviewFrameCreationListener) - Method in class pulse.ui.frames.ResultFrame
 
addFrameVisibilityRequestListener(FrameVisibilityRequestListener) - Method in class pulse.ui.components.PulseMainMenu
 
addHeatingCurveListener(HeatingCurveListener) - Method in class pulse.HeatingCurve
 
addHierarchyListener(HierarchyListener) - Method in class pulse.util.UpwardsNavigable
 
addListener(LogEntryListener) - Method in class pulse.tasks.logs.Log
 
addListener(ResultListener) - Method in class pulse.ui.components.models.ResultTableModel
 
addListener(DescriptorChangeListener) - Method in class pulse.util.DiscreteSelector
 
addListener(DescriptorChangeListener) - Method in class pulse.util.InstanceDescriptor
 
addListener(PropertyHolderListener) - Method in class pulse.util.PropertyHolder
 
addLogListener(LogListener) - Method in class pulse.ui.components.panels.LogToolbar
 
addPlotRequestListener(PlotRequestListener) - Method in class pulse.ui.components.panels.ChartToolbar
 
addPlotRequestListener(PlotRequestListener) - Method in class pulse.ui.components.panels.OpacitySlider
 
addPoint(double, double) - Method in class pulse.AbstractData
Adds a time-signal pair to the lists.
addPoint(double, double) - Method in class pulse.input.ExperimentalData
Adds time and temperature to the respective Lists.
addPoint(double, double) - Method in class pulse.problem.laser.NumericPulseData
Adds a data point to the internal storage and increments counter.
addProblemSelectionListener(ProblemSelectionListener) - Method in class pulse.ui.components.ProblemTree
 
addProperty(NumericProperty) - Method in class pulse.tasks.processing.AbstractResult
 
addResultFormatListener(ResultFormatListener) - Static method in class pulse.tasks.processing.ResultFormat
 
addResultRequestListener(ResultRequestListener) - Method in class pulse.ui.components.panels.ResultToolbar
 
addRow(AbstractResult) - Method in class pulse.ui.components.models.ResultTableModel
 
addRTEListener(RTECalculationListener) - Method in class pulse.problem.schemes.rte.RadiativeTransferSolver
Adds a listener that can listen to status updates.
addSelectionListener(TaskSelectionListener) - Method in class pulse.tasks.TaskManager
 
addSessionListener(SessionListener) - Static method in class pulse.tasks.TaskManager
 
addStatusChangeListener(StatusChangeListener) - Method in class pulse.tasks.SearchTask
 
addTask(SearchTask) - Method in class pulse.tasks.TaskManager
If a task equal to t has already been previously loaded, does nothing.
addTask(SearchTask) - Method in class pulse.ui.components.models.TaskTableModel
 
addTaskActionListener(TaskActionListener) - Method in class pulse.ui.components.panels.TaskToolbar
 
addTaskListener(DataCollectionListener) - Method in class pulse.tasks.SearchTask
 
addTaskRepositoryListener(TaskRepositoryListener) - Method in class pulse.tasks.TaskManager
 
AdiabaticSolution - Class in pulse.problem.statements
 
ADILinearisedSolver - Class in pulse.problem.schemes.solvers
An alternating direction implicit (ADI) solver for a classical two-dimensional linearised problem.
ADILinearisedSolver() - Constructor for class pulse.problem.schemes.solvers.ADILinearisedSolver
 
ADILinearisedSolver(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ADILinearisedSolver
 
ADILinearisedSolver(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ADILinearisedSolver
 
ADIScheme - Class in pulse.problem.schemes
An ADIScheme uses a Grid2D to provide numerical capabilities needed to solve a Problem.
ADIScheme() - Constructor for class pulse.problem.schemes.ADIScheme
Creates a new ADIScheme with default values of grid density and time factor.
ADIScheme(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.ADIScheme
Creates an ADIScheme with the specified arguments.
ADIScheme(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.ADIScheme
Creates an ADIScheme with the specified arguments.
AdjustableBaseline - Class in pulse.baseline
A baseline that can shift in the vertical direction.
AdjustableBaseline(double, double) - Constructor for class pulse.baseline.AdjustableBaseline
Creates a flat baseline equal to the argument.
adjustStepSize(DiscretePulse) - Method in class pulse.problem.schemes.Grid2D
Calls the adjustTo method from superclass, then adjusts the gridDensity of the grid if discretePulseSpot < (Grid2D)grid.hy.
adopt(ParticleState) - Method in class pulse.search.direction.pso.Particle
 
AICStatistic - Class in pulse.search.statistics
AIC algorithm: Banks, H.
AICStatistic() - Constructor for class pulse.search.statistics.AICStatistic
 
AICStatistic(ModelSelectionCriterion) - Constructor for class pulse.search.statistics.AICStatistic
 
AICStatistic(OptimiserStatistic) - Constructor for class pulse.search.statistics.AICStatistic
 
allDescriptors(Class<T>) - Static method in interface pulse.util.Reflexive
 
allFlags() - Static method in class pulse.properties.Flag
List of all possible Flags that can be used in finding the reverse solution of the heat conduction problems.
allGrouppedContents() - Method in class pulse.tasks.TaskManager
 
allSubclassesNames(Class<T>) - Static method in interface pulse.util.Reflexive
 
alteredParameters() - Method in class pulse.tasks.SearchTask
 
AMBIGUOUS - pulse.tasks.logs.Status
Task has finished, but the results cannot be considered reliable (perhaps, due to large scatter of data points).
AndersonDarlingTest - Class in pulse.search.statistics
The Anderson-Darling normality test.
AndersonDarlingTest() - Constructor for class pulse.search.statistics.AndersonDarlingTest
 
apparentMaximum() - Method in class pulse.AbstractData
Calculates the simple maximum signal.
apply(double[]) - Method in interface pulse.math.Window
 
apply(Baseline) - Method in class pulse.HeatingCurve
Adds the baseline value to each element of the signal list.
approximatelyEquals(double, double) - Static method in class pulse.math.MathUtils
Checks if two numbers are approximately equal by comparing the modulus of their difference to 1.0E-5.
areDetailsHidden() - Method in class pulse.problem.schemes.DifferenceScheme
If true, Lets the UI know that the user only wants to have the most important properties displayed.
areDetailsHidden() - Method in class pulse.problem.statements.model.ThermalProperties
Hides optimiser directives
areDetailsHidden() - Method in class pulse.problem.statements.Problem
Checks whether some 'advanced' details should stay hidden by the GUI when customising the Problem statement.
areDetailsHidden() - Method in class pulse.util.PropertyHolder
By default, this is set to false.
areHtmlTagsAdded() - Method in class pulse.properties.NumericPropertyFormatter
 
areThermalPropertiesLoaded() - Method in class pulse.problem.statements.model.ThermalProperties
 
askToExport(T, JFrame, String) - Static method in class pulse.io.export.ExportManager
Finds an exporter matching to target and allows the user to select the location of export.
askToExport(T, JFrame, String, File) - Method in interface pulse.io.export.Exporter
Provides a JFileChooser for the user to select the export destination for target.
assign(ParameterVector) - Method in class pulse.baseline.AdjustableBaseline
 
assign(ParameterVector) - Method in class pulse.baseline.LinearBaseline
Assigns parameter values of this Problem using the optimisation vector params.
assign(ParameterVector) - Method in class pulse.baseline.SinusoidalBaseline
 
assign(ParameterVector) - Method in class pulse.input.Range
Tries to assign the upper and lower bound based on params.
assign(ParameterVector) - Method in class pulse.math.filters.OptimisablePolyline
 
assign(ParameterVector) - Method in class pulse.math.Harmonic
 
assign(ParameterVector) - Method in class pulse.problem.statements.ClassicalProblem
 
assign(ParameterVector) - Method in class pulse.problem.statements.ClassicalProblem2D
 
assign(ParameterVector) - Method in class pulse.problem.statements.DiathermicMedium
 
assign(ParameterVector) - Method in class pulse.problem.statements.model.AbsorptionModel
 
assign(ParameterVector) - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
assign(ParameterVector) - Method in class pulse.problem.statements.NonlinearProblem
Does the same as super-class method plus updates the laser energy, if needed.
assign(ParameterVector) - Method in class pulse.problem.statements.ParticipatingMedium
 
assign(ParameterVector) - Method in class pulse.problem.statements.PenetrationProblem
 
assign(ParameterVector) - Method in class pulse.problem.statements.Problem
Assigns parameter values of this Problem using the optimisation vector params.
assign(ParameterVector) - Method in class pulse.problem.statements.TwoTemperatureModel
 
assign(ParameterVector) - Method in class pulse.search.GeneralTask
Tries to assign a selected set of parameters to the search vector used in optimisation.
assign(ParameterVector) - Method in interface pulse.search.Optimisable
Assigns parameter values of this Optimisable using the optimisation vector params.
assign(ParameterVector) - Method in class pulse.search.SimpleOptimisationTask
 
assign(ParameterVector) - Method in class pulse.tasks.SearchTask
Assigns the values of the parameters of this SearchTask to searchParameters.
AssignmentListener - Interface in pulse.math.filters
 
asSquareMatrix(RectangularMatrix) - Static method in class pulse.math.linear.SquareMatrix
 
assumeNewState(TaskManager) - Static method in class pulse.tasks.TaskManager
 
atanh(double) - Static method in class pulse.math.MathUtils
Calculate the hyperbolic arctangent (exact).
AtanhTransform - Class in pulse.math.transforms
Hyper-tangent parameter transform allowing to set an upper bound for a parameter.
AtanhTransform(Segment) - Constructor for class pulse.math.transforms.AtanhTransform
Only the upper bound of the argument is used.
ATOL - pulse.properties.NumericPropertyKeyword
Absolute tolerance (atol) for RK calculations (RTE).
attemptMove(Particle, Particle[], ParticleState) - Method in class pulse.search.direction.pso.ConstrictionMover
 
attemptMove(Particle, Particle[], ParticleState) - Method in class pulse.search.direction.pso.FIPSMover
 
attemptMove(Particle, Particle[], ParticleState) - Method in interface pulse.search.direction.pso.Mover
 
attemptUpdate(Object) - Method in class pulse.properties.Flag
 
attemptUpdate(Object) - Method in class pulse.properties.NumericProperty
 
attemptUpdate(Object) - Method in interface pulse.properties.Property
 
attemptUpdate(Object) - Method in class pulse.properties.SampleName
 
attemptUpdate(Object) - Method in class pulse.util.DiscreteSelector
 
attemptUpdate(Object) - Method in class pulse.util.InstanceDescriptor
 
AuxPlotter<T> - Class in pulse.ui.components
 
AuxPlotter() - Constructor for class pulse.ui.components.AuxPlotter
 
AuxPlotter(String, String) - Constructor for class pulse.ui.components.AuxPlotter
 
availableProperties() - Static method in class pulse.search.direction.ActiveFlags
 
availableSolutions() - Method in class pulse.problem.statements.Problem
Lists the available DifferenceSchemes for this Problem.
average(NumericPropertyKeyword) - Method in class pulse.tasks.processing.Buffer
Calculates the average for the index -- if the respective NumericProperty is contained in the IndexedVector data of this Buffer.
AverageResult - Class in pulse.tasks.processing
An AverageResult is obtained by averaging a list of AbstractResults and calculating the associated errors of averaging.
AverageResult(List<AbstractResult>, ResultFormat) - Constructor for class pulse.tasks.processing.AverageResult
This will create an AverageResult based on the AbstractResult in res.
averageStatistic() - Method in class pulse.tasks.processing.Buffer
Calculates the average statistic value
AWAITING_TERMINATION - pulse.tasks.logs.Status
Termination requested.
AXIAL_COATING_THICKNESS - pulse.properties.NumericPropertyKeyword
Not implemented yet.

B

Baseline - Class in pulse.baseline
An abstract class for baseline calculations.
Baseline() - Constructor for class pulse.baseline.Baseline
 
BASELINE_AMPLITUDE - pulse.properties.NumericPropertyKeyword
Amplitude of the sinusoidal baseline.
BASELINE_COLUMN - Static variable in class pulse.ui.components.models.StoredCalculationTableModel
 
BASELINE_FREQUENCY - pulse.properties.NumericPropertyKeyword
Frequency of the sinusoidal baseline.
BASELINE_INTERCEPT - pulse.properties.NumericPropertyKeyword
The baseline intercept value.
BASELINE_PHASE_SHIFT - pulse.properties.NumericPropertyKeyword
Phase shift of the sinusoidal baseline.
BASELINE_SLOPE - pulse.properties.NumericPropertyKeyword
The baseline slope (for linear baselines).
BeerLambertAbsorption - Class in pulse.problem.statements.model
 
BeerLambertAbsorption() - Constructor for class pulse.problem.statements.model.BeerLambertAbsorption
 
BeerLambertAbsorption(AbsorptionModel) - Constructor for class pulse.problem.statements.model.BeerLambertAbsorption
 
BEST_MODEL_SELECTED - pulse.tasks.listeners.TaskRepositoryEvent.State
Indicates the task has discarded superfluous calculations.
bestSoFar() - Method in class pulse.search.direction.pso.SwarmState
Returns the best state achieved by any particle so far.
beta(double, double, int) - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
BETTER_CALCULATION_RESULTS_THAN_PREVIOUSLY_OBTAINED - pulse.tasks.logs.Details
Indicates that the result table had been updated, as the current model selection criterion showed better result than already present.
BFGSOptimiser - Class in pulse.search.direction
The 'advanced' PathSolver implementing the variable-metric (quasi-Newton) search method.
Bi1HTAU - Variable in class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
BICStatistic - Class in pulse.search.statistics
Bayesian Information Criterion (BIC) algorithm formulated for the Gaussian distribution of residuals.
BICStatistic() - Constructor for class pulse.search.statistics.BICStatistic
 
BICStatistic(ModelSelectionCriterion) - Constructor for class pulse.search.statistics.BICStatistic
 
BICStatistic(OptimiserStatistic) - Constructor for class pulse.search.statistics.BICStatistic
 
binomial(int, int) - Static method in class pulse.math.LegendrePoly
Fast calculation of binomial coefficient Cmk = m!/(k!(m-k)!)
BlackbodySpectrum - Class in pulse.problem.schemes.rte
Contains methods for calculating the integral spectral characteristics of a black body with a specific spatial temperature profile.
BlackbodySpectrum(NonlinearProblem) - Constructor for class pulse.problem.schemes.rte.BlackbodySpectrum
Creates a BlackbodySpectrum.
BLACKMANN_HARRIS - Static variable in interface pulse.math.Window
 
blend(Color, Color, float) - Static method in class pulse.util.ImageUtils
Credit to bmauter (https://stackoverflow.com/questions/19398238/how-to-mix-two-int-colors-correctly)
blockDiagonal() - Method in class pulse.math.linear.SquareMatrix
Creates a block-diagonal matrix from the diagonal of this matrix.
BlockMatrixAlgorithm - Class in pulse.problem.schemes
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.
BlockMatrixAlgorithm(Grid) - Constructor for class pulse.problem.schemes.BlockMatrixAlgorithm
 
bMinusA - Variable in class pulse.problem.schemes.rte.dom.HermiteInterpolator
 
BoundedParameterTransform - Class in pulse.math.transforms
An abstract Transformable where the bounds of the parameter is manually set.
BoundedParameterTransform(Segment) - Constructor for class pulse.math.transforms.BoundedParameterTransform
 
boundLimits(boolean) - Method in class pulse.input.Range
Calculates the allowed range for either the upper or lower bound.
bounds() - Method in interface pulse.DiscreteInput
 
boundsFrom(NumericPropertyKeyword) - Static method in class pulse.math.Segment
Creates a segment representing the bounds of p, i.e.
Buffer - Class in pulse.tasks.processing
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.
Buffer() - Constructor for class pulse.tasks.processing.Buffer
Creates a Buffer with a default size.
BUFFER_SIZE - pulse.properties.NumericPropertyKeyword
The buffer size that is used to establish whether results are converging.
ButcherTableau - Class in pulse.problem.schemes.rte.dom
The Butcher tableau coefficients used by the explicit Runge-Kutta solvers.
ButcherTableau(String, double[][], double[], double[], double[], boolean) - Constructor for class pulse.problem.schemes.rte.dom.ButcherTableau
 
ButcherTableauReader - Class in pulse.io.readers
Provides a reader class for Butcher tableaux.
ButtonEditor - Class in pulse.ui.components.controllers
 
ButtonEditor(AbstractButton, PropertyHolder) - Constructor for class pulse.ui.components.controllers.ButtonEditor
 
ButtonEditor(IconCheckBox, NumericPropertyKeyword) - Constructor for class pulse.ui.components.controllers.ButtonEditor
 

C

C1 - Static variable in class pulse.search.linear.WolfeOptimiser
The constant used in the Armijo inequality, equal to 0.05.
C2 - Static variable in class pulse.search.linear.WolfeOptimiser
The constant used in the strong Wolfe inequality for the modulus of the gradient projection, equal to 0.8.
calcCriterion() - Method in class pulse.search.statistics.ModelSelectionCriterion
This calculates either the AIC or BIC statistic, which only differ by the penalising term.
calculate() - Method in class pulse.math.filters.HalfTimeCalculator
Calculates the approximate half-rise time used for crude estimation of thermal diffusivity.
calculateEmissivity() - Method in class pulse.problem.statements.model.ThermalProperties
 
calculateResiduals(DiscreteInput, Response) - Method in class pulse.search.statistics.ResidualStatistic
 
calculateResiduals(DiscreteInput, Response, int, int) - Method in class pulse.search.statistics.ResidualStatistic
This will calculate the residuals for the task using the time sequence defined by the ExperimentalData object.The residuals are calculated between the model, which was previously used to populate the HeatingCurveand the experimental data.The temperature value of the model at the reference time is ti.and unknown a priori.
calculateResiduals(GeneralTask) - Method in class pulse.search.statistics.ResidualStatistic
 
Calculation - Class in pulse.tasks
 
Calculation(Calculation) - Constructor for class pulse.tasks.Calculation
Creates an orphan Calculation, retaining some properties of the argument
Calculation(SearchTask) - Constructor for class pulse.tasks.Calculation
 
CALCULATION_FINISHED - pulse.input.listeners.CurveEventType
A calculation associated with this curve has finished and the required arrays have been filled.
CALCULATION_RESULTS_WORSE_THAN_PREVIOUSLY_OBTAINED - pulse.tasks.logs.Details
Indicates that the result table had not been updated, as the selected model produced results worse than expected by the model selection criterion.
CalculationTable - Class in pulse.ui.components
 
CalculationTable() - Constructor for class pulse.ui.components.CalculationTable
 
callUpdate() - Method in class pulse.tasks.logs.AbstractLogger
 
cancelAllTasks() - Method in class pulse.tasks.TaskManager
This will terminate all tasks in this TaskManager and trigger a SHUTDOWN TaskRepositoryEvent.
ChandrasekharsQuadrature - Class in pulse.problem.schemes.rte.exact
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.
ChandrasekharsQuadrature() - Constructor for class pulse.problem.schemes.rte.exact.ChandrasekharsQuadrature
Constructs a ChandrasekharsQuadrature object with a default number of nodes, a LaguerreSolver with default precision and integration bounds set to [0,1].
changeAxis(boolean) - Method in class pulse.ui.components.LogChart
 
changeFormat(ResultFormat) - Method in class pulse.ui.components.models.ResultTableModel
 
characteristicTime() - Method in class pulse.problem.statements.model.ThermalProperties
Performs simple calculation of the l2/a factor that is commonly used to evaluate the dimensionless time t/timeFactor.
Chart - Class in pulse.ui.components
 
Chart() - Constructor for class pulse.ui.components.Chart
 
chartMouseClicked(ChartMouseEvent) - Method in class pulse.ui.components.listeners.MouseOnMarkerListener
 
chartMouseMoved(ChartMouseEvent) - Method in class pulse.ui.components.listeners.MouseOnMarkerListener
 
ChartToolbar - Class in pulse.ui.components.panels
 
ChartToolbar() - Constructor for class pulse.ui.components.panels.ChartToolbar
 
checkArrays() - Method in class pulse.problem.schemes.rte.Fluxes
Checks whether all stored values are finite.
checkNewVersion() - Method in class pulse.ui.Version
 
checkProblems() - Method in class pulse.tasks.SearchTask
Checks if this SearchTask is ready to be run.Performs basic check to see whether the user has uploaded all necessary data.
checkProblemStatementSet() - Method in enum pulse.tasks.logs.Status
 
children() - Method in class pulse.util.Group
Selects only those Accessibles, the parent of which is this.
classesIn(String) - Static method in class pulse.util.ReflexiveFinder
Uses Java Reflection API to find all classes within the package named pckgname.
ClassicalProblem - Class in pulse.problem.statements
The simplest problem statement supported in PULsE, which is formulated in the dimensionless form and with linearised boundary conditions.
ClassicalProblem() - Constructor for class pulse.problem.statements.ClassicalProblem
 
ClassicalProblem(Problem) - Constructor for class pulse.problem.statements.ClassicalProblem
 
ClassicalProblem2D - Class in pulse.problem.statements
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.
ClassicalProblem2D() - Constructor for class pulse.problem.statements.ClassicalProblem2D
 
ClassicalProblem2D(Problem) - Constructor for class pulse.problem.statements.ClassicalProblem2D
 
classicSolution(Problem) - Static method in class pulse.problem.statements.AdiabaticSolution
Calculates the classic solution, using the default value of the precision and the time limit specified by the HeatingCurve of p.
classicSolution(Problem, double) - Static method in class pulse.problem.statements.AdiabaticSolution
 
classicSolution(Problem, double, int) - Static method in class pulse.problem.statements.AdiabaticSolution
A static factory method for calculating a heating curve based on the analytical solution of Parker et al.
clear() - Method in class pulse.AbstractData
Clears all elements from the three List objects, thus releasing memory.
clear() - Method in class pulse.HeatingCurve
 
clear() - Method in class pulse.problem.schemes.rte.dom.HermiteInterpolator
 
clear() - Method in class pulse.tasks.Calculation
 
clear() - Method in class pulse.tasks.logs.AbstractLogger
 
clear() - Method in class pulse.tasks.processing.CorrelationBuffer
 
clear() - Method in class pulse.tasks.SearchTask
Resets everything to default values (for a list of default values please see the .xml document.
clear() - Method in class pulse.tasks.TaskManager
Purges all tasks from this TaskManager.
clear() - Method in class pulse.ui.components.GraphicalLogPane
 
clear() - Method in class pulse.ui.components.LogChart
 
clear() - Method in class pulse.ui.components.models.ResultTableModel
 
clear() - Method in class pulse.ui.components.ResultTable
 
clear() - Method in class pulse.ui.components.TextLogPane
 
clearArrays() - Method in class pulse.problem.schemes.DifferenceScheme
 
clearArrays() - Method in class pulse.problem.schemes.OneDimensionalScheme
 
clearArrays() - Method in class pulse.problem.schemes.solvers.ADILinearisedSolver
 
clearDataListener() - Method in class pulse.input.ExperimentalData
 
closestLeft(double, List<Double>) - Static method in class pulse.input.IndexRange
Searches through the elements contained in the the second argument of this method to find an element belonging to in most closely resembling the first argument.
closestRight(double, List<Double>) - Static method in class pulse.input.IndexRange
Searches through the elements contained in the the second argument of this method to find an element belonging to in most closely resembling the first argument.
COATING_DIFFUSIVITY - pulse.properties.NumericPropertyKeyword
Not implemented yet.
coefficients() - Method in class pulse.math.LegendrePoly
This will generate the coefficients for the Legendre polynomial, arranged in order of significance (from x0 to xn).
ColorGenerator - Class in pulse.ui
 
ColorGenerator() - Constructor for class pulse.ui.ColorGenerator
 
COMBINED_ABSORPTIVITY - pulse.properties.NumericPropertyKeyword
A directive to the optimiser informing both front and rear side absorptivities must be equal.
compare(NumericProperty, NumericProperty) - Static method in class pulse.properties.NumericProperties
Compares the numeric values of this NumericProperty and arg0
compare(NumericProperty, NumericProperty) - Method in class pulse.ui.components.controllers.NumericPropertyComparator
 
compareTo(Harmonic) - Method in class pulse.math.Harmonic
 
compareTo(NumericProperty) - Method in class pulse.properties.NumericProperty
 
compareTo(Calculation) - Method in class pulse.tasks.Calculation
Compares two calculations based on their model selection criteria.
compareToThreshold(double) - Method in class pulse.search.statistics.CorrelationTest
 
compatibleWith(OptimiserStatistic) - Method in class pulse.search.direction.LMOptimiser
The Levenberg-Marquardt optimiser will only accept ordinary least-squares as its objective function.
compatibleWith(OptimiserStatistic) - Method in class pulse.search.direction.PathOptimiser
Checks if this optimiser is compatible with the statistic passed to the method as its argument.By default, this will accept any OptimiserStatistic
compatibleWith(OptimiserStatistic) - Method in class pulse.search.direction.pso.ParticleSwarmOptimiser
 
ComplexPath - Class in pulse.search.direction
A more complex version of Path, which in addition to other variables stores the Hessian matrix at the current step.
ComplexPath(GeneralTask) - Constructor for class pulse.search.direction.ComplexPath
 
CompositeGaussianQuadrature - Class in pulse.problem.schemes.rte.dom
A composite Gaussian quadrature for numerical evaluation of the scattering integral in one-dimensional heat transfer.
CompositeGaussianQuadrature(int) - Constructor for class pulse.problem.schemes.rte.dom.CompositeGaussianQuadrature
Constructs a composite Gaussian quadrature for an even n
CompositePathOptimiser - Class in pulse.search.direction
 
CompositePathOptimiser() - Constructor for class pulse.search.direction.CompositePathOptimiser
 
CompositionProduct - Class in pulse.problem.schemes.rte.exact
A class for evaluating the definite integral ab f(x) En (α + β x) dx}.
CompositionProduct(Segment) - Constructor for class pulse.problem.schemes.rte.exact.CompositionProduct
Constructs the composition product with the specified integration bounds.
compute(double[]) - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
compute(double[]) - Method in class pulse.problem.schemes.rte.exact.NonscatteringAnalyticalDerivatives
Evaluates fluxes and their derivatives using analytical formulae and the selected numerical quadrature.Usually works best with the ChandrasekharsQuadrature
compute(double[]) - Method in class pulse.problem.schemes.rte.exact.NonscatteringDiscreteDerivatives
 
compute(double[]) - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
The superclass method will update the interpolation that the blackbody spectrum uses to evaluate the temperature profile and calculate the radiosities.A NORMALstatus is always returned.
compute(double[]) - Method in class pulse.problem.schemes.rte.RadiativeTransferSolver
Launches a calculation of the radiative transfer equation.
CONDUCTIVITY - pulse.properties.NumericPropertyKeyword
Thermal conductivity.
configure(GeneralTask) - Method in class pulse.search.direction.ComplexPath
In addition to the superclass method, resets the Hessian to an Identity matrix.
configure(GeneralTask) - Method in class pulse.search.direction.GradientGuidedPath
Resets the Path: calculates the current gradient and the direction of search.Sets the minimum point to 0.0.
ConfirmAction - Interface in pulse.ui.components.controllers
 
conformTo(UpwardsNavigable) - Method in class pulse.tasks.Calculation
 
ConstrictionMover - Class in pulse.search.direction.pso
 
ConstrictionMover() - Constructor for class pulse.search.direction.pso.ConstrictionMover
 
contains(double) - Method in class pulse.math.Segment
Checks whether x is contained inside this Segment.
contains(NumericPropertyKeyword) - Method in class pulse.ui.components.models.ParameterTableModel
 
contains(NumericPropertyKeyword) - Method in class pulse.ui.components.models.SelectedKeysModel
 
contents(Group) - Static method in class pulse.util.Group
Recursively analyses all Group objects that are identified as subgroups to root (explicitly checks that subgroups exclude parents of root) and chooses those for which an Exporter exists.
convert(double[], double[]) - Static method in interface pulse.DiscreteInput
 
convert(List<Double>, List<Double>) - Static method in interface pulse.DiscreteInput
 
convert(List<Flag>) - Static method in class pulse.properties.Flag
A static method for converting enabled flags to a List of NumericPropertyKeywords.
copy() - Method in class pulse.baseline.Baseline
 
copy() - Method in class pulse.baseline.FlatBaseline
 
copy() - Method in class pulse.baseline.LinearBaseline
 
copy() - Method in class pulse.baseline.SinusoidalBaseline
 
copy() - Method in class pulse.math.Parameter
 
copy() - Method in class pulse.problem.laser.ExponentiallyModifiedGaussian
 
copy() - Method in class pulse.problem.laser.NumericPulse
 
copy() - Method in class pulse.problem.laser.PulseTemporalShape
 
copy() - Method in class pulse.problem.laser.RectangularPulse
 
copy() - Method in class pulse.problem.laser.TrapezoidalPulse
 
copy() - Method in class pulse.problem.schemes.DifferenceScheme
Creates a DifferenceScheme, which is an exact copy of this object.
copy() - Method in class pulse.problem.schemes.Grid
Creates a new Grid object with exactly the same parameters as this one.
copy() - Method in class pulse.problem.schemes.Grid2D
 
copy() - Method in class pulse.problem.schemes.solvers.ADILinearisedSolver
 
copy() - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolverNL
 
copy() - Method in class pulse.problem.schemes.solvers.ExplicitLinearisedSolver
 
copy() - Method in class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
copy() - Method in class pulse.problem.schemes.solvers.ExplicitTranslucentSolver
 
copy() - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolverNL
 
copy() - Method in class pulse.problem.schemes.solvers.ImplicitDiathermicSolver
 
copy() - Method in class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
copy() - Method in class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
copy() - Method in class pulse.problem.schemes.solvers.ImplicitTranslucentSolver
 
copy() - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
copy() - Method in class pulse.problem.schemes.solvers.MixedCoupledSolverNL
 
copy() - Method in class pulse.problem.schemes.solvers.MixedLinearisedSolver
 
copy() - Method in class pulse.problem.statements.ClassicalProblem
 
copy() - Method in class pulse.problem.statements.ClassicalProblem2D
 
copy() - Method in class pulse.problem.statements.DiathermicMedium
 
copy() - Method in class pulse.problem.statements.model.AbsorptionModel
 
copy() - Method in class pulse.problem.statements.model.BeerLambertAbsorption
 
copy() - Method in class pulse.problem.statements.model.DiathermicProperties
 
copy() - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
copy() - Method in class pulse.problem.statements.model.Insulator
 
copy() - Method in class pulse.problem.statements.model.ThermalProperties
 
copy() - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
copy() - Method in class pulse.problem.statements.model.TwoTemperatureProperties
 
copy() - Method in class pulse.problem.statements.NonlinearProblem
 
copy() - Method in class pulse.problem.statements.ParticipatingMedium
 
copy() - Method in class pulse.problem.statements.PenetrationProblem
 
copy() - Method in class pulse.problem.statements.Problem
 
copy() - Method in class pulse.problem.statements.Pulse
 
copy() - Method in class pulse.problem.statements.Pulse2D
 
copy() - Method in class pulse.problem.statements.TwoTemperatureModel
 
copy() - Method in class pulse.search.statistics.AbsoluteDeviations
 
copy() - Method in class pulse.search.statistics.AICStatistic
 
copy() - Method in class pulse.search.statistics.BICStatistic
 
copy() - Method in class pulse.search.statistics.ModelSelectionCriterion
 
copy() - Method in class pulse.search.statistics.OptimiserStatistic
 
copy() - Method in class pulse.search.statistics.RangePenalisedLeastSquares
 
copy() - Method in class pulse.search.statistics.RegularisedLeastSquares
 
copy() - Method in class pulse.search.statistics.SumOfSquares
 
copyFrom(DifferenceScheme) - Method in class pulse.problem.schemes.DifferenceScheme
Copies the Grid and timeLimit from df.
copyToLastCalculation() - Method in class pulse.HeatingCurve
 
CornetteSchanksPF - Class in pulse.problem.schemes.rte.dom
The single-parameter Cornette-Schanks scattering phase function.
CornetteSchanksPF(ThermoOpticalProperties, Discretisation) - Constructor for class pulse.problem.schemes.rte.dom.CornetteSchanksPF
 
CORRELATION_THRESHOLD - pulse.properties.NumericPropertyKeyword
Threshold above which properties are thought to be strongly correlated.
CorrelationBuffer - Class in pulse.tasks.processing
 
CorrelationBuffer() - Constructor for class pulse.tasks.processing.CorrelationBuffer
 
CorrelationLogEntry - Class in pulse.tasks.logs
 
CorrelationLogEntry(SearchTask) - Constructor for class pulse.tasks.logs.CorrelationLogEntry
 
CorrelationTest - Class in pulse.search.statistics
 
CorrelationTest() - Constructor for class pulse.search.statistics.CorrelationTest
 
cosineTheta(int, int) - Method in class pulse.problem.schemes.rte.dom.PhaseFunction
Calculates the cosine of the scattering angle as the product of the two discrete cosine nodes.
CoupledImplicitScheme - Class in pulse.problem.schemes
 
CoupledImplicitScheme(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.CoupledImplicitScheme
 
CoupledImplicitScheme(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.CoupledImplicitScheme
 
cp() - Method in class pulse.problem.statements.model.Gas
 
cpuUsage() - Method in class pulse.util.ResourceMonitor
This will calculate the CPU load for the machine running PULsE.
create() - Method in class pulse.search.direction.pso.SwarmState
 
createDefaultTableHeader() - Method in class pulse.ui.components.ResultTable
 
createIdentityMatrix(int) - Static method in class pulse.math.linear.Matrices
Creates an identity matrix with its dimension equal to the argument
createMatrix(double[][]) - Static method in class pulse.math.linear.Matrices
Creates a square matrix out of data.
createSquareMatrix(double[][]) - Static method in class pulse.math.linear.Matrices
 
CSV - pulse.io.export.Extension
The result will be a tab-delimited CSV document.
CurveEvent - Class in pulse.input.listeners
A CurveEvent is associated with an HeatingCurve object.
CurveEvent(CurveEventType) - Constructor for class pulse.input.listeners.CurveEvent
Constructs a CurveEvent object, combining the type and associated data
CurveEventType - Enum in pulse.input.listeners
An event type associated with an HeatingCurve object.
CurveExporter - Class in pulse.io.export
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 - Interface in pulse.io.readers
Basic interface for reading ExperimentalData (which extends HeatingCurve -- hence the name).
curveReaders() - Static method in class pulse.io.readers.ReaderManager
Finds all classes assignable from CurveReader within this package.
CUTOFF - Static variable in class pulse.problem.schemes.rte.exact.ExponentialIntegrals
 
CUTOFF_FACTOR - Static variable in class pulse.input.ExperimentalData
This is the cutoff factor which is used as a criterion for data truncation.

D

d0 - Variable in class pulse.problem.schemes.rte.dom.HermiteInterpolator
 
d1 - Variable in class pulse.problem.schemes.rte.dom.HermiteInterpolator
 
DAMPING_RATIO - pulse.properties.NumericPropertyKeyword
Levenberg-Marquardt damping ratio.
data() - Method in class pulse.input.Metadata
Creates a list of data that contain all NumericProperty objects belonging to this Metadata and an InstanceDescriptor relating to the pulse shape.
data() - Method in class pulse.ui.components.ResultTable
 
data() - Method in class pulse.util.PropertyHolder
Lists all data contained in this PropertyHolder.
DATA_LOADED - pulse.input.listeners.DataEventType
All data points loaded and are ready for processing.
DataCollectionListener - Interface in pulse.tasks.listeners
 
DataEvent - Class in pulse.input.listeners
A DataEvent is used to track changes happening with a ExperimentalData.
DataEvent(DataEventType, AbstractData) - Constructor for class pulse.input.listeners.DataEvent
Constructs a DataEvent object, combining the type and associated data
DataEventType - Enum in pulse.input.listeners
An event type that is associated with an ExperimentalData object.
DataFrame - Class in pulse.ui.frames
 
DataFrame(PropertyHolder, Component) - Constructor for class pulse.ui.frames.DataFrame
Create the frame.
DataListener - Interface in pulse.input.listeners
A listener interface, which is used to listen to DataEvents occurring with an ExperimentalData object.
DataLoader - Class in pulse.ui.components
Manages loading the experimental time-temperature profiles, metadata files and InterpolationDatasets.
DataLogEntry - Class in pulse.tasks.logs
A LogEntry with a list of NumericProperties.
DataLogEntry(SearchTask) - Constructor for class pulse.tasks.logs.DataLogEntry
Creates a new DataLogEntry based on the current values of the properties from task which match the currently selected LogFormat.
DatasetReader - Interface in pulse.io.readers
An AbstractReader for reading tabular datasets and enhancing them with an interpolation algorithm.
datasetReaders() - Static method in class pulse.io.readers.ReaderManager
Finds all classes assignable from DatasetReader within this package.
DATReader - Class in pulse.io.readers
A specific implementation of CurveReader used to read .dat files.
def(NumericPropertyKeyword) - Static method in class pulse.properties.NumericProperties
Searches for the default NumericProperty corresponding to keyword in the list of pre-defined properties loaded from the respective .xml file.
DEFAULT_BINS - Static variable in class pulse.math.filters.RunningAverage
The binning factor used to build a crude approximation of the heating curve.
DEFAULT_C - Static variable in class pulse.search.direction.pso.ConstrictionMover
 
DEFAULT_CHI - Static variable in class pulse.search.direction.pso.ConstrictionMover
 
DEFAULT_CHI - Static variable in class pulse.search.direction.pso.FIPSMover
 
DEFAULT_CLASSIC_PRECISION - Static variable in class pulse.problem.statements.AdiabaticSolution
 
DEFAULT_PHI - Static variable in class pulse.search.direction.pso.FIPSMover
 
DEFAULT_POINTS - Static variable in class pulse.problem.statements.AdiabaticSolution
 
DEFAULT_SET - Static variable in class pulse.problem.schemes.rte.dom.OrdinateSet
 
DEFAULT_TABLEAU - Static variable in class pulse.problem.schemes.rte.dom.ButcherTableau
 
defaultList() - Static method in class pulse.properties.NumericProperties
 
defaultScheme() - Method in class pulse.problem.statements.ClassicalProblem
 
defaultScheme() - Method in class pulse.problem.statements.ClassicalProblem2D
 
defaultScheme() - Method in class pulse.problem.statements.DiathermicMedium
 
defaultScheme() - Method in class pulse.problem.statements.NonlinearProblem
 
defaultScheme() - Method in class pulse.problem.statements.ParticipatingMedium
 
defaultScheme() - Method in class pulse.problem.statements.PenetrationProblem
 
defaultScheme() - Method in class pulse.problem.statements.Problem
 
defaultScheme() - Method in class pulse.problem.statements.TwoTemperatureModel
 
deleteSelected() - Method in class pulse.ui.components.ResultTable
 
density(double, double) - Method in class pulse.problem.statements.model.Gas
 
DENSITY - pulse.properties.NumericPropertyKeyword
Density of the sample.
DENSITY - pulse.ui.components.buttons.LoaderButton.DataType
 
derivableProperties() - Method in class pulse.tasks.TaskManager
Creates a list of property keywords that can be derived with help of the loaded data.
derivative(double) - Method in class pulse.math.LegendrePoly
Calculates the derivative of this Legendre polynomial.
derivative(double) - Method in class pulse.problem.schemes.rte.dom.HermiteInterpolator
Calculates the derivative of the interpolant at x
derivative(int, double, double[], double[], int, int) - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
derivative(int, int, double, double) - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
DerivativeCalculator - Interface in pulse.problem.schemes.rte
This is basically a coupling interface between a Solver and a RadiativeTransferSolver.
derive(boolean) - Method in class pulse.properties.Flag
Creates a new Flag object based on this Flag, but with a different value.
derive(NumericPropertyKeyword, Number) - Static method in class pulse.properties.NumericProperties
Searches for the default NumericProperty corresponding to keyword in the list of pre-defined properties loaded from the respective .xml file, and if found creates a new {
describe() - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
describe() - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
describe() - Method in class pulse.tasks.logs.AbstractLogger
 
describe() - Method in class pulse.tasks.SearchTask
 
describe() - Method in class pulse.tasks.TaskManager
This TaskManager will be described by the sample name for the experiment.
describe() - Method in class pulse.ui.components.ResultTable
 
describe() - Method in interface pulse.util.Descriptive
Creates a String 'describing' this object, usually for exporting purposes.
describe() - Method in class pulse.util.PropertyHolder
 
describe() - Method in class pulse.util.UpwardsNavigable
Uses the SearchTask id (if present) to describe this UpwardsNavigable.
Descriptive - Interface in pulse.util
Provides the describe() functionality.
DescriptorChangeListener - Interface in pulse.util
 
descriptors() - Method in class pulse.tasks.processing.ResultFormat
Creates a List<String> of default descriptions corresponding to the list of keywords specific to NumericProperty objects.
deserialize() - Static method in class pulse.util.Serializer
 
deserialize(File) - Static method in class pulse.util.Serializer
 
det() - Method in class pulse.math.linear.SquareMatrix
Calculates the determinant for an n-by-n square matrix.
Details - Enum in pulse.tasks.logs
An enum which lists different possible problems wit the SearchTask.
DETECTOR_GAIN - pulse.properties.NumericPropertyKeyword
The detector gain (amplification).
DETECTOR_IRIS - pulse.properties.NumericPropertyKeyword
The detector iris (aperture).
determineShotID(BufferedReader, File) - Static method in class pulse.io.readers.NetzschCSVReader
 
DIAMETER - pulse.properties.NumericPropertyKeyword
Sample diameter.
DIATHERMIC_COEFFICIENT - pulse.properties.NumericPropertyKeyword
A dimensionless coefficient in the radiation flux expression for the radiative heat transfer between the front and the rear (coated) surfaces.
DiathermicMedium - Class in pulse.problem.statements
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.
DiathermicMedium() - Constructor for class pulse.problem.statements.DiathermicMedium
 
DiathermicMedium(Problem) - Constructor for class pulse.problem.statements.DiathermicMedium
 
DiathermicProperties - Class in pulse.problem.statements.model
 
DiathermicProperties() - Constructor for class pulse.problem.statements.model.DiathermicProperties
 
DiathermicProperties(ThermalProperties) - Constructor for class pulse.problem.statements.model.DiathermicProperties
 
DifferenceScheme - Class in pulse.problem.schemes
A DifferenceScheme is an abstract class that declares general methods for converting a Problem to a set of algebraic operations on a Grid.
DifferenceScheme() - Constructor for class pulse.problem.schemes.DifferenceScheme
A constructor which merely sets the time limit to its default value.
DifferenceScheme(NumericProperty) - Constructor for class pulse.problem.schemes.DifferenceScheme
A constructor for setting the time limit to a pre-set value.
DIFFUSIVITY - pulse.properties.NumericPropertyKeyword
The thermal diffusivity of the sample.
diffusivityRatio() - Method in class pulse.problem.statements.TwoTemperatureModel
Diffusivity of solid over diffusivity of gas
dimension() - Method in class pulse.math.linear.SquareMatrix
 
dimension() - Method in class pulse.math.linear.Vector
The dimension is simply the number of elements in a Vector
dimension() - Method in class pulse.math.ParameterVector
 
dimensionsMatch(RectangularMatrix) - Method in class pulse.math.linear.RectangularMatrix
Checks if the dimension of this Matrix and m match, i.e.
direction(GradientGuidedPath) - Method in interface pulse.search.direction.DirectionSolver
Finds the direction of the minimum using the previously calculated values stored in p.
direction(GradientGuidedPath) - Method in interface pulse.search.direction.HessianDirectionSolver
Uses an approximation of the Hessian matrix, containing the information on second derivatives, calculated with the BFGS formula in combination with the local value of the gradient to evaluate the direction of the minimum on p.
DirectionSolver - Interface in pulse.search.direction
 
DiscreteInput - Interface in pulse
 
DiscreteOrdinatesMethod - Class in pulse.problem.schemes.rte.dom
A class that manages the solution of the radiative transfer equation using the discrete ordinates method.
DiscreteOrdinatesMethod(ParticipatingMedium, Grid) - Constructor for class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
Constructs a discrete ordinates solver using the parameters (emissivity, scattering albedo and optical thickness) declared by the problem object.
DiscretePulse - Class in pulse.problem.laser
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.
DiscretePulse(Problem, Grid) - Constructor for class pulse.problem.laser.DiscretePulse
This creates a one-dimensional discrete pulse on a grid.
DiscretePulse2D - Class in pulse.problem.laser
The discrete pulse on a Grid2D.
DiscretePulse2D(ClassicalProblem2D, Grid2D) - Constructor for class pulse.problem.laser.DiscretePulse2D
The constructor for DiscretePulse2D.
discretePulseOn(Grid) - Method in class pulse.problem.statements.ClassicalProblem2D
 
discretePulseOn(Grid) - Method in class pulse.problem.statements.Problem
Constructs a DiscretePulse on the specified grid using the Pulse corresponding to this Problem.
DiscreteQuantities - Class in pulse.problem.schemes.rte.dom
Defines the main quantities calculated within the discrete ordinates method.
DiscreteQuantities(int, int) - Constructor for class pulse.problem.schemes.rte.dom.DiscreteQuantities
Constructs a set of quantities based on the specified spatial and angular discretisation.
DiscreteSelector<T extends Descriptive> - Class in pulse.util
 
DiscreteSelector(AbstractReader<T>, String, String) - Constructor for class pulse.util.DiscreteSelector
 
Discretisation - Class in pulse.problem.schemes.rte.dom
A class specifying the discretisation (both spatial and angular) scheme used to solve the radiative transfer equation with the discrete ordinates method.
Discretisation(ThermoOpticalProperties) - Constructor for class pulse.problem.schemes.rte.dom.Discretisation
Constructs a DiscreteIntensities with the default OrdinateSet and a new uniform grid.
dispose() - Method in class pulse.ui.frames.DataFrame
 
distanceToSq(Vector) - Method in class pulse.math.linear.Vector
Calculates the squared distance from this Vector to v (which is the squared length of the connecting Vector).
DistributedDetection - Class in pulse.problem.schemes
An interface providing the ability to calculate the integral signal out from a finite-depth material layer.
DistributedDetection() - Constructor for class pulse.problem.schemes.DistributedDetection
 
doFit(List<Double>, List<Double>) - Method in class pulse.baseline.Baseline
Calculates the baseline parameters based on input arguments.
doFit(List<Double>, List<Double>) - Method in class pulse.baseline.FlatBaseline
 
doFit(List<Double>, List<Double>) - Method in class pulse.baseline.LinearBaseline
 
doInterpolation() - Method in class pulse.input.InterpolationDataset
Constructs a new Akima spline interpolator and uses the available dataset to produce a SplineInterpolation.
doIterations(double[], double, int) - Method in interface pulse.problem.schemes.FixedPointIterations
Performs iterations until the convergence criterion is satisfied.The latter consists in having a difference two consequent iterations of V less than the specified error.
doIterations(AdaptiveIntegrator) - Method in class pulse.problem.schemes.rte.dom.FixedIterations
 
doIterations(AdaptiveIntegrator) - Method in class pulse.problem.schemes.rte.dom.IterativeSolver
De-facto solves the radiative transfer problem iteratively.
doIterations(AdaptiveIntegrator) - Method in class pulse.problem.schemes.rte.dom.SuccessiveOverrelaxation
 
DOM_DIRECTIONS - pulse.properties.NumericPropertyKeyword
Number of independent directions (DOM).
DOM_GRID_DENSITY - pulse.properties.NumericPropertyKeyword
Internal DOM grid density (RTE).
DOM_ITERATION_ERROR - pulse.properties.NumericPropertyKeyword
Iteration error tolerance in DOM calculations.
domain() - Method in class pulse.problem.schemes.CoupledImplicitScheme
 
domain() - Method in class pulse.problem.schemes.DifferenceScheme
Retrieves all problem statements that can be solved with this implementation of the difference scheme.
domain() - Method in class pulse.problem.schemes.solvers.ADILinearisedSolver
 
domain() - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
domain() - Method in class pulse.problem.schemes.solvers.ExplicitLinearisedSolver
 
domain() - Method in class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
domain() - Method in class pulse.problem.schemes.solvers.ExplicitTranslucentSolver
 
domain() - Method in class pulse.problem.schemes.solvers.ImplicitDiathermicSolver
 
domain() - Method in class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
domain() - Method in class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
domain() - Method in class pulse.problem.schemes.solvers.ImplicitTranslucentSolver
 
domain() - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
domain() - Method in class pulse.problem.schemes.solvers.MixedLinearisedSolver
 
domain(ParameterVector, Vector) - Static method in class pulse.search.linear.LinearOptimiser
Sets the domain for this linear search on p.
DONE - pulse.tasks.logs.Status
Task successfully finished.
dot(Vector) - Method in class pulse.math.linear.Vector
Calculates the scalar product of this and v.
DoubleTablePanel - Class in pulse.ui.components.panels
 
DoubleTablePanel(JTable, String, JTable, String) - Constructor for class pulse.ui.components.panels.DoubleTablePanel
 
dx(NumericProperty, double) - Method in class pulse.search.direction.GradientBasedOptimiser
Calculates the gradient step.
dye(BufferedImage, Color) - Static method in class pulse.util.ImageUtils
Credit to Marco13 (https://stackoverflow.com/questions/21382966/colorize-a-picture-in-java)
dye(ImageIcon, Color) - Static method in class pulse.util.ImageUtils
Credit to Werner Kvalem Vesterås (https://stackoverflow.com/questions/15053214/converting-an-imageicon-to-a-bufferedimage)

E

elements - Variable in class pulse.ui.components.models.ParameterTableModel
 
emission(double) - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
emissivePower(double) - Method in class pulse.problem.schemes.rte.BlackbodySpectrum
Calculates the emissive power.
EMISSIVITY - pulse.properties.NumericPropertyKeyword
Emissivity of the sample (nonlinear problems).
EmptyCorrelationTest - Class in pulse.search.statistics
 
EmptyCorrelationTest() - Constructor for class pulse.search.statistics.EmptyCorrelationTest
 
EmptyTest - Class in pulse.search.statistics
 
EmptyTest() - Constructor for class pulse.search.statistics.EmptyTest
 
EPS - Static variable in class pulse.search.direction.CompositePathOptimiser
For numerical comparison.
equals(Object) - Method in class pulse.AbstractData
 
equals(Object) - Method in class pulse.HeatingCurve
 
equals(Object) - Method in class pulse.input.ExperimentalData
 
equals(Object) - Method in class pulse.input.Metadata
 
equals(Object) - Method in class pulse.math.Harmonic
 
equals(Object) - Method in class pulse.math.linear.RectangularMatrix
Checks whether o is a SquareMatrix with matching dimensions and all elements of which are (approximately) equal to the respective elements of this matrix}.
equals(Object) - Method in class pulse.math.linear.Vector
Checks if o is logically equivalent to an instance of this class.
equals(Object) - Method in class pulse.math.ParameterIdentifier
 
equals(Object) - Method in class pulse.properties.Flag
 
equals(Object) - Method in class pulse.properties.NumericProperty
The Object o is considered to be equal to this NumericProperty if (a) it is of the same class; (b) its value is the same as for this NumericProperty, and (c) if it is specified by the same NumericPropertyKeyword.
equals(Object) - Method in class pulse.properties.SampleName
 
equals(Object) - Method in class pulse.search.statistics.ModelSelectionCriterion
 
equals(Object) - Method in class pulse.search.statistics.ResidualStatistic
 
equals(Object) - Method in class pulse.tasks.Calculation
 
equals(Object) - Method in class pulse.tasks.processing.AbstractResult
 
equals(Object) - Method in class pulse.tasks.processing.ResultFormat
 
equals(Object) - Method in class pulse.tasks.SearchTask
A SearchTask is deemed equal to another one if it has the same ExperimentalData.
equals(Object) - Method in class pulse.util.ImmutablePair
 
equals(Object) - Method in class pulse.util.InstanceDescriptor
 
EQUALS_TOLERANCE - Static variable in class pulse.math.MathUtils
 
ERROR_TOLERANCE - pulse.properties.NumericPropertyKeyword
The total error tolerance.
errorInCurrentUnits() - Method in class pulse.properties.NumericProperty
 
estimateSignalRange(ExperimentalData) - Method in class pulse.problem.statements.Problem
The signal range is defined as max{ T(t) } - min{ T(t) }, where max{...} and min{...} are robust to outliers.
evalPulseSpot() - Method in class pulse.problem.laser.DiscretePulse2D
Calculates the discretePulseSpot using the gridRadialDistance method.
evalRightBoundary(double, double) - Method in class pulse.problem.schemes.ImplicitScheme
 
evalRightBoundary(double, double) - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolver
 
evalRightBoundary(double, double) - Method in class pulse.problem.schemes.solvers.ImplicitDiathermicSolver
 
evalRightBoundary(double, double) - Method in class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
evalRightBoundary(double, double) - Method in class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
evalRightBoundary(double, double) - Method in class pulse.problem.schemes.solvers.ImplicitTranslucentSolver
 
evalRightBoundary(double, double) - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
evalRightBoundary(double, double) - Method in class pulse.problem.schemes.solvers.MixedCoupledSolver
 
evalRightBoundary(double, double) - Method in class pulse.problem.schemes.solvers.MixedLinearisedSolver
 
evaluate() - Method in class pulse.tasks.TaskManager
 
evaluate(double) - Method in class pulse.math.filters.PolylineOptimiser.PolylineResponse
 
evaluate(double) - Method in class pulse.math.FunctionWithInterpolation
Performs the calculation at t.
evaluate(double) - Method in class pulse.problem.statements.model.Gas
 
evaluate(double) - Method in interface pulse.Response
 
evaluate(double) - Method in class pulse.tasks.Calculation
 
evaluate(double[], double[]) - Method in class pulse.search.statistics.CorrelationTest
 
evaluate(double[], double[]) - Method in class pulse.search.statistics.EmptyCorrelationTest
 
evaluate(double[], double[]) - Method in class pulse.search.statistics.PearsonCorrelation
 
evaluate(double[], double[]) - Method in class pulse.search.statistics.SpearmansCorrelationTest
 
evaluate(double, double) - Method in class pulse.problem.statements.model.Gas
 
evaluate(int, int) - Method in interface pulse.math.Window
 
evaluate(String) - Static method in class pulse.io.readers.ExpressionParser
 
evaluate(GeneralTask) - Method in class pulse.search.direction.pso.Particle
 
evaluate(GeneralTask) - Method in class pulse.search.direction.pso.SwarmState
 
evaluate(GeneralTask) - Method in class pulse.search.statistics.AbsoluteDeviations
Calculates the L1 norm statistic, which simply sums up the absolute values of residuals.
evaluate(GeneralTask) - Method in class pulse.search.statistics.AndersonDarlingTest
 
evaluate(GeneralTask) - Method in class pulse.search.statistics.EmptyTest
 
evaluate(GeneralTask) - Method in class pulse.search.statistics.KSTest
 
evaluate(GeneralTask) - Method in class pulse.search.statistics.ModelSelectionCriterion
 
evaluate(GeneralTask) - Method in class pulse.search.statistics.RangePenalisedLeastSquares
 
evaluate(GeneralTask) - Method in class pulse.search.statistics.RegularisedLeastSquares
 
evaluate(GeneralTask) - Method in class pulse.search.statistics.RSquaredTest
Calculates the coefficient of determination, or simply the R2 value.
evaluate(GeneralTask) - Method in class pulse.search.statistics.Statistic
 
evaluate(GeneralTask) - Method in class pulse.search.statistics.SumOfSquares
Calculates the sum of squared deviations using curve as reference.
evaluate(CorrelationTest) - Method in class pulse.tasks.processing.CorrelationBuffer
 
evaluate(Calculation, Calculation) - Static method in class pulse.search.statistics.FTest
Evaluates the F-statistic for two calculations.
evaluateAlpha() - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
Calculates the alpha coefficients as part of the tridiagonal matrix algorithm.
evaluateAt(double) - Method in class pulse.problem.laser.ExponentiallyModifiedGaussian
Evaluates the laser power function.
evaluateAt(double) - Method in class pulse.problem.laser.NumericPulse
If the argument is less than the pulse width, uses a spline to interpolate the pulse data at time.
evaluateAt(double) - Method in class pulse.problem.laser.PulseTemporalShape
This evaluates the dimensionless, discretised pulse function on a grid needed to evaluate the heat source in the difference scheme.
evaluateAt(double) - Method in class pulse.problem.laser.RectangularPulse
 
evaluateAt(double) - Method in class pulse.problem.laser.TrapezoidalPulse
Calculates power using a piecewise function, which corresponds to either a linearly changing, a constant laser power or zero.
evaluateAt(double, double) - Method in class pulse.problem.laser.DiscretePulse2D
This calculates the dimensionless, discretised pulse function at a dimensionless radial coordinate coord.
evaluateBeta(double[]) - Method in class pulse.problem.schemes.BlockMatrixAlgorithm
 
evaluateBeta(double[]) - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
evaluateBeta(double[], int, int) - Method in class pulse.problem.schemes.BlockMatrixAlgorithm
 
evaluateBeta(double[], int, int) - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
Calculates the beta coefficients as part of the tridiagonal matrix algorithm.
evaluateSignal(AbsorptionModel, Grid, double[]) - Static method in class pulse.problem.schemes.DistributedDetection
Calculates the effective signal registered by the detector, which takes into account a distributed emission pattern.
excludePair(NumericPropertyKeyword, NumericPropertyKeyword) - Static method in class pulse.tasks.processing.CorrelationBuffer
 
excludePair(ImmutablePair<NumericPropertyKeyword>) - Static method in class pulse.tasks.processing.CorrelationBuffer
 
excludeSingle(NumericPropertyKeyword) - Static method in class pulse.tasks.processing.CorrelationBuffer
 
execute(SearchTask) - Method in class pulse.tasks.TaskManager
Executes t asynchronously using a CompletableFuture.
EXECUTE - pulse.ui.components.buttons.ExecutionButton.ExecutionState
 
executeAll() - Method in class pulse.tasks.TaskManager
Creates a queue of SearchTasks based on their readiness and feeds that queue to a ForkJoinPool using a parallel stream.
EXECUTION_ERROR - pulse.tasks.logs.Status
An error has occurred during execution.
ExecutionButton - Class in pulse.ui.components.buttons
 
ExecutionButton() - Constructor for class pulse.ui.components.buttons.ExecutionButton
 
ExecutionButton.ExecutionState - Enum in pulse.ui.components.buttons
 
ExitRequestListener - Interface in pulse.ui.components.listeners
 
ExperimentalData - Class in pulse.input
An ExperimentalData object is essentially a AbstractData with adjustable range and linked Metadata.
ExperimentalData() - Constructor for class pulse.input.ExperimentalData
Constructs an ExperimentalData object using the superclass constructor and creating a new list of data listeners.
ExplicitCoupledSolver - Class in pulse.problem.schemes.solvers
 
ExplicitCoupledSolver() - Constructor for class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
ExplicitCoupledSolver(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
ExplicitCoupledSolverNL - Class in pulse.problem.schemes.solvers
 
ExplicitCoupledSolverNL() - Constructor for class pulse.problem.schemes.solvers.ExplicitCoupledSolverNL
 
ExplicitCoupledSolverNL(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ExplicitCoupledSolverNL
 
ExplicitLinearisedSolver - Class in pulse.problem.schemes.solvers
Performs a fully-dimensionless calculation for the LinearisedProblem.
ExplicitLinearisedSolver() - Constructor for class pulse.problem.schemes.solvers.ExplicitLinearisedSolver
 
ExplicitLinearisedSolver(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ExplicitLinearisedSolver
 
ExplicitLinearisedSolver(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ExplicitLinearisedSolver
 
ExplicitNonlinearSolver - Class in pulse.problem.schemes.solvers
 
ExplicitNonlinearSolver() - Constructor for class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
ExplicitNonlinearSolver(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
ExplicitNonlinearSolver(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
ExplicitRungeKutta - Class in pulse.problem.schemes.rte.dom
Explicit Runge-Kutta integrator with Hermite interpolation for the solution of one-dimensional radiative transfer problems.
ExplicitRungeKutta(Discretisation) - Constructor for class pulse.problem.schemes.rte.dom.ExplicitRungeKutta
 
ExplicitScheme - Class in pulse.problem.schemes
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.
ExplicitScheme() - Constructor for class pulse.problem.schemes.ExplicitScheme
Constructs a default explicit scheme using the default values of GRID_DENSITY and TAU_FACTOR.
ExplicitScheme(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.ExplicitScheme
Constructs an explicit scheme on a one-dimensional grid that is specified by the values N and timeFactor.
ExplicitScheme(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.ExplicitScheme
Constructs an explicit scheme on a one-dimensional grid that is specified by the values N and timeFactor.
explicitSolution() - Method in class pulse.problem.schemes.ExplicitScheme
Uses the explicit finite-difference representation of the heat equation to calculate the grid-function everywhere except for the boundaries.
explicitSolution() - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
ExplicitTranslucentSolver - Class in pulse.problem.schemes.solvers
 
ExplicitTranslucentSolver() - Constructor for class pulse.problem.schemes.solvers.ExplicitTranslucentSolver
 
ExplicitTranslucentSolver(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ExplicitTranslucentSolver
 
ExponentialIntegrals - Class in pulse.problem.schemes.rte.exact
A factory class for creating and evaluating ExponentialIntegrals of orders from 1 to 4.
ExponentiallyModifiedGaussian - Class in pulse.problem.laser
Represents the exponentially modified Gaussian function, which is given by three independent parameters (μ, σ and λ).
ExponentiallyModifiedGaussian() - Constructor for class pulse.problem.laser.ExponentiallyModifiedGaussian
Creates an exponentially modified Gaussian with the default parameter values.
ExponentiallyModifiedGaussian(ExponentiallyModifiedGaussian) - Constructor for class pulse.problem.laser.ExponentiallyModifiedGaussian
 
export(Metadata, File, Extension) - Method in class pulse.io.export.MetadataExporter
Ignores metadata whose external IDs are negative, otherwise calls the superclass method.
export(T, File, Extension) - Method in interface pulse.io.export.Exporter
Exports the available contents to directory without asking a confirmation from the user.
export(T, File, Extension) - Static method in class pulse.io.export.ExportManager
Attempts to export the given target to the directory by saving the contents in a file with the given Extension.
exportAllResults(File, Extension) - Static method in class pulse.io.export.ExportManager
Exports all results generated previously during task execution for all tasks listed by the TaskManager, provided those tasks had the respective result assigned to them.
exportAllTasks(File, Extension) - Static method in class pulse.io.export.ExportManager
This will invoke exportGroup on each task listed by the TaskManager.
exportCurrentTask(File) - Static method in class pulse.io.export.ExportManager
Exports the currently selected task as a group of objects using the default export extension.
exportCurrentTask(File, Extension) - Static method in class pulse.io.export.ExportManager
Exports the currently selected task as a group of objects.
ExportDialog - Class in pulse.ui.frames.dialogs
 
ExportDialog() - Constructor for class pulse.ui.frames.dialogs.ExportDialog
 
Exporter<T extends Descriptive> - Interface in pulse.io.export
An Exporter defines a set of rules to enable exporting of a certain type of PULsE objects (typically, instances of the PropertyHolder class).
exportGroup(Group, File, Extension) - Static method in class pulse.io.export.ExportManager
Fully exports group and all its contents to the root directory requesting the files to be saved with the extension.
ExportManager - Class in pulse.io.export
Manages export operations.
ExpressionParser - Class in pulse.io.readers
Original source: https://stackoverflow.com/questions/3422673/how-to-evaluate-a-math-expression-given-in-string-form#3423360
ExtendedThermalProperties - Class in pulse.problem.statements.model
 
ExtendedThermalProperties() - Constructor for class pulse.problem.statements.model.ExtendedThermalProperties
 
ExtendedThermalProperties(ExtendedThermalProperties) - Constructor for class pulse.problem.statements.model.ExtendedThermalProperties
 
ExtendedThermalProperties(ThermalProperties) - Constructor for class pulse.problem.statements.model.ExtendedThermalProperties
 
extendedTo(ExperimentalData, Baseline) - Method in class pulse.HeatingCurve
This creates a new HeatingCurve to match the time boundaries of the data.
Extension - Enum in pulse.io.export
Describes the available extensions for the exported files.
extensionsMatch(File, String) - Static method in interface pulse.io.readers.AbstractHandler
Checks if the file suffix for file matches the extension.
ExternalDatasetListener - Interface in pulse.input.listeners
A listener associated with the InterpolationDataset static repository of interpolations.
ExternalGraphFrame<T> - Class in pulse.ui.frames
 
ExternalGraphFrame(String, AuxPlotter<T>, int, int) - Constructor for class pulse.ui.frames.ExternalGraphFrame
 
externalIdentifier(int) - Static method in class pulse.tasks.Identifier
 
extract(ThermoOpticalProperties) - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 

F

FAIL_SAFE_FACTOR - Static variable in class pulse.math.filters.HalfTimeCalculator
A fail-safe factor.
FAILED - pulse.tasks.logs.Status
Task has finished without errors, however failing to meet a statistical criterion.
FALSE_REJECTION_PROBABILITY - Static variable in class pulse.search.statistics.FTest
False-rejection probability for the F-test, equal to 0.05
fastAbs(double) - Static method in class pulse.math.MathUtils
A fast bitwise calculation of the absolute value.
fastExp(double) - Static method in class pulse.math.MathUtils
Approximate calculation of exp(val).
fastLog(double) - Static method in class pulse.math.MathUtils
A highly-approximate calculation of ln(val).
fastPowGeneral(double, double) - Static method in class pulse.math.MathUtils
Approximate calculation of ab.
fastPowInt(long, int) - Static method in class pulse.math.MathUtils
Rapid exponentiation where the base and the exponent are integer value.
fastPowLoop(double, int) - Static method in class pulse.math.MathUtils
Rapid calculation of b-th power of a, which is simply a repeated multiplication, in case of positive b, or a repeated division.
fastPowSgn(int) - Static method in class pulse.math.MathUtils
Rapid calculation of (-1)n using a ternary conditional operator.
fastTanh(double) - Static method in class pulse.math.MathUtils
A method for the approximate calculation of the hyperbolic tangent.
FFTTransformer - Class in pulse.math
 
FFTTransformer(double[]) - Constructor for class pulse.math.FFTTransformer
 
FFTTransformer(Window, double[]) - Constructor for class pulse.math.FFTTransformer
 
FFTTransformer(Window, double[], double[]) - Constructor for class pulse.math.FFTTransformer
 
fill(GeneralTask, int) - Method in class pulse.tasks.processing.Buffer
(Over)writes a buffer cell corresponding to the bufferElement with the current set of parameters of SearchTask and the search statistic.
filter(DiscreteInput) - Method in class pulse.input.Range
Contains a data double array ([0] - x, [1] - y), where the data points have been filtered so that each x fits into this range.
Filter - Interface in pulse.math.filters
 
filterProperties(AbstractResult) - Static method in class pulse.tasks.processing.AbstractResult
A static method for filtering the properties contained in the result to choose only those that conform to its format.
filterProperties(AbstractResult, ResultFormat) - Static method in class pulse.tasks.processing.AbstractResult
A static method for filtering the properties contained in the result to choose only those that conform to the format.
finaliseIteration(double[]) - Method in interface pulse.problem.schemes.FixedPointIterations
Finalises the current iteration.By default, does nothing.
finaliseIteration(double[]) - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolverNL
 
finaliseIteration(double[]) - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolverNL
 
finaliseIteration(double[]) - Method in class pulse.problem.schemes.solvers.MixedCoupledSolverNL
 
finaliseStep() - Method in class pulse.problem.schemes.CoupledImplicitScheme
 
finaliseStep() - Method in class pulse.problem.schemes.DifferenceScheme
 
finaliseStep() - Method in class pulse.problem.schemes.OneDimensionalScheme
Overwrites previously calculated temperature values with the calculations made at the current time step
finaliseStep() - Method in class pulse.problem.schemes.solvers.ADILinearisedSolver
 
finaliseStep() - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
finalize() - Method in class pulse.ui.Launcher
 
find(String) - Method in class pulse.util.DiscreteSelector
 
findAny(String) - Static method in enum pulse.properties.NumericPropertyKeyword
 
findBestCalculation() - Method in class pulse.tasks.SearchTask
Finds the best calculation by comparing those already stored by their model selection statistics.
findCurveReaders(String) - Static method in class pulse.io.readers.ReaderManager
Finds all classes assignable from CurveReader within the pckgname package.
findDatasetReaders(String) - Static method in class pulse.io.readers.ReaderManager
Finds all classes assignable from DatasetReader within the pckgname package.
findExporter(Class<T>) - Static method in class pulse.io.export.ExportManager
Finds an exporter that can work with target.
findExporter(T) - Static method in class pulse.io.export.ExportManager
Finds a suitable exporter for a non-null target by calling findExporter(target.getClass()).
findLineByLabel(BufferedReader, String, boolean) - Static method in class pulse.io.readers.NetzschCSVReader
 
findLineByLabel(BufferedReader, String, String, boolean) - Static method in class pulse.io.readers.NetzschCSVReader
 
findMalformedElements() - Method in class pulse.math.ParameterVector
Finds any elements of this vector which do not pass sanity checks.
findMalformedProperties() - Method in class pulse.problem.statements.model.ThermalProperties
 
findNested(Calculation, Calculation) - Static method in class pulse.search.statistics.FTest
Tests two models to see which one is nested in the other.
findPulseReaders(String) - Static method in class pulse.io.readers.ReaderManager
 
FINITE_DIFFERENCE_ERROR - pulse.problem.schemes.solvers.SolverException.SolverExceptionType
 
FIPSMover - Class in pulse.search.direction.pso
 
FIPSMover() - Constructor for class pulse.search.direction.pso.FIPSMover
 
fireDataChanged(DataEvent) - Method in class pulse.input.ExperimentalData
 
fireDescriptorChange() - Method in class pulse.util.DiscreteSelector
 
firePropertyChanged(Object, Property) - Method in class pulse.util.PropertyHolder
 
fireStatusUpdate(RTECalculationStatus) - Method in class pulse.problem.schemes.rte.RadiativeTransferSolver
 
fireTaskSelected(Object) - Method in class pulse.tasks.TaskManager
 
firstBeta() - Method in class pulse.problem.schemes.ImplicitScheme
 
firstBeta() - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolver
 
firstBeta() - Method in class pulse.problem.schemes.solvers.ImplicitDiathermicSolver
 
firstBeta() - Method in class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
firstBeta() - Method in class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
firstBeta() - Method in class pulse.problem.schemes.solvers.ImplicitTranslucentSolver
 
firstBeta() - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
firstBeta() - Method in class pulse.problem.schemes.solvers.MixedCoupledSolver
 
firstBeta() - Method in class pulse.problem.schemes.solvers.MixedLinearisedSolver
 
firstMoment(double[][], int) - Method in class pulse.problem.schemes.rte.dom.Discretisation
Calculates the first moment iwiμiextij, which can be applied e.g.
fitTo(List<Double>, List<Double>) - Method in class pulse.baseline.Baseline
 
fitTo(DiscreteInput) - Method in class pulse.baseline.Baseline
Calls fitTo using the default time range for the data: -Infinity < t < ZERO_LEFT, where the upper bound is a small negative constant.
fitTo(DiscreteInput) - Method in class pulse.baseline.SinusoidalBaseline
 
FixedIntervalIntegrator - Class in pulse.math
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.
FixedIntervalIntegrator(Segment) - Constructor for class pulse.math.FixedIntervalIntegrator
Creates a FixedIntervalIntegrator with the specified integration bounds and a default number of integration segments.
FixedIntervalIntegrator(Segment, NumericProperty) - Constructor for class pulse.math.FixedIntervalIntegrator
Creates a FixedIntervalIntegrator with the specified integration bounds number of integration segments.
FixedIterations - Class in pulse.problem.schemes.rte.dom
 
FixedIterations() - Constructor for class pulse.problem.schemes.rte.dom.FixedIterations
 
FixedPointIterations - Interface in pulse.problem.schemes
 
Flag - Class in pulse.properties
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).
Flag(Flag) - Constructor for class pulse.properties.Flag
 
Flag(NumericPropertyKeyword) - Constructor for class pulse.properties.Flag
Creates a Flag with the type type.
Flag(NumericPropertyKeyword, boolean) - Constructor for class pulse.properties.Flag
 
Flag(NumericProperty, boolean) - Constructor for class pulse.properties.Flag
Creates a Flag with the following pre-specified parameters: type type, short description abbreviations, and value.
FLAT_TOP - Static variable in interface pulse.math.Window
 
FlatBaseline - Class in pulse.baseline
A flat baseline.
FlatBaseline() - Constructor for class pulse.baseline.FlatBaseline
A primitive constructor, which initialises a CONSTANT baseline with zero intercept and slope.
FlatBaseline(double) - Constructor for class pulse.baseline.FlatBaseline
Creates a flat baseline equal to the argument.
flux(int) - Method in class pulse.problem.schemes.rte.dom.Discretisation
Calculates the net flux at j.
flux(int) - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
 
flux(int, int, int) - Method in class pulse.problem.schemes.rte.dom.Discretisation
Calculates the partial flux by performing a simple summation bounded by the arguments.
fluxDerivative(int) - Method in interface pulse.problem.schemes.rte.DerivativeCalculator
Calculates the flux derivative at the uIndex grid point.
fluxDerivative(int) - Method in class pulse.problem.schemes.rte.FluxesAndExplicitDerivatives
 
fluxDerivative(int) - Method in class pulse.problem.schemes.rte.FluxesAndImplicitDerivatives
 
fluxDerivativeFront() - Method in interface pulse.problem.schemes.rte.DerivativeCalculator
Calculates the flux derivative at the front surface.
fluxDerivativeFront() - Method in class pulse.problem.schemes.rte.FluxesAndExplicitDerivatives
 
fluxDerivativeFront() - Method in class pulse.problem.schemes.rte.FluxesAndImplicitDerivatives
 
fluxDerivativeRear() - Method in interface pulse.problem.schemes.rte.DerivativeCalculator
Calculates the flux derivative at the rear surface.
fluxDerivativeRear() - Method in class pulse.problem.schemes.rte.FluxesAndExplicitDerivatives
 
fluxDerivativeRear() - Method in class pulse.problem.schemes.rte.FluxesAndImplicitDerivatives
 
fluxes() - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
Calculates the radiative fluxes on the grid specified in the constructor arguments.
Fluxes - Class in pulse.problem.schemes.rte
 
Fluxes(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.rte.Fluxes
 
FluxesAndExplicitDerivatives - Class in pulse.problem.schemes.rte
 
FluxesAndExplicitDerivatives(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.rte.FluxesAndExplicitDerivatives
 
FluxesAndImplicitDerivatives - Class in pulse.problem.schemes.rte
 
FluxesAndImplicitDerivatives(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.rte.FluxesAndImplicitDerivatives
 
fluxLeft(BlackbodySpectrum) - Method in class pulse.problem.schemes.rte.dom.Discretisation
Calculates the flux at the left boundary using an alternative formula.
fluxRight(BlackbodySpectrum) - Method in class pulse.problem.schemes.rte.dom.Discretisation
Calculates the flux at the right boundary using an alternative formula.
format(double, StringBuffer, FieldPosition) - Method in class pulse.properties.ScientificFormat
 
format(long, StringBuffer, FieldPosition) - Method in class pulse.properties.ScientificFormat
 
FormattedInputDialog - Class in pulse.ui.frames.dialogs
 
FormattedInputDialog(NumericProperty) - Constructor for class pulse.ui.frames.dialogs.FormattedInputDialog
 
formattedOutput() - Method in class pulse.properties.NumericProperty
Uses a NumericPropertyFormatter to generate a formatted output
formattedOutput() - Method in interface pulse.properties.Property
Formats the value so that it is suitable for output using the GUI or console.
FOV_INNER - pulse.properties.NumericPropertyKeyword
The inner field of view diameter for the detector sighting.
FOV_OUTER - pulse.properties.NumericPropertyKeyword
The outer field of view diameter for the detector sighting.
FrameVisibilityRequestListener - Interface in pulse.ui.components.listeners
 
fromAbbreviation(String) - Method in class pulse.tasks.processing.ResultFormat
Finds a NumericPropertyKeyword contained in the nameMap, the description of which matches descriptor.
FTest - Class in pulse.search.statistics
A static class for testing two calculations based on the Fischer test (F-Test) implemented in Apache Commons Math.
fullSum(int, int) - Method in class pulse.problem.schemes.rte.dom.PhaseFunction
 
function(int, int) - Method in class pulse.problem.schemes.rte.dom.CornetteSchanksPF
 
function(int, int) - Method in class pulse.problem.schemes.rte.dom.HenyeyGreensteinPF
 
function(int, int) - Method in class pulse.problem.schemes.rte.dom.LinearAnisotropicPF
 
function(int, int) - Method in class pulse.problem.schemes.rte.dom.PhaseFunction
 
FunctionSerializer - Class in pulse.util
 
FunctionWithInterpolation - Class in pulse.math
An abstract class for univariate functions with the capacity of spline interpolation.
FunctionWithInterpolation(Segment) - Constructor for class pulse.math.FunctionWithInterpolation
Creates a FunctionWithInterpolation using the parameterBounds and a default number of points 8192.
FunctionWithInterpolation(Segment, int) - Constructor for class pulse.math.FunctionWithInterpolation
Constructs a FunctionWithInterpolation by tabulating the function values within the parameterBounds at discrete nodes, the number of which is given by the second argument.

G

Gas - Class in pulse.problem.statements.model
 
Gas(int, double) - Constructor for class pulse.problem.statements.model.Gas
 
GAS_EXCHANGE_COEFFICIENT - pulse.properties.NumericPropertyKeyword
Energy exchange coefficient in the two-temperature model (g').
generalisedBinomial(double, int) - Static method in class pulse.math.LegendrePoly
Calculates the generalised binomial coefficient.
GeneralTask<I extends DiscreteInput,​R extends Response> - Class in pulse.search
 
GeneralTask() - Constructor for class pulse.search.GeneralTask
 
generate(int) - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
generateFormat(List<NumericPropertyKeyword>) - Static method in class pulse.tasks.processing.ResultFormat
 
generateGrid(int) - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
Generates a uniform grid using the argument as the density.
generateGrid(int) - Method in class pulse.problem.schemes.rte.dom.TRBDF2
Generates a non-uniform (stretched at boundaries) grid using the argument as the density.
generateTask(File) - Method in class pulse.tasks.TaskManager
Generates a SearchTask assuming that the ExperimentalData is stored in the file.
generateTasks(List<File>) - Method in class pulse.tasks.TaskManager
Generates multiple tasks from multiple files.
generateUniform(boolean) - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
generateUniformBase(int, boolean) - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
genericProperties() - Method in class pulse.search.direction.PathOptimiser
This method has been overriden to account for each individual flag in the List<Flag> set out by this class.
genericProperties() - Method in class pulse.util.Accessible
Tries to access the property getter methods in this Accessible, which should be declared as no-argument methods with a specific return type.
genericProperty(Property) - Method in class pulse.util.Accessible
Recursively searches for a Property from the non-unique list of generic properties in this Accessible by comparing its class to sameClass.getClass().
get(int) - Method in class pulse.math.linear.Vector
Gets the component of this Vector specified by index
get(int) - Static method in class pulse.problem.schemes.rte.exact.ExponentialIntegrals
Retrieves the pre-calculated interpolation functions for the exponential integrals.
get(int, int) - Method in class pulse.math.linear.RectangularMatrix
 
get(NumericPropertyKeyword) - Static method in class pulse.search.direction.ActiveFlags
 
getAbbreviation(boolean) - Method in class pulse.properties.NumericProperty
 
getAbsoluteTolerance() - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
getAbsorptionModel() - Method in class pulse.problem.statements.PenetrationProblem
 
getAbsorptionSelector() - Method in class pulse.problem.statements.PenetrationProblem
 
getAbsorptivity(SpectralRange) - Method in class pulse.problem.statements.model.AbsorptionModel
 
getAllDescriptors() - Method in class pulse.util.InstanceDescriptor
 
getAllFlags() - Static method in class pulse.search.direction.ActiveFlags
 
getAllOptions() - Method in class pulse.util.DiscreteSelector
 
getAlpha() - Method in class pulse.problem.schemes.rte.exact.CompositionProduct
 
getAlpha() - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
getAmplitude() - Method in class pulse.math.filters.Randomiser
 
getAmplitude() - Method in class pulse.math.Harmonic
 
getAmpltiudeSpectrum() - Method in class pulse.math.FFTTransformer
 
getAnisotropyFactor() - Method in class pulse.problem.schemes.rte.dom.PhaseFunction
 
getApparentValue() - Method in class pulse.math.Parameter
 
getBaseline() - Method in class pulse.problem.statements.Problem
Return the Baseline of this Problem.
getBaselineCorrectedData() - Method in class pulse.HeatingCurve
 
getBaselineDescriptor() - Method in class pulse.problem.statements.Problem
 
getBestSoFar() - Method in class pulse.search.direction.pso.SwarmState
 
getBestSoFarIndex() - Method in class pulse.search.direction.pso.SwarmState
 
getBestState() - Method in class pulse.search.direction.pso.Particle
Returns the personal best state ever achieved by the particle.
getBestState() - Method in class pulse.search.GeneralTask
 
getBeta() - Method in class pulse.problem.schemes.rte.exact.CompositionProduct
 
getBeta() - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
getBinCount() - Method in class pulse.ui.components.ResidualsChart
 
getBounds() - Method in class pulse.math.AbstractIntegrator
Retrieves the integration bounds
getBounds() - Method in class pulse.math.Parameter
 
getBounds() - Method in class pulse.math.transforms.BoundedParameterTransform
 
getBounds() - Method in class pulse.properties.NumericProperty
Represents the bounds specified for this numeric property as a Segment object.
getBounds() - Method in class pulse.properties.NumericPropertyFormatter
 
getBuffer() - Method in class pulse.search.GeneralTask
 
getButcherTableau() - Method in class pulse.problem.schemes.rte.dom.ExplicitRungeKutta
 
getC() - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
getCalculationStatus() - Method in class pulse.problem.schemes.CoupledImplicitScheme
 
getCellEditor(int, int) - Method in class pulse.ui.components.PropertyHolderTable
 
getCellEditorValue() - Method in class pulse.ui.components.controllers.ButtonEditor
 
getCellEditorValue() - Method in class pulse.ui.components.controllers.InstanceCellEditor
 
getCellEditorValue() - Method in class pulse.ui.components.controllers.NumberEditor
 
getCellRenderer(int, int) - Method in class pulse.ui.components.CalculationTable
 
getCellRenderer(int, int) - Method in class pulse.ui.components.PropertyHolderTable
 
getCellRenderer(int, int) - Method in class pulse.ui.components.ResultTable
 
getCellRenderer(int, int) - Method in class pulse.ui.components.TaskTable
 
getCharacteristicTime() - Method in class pulse.problem.laser.DiscretePulse
Gets the dimensional factor required to convert real time variable into a dimensional variable, defined in the Problem class
getChart() - Method in class pulse.ui.components.AuxPlotter
 
getChart() - Method in class pulse.ui.frames.ExternalGraphFrame
 
getChart() - Method in class pulse.ui.frames.InternalGraphFrame
 
getChart() - Static method in class pulse.ui.frames.MainGraphFrame
 
getChartPanel() - Method in class pulse.ui.components.AuxPlotter
 
getChartPanel() - Method in class pulse.ui.components.Chart
 
getChartPlot() - Method in class pulse.ui.components.Chart
 
getCoefA() - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
getCoefB() - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
getCoefC() - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
getColor() - Method in enum pulse.problem.statements.ProblemComplexity
 
getColor() - Method in enum pulse.tasks.logs.Status
 
getColumnCount() - Method in class pulse.ui.components.models.ParameterTableModel
 
getColumnCount() - Method in class pulse.ui.components.models.SelectedKeysModel
 
getCombinedAbsorptivity() - Method in class pulse.problem.statements.model.AbsorptionModel
 
getCombinedLosses() - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
getComplexity() - Method in class pulse.problem.statements.Problem
 
getConductivity() - Method in class pulse.problem.statements.model.Gas
 
getConfirmAction() - Method in class pulse.ui.frames.dialogs.FormattedInputDialog
 
getConvectiveLosses() - Method in class pulse.problem.statements.model.DiathermicProperties
 
getConvectiveLosses() - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
getCorrelationBuffer() - Method in class pulse.tasks.SearchTask
 
getCorrelationTest() - Method in class pulse.tasks.SearchTask
 
getCost() - Method in class pulse.search.direction.IterativeState
 
getCoupling() - Method in class pulse.problem.schemes.CoupledImplicitScheme
 
getCoupling() - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
getCpuUsage() - Method in class pulse.util.ResourceMonitor
 
getCurrentPulseValue() - Method in class pulse.problem.schemes.DifferenceScheme
 
getCurrentSolution() - Method in class pulse.problem.schemes.OneDimensionalScheme
 
getCurrentState() - Method in class pulse.search.direction.pso.Particle
Returns the current state (position, velocity, fitness) of the particle.
getCurrentVersion() - Static method in class pulse.ui.Version
 
getCurveExtensions() - Static method in class pulse.io.readers.ReaderManager
Returns a list of extensions recognised by the available CurveReaders.
getCutoff() - Method in class pulse.problem.schemes.rte.exact.NewtonCotesQuadrature
 
getDampingRatio() - Method in class pulse.search.direction.LMOptimiser
 
getData() - Method in class pulse.input.InterpolationDataset
Extracts all data available in this InterpolationDataset.
getData() - Method in class pulse.input.listeners.DataEvent
Used to get the ExperimentalData object that has undergone certain changes specified by this event type.
getData() - Method in class pulse.math.filters.HalfTimeCalculator
 
getData() - Method in class pulse.math.linear.RectangularMatrix
 
getData() - Method in class pulse.math.linear.Vector
 
getData() - Method in class pulse.problem.laser.NumericPulse
 
getData() - Method in class pulse.tasks.logs.DataLogEntry
 
getData() - Method in class pulse.tasks.processing.Buffer
Retrieves the contents of this Buffer.
getData() - Method in class pulse.ui.components.models.ParameterTableModel
 
getData() - Method in class pulse.ui.components.models.SelectedKeysModel
 
getDataObject() - Method in class pulse.ui.frames.DataFrame
 
getDataset() - Method in class pulse.ui.components.buttons.LoaderButton
 
getDatasetExtensions() - Static method in class pulse.io.readers.ReaderManager
Returns a list of extensions recognised by the available DatasetReaders.
getDefaultExportExtension() - Static method in interface pulse.io.export.Exporter
Gets the default export extension.
getDefaultSelection() - Method in class pulse.util.DiscreteSelector
 
getDelims() - Static method in class pulse.io.readers.NetzschCSVReader
Get the standard delimiter chars.
getDensity() - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
getDensity() - Method in class pulse.problem.schemes.rte.Fluxes
 
getDensity() - Method in class pulse.problem.statements.model.ThermalProperties
 
getDensityDataset() - Method in class pulse.tasks.TaskManager
 
getDerivative(int, int) - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
getDerivatives() - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
getDescriptor() - Method in class pulse.baseline.Baseline
 
getDescriptor() - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
getDescriptor() - Method in class pulse.problem.schemes.rte.dom.Discretisation
 
getDescriptor() - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
getDescriptor() - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
getDescriptor() - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
 
getDescriptor() - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
getDescriptor() - Method in class pulse.problem.statements.model.ThermalProperties
 
getDescriptor() - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
getDescriptor() - Method in class pulse.search.statistics.AbsoluteDeviations
 
getDescriptor() - Method in class pulse.search.statistics.AICStatistic
 
getDescriptor() - Method in class pulse.search.statistics.AndersonDarlingTest
 
getDescriptor() - Method in class pulse.search.statistics.BICStatistic
 
getDescriptor() - Method in class pulse.search.statistics.EmptyCorrelationTest
 
getDescriptor() - Method in class pulse.search.statistics.EmptyTest
 
getDescriptor() - Method in class pulse.search.statistics.KSTest
 
getDescriptor() - Method in class pulse.search.statistics.PearsonCorrelation
 
getDescriptor() - Method in class pulse.search.statistics.RangePenalisedLeastSquares
 
getDescriptor() - Method in class pulse.search.statistics.RegularisedLeastSquares
 
getDescriptor() - Method in class pulse.search.statistics.RSquaredTest
 
getDescriptor() - Method in class pulse.search.statistics.SpearmansCorrelationTest
 
getDescriptor() - Method in class pulse.search.statistics.SumOfSquares
 
getDescriptor() - Method in class pulse.util.Group
The same as getSimpleName in this implementation.
getDescriptor() - Method in class pulse.util.PropertyHolder
If not null, will return the prefix, otherwise calls the superclass method.
getDescriptor(boolean) - Method in class pulse.properties.Flag
Creates a short description for the GUI.
getDescriptor(boolean) - Method in class pulse.properties.NumericProperty
 
getDescriptor(boolean) - Method in interface pulse.properties.Property
Creates a String to describe this property (often used in GUI applications).
getDescriptor(boolean) - Method in class pulse.properties.SampleName
 
getDescriptor(boolean) - Method in class pulse.util.DiscreteSelector
 
getDescriptor(boolean) - Method in class pulse.util.InstanceDescriptor
 
getDetailedMessage() - Method in enum pulse.tasks.logs.Status
 
getDetails() - Method in enum pulse.tasks.logs.Status
 
getDiathermicCoefficient() - Method in class pulse.problem.statements.model.DiathermicProperties
 
getDiffusivity() - Method in class pulse.problem.statements.model.ThermalProperties
 
getDimension() - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
getDimensionDelta() - Method in class pulse.properties.NumericProperty
 
getDimensionFactor() - Method in class pulse.properties.NumericProperty
 
getDirection() - Method in class pulse.search.direction.GradientGuidedPath
 
getDiscreteIntensities() - Method in class pulse.problem.schemes.rte.dom.PhaseFunction
 
getDiscretePulse() - Method in class pulse.problem.schemes.DifferenceScheme
Gets the discrete representation of Pulse on the Grid.
getDiscretePulseSpot() - Method in class pulse.problem.laser.DiscretePulse2D
 
getDiscreteWidth() - Method in class pulse.problem.laser.DiscretePulse
Gets the discrete dimensionless pulse width, which is a multiplier of the current grid timestep.
getDiscretisation() - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
getEffectiveEndTime() - Method in class pulse.input.ExperimentalData
Gets the time sequence element corresponding to the upper bound of the index range
getEffectiveStartTime() - Method in class pulse.input.ExperimentalData
Gets the time sequence element corresponding to the lower bound of the index range
getElementAt(int) - Method in class pulse.ui.components.models.ParameterTableModel
 
getElementAt(int) - Method in class pulse.ui.components.models.SelectedKeysModel
 
getElementAt(int) - Method in class pulse.ui.components.models.TaskBoxModel
 
getEmissionFunction() - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
getEmissionFunction() - Method in class pulse.problem.schemes.rte.exact.CompositionProduct
 
getEmissionFunction() - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
 
getEmissivity() - Method in class pulse.problem.statements.model.ThermalProperties
 
getEnd() - Method in class pulse.tasks.logs.Log
This is the time after the creation of the Log when a change of status to DONE happened.
getError() - Method in class pulse.properties.NumericProperty
 
getErrorTolerance() - Method in class pulse.search.direction.PathOptimiser
 
getEstimator() - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
getExcludeKeywords() - Method in class pulse.properties.NumericProperty
 
getExecutionState() - Method in class pulse.ui.components.buttons.ExecutionButton
 
getExternalID() - Method in class pulse.input.Metadata
Gets the external ID usually specified in the experimental files.
getExternalID() - Method in class pulse.problem.laser.NumericPulseData
Gets the external ID usually specified in the experimental files.
getFailedAttempts() - Method in class pulse.search.direction.IterativeState
 
getFilteredAverage() - Method in class pulse.math.ZScore
 
getFilteredMaximum() - Method in class pulse.math.filters.HalfTimeCalculator
 
getFilteredStdev() - Method in class pulse.math.ZScore
 
getFirst() - Method in class pulse.util.ImmutablePair
 
getFirstNegativeNode() - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
getFirstPositiveNode() - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
getFitness() - Method in class pulse.search.direction.pso.ParticleState
 
getFlux(int) - Method in class pulse.problem.schemes.rte.Fluxes
Retrieves the currently calculated flux at the i grid point
getFluxDerivative(int) - Method in class pulse.problem.schemes.rte.FluxesAndExplicitDerivatives
 
getFluxes() - Method in class pulse.problem.schemes.rte.RadiativeTransferSolver
 
getFormat() - Method in class pulse.tasks.processing.AbstractResult
 
getFormat() - Method in class pulse.ui.components.models.ResultTableModel
 
getFOVInner() - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
getFOVOuter() - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
getFrequency() - Method in class pulse.math.Harmonic
 
getGamma() - Method in class pulse.problem.schemes.BlockMatrixAlgorithm
 
getGas() - Method in class pulse.problem.statements.TwoTemperatureModel
 
getGasExchangeCoefficient() - Method in class pulse.problem.statements.model.TwoTemperatureProperties
 
getGasHeatLoss() - Method in class pulse.problem.statements.model.TwoTemperatureProperties
 
getGasSelector() - Method in class pulse.problem.statements.TwoTemperatureModel
 
getGeometricFactor() - Method in class pulse.problem.statements.ClassicalProblem
 
getGradient() - Method in class pulse.search.direction.GradientGuidedPath
 
getGradientResolution() - Method in class pulse.search.direction.GradientBasedOptimiser
 
getGradientStep() - Method in class pulse.search.direction.GradientBasedOptimiser
 
getGrid() - Method in class pulse.problem.laser.DiscretePulse
Gets the Grid object used to construct this DiscretePulse
getGrid() - Method in class pulse.problem.schemes.DifferenceScheme
Gets the Grid object defining partioning used in this DifferenceScheme
getGrid() - Method in class pulse.problem.schemes.rte.dom.Discretisation
 
getGridDensity() - Method in class pulse.problem.schemes.Grid
Retrieves the value of the gridDensity used to calculate the hx and tau.
getGridDensityValue() - Method in class pulse.problem.schemes.Grid
 
getGridPoints() - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
getGridScalingFactor() - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
getGridStep() - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
getGUIComponent() - Method in class pulse.tasks.logs.AbstractLogger
 
getGUIComponent() - Method in class pulse.ui.components.GraphicalLogPane
 
getGUIComponent() - Method in class pulse.ui.components.TextLogPane
 
getHalfAlbedo() - Method in class pulse.problem.schemes.rte.dom.PhaseFunction
 
getHalfLength() - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
getHalfTime() - Method in class pulse.math.filters.HalfTimeCalculator
Retrieves the half-time value of this dataset, which is equal to the time needed to reach half of the signal maximum.
getHalfTimeCalculator() - Method in class pulse.input.ExperimentalData
 
getHarmonics() - Method in class pulse.baseline.SinusoidalBaseline
 
getHeatingCurve() - Method in class pulse.problem.statements.Problem
 
getHeatLoss() - Method in class pulse.problem.statements.model.ThermalProperties
Assuming that Bi1 = Bi2, returns the value of Bi1.
getHermiteInterpolator() - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
getHessian() - Method in class pulse.search.direction.ComplexPath
 
getHideDetailsCheckBox() - Method in class pulse.ui.components.panels.SettingsToolBar
 
getHierarchyListeners() - Method in class pulse.util.UpwardsNavigable
 
getHiFreqMax() - Method in class pulse.baseline.SinusoidalBaseline
 
getIcon() - Method in enum pulse.ui.components.buttons.ExecutionButton.ExecutionState
 
getId() - Method in class pulse.search.direction.pso.Particle
 
getId() - Method in class pulse.tasks.listeners.TaskRepositoryEvent
 
getIdentifier() - Method in class pulse.math.Parameter
 
getIdentifier() - Method in class pulse.tasks.logs.Log
 
getIdentifier() - Method in class pulse.tasks.logs.LogEntry
 
getIdentifier() - Method in class pulse.tasks.SearchTask
 
getIndex() - Method in class pulse.math.ParameterIdentifier
 
getIndexRange() - Method in interface pulse.DiscreteInput
 
getIndexRange() - Method in class pulse.input.ExperimentalData
Gets the index range of this data.
getIndexRange() - Method in class pulse.problem.laser.NumericPulseData
 
getIndividualResults() - Method in class pulse.tasks.processing.AverageResult
This will analyse the list of AbstractResults used for calculation of the mean and find all associated individual results.
getInput() - Method in class pulse.search.GeneralTask
 
getInput() - Method in class pulse.search.SimpleOptimisationTask
 
getInput() - Method in class pulse.tasks.SearchTask
 
getInstance() - Static method in class pulse.io.export.CurveExporter
Returns the single instance of this subclass.
getInstance() - Static method in class pulse.io.export.LogExporter
Gets the only static instance of this subclass.
getInstance() - Static method in class pulse.io.export.MetadataExporter
Retrieves the single instance of this class.
getInstance() - Static method in class pulse.io.export.RawDataExporter
Retrieves the single static instance of this class
getInstance() - Static method in class pulse.io.export.ResidualStatisticExporter
Retrieves the single instance of this class.
getInstance() - Static method in class pulse.io.export.ResultExporter
Returns the single static instance of this class.
getInstance() - Static method in class pulse.io.export.ResultTableExporter
Gets the single instance of this class.
getInstance() - Static method in class pulse.io.export.TextLogPaneExporter
Gets the only static instance of this subclass.
getInstance() - Static method in class pulse.io.readers.ButcherTableauReader
 
getInstance() - Static method in class pulse.io.readers.DATReader
As this class uses the singleton pattern, only one instance is created using an empty no-argument constructor.
getInstance() - Static method in class pulse.io.readers.LFRReader
Retrieves the single instance of this class.
getInstance() - Static method in class pulse.io.readers.MetaFilePopulator
Gets the single instance of this class.
getInstance() - Static method in class pulse.io.readers.NetzschCSVReader
As this class uses the singleton pattern, only one instance is created using an empty no-argument constructor.
getInstance() - Static method in class pulse.io.readers.NetzschPulseCSVReader
As this class uses the singleton pattern, only one instance is created using an empty no-argument constructor.
getInstance() - Static method in class pulse.io.readers.QuadratureReader
Returns the single instance of this class.
getInstance() - Static method in class pulse.io.readers.TBLReader
As this class is built using a singleton pattern, only one instance exists.
getInstance() - Static method in class pulse.search.direction.BFGSOptimiser
This class uses a singleton pattern, meaning there is only instance of this class.
getInstance() - Static method in class pulse.search.direction.LMOptimiser
This class uses a singleton pattern, meaning there is only instance of this class.
getInstance() - Static method in class pulse.search.direction.PathOptimiser
 
getInstance() - Static method in class pulse.search.direction.SR1Optimiser
This class uses a singleton pattern, meaning there is only instance of this class.
getInstance() - Static method in class pulse.search.direction.SteepestDescentOptimiser
This class uses a singleton pattern, meaning there is only instance of this class.
getInstance() - Static method in class pulse.search.linear.GoldenSectionOptimiser
This class uses a singleton pattern, meaning there is only instance of this class.
getInstance() - Static method in class pulse.search.linear.WolfeOptimiser
This class uses a singleton pattern, meaning there is only instance of this class.
getInstance() - Static method in class pulse.tasks.processing.ResultFormat
This class uses a singleton pattern, meaning there is only instance of this class.
getInstance() - Static method in class pulse.ui.frames.MainGraphFrame
 
getInstance() - Static method in class pulse.ui.frames.TaskControlFrame
 
getInstance() - Static method in class pulse.util.ResourceMonitor
 
getInstanceDescriptor() - Method in class pulse.problem.schemes.RadiativeTransferCoupling
 
getInstanceDescriptor() - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
 
getIntegrationSegments() - Method in class pulse.math.FixedIntervalIntegrator
Retrieves the number of integration segments.
getIntegrator() - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
getIntegrator() - Method in class pulse.problem.schemes.rte.exact.NewtonCotesQuadrature
This will retrieve the Newton-Cotes integrator, which by default is the Simpson integrator.
getIntegratorDescriptor() - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
getIntensities() - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
getIntensity(int, int) - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
getIntercept() - Method in class pulse.baseline.AdjustableBaseline
Provides getter accessibility to the intercept as a NumericProperty
getInterpolation() - Method in class pulse.HeatingCurve
 
getInterpolation() - Method in class pulse.problem.laser.NumericPulse
 
getInterpolation() - Method in class pulse.problem.schemes.rte.BlackbodySpectrum
 
getInterpolator() - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
getInverseHessian() - Method in class pulse.search.direction.ComplexPath
 
getItemViewStored() - Method in class pulse.ui.components.TaskPopupMenu
 
getIteration() - Method in class pulse.search.direction.IterativeState
 
getIterationError() - Method in class pulse.problem.schemes.rte.dom.IterativeSolver
 
getIterationErrorTolerance() - Method in class pulse.problem.schemes.rte.dom.IterativeSolver
 
getIterativeSolver() - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
getIterativeSolverSelector() - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
getIterativeState() - Method in class pulse.search.GeneralTask
 
getKey() - Method in class pulse.util.ImmutableDataEntry
Gets the key object
getKeyword() - Method in class pulse.math.ParameterIdentifier
 
getKeywords() - Method in class pulse.tasks.processing.ResultFormat
Retrieves the list of keyword associated with this ResultFormat
getLambda() - Method in class pulse.problem.laser.ExponentiallyModifiedGaussian
 
getLambda() - Method in class pulse.search.statistics.RangePenalisedLeastSquares
The lambda is the regularisation strength.
getLambda() - Method in class pulse.search.statistics.RegularisedLeastSquares
The lambda is the regularisation strength.
getLaserAbsorptivity() - Method in class pulse.problem.statements.model.AbsorptionModel
 
getLaserEnergy() - Method in class pulse.problem.statements.Pulse
 
getLinearOptimiserDescriptor() - Method in class pulse.search.direction.CompositePathOptimiser
 
getLinearResolution() - Static method in class pulse.search.linear.LinearOptimiser
The linear resolution determines the minimum distance between any two points belonging to the domain of this search while they still are considered separate.
getLinearSolver() - Method in class pulse.search.direction.CompositePathOptimiser
 
getListCellRendererComponent(JList<?>, Object, int, boolean, boolean) - Method in class pulse.ui.components.controllers.SearchListRenderer
 
getListeners() - Method in class pulse.tasks.logs.Log
 
getListeners() - Method in class pulse.util.DiscreteSelector
 
getListeners() - Method in class pulse.util.InstanceDescriptor
 
getListeners() - Method in class pulse.util.PropertyHolder
 
getLog() - Method in class pulse.tasks.SearchTask
 
getLogEntries() - Method in class pulse.tasks.logs.Log
 
getLogger() - Method in class pulse.ui.frames.LogFrame
 
getLowerBound() - Method in class pulse.input.IndexRange
Gets the integer value representing the index of the lower bound previously set by looking at a certain unspecified data list.
getLowerBound() - Method in class pulse.input.Range
Gets the numeric property defining the lower bound of this range.
getLowerLimitField() - Method in class pulse.ui.components.RangeTextFields
 
getLowFreqMax() - Method in class pulse.baseline.SinusoidalBaseline
 
getManagerInstance() - Static method in class pulse.tasks.TaskManager
This class uses a singleton pattern, meaning there is only instance of this class.
getMatrix() - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
getMaximum() - Method in class pulse.math.Segment
Gets the b value for this Segment
getMaximum() - Method in class pulse.properties.NumericProperty
 
getMaximumTemperature() - Method in class pulse.problem.statements.model.ThermalProperties
 
getMaxIterations() - Method in class pulse.problem.schemes.rte.dom.IterativeSolver
 
getMaxIterations() - Method in class pulse.search.direction.PathOptimiser
 
getMemoryUsage() - Method in class pulse.util.ResourceMonitor
 
getMessage() - Method in enum pulse.tasks.logs.Status
 
getMessage() - Method in enum pulse.ui.components.buttons.ExecutionButton.ExecutionState
 
getMetadata() - Method in class pulse.input.ExperimentalData
Retrieves the Metadata object for this ExperimentalData.
getMinimalArray() - Static method in class pulse.tasks.processing.ResultFormat
 
getMinimum() - Method in class pulse.math.Segment
Gets the a value for this Segment
getMinimum() - Method in class pulse.properties.NumericProperty
 
getMinimumPoint() - Method in class pulse.search.direction.GradientGuidedPath
 
getMode() - Method in class pulse.ui.frames.TaskControlFrame
 
getModelSelectionCriterion() - Method in class pulse.tasks.Calculation
 
getModelSelectionDescriptor() - Static method in class pulse.tasks.Calculation
 
getMolarMass() - Method in class pulse.problem.statements.model.Gas
 
getMu() - Method in class pulse.problem.laser.ExponentiallyModifiedGaussian
 
getName() - Method in class pulse.AbstractData
 
getName() - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
getNeighborhoodTopology() - Method in class pulse.search.direction.pso.SwarmState
 
getNeighbours() - Method in class pulse.search.direction.pso.Particle
 
getNode(int) - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
getNode(int) - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
getNodes() - Method in class pulse.problem.schemes.rte.dom.CompositeGaussianQuadrature
The cosine nodes of the composite quadrature.
getNodes() - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
getNonlinearPrecision() - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolverNL
 
getNonlinearPrecision() - Method in class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
getNonlinearPrecision() - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolverNL
 
getNonlinearPrecision() - Method in class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
getNonlinearPrecision() - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
getNonlinearPrecision() - Method in class pulse.problem.schemes.solvers.MixedCoupledSolverNL
 
getNormalityTest() - Method in class pulse.tasks.SearchTask
 
getNumberOfAtoms() - Method in class pulse.problem.statements.model.Gas
 
getNumberOfBins() - Method in class pulse.math.filters.RunningAverage
 
getNumberOfNodes() - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
getNumPoints() - Method in class pulse.AbstractData
Getter method providing accessibility to the count NumericProperty.
getNumVariables() - Method in class pulse.search.statistics.ModelSelectionCriterion
 
getOpacity() - Method in class pulse.ui.components.Chart
 
getOpticalGridStep() - Method in class pulse.problem.schemes.rte.Fluxes
 
getOpticalThickness() - Method in class pulse.problem.schemes.rte.Fluxes
 
getOpticalThickness() - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
getOptimiserStatistic() - Method in interface pulse.Response
 
getOptimiserStatistic() - Method in class pulse.search.SimpleResponse
 
getOptimiserStatistic() - Method in class pulse.search.statistics.ModelSelectionCriterion
 
getOptimiserStatistic() - Method in class pulse.tasks.Calculation
 
getOrder() - Method in class pulse.math.LegendrePoly
 
getOrder() - Method in class pulse.problem.schemes.rte.exact.CompositionProduct
 
getOrdinates() - Method in class pulse.problem.schemes.rte.dom.Discretisation
 
getP() - Method in class pulse.problem.schemes.BlockMatrixAlgorithm
 
getParameterBounds() - Method in class pulse.math.FunctionWithInterpolation
Retrieves the parameter bounds.
getParameters() - Method in class pulse.math.ParameterVector
 
getParameters() - Method in class pulse.search.direction.IterativeState
 
getParameterValue(NumericPropertyKeyword, int) - Method in class pulse.math.ParameterVector
 
getParent() - Method in class pulse.util.UpwardsNavigable
Return the parent of this UpwardsNavigable -- if is has been previously explicitly set.
getParticles() - Method in class pulse.search.direction.pso.SwarmState
Returns the particles of the swarm.
getPhaseFunction() - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
getPhaseFunctionSelector() - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
getPhaseShift() - Method in class pulse.math.Harmonic
 
getPhaseSpectrum() - Method in class pulse.math.FFTTransformer
 
getPhysicalPulse() - Method in class pulse.problem.laser.DiscretePulse
Gets the physical Pulse
getPlanckNumber() - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
getPlot() - Method in class pulse.ui.components.AuxPlotter
 
getPosition() - Method in class pulse.search.direction.pso.ParticleState
 
getPrefix() - Method in class pulse.math.AbstractIntegrator
 
getPrefix() - Method in class pulse.math.FixedIntervalIntegrator
 
getPrefix() - Method in class pulse.problem.laser.PulseTemporalShape
 
getPrefix() - Method in class pulse.problem.schemes.RadiativeTransferCoupling
 
getPrefix() - Method in class pulse.problem.schemes.rte.exact.CompositionProduct
 
getPrefix() - Method in class pulse.problem.schemes.rte.RadiativeTransferSolver
 
getPrefix() - Method in class pulse.util.PropertyHolder
 
getPreviousEntry() - Method in class pulse.tasks.logs.LogEntry
 
getPreviousSolution() - Method in class pulse.problem.schemes.OneDimensionalScheme
 
getProblem() - Method in class pulse.tasks.Calculation
 
getProblem() - Method in class pulse.ui.components.listeners.ProblemSelectionEvent
 
getProperties() - Method in class pulse.problem.statements.Problem
 
getProperties() - Method in class pulse.tasks.processing.AbstractResult
Returns a list of NumericProperties, which conform to the chosen ResultFormat
getProperty() - Method in class pulse.util.PropertyEvent
Gets the property, which is related to this event.
getProperty(int) - Method in class pulse.tasks.processing.AbstractResult
 
getPropertyHolder() - Method in class pulse.ui.components.PropertyHolderTable
 
getPropertyHolder() - Method in class pulse.util.PropertyEvent
 
getPulse() - Method in class pulse.problem.statements.Problem
 
getPulseData() - Method in class pulse.input.Metadata
If a Numerical Pulse has been loaded (for example, when importing from Proteus), this will return an object describing this data.
getPulseDescriptor() - Method in class pulse.input.Metadata
Retrieves the pulse shape recorded in this Metadata
getPulseDescriptor() - Method in class pulse.problem.statements.Pulse
 
getPulseExtensions() - Static method in class pulse.io.readers.ReaderManager
 
getPulseFrame() - Method in class pulse.ui.frames.TaskControlFrame
 
getPulseShape() - Method in class pulse.problem.statements.Pulse
 
getPulseWidth() - Method in class pulse.problem.laser.PulseTemporalShape
 
getPulseWidth() - Method in class pulse.problem.statements.Pulse
 
getQ() - Method in class pulse.problem.schemes.BlockMatrixAlgorithm
 
getQLast(int) - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
getQuadrature() - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
Retrieves the quadrature that is used to evaluate the composition product invoked when calculating the radiative fluxes.
getQuadraturePoints() - Method in class pulse.problem.schemes.rte.exact.ChandrasekharsQuadrature
 
getQuadratureSelector() - Method in class pulse.problem.schemes.rte.dom.Discretisation
 
getQuantities() - Method in class pulse.problem.schemes.rte.dom.Discretisation
 
getRadialConversionFactor() - Method in class pulse.problem.laser.DiscretePulse2D
 
getRadiativeTransferEquation() - Method in class pulse.problem.schemes.RadiativeTransferCoupling
 
getRadiosityFront() - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
 
getRadiosityRear() - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
 
getRange() - Method in class pulse.input.ExperimentalData
Gets the dimensional time Range of this data.
getRank() - Method in class pulse.math.Harmonic
 
getReflectance() - Method in class pulse.problem.statements.model.Insulator
 
getRelativeTolerance() - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
getRelaxationParameter() - Method in class pulse.problem.schemes.rte.dom.SuccessiveOverrelaxation
 
getRequiredDiscretisation() - Method in class pulse.problem.laser.ExponentiallyModifiedGaussian
 
getRequiredDiscretisation() - Method in class pulse.problem.laser.NumericPulse
 
getRequiredDiscretisation() - Method in class pulse.problem.laser.PulseTemporalShape
 
getRequiredDiscretisation() - Method in class pulse.problem.laser.RectangularPulse
 
getRequiredDiscretisation() - Method in class pulse.problem.laser.TrapezoidalPulse
 
getResiduals() - Method in class pulse.search.statistics.ResidualStatistic
 
getResponse() - Method in class pulse.math.filters.PolylineOptimiser
 
getResponse() - Method in class pulse.search.GeneralTask
 
getResponse() - Method in class pulse.tasks.SearchTask
 
getResult() - Method in class pulse.tasks.Calculation
 
getResultFormat() - Method in class pulse.tasks.listeners.ResultFormatEvent
 
getResults() - Method in class pulse.ui.components.models.ResultTableModel
 
getResultTable() - Method in class pulse.ui.frames.ResultFrame
 
getRowCount() - Method in class pulse.ui.components.models.ParameterTableModel
 
getRowCount() - Method in class pulse.ui.components.models.SelectedKeysModel
 
getRTEListeners() - Method in class pulse.problem.schemes.rte.RadiativeTransferSolver
 
getSampleDiameter() - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
getSampleName() - Method in class pulse.input.Metadata
Retrieves the sample name.
getSampleName() - Method in class pulse.tasks.TaskManager
Uses the first non-null SearchTask to retrieve the sample name from the Metadata associated with its ExperimentalData.
getSampleThickness() - Method in class pulse.problem.statements.model.ThermalProperties
 
getScatteringAlbedo() - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
getScatteringAnisostropy() - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
getScheme() - Method in class pulse.tasks.Calculation
 
getSecond() - Method in class pulse.util.ImmutablePair
 
getSegment() - Method in class pulse.input.Range
Gets the segment representing this range
getSelectedIndex() - Method in class pulse.ui.components.models.TaskBoxModel
 
getSelectedItem() - Method in class pulse.ui.components.models.TaskBoxModel
 
getSelectedOptimiserDescriptor() - Static method in class pulse.search.statistics.OptimiserStatistic
 
getSelectedTask() - Method in class pulse.tasks.TaskManager
 
getSelectedTestDescriptor() - Static method in class pulse.search.statistics.NormalityTest
 
getSelectionListeners() - Method in class pulse.tasks.TaskManager
 
getSideLosses() - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
getSigma() - Method in class pulse.problem.laser.ExponentiallyModifiedGaussian
 
getSignalData() - Method in class pulse.AbstractData
 
getSignals() - Method in class pulse.math.ZScore
 
getSimpleName() - Method in class pulse.util.Group
This will generate a simple name for identifying this Accessible.
getSingleStatementCheckBox() - Method in class pulse.ui.components.panels.SettingsToolBar
 
getSize() - Static method in class pulse.tasks.processing.Buffer
Gets the buffer size (a NumericProperty derived from BUFFER_SIZE.
getSize() - Method in class pulse.ui.components.models.TaskBoxModel
 
getSlope() - Method in class pulse.baseline.AdjustableBaseline
Provides getter accessibility to the slope as a NumericProperty
getSolidExchangeCoefficient() - Method in class pulse.problem.statements.model.TwoTemperatureProperties
 
getSolver() - Method in class pulse.search.direction.PathOptimiser
 
getSource() - Method in class pulse.ui.components.listeners.ProblemSelectionEvent
 
getSource() - Method in class pulse.util.PropertyEvent
Gets the 'source', which is an Object that is the originator of this event.
getSpecificHeat() - Method in class pulse.problem.statements.model.ThermalProperties
 
getSpecificHeatDataset() - Method in class pulse.tasks.TaskManager
 
getSpotDiameter() - Method in class pulse.problem.statements.Pulse2D
 
getStart() - Method in class pulse.tasks.logs.Log
This is the time after the creation of the Log when a change of status to IN_PROGRESS happened.
getState() - Method in class pulse.tasks.listeners.TaskRepositoryEvent
 
getState() - Method in class pulse.tasks.logs.StateEntry
 
getState() - Method in class pulse.ui.components.MovableValueMarker
 
getStatistic() - Method in class pulse.search.statistics.ModelSelectionCriterion
 
getStatistic() - Method in class pulse.search.statistics.NormalityTest
 
getStatistic() - Method in class pulse.search.statistics.ResidualStatistic
 
getStatisticalSignifiance() - Static method in class pulse.search.statistics.NormalityTest
 
getStatus() - Method in class pulse.tasks.Calculation
 
getStatus() - Method in class pulse.tasks.logs.StateEntry
 
getStatus() - Method in class pulse.tasks.SearchTask
 
getStoredCalculations() - Method in class pulse.tasks.SearchTask
 
getStoredDerivative(int, int) - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
getStoredFlux(int) - Method in class pulse.problem.schemes.rte.Fluxes
Retrieves the previously calculated flux at the i grid point.
getStoredFluxDerivative(int) - Method in class pulse.problem.schemes.rte.FluxesAndExplicitDerivatives
 
getStoredIntensity(int, int) - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
getStretchingFactor() - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
getString(String) - Static method in class pulse.ui.Messages
 
getSumOfSquares() - Method in class pulse.search.statistics.RSquaredTest
 
getSupportedExtension() - Method in interface pulse.io.readers.AbstractHandler
Retrieves the supported extension of files, which this AbstractHandler is able to process.
getSupportedExtension() - Method in class pulse.io.readers.ButcherTableauReader
 
getSupportedExtension() - Method in class pulse.io.readers.DATReader
 
getSupportedExtension() - Method in class pulse.io.readers.LFRReader
 
getSupportedExtension() - Method in class pulse.io.readers.MetaFilePopulator
 
getSupportedExtension() - Method in class pulse.io.readers.NetzschCSVReader
 
getSupportedExtension() - Method in class pulse.io.readers.NetzschPulseCSVReader
 
getSupportedExtension() - Method in class pulse.io.readers.QuadratureReader
 
getSupportedExtension() - Method in class pulse.io.readers.TBLReader
 
getSupportedExtensions() - Method in class pulse.io.export.CurveExporter
Currently html and csv extensions are supported.
getSupportedExtensions() - Method in interface pulse.io.export.Exporter
Returns an array of supported extensions, which by default contains only the default extension.
getSupportedExtensions() - Method in class pulse.io.export.LogExporter
Only html is currently supported by this exporter.
getSupportedExtensions() - Method in class pulse.io.export.MetadataExporter
 
getSupportedExtensions() - Method in class pulse.io.export.RawDataExporter
Currently html and csv extensions are supported.
getSupportedExtensions() - Method in class pulse.io.export.ResidualStatisticExporter
The supported extensions for exporting the data contained in this object.
getSupportedExtensions() - Method in class pulse.io.export.ResultExporter
Currently the supported extensions include .html and .csv.
getSupportedExtensions() - Method in class pulse.io.export.ResultTableExporter
Both html and csv are suported.
getSupportedExtensions() - Method in class pulse.io.export.TextLogPaneExporter
Only html is currently supported by this exporter.
getTableauSelector() - Method in class pulse.problem.schemes.rte.dom.ExplicitRungeKutta
 
getTableCellEditorComponent(JTable, Object, boolean, int, int) - Method in class pulse.ui.components.controllers.ButtonEditor
 
getTableCellEditorComponent(JTable, Object, boolean, int, int) - Method in class pulse.ui.components.controllers.InstanceCellEditor
 
getTableCellEditorComponent(JTable, Object, boolean, int, int) - Method in class pulse.ui.components.controllers.NumberEditor
 
getTableCellRendererComponent(JTable, Object, boolean, boolean, int, int) - Method in class pulse.ui.components.controllers.AccessibleTableRenderer
 
getTableCellRendererComponent(JTable, Object, boolean, boolean, int, int) - Method in class pulse.ui.components.controllers.NumericPropertyRenderer
 
getTableCellRendererComponent(JTable, Object, boolean, boolean, int, int) - Method in class pulse.ui.components.controllers.TaskTableRenderer
 
getTask() - Method in class pulse.tasks.logs.StateEntry
 
getTask(int) - Method in class pulse.tasks.TaskManager
Finds a SearchTask using the external identifier specified in its metadata.
getTask(Identifier) - Method in class pulse.tasks.TaskManager
Finds a SearchTask whose Identifier matches id.
getTaskIdentifier() - Method in class pulse.tasks.processing.Result
 
getTaskList() - Method in class pulse.tasks.TaskManager
 
getTaskRepositoryListeners() - Method in class pulse.tasks.TaskManager
 
getTaskToolbar() - Method in class pulse.ui.frames.TaskManagerFrame
 
getTestDescriptor() - Static method in class pulse.search.statistics.CorrelationTest
 
getTestTemperature() - Method in class pulse.problem.statements.model.ThermalProperties
 
getThermalAbsorptivity() - Method in class pulse.problem.statements.model.AbsorptionModel
 
getThermalConductivity() - Method in class pulse.problem.statements.model.ThermalProperties
 
getThermalConductivity() - Method in class pulse.problem.statements.NonlinearProblem
 
getThermalMass() - Method in class pulse.problem.statements.model.Gas
 
getThermalMass() - Method in class pulse.problem.statements.model.ThermalProperties
 
getThreadsAvailable() - Method in class pulse.util.ResourceMonitor
 
getThreshold() - Static method in class pulse.search.statistics.CorrelationTest
 
getTime() - Method in class pulse.tasks.logs.LogEntry
 
getTimeFactor() - Method in class pulse.problem.schemes.Grid
Retrieves the value of the τ-factor, or the time factor, used in finite-difference calculation.
getTimeInterval() - Method in class pulse.problem.schemes.DifferenceScheme
The time interval is the number of discrete timesteps that will be discarded when storing the resulting solution into a HeatingCurve object, thus ensuring that only a limited set of points is stored.
getTimeLimit() - Method in class pulse.problem.schemes.DifferenceScheme
The time limit (in whatever units this DifferenceScheme uses to process the solution), which serves as the ultimate breakpoint for the calculations.
getTimeSequence() - Method in class pulse.AbstractData
 
getTimeSequence() - Method in class pulse.search.statistics.ResidualStatistic
 
getTimeShift() - Method in class pulse.HeatingCurve
The time shift is the position of the 'zero-time'.
getTimeStep() - Method in class pulse.problem.schemes.Grid
Retrieves the value of the τ time step used in finite-difference calculation.
getTimeStep() - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
getTimeThreshold() - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
getTooltips() - Method in class pulse.ui.components.models.ResultTableModel
 
getTotalNodes() - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
getTransform() - Method in class pulse.math.Parameter
 
getTransformedBounds() - Method in class pulse.math.Parameter
If transform of i is not null, applies the transformation to the component bounds
getTrapezoidalFall() - Method in class pulse.problem.laser.TrapezoidalPulse
 
getTrapezoidalRise() - Method in class pulse.problem.laser.TrapezoidalPulse
 
getTreeCellRendererComponent(JTree, Object, boolean, boolean, boolean, int, boolean) - Method in class pulse.ui.components.controllers.ProblemCellRenderer
 
getTridiagonalMatrixAlgorithm() - Method in class pulse.problem.schemes.ImplicitScheme
 
getType() - Method in class pulse.input.listeners.CurveEvent
Used to get the type of this event.
getType() - Method in class pulse.input.listeners.DataEvent
Used to get the type of this event.
getType() - Method in exception pulse.problem.schemes.solvers.SolverException
 
getType() - Method in class pulse.properties.Flag
Returns the type of this Flag.
getType() - Method in class pulse.properties.NumericProperty
 
getUpdateExecutor() - Method in class pulse.tasks.logs.AbstractLogger
 
getUpperBound() - Method in class pulse.input.IndexRange
Gets the integer value representing the index of the upper bound previously set by looking at a certain unspecified data list.
getUpperBound() - Method in class pulse.input.Range
Gets the numeric property defining the upper bound of this range.
getUpperLimitField() - Method in class pulse.ui.components.RangeTextFields
 
getValue() - Method in class pulse.properties.Flag
The value for this Property is a boolean.
getValue() - Method in class pulse.properties.NumericProperty
 
getValue() - Method in interface pulse.properties.Property
Retrieves the value of this Property.
getValue() - Method in class pulse.properties.SampleName
 
getValue() - Method in class pulse.util.DiscreteSelector
 
getValue() - Method in class pulse.util.ImmutableDataEntry
Gets the value object
getValue() - Method in class pulse.util.InstanceDescriptor
 
getValueAt(int, int) - Method in class pulse.ui.components.models.ParameterTableModel
 
getValueAt(int, int) - Method in class pulse.ui.components.models.SelectedKeysModel
 
getVelocity() - Method in class pulse.search.direction.pso.ParticleState
 
getVersionDate() - Method in class pulse.ui.Version
 
getVersionLabel() - Method in class pulse.ui.Version
 
getWeight() - Method in class pulse.problem.schemes.solvers.MixedCoupledSolver
 
getWeight(int) - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
getWeights() - Method in class pulse.problem.schemes.rte.dom.CompositeGaussianQuadrature
The weights of the composite quadrature.
getWidthToleranceFactor() - Method in class pulse.problem.laser.DiscretePulse
Assuming a characteristic time is divided by the return value of this method and is set to the minimal resolved pulse width, shows how small a pulse width can be to enable finite pulse correction.
getWidthToleranceFactor() - Method in class pulse.problem.laser.DiscretePulse2D
A smaller tolerance factor is set for 2D calculations
getX() - Method in interface pulse.DiscreteInput
 
getX() - Method in class pulse.input.ExperimentalData
 
getX() - Method in class pulse.math.filters.OptimisablePolyline
 
getX() - Method in class pulse.problem.laser.NumericPulseData
 
getXStep() - Method in class pulse.problem.schemes.Grid
Retrieves the value of the hx coordinate step used in finite-difference calculation.
getY() - Method in interface pulse.DiscreteInput
 
getY() - Method in class pulse.input.ExperimentalData
 
getY() - Method in class pulse.math.filters.OptimisablePolyline
 
getY() - Method in class pulse.problem.laser.NumericPulseData
 
getYStep() - Method in class pulse.problem.schemes.Grid2D
 
GLOBAL - Static variable in class pulse.search.direction.pso.StaticTopologies
Global best
GoldenSectionOptimiser - Class in pulse.search.linear
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.
gradient(GeneralTask) - Method in class pulse.search.direction.GradientBasedOptimiser
Calculates the Vector gradient of the target function (the sum of squared residuals, SSR, for this task.
GRADIENT_RESOLUTION - pulse.properties.NumericPropertyKeyword
The accuracy of gradient calculation.
GradientBasedOptimiser - Class in pulse.search.direction
 
GradientBasedOptimiser() - Constructor for class pulse.search.direction.GradientBasedOptimiser
Abstract constructor that sets up the default ITERATION_LIMIT, ERROR_TOLERANCE and GRADIENT_RESOLUTION for this PathSolver.
GradientGuidedPath - Class in pulse.search.direction
A Path stores information relevant to the selected PathSolver, which is related to a specific SearchTask.
GradientGuidedPath(GeneralTask) - Constructor for class pulse.search.direction.GradientGuidedPath
 
GraphicalLogPane - Class in pulse.ui.components
 
GraphicalLogPane() - Constructor for class pulse.ui.components.GraphicalLogPane
 
Grid - Class in pulse.problem.schemes
A Grid is used to partition the space and time domain of a Problem to allow a numeric solution with a DifferenceScheme.
Grid() - Constructor for class pulse.problem.schemes.Grid
 
Grid(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.Grid
Creates a Grid object with the specified gridDensity and timeFactor.
GRID_DENSITY - pulse.properties.NumericPropertyKeyword
Grid (space partitioning) density.
GRID_SCALING_FACTOR - pulse.properties.NumericPropertyKeyword
Grid scaling factor.
GRID_STRETCHING_FACTOR - pulse.properties.NumericPropertyKeyword
Grid stretching factor (RTE).
GRID_TOO_LARGE - pulse.problem.schemes.rte.RTECalculationStatus
The grid density required to reach the error threshold was too large.
Grid2D - Class in pulse.problem.schemes
A Grid2D is used to partition the space and time domain of a Problem2D to allow a numeric solution with a DifferenceScheme.
Grid2D() - Constructor for class pulse.problem.schemes.Grid2D
 
Grid2D(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.Grid2D
Creates a Grid2D where the radial and axial spatial steps are equal to the inverse gridDensity.
gridAxialDistance(double, double) - Method in class pulse.problem.schemes.Grid
The dimensionless axial distance on this Grid, which is the distance/lengthFactor rounded up to a factor of the coordinate step hx.
gridRadialDistance(double, double) - Method in class pulse.problem.schemes.Grid2D
The dimensionless radial distance on this Grid2D, which is the radial/lengthFactor rounded up to a factor of the coordinate step hy.
gridTime(double, double) - Method in class pulse.problem.schemes.Grid
The dimensionless time on this Grid, which is the time/dimensionFactor rounded up to a factor of the time step tau.
group(List<AbstractResult>, AbstractResult, double) - Method in class pulse.ui.components.models.ResultTableModel
Takes a list of results, which should be mandatory sorted in the order of ascending id values, and searches for those results that can be merged with r, satisfying these criteria: (a) these results correspond to test temperatures within a specified temperatureDelta (b) they form a single sequence of measurements
Group - Class in pulse.util
 
Group() - Constructor for class pulse.util.Group
 

H

HalfTimeCalculator - Class in pulse.math.filters
 
HalfTimeCalculator(DiscreteInput) - Constructor for class pulse.math.filters.HalfTimeCalculator
 
HAMMING - Static variable in interface pulse.math.Window
 
HANN - Static variable in interface pulse.math.Window
 
HANN_POISSON - Static variable in interface pulse.math.Window
 
Harmonic - Class in pulse.math
Harmonic class.
Harmonic() - Constructor for class pulse.math.Harmonic
 
Harmonic(double, double, double) - Constructor for class pulse.math.Harmonic
 
Harmonic(Harmonic) - Constructor for class pulse.math.Harmonic
 
hasEnoughElements(int) - Method in class pulse.ui.components.ResultTable
 
hashCode() - Method in class pulse.math.ParameterIdentifier
 
hashCode() - Method in class pulse.properties.SampleName
 
hashCode() - Method in class pulse.search.statistics.ModelSelectionCriterion
 
hashCode() - Method in class pulse.search.statistics.ResidualStatistic
 
hashCode() - Method in class pulse.tasks.Calculation
 
hashCode() - Method in class pulse.util.ImmutablePair
 
hasZeroNode() - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
HEAT_CAPACITY - pulse.ui.components.buttons.LoaderButton.DataType
 
HEAT_LOSS - pulse.properties.NumericPropertyKeyword
The coefficient of heat losses from the front and rear surfaces of the sample (1D and 2D problems).
HEAT_LOSS_COMBINED - pulse.properties.NumericPropertyKeyword
A directive for the optimiser to maintain equal heat losses on all surfaces of the sample.
HEAT_LOSS_CONVECTIVE - pulse.properties.NumericPropertyKeyword
The convective heat loss in diathermic and participating medium problems.
HEAT_LOSS_GAS - pulse.properties.NumericPropertyKeyword
Heat loss for the gas in the 2T-model.
HEAT_LOSS_SIDE - pulse.properties.NumericPropertyKeyword
The coefficient of heat losses from the side surface of the sample (two-dimensional problems).
HeatingCurve - Class in pulse
The HeatingCurve represents a time-temperature profile (a AbstractData instance) generated using a calculation algorithm implemented by a Problem's Solver.
HeatingCurve() - Constructor for class pulse.HeatingCurve
Calls the super-constructor and initialises the baseline-corrected signal list.
HeatingCurve(List<Double>, List<Double>, double, String) - Constructor for class pulse.HeatingCurve
 
HeatingCurve(HeatingCurve) - Constructor for class pulse.HeatingCurve
Copy constructor.
HeatingCurve(NumericProperty) - Constructor for class pulse.HeatingCurve
Creates a HeatingCurve, where the number of elements in the time, signal, and adjustedSignal collections are set to count.getValue().
HeatingCurveListener - Interface in pulse
An interface used to listen to data events related to HeatingCurve.
HEIGHT_FACTOR - Static variable in class pulse.ui.components.LogChart
 
Helium - Class in pulse.problem.statements.model
 
Helium() - Constructor for class pulse.problem.statements.model.Helium
 
HenyeyGreensteinPF - Class in pulse.problem.schemes.rte.dom
The single-parameter Henyey-Greenstein scattering phase function.
HenyeyGreensteinPF(ThermoOpticalProperties, Discretisation) - Constructor for class pulse.problem.schemes.rte.dom.HenyeyGreensteinPF
 
HermiteInterpolator - Class in pulse.problem.schemes.rte.dom
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).
HermiteInterpolator() - Constructor for class pulse.problem.schemes.rte.dom.HermiteInterpolator
 
HessianDirectionSolver - Interface in pulse.search.direction
 
HH - Variable in class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
HierarchyListener - Interface in pulse.util
An hierarchy listener, which listens to any changes happening with the children of an UpwardsNavigable.
HIGH - pulse.problem.statements.ProblemComplexity
 
HIGHEST_ORDER - Static variable in class pulse.problem.schemes.rte.exact.ExponentialIntegrals
 
highlight(boolean) - Method in class pulse.ui.components.buttons.LoaderButton
 
highlightButtons(boolean) - Method in class pulse.ui.components.panels.ProblemToolbar
 
highlightIfNeeded() - Method in class pulse.ui.components.buttons.LoaderButton
 
HistogramFrame - Class in pulse.ui.frames
 
HistogramFrame(AuxPlotter<ResidualStatistic>, int, int) - Constructor for class pulse.ui.frames.HistogramFrame
 
HTML - pulse.io.export.Extension
The result will be a document with html tags that can be viewed in any web browser.

I

IconCheckBox - Class in pulse.ui.components.buttons
 
IconCheckBox() - Constructor for class pulse.ui.components.buttons.IconCheckBox
 
IconCheckBox(boolean) - Constructor for class pulse.ui.components.buttons.IconCheckBox
 
identifier() - Method in class pulse.properties.Flag
 
identifier() - Method in interface pulse.properties.Property
 
identifier() - Method in class pulse.util.InstanceDescriptor
 
Identifier - Class in pulse.tasks
An Identifier is used to identify SearchTasks.
Identifier() - Constructor for class pulse.tasks.Identifier
Creates an Identifier by incrementing the previously recorded ID.
IDENTIFIER - pulse.properties.NumericPropertyKeyword
Task identifier.
identify() - Method in class pulse.input.Metadata
 
identify() - Method in class pulse.util.UpwardsNavigable
Retrieves the Identifier of the SearchTaks this UpwardsNavigable belongs to.
identifySelection(SearchTask) - Method in class pulse.ui.components.CalculationTable
 
IDLE - pulse.ui.components.MovableValueMarker.State
 
IDLE_STROKE - Static variable in class pulse.ui.components.MovableValueMarker
 
ignoreSiblings() - Method in class pulse.AbstractData
 
ignoreSiblings() - Method in class pulse.problem.schemes.rte.exact.NewtonCotesQuadrature
 
ignoreSiblings() - Method in class pulse.problem.schemes.rte.RadiativeTransferSolver
 
ignoreSiblings() - Method in class pulse.search.direction.PathOptimiser
 
ignoreSiblings() - Method in class pulse.util.PropertyHolder
Should Accessibles that belong to this PropertyHolder be ignored when this PropertyHolder is displayed in a table?
ILLEGAL_PARAMETERS - pulse.problem.schemes.solvers.SolverException.SolverExceptionType
 
ImageUtils - Class in pulse.util
 
ImmutableDataEntry<T,​R> - Class in pulse.util
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'.
ImmutableDataEntry(T, R) - Constructor for class pulse.util.ImmutableDataEntry
Constructs a new DataEntry from key and value.
ImmutablePair<T> - Class in pulse.util
 
ImmutablePair(T, T) - Constructor for class pulse.util.ImmutablePair
 
ImplicitCoupledSolver - Class in pulse.problem.schemes.solvers
 
ImplicitCoupledSolver() - Constructor for class pulse.problem.schemes.solvers.ImplicitCoupledSolver
 
ImplicitCoupledSolver(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ImplicitCoupledSolver
 
ImplicitCoupledSolverNL - Class in pulse.problem.schemes.solvers
 
ImplicitCoupledSolverNL() - Constructor for class pulse.problem.schemes.solvers.ImplicitCoupledSolverNL
 
ImplicitCoupledSolverNL(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ImplicitCoupledSolverNL
 
ImplicitDiathermicSolver - Class in pulse.problem.schemes.solvers
 
ImplicitDiathermicSolver() - Constructor for class pulse.problem.schemes.solvers.ImplicitDiathermicSolver
 
ImplicitDiathermicSolver(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ImplicitDiathermicSolver
 
ImplicitDiathermicSolver(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ImplicitDiathermicSolver
 
ImplicitLinearisedSolver<T extends ClassicalProblem> - Class in pulse.problem.schemes.solvers
Performs a fully-dimensionless calculation for the LinearisedProblem.
ImplicitLinearisedSolver() - Constructor for class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
ImplicitLinearisedSolver(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
ImplicitLinearisedSolver(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
ImplicitNonlinearSolver - Class in pulse.problem.schemes.solvers
 
ImplicitNonlinearSolver() - Constructor for class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
ImplicitNonlinearSolver(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
ImplicitNonlinearSolver(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
ImplicitScheme - Class in pulse.problem.schemes
An abstract implicit finite-difference scheme for solving one-dimensional heat conduction problems.
ImplicitScheme() - Constructor for class pulse.problem.schemes.ImplicitScheme
Constructs a default fully-implicit scheme using the default values of GRID_DENSITY and TAU_FACTOR.
ImplicitScheme(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.ImplicitScheme
Constructs a fully-implicit scheme on a one-dimensional grid that is specified by the values N and timeFactor.
ImplicitScheme(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.ImplicitScheme
Constructs a fully-implicit scheme on a one-dimensional grid that is specified by the values N and timeFactor.
ImplicitTranslucentSolver - Class in pulse.problem.schemes.solvers
 
ImplicitTranslucentSolver() - Constructor for class pulse.problem.schemes.solvers.ImplicitTranslucentSolver
 
ImplicitTranslucentSolver(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ImplicitTranslucentSolver
 
ImplicitTwoTemperatureSolver - Class in pulse.problem.schemes.solvers
 
ImplicitTwoTemperatureSolver() - Constructor for class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
ImplicitTwoTemperatureSolver(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
IN_PROGRESS - pulse.tasks.logs.Status
The task is being executed.
INCIDENT_INTENSITY - pulse.properties.NumericPropertyKeyword
Intensity of incident radiation.
incidentRadation(int) - Method in class pulse.problem.schemes.rte.dom.Discretisation
Calculates the incident radiation iwi Iij, which is the zeroth moment of the intensities.
incidentRadiation(int, int, int) - Method in class pulse.problem.schemes.rte.dom.Discretisation
Calculates the incident radiation iwi Iij, by performing simple summation for node points between startInclusive and endExclusive.
INCOMPATIBLE_OPTIMISER - pulse.tasks.logs.Details
The optimisation statistic is not suported by the selected optimiser.
INCOMPLETE - pulse.tasks.logs.Status
Not all necessary details have been uploaded to a SearchTask and that it cannot be executed yet.
increaseAmplitudeBy(int) - Method in class pulse.math.Harmonic
 
incrementCount() - Method in class pulse.AbstractData
 
incrementFailedAttempts() - Method in class pulse.search.direction.IterativeState
 
incrementProgress() - Method in class pulse.ui.frames.dialogs.ProgressDialog
 
incrementStep() - Method in class pulse.search.direction.IterativeState
 
indexOf(NumericPropertyKeyword) - Method in class pulse.tasks.processing.ResultFormat
 
indexOfTask(SearchTask) - Method in class pulse.tasks.TaskManager
 
IndexRange - Class in pulse.input
Provides a way to define the indices corresponding to a certain range of data.
IndexRange(int, int) - Constructor for class pulse.input.IndexRange
 
IndexRange(List<Double>, Range) - Constructor for class pulse.input.IndexRange
Constructs a new index range for data based on the dimensional range.
IndexRange(IndexRange) - Constructor for class pulse.input.IndexRange
 
inflate(SearchTask) - Method in class pulse.tasks.processing.CorrelationBuffer
 
init() - Method in class pulse.problem.laser.DiscretePulse
Recalculates the discretePulseWidth by calling gridTime on the physical pulse width and timeFactor.
init() - Method in class pulse.problem.schemes.rte.Fluxes
 
init() - Method in class pulse.problem.schemes.rte.FluxesAndExplicitDerivatives
 
init() - Static method in class pulse.search.statistics.CorrelationTest
 
init() - Method in class pulse.tasks.processing.Buffer
 
init() - Method in class pulse.ui.components.buttons.LoaderButton
 
init() - Method in class pulse.ui.components.TaskBox
 
init(int, int) - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
init(ExperimentalData, DiscretePulse) - Method in class pulse.problem.laser.NumericPulse
Defines the pulse width as the last element of the time sequence contained in NumericPulseData.
init(ExperimentalData, DiscretePulse) - Method in class pulse.problem.laser.PulseTemporalShape
Stores the pulse width from pulse and initialises area integration.
init(ThermoOpticalProperties) - Method in class pulse.problem.schemes.rte.dom.CornetteSchanksPF
 
init(ThermoOpticalProperties) - Method in class pulse.problem.schemes.rte.dom.HenyeyGreensteinPF
 
init(ThermoOpticalProperties) - Method in class pulse.problem.schemes.rte.dom.LinearAnisotropicPF
 
init(ThermoOpticalProperties) - Method in class pulse.problem.schemes.rte.dom.PhaseFunction
 
init(NonlinearProblem) - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
init(ParticipatingMedium, Grid) - Method in class pulse.problem.schemes.RadiativeTransferCoupling
 
init(ParticipatingMedium, Grid) - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
init(ParticipatingMedium, Grid) - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
 
init(ParticipatingMedium, Grid) - Method in class pulse.problem.schemes.rte.RadiativeTransferSolver
Retrieves the parameters from p and grid needed to run the calculations.Resets the flux arrays.
initComponents() - Method in class pulse.ui.components.panels.ChartToolbar
 
initComponents() - Method in class pulse.ui.components.panels.LogToolbar
 
initComponents() - Method in class pulse.ui.components.panels.OpacitySlider
 
initComponents() - Method in class pulse.ui.components.panels.ResultToolbar
 
initComponents(JTable, String, JTable, String) - Method in class pulse.ui.components.panels.DoubleTablePanel
 
initCorrelationTest() - Method in class pulse.tasks.SearchTask
 
initFrom(DifferenceScheme) - Method in class pulse.problem.schemes.DifferenceScheme
 
initFrom(Pulse) - Method in class pulse.problem.statements.Pulse
 
initFrom(Pulse) - Method in class pulse.problem.statements.Pulse2D
 
initListeners() - Method in class pulse.HeatingCurve
 
initListeners() - Method in class pulse.input.ExperimentalData
 
initListeners() - Method in class pulse.problem.statements.Pulse
 
initListeners() - Method in class pulse.tasks.logs.Log
 
initListeners() - Method in class pulse.tasks.SearchTask
 
initListeners() - Method in class pulse.tasks.TaskManager
 
initListeners() - Method in class pulse.ui.components.CalculationTable
 
initListeners() - Method in class pulse.ui.components.TaskTable
 
initListeners() - Method in class pulse.util.PropertyHolder
 
initListeners() - Method in class pulse.util.UpwardsNavigable
 
initModelCriterion(Statistic) - Method in class pulse.tasks.Calculation
 
initNormalityTest() - Method in class pulse.tasks.SearchTask
 
initOptimiser() - Method in class pulse.tasks.Calculation
 
initProperties() - Method in class pulse.problem.statements.ClassicalProblem
 
initProperties() - Method in class pulse.problem.statements.ClassicalProblem2D
 
initProperties() - Method in class pulse.problem.statements.DiathermicMedium
 
initProperties() - Method in class pulse.problem.statements.ParticipatingMedium
 
initProperties() - Method in class pulse.problem.statements.Problem
 
initProperties() - Method in class pulse.problem.statements.TwoTemperatureModel
 
initProperties(ThermalProperties) - Method in class pulse.problem.statements.ClassicalProblem
 
initProperties(ThermalProperties) - Method in class pulse.problem.statements.ClassicalProblem2D
 
initProperties(ThermalProperties) - Method in class pulse.problem.statements.DiathermicMedium
 
initProperties(ThermalProperties) - Method in class pulse.problem.statements.ParticipatingMedium
 
initProperties(ThermalProperties) - Method in class pulse.problem.statements.Problem
 
initProperties(ThermalProperties) - Method in class pulse.problem.statements.TwoTemperatureModel
 
initState(GeneralTask) - Method in class pulse.search.direction.CompositePathOptimiser
Creates a new Path instance for storing the gradient, direction, and minimum point for this PathSolver.
initState(GeneralTask) - Method in class pulse.search.direction.LMOptimiser
 
initState(GeneralTask) - Method in class pulse.search.direction.PathOptimiser
Creates a new Path suitable for this PathSolver
initState(GeneralTask) - Method in class pulse.search.direction.pso.ParticleSwarmOptimiser
 
initState(GeneralTask) - Method in class pulse.search.direction.SteepestDescentOptimiser
Creates a new Path instance for storing the gradient, direction, and minimum point for this PathSolver.
InstanceCellEditor - Class in pulse.ui.components.controllers
 
InstanceCellEditor(InstanceDescriptor<?>) - Constructor for class pulse.ui.components.controllers.InstanceCellEditor
 
InstanceDescriptor<T extends Reflexive> - Class in pulse.util
 
InstanceDescriptor(Class<T>, Object...) - Constructor for class pulse.util.InstanceDescriptor
 
InstanceDescriptor(String, Class<T>, Object...) - Constructor for class pulse.util.InstanceDescriptor
 
instancesOf(Class<T>) - Static method in interface pulse.util.Reflexive
Uses the ReflexiveFinder to create a list of simple instance of reflexiveType generated by any classes listed in the same package where the reflexiveType is found.
instancesOf(Class<T>, Object...) - Static method in interface pulse.util.Reflexive
 
instancesOf(Class<T>, String) - Static method in interface pulse.util.Reflexive
 
instancesOf(Class<T>, String, Object...) - Static method in interface pulse.util.Reflexive
Uses the ReflexiveFinder to create a list of simple instance of reflexiveType generated by any classes listed in the package pckgname.
instantiate(Class<T>, String) - Static method in interface pulse.util.Reflexive
 
INSUFFICIENT_DATA_IN_PROBLEM_STATEMENT - pulse.tasks.logs.Details
Some data is missing in the problem statement.
Insulator - Class in pulse.problem.statements.model
 
Insulator() - Constructor for class pulse.problem.statements.model.Insulator
 
Insulator(AbsorptionModel) - Constructor for class pulse.problem.statements.model.Insulator
 
integrand(double...) - Method in class pulse.math.AbstractIntegrator
Calculates the integrand function.
integrand(double...) - Method in class pulse.problem.schemes.rte.exact.CompositionProduct
Evaluates the integrand f(x) En (α + β x) dx}.
integrate() - Method in class pulse.math.AbstractIntegrator
Calculates the definite integral within the specified integration bounds.
integrate() - Method in class pulse.math.MidpointIntegrator
Performs the integration according to the midpoint scheme.
integrate() - Method in class pulse.math.SimpsonIntegrator
Performs the integration with the Simpson's rule.
integrate() - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
integrate() - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
integrate() - Method in class pulse.problem.schemes.rte.dom.TRBDF2
 
integrate() - Method in class pulse.problem.schemes.rte.exact.ChandrasekharsQuadrature
 
integrate() - Method in class pulse.problem.schemes.rte.exact.NewtonCotesQuadrature
Uses the Newton-Cotes integrator (by default, the Simpson's rule) to evaluate the composition product.
INTEGRATION_CUTOFF - pulse.properties.NumericPropertyKeyword
Cutoff for numeric integration.
INTEGRATION_SEGMENTS - pulse.properties.NumericPropertyKeyword
Number of subdivisions for numeric integration.
INTEGRATOR_TIMEOUT - pulse.problem.schemes.rte.RTECalculationStatus
The integrator took too long to finish.
intensitiesLeftBoundary(BlackbodySpectrum) - Method in class pulse.problem.schemes.rte.dom.Discretisation
Calculates the reflected intensity (positive angles, first half of indices) at the left boundary (τ = 0).
intensitiesRightBoundary(BlackbodySpectrum) - Method in class pulse.problem.schemes.rte.dom.Discretisation
Calculates the reflected intensity (negative angles, second half of indices) at the right boundary (τ = τ0).
intermediateProcessing() - Method in class pulse.search.GeneralTask
Override this to add intermediate processing of results e.g.
intermediateProcessing() - Method in class pulse.tasks.SearchTask
 
InternalGraphFrame<T> - Class in pulse.ui.frames
 
InternalGraphFrame(String, AuxPlotter<T>) - Constructor for class pulse.ui.frames.InternalGraphFrame
 
interpolate(double) - Method in class pulse.problem.schemes.rte.dom.HermiteInterpolator
Interpolates the function at x
interpolateAt(double) - Method in class pulse.input.InterpolationDataset
Provides an interpolated value at key based on the available data in the DataEntry List.
interpolateOnExternalGrid(int, AdaptiveIntegrator) - Method in class pulse.problem.schemes.rte.dom.HermiteInterpolator
Interpolates intensities and their derivatives w.r.t.
interpolateSignalAt(double) - Method in class pulse.HeatingCurve
 
interpolateTemperatureProfile(double[]) - Method in class pulse.problem.schemes.rte.RadiativeTransferSolver
Performs interpolation with natural cubic splines using the input arguments.
InterpolationDataset - Class in pulse.input
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'.
InterpolationDataset() - Constructor for class pulse.input.InterpolationDataset
Creates an empty InterpolationDataset.
INVALID_FLUXES - pulse.problem.schemes.rte.RTECalculationStatus
The radiative fluxes contain illegal values.
InvDiamTransform - Class in pulse.math.transforms
A transform that simply divides the value by the squared length of the sample.
InvDiamTransform(ExtendedThermalProperties) - Constructor for class pulse.math.transforms.InvDiamTransform
 
inverse() - Method in class pulse.math.linear.SquareMatrix
Conducts matrix inversion with the procedural EJML approach.
inverse(double) - Method in class pulse.math.transforms.AtanhTransform
 
inverse(double) - Method in class pulse.math.transforms.InvDiamTransform
 
inverse(double) - Method in class pulse.math.transforms.PeriodicTransform
 
inverse(double) - Method in class pulse.math.transforms.StickTransform
 
inverse(double) - Method in interface pulse.math.transforms.Transformable
Inverses the transform.
inverseTransform() - Method in class pulse.math.Parameter
 
inverted() - Method in class pulse.math.linear.Vector
Creates a new Vector based on this one, all elements of which are inverted, i.e.
inwardPartialSum(int, double[], int, int) - Method in class pulse.problem.schemes.rte.dom.PhaseFunction
 
isAcquisitionTimeSensible() - Method in class pulse.input.ExperimentalData
Checks if the acquisition time used to collect this ExperimentalData is sensible.
isAutoUpdateFluxes() - Method in class pulse.problem.schemes.CoupledImplicitScheme
 
isAutoUpdateFluxes() - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
isBetterThan(ParticleState) - Method in class pulse.search.direction.pso.ParticleState
 
isBetterThan(Calculation) - Method in class pulse.tasks.Calculation
Checks if this Calculation is better than a.
isCellEditable(int, int) - Method in class pulse.ui.components.models.ResultTableModel
 
isDefaultSearchVariable() - Method in class pulse.properties.NumericProperty
 
isDimensionConverted() - Method in class pulse.properties.NumericPropertyFormatter
 
isDiscrete() - Method in class pulse.properties.NumericProperty
 
isDiscrete(NumericPropertyKeyword) - Static method in class pulse.properties.NumericProperties
 
isDrawSmooth() - Method in class pulse.ui.frames.PreviewFrame
 
isEmpty() - Method in class pulse.tasks.logs.AbstractLogger
 
isEmpty() - Method in class pulse.ui.components.GraphicalLogPane
 
isEmpty() - Method in class pulse.ui.components.TextLogPane
 
isEnabled() - Method in class pulse.problem.statements.Problem
Used for debugging.
isErrorTooHigh(double) - Method in class pulse.tasks.processing.Buffer
Determines whether the relative error (variance divided by mean) for any of the properties in this buffer is higher than the expect errorTolerance.
isExtensionSupported(File) - Method in interface pulse.io.readers.AbstractHandler
Invokes extensionMatch with the second argument set as getSupportedExtension().
isFinished() - Method in class pulse.tasks.logs.Log
 
isFirstRun() - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
isFSAL() - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
isFull() - Method in class pulse.AbstractData
 
isGraphicalLog() - Static method in class pulse.tasks.logs.Log
Checks whether this Log is verbose.
isInProgress() - Method in class pulse.search.GeneralTask
 
isInProgress() - Method in class pulse.search.SimpleOptimisationTask
 
isInProgress() - Method in class pulse.tasks.SearchTask
 
isListedNumericType(NumericPropertyKeyword) - Method in class pulse.util.PropertyHolder
 
isListedParameter(Property) - Method in class pulse.util.PropertyHolder
Checks whether p, which is either a generic or a numeric property, is listed as as parameter for this PropertyHolder.
isOptimisable() - Method in class pulse.properties.NumericProperty
 
isPositiveDefinite() - Method in class pulse.math.linear.SquareMatrix
Checks if a matrix is positive definite.
isReady() - Method in class pulse.problem.statements.ClassicalProblem
 
isReady() - Method in class pulse.problem.statements.ClassicalProblem2D
 
isReady() - Method in class pulse.problem.statements.NonlinearProblem
 
isReady() - Method in class pulse.problem.statements.Problem
 
isResidualsShown() - Method in class pulse.ui.components.Chart
 
isSelectionEmpty() - Method in class pulse.ui.components.ResultTable
 
isSingleStatement() - Method in class pulse.tasks.TaskManager
Checks whether changes in this PropertyHolder should automatically be accounted for by other instances of this class.
isStarted() - Method in class pulse.tasks.logs.Log
Checks whether this Log has observed a TaskStateEvent triggered by a change of status of its respective SearchTask to IN_PROGRESS.
isTaskQueueEmpty() - Method in class pulse.tasks.TaskManager
Checks if any of the tasks that this TaskManager manages is either QUEUED or IN_PROGRESS.
isValid() - Method in class pulse.input.IndexRange
Checks if this index range is viable.
isValueSensible(NumericProperty, Number) - Static method in class pulse.properties.NumericProperties
Checks whether the val that is going to be passed to the property (a) has the same type as the property.getValue() object; (b) is confined within the definition domain: minimum <= value <= maximum.
isVisibleByDefault() - Method in class pulse.properties.NumericProperty
 
isZeroApproximationShown() - Method in class pulse.ui.components.Chart
 
iteration(int) - Method in interface pulse.problem.schemes.FixedPointIterations
Performs an iteration at time m
iteration(int) - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolverNL
 
iteration(int) - Method in class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
iteration(int) - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolverNL
 
iteration(int) - Method in class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
iteration(int) - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
iteration(int) - Method in class pulse.problem.schemes.solvers.MixedCoupledSolverNL
 
iteration(GeneralTask) - Method in class pulse.search.direction.CompositePathOptimiser
 
iteration(GeneralTask) - Method in class pulse.search.direction.LMOptimiser
 
iteration(GeneralTask) - Method in class pulse.search.direction.PathOptimiser
This method sets out the basic algorithm for estimating the minimum of the target function, which is defined as the sum of squared residuals (SSR), or the deviations of the model solution (a DifferenceScheme used to solve the Problem for this task) from the empirical values (the ExperimentalData).
iteration(GeneralTask) - Method in class pulse.search.direction.pso.ParticleSwarmOptimiser
Iterates the swarm.
ITERATION - pulse.properties.NumericPropertyKeyword
Search iteration.
ITERATION_LIMIT - pulse.properties.NumericPropertyKeyword
Iteration limit for reverse problem solution.
ITERATION_LIMIT_REACHED - pulse.problem.schemes.rte.RTECalculationStatus
The iterative solver took too long to finish.
IterativeSolver - Class in pulse.problem.schemes.rte.dom
Used to iteratively solve the radiative transfer problem.
IterativeSolver() - Constructor for class pulse.problem.schemes.rte.dom.IterativeSolver
Constructs an IterativeSolver with the default thresholds for iteration error and number of iterations.
IterativeState - Class in pulse.search.direction
 
IterativeState() - Constructor for class pulse.search.direction.IterativeState
 
IterativeState(IterativeState) - Constructor for class pulse.search.direction.IterativeState
Stores the parameter vector and cost function value associated with the specified state.
IterativeState(GeneralTask) - Constructor for class pulse.search.direction.IterativeState
 

J

jacobian(GeneralTask) - Method in class pulse.search.direction.LMOptimiser
Calculates the Jacobian of the model function given as a discrete set of time-signal values.

K

KSTest - Class in pulse.search.statistics
The Kolmogorov-Smirnov normality test as implemented in ApacheCommonsMath.
KSTest() - Constructor for class pulse.search.statistics.KSTest
 

L

LAGUERRE_SOLVER_ERROR - pulse.properties.NumericPropertyKeyword
Error tolerance for the Laguerre solver (RTE).
LASER - pulse.problem.statements.model.SpectralRange
 
LASER_ABSORPTIVITY - pulse.properties.NumericPropertyKeyword
Dimensionless coefficient of laser energy absorption (γ0).
LASER_ENERGY - pulse.properties.NumericPropertyKeyword
Absorbed energy (nonlinear problems).
laserPowerAt(double) - Method in class pulse.problem.laser.DiscretePulse
Uses the PulseTemporalShape of the Pulse object to calculate the laser power at the specified moment of time.
laserPowerAt(double) - Method in class pulse.problem.laser.DiscretePulse2D
Calculates the laser power at a give moment in time.
lastEntry() - Method in class pulse.tasks.logs.Log
Finds the last recorded entry in this Log.
Launcher - Class in pulse.ui
This is the main class used to launch PULsE and start the GUI.
leftBoundary(int) - Method in class pulse.problem.schemes.ImplicitScheme
 
leftBoundary(int) - Method in class pulse.problem.schemes.solvers.ImplicitDiathermicSolver
 
LegendrePoly - Class in pulse.math
A utility class represents the Legendre polynomial of a given order.
LegendrePoly(int) - Constructor for class pulse.math.LegendrePoly
Creates a Legendre polynomial of the order n.
length() - Method in class pulse.math.linear.Vector
Calculates the length, which is represented by the square-root of the squared length.
length() - Method in class pulse.math.Segment
Calculates the length (b - a)
lengthSq() - Method in class pulse.math.linear.Vector
The squared length of this vector is the dot product of this vector by itself.
lengthSq() - Method in class pulse.math.Segment
Calculates the squared length
LFRReader - Class in pulse.io.readers
A CurveReader capable of reading ASCII master-files generated by the Linseis software.
LINEAR_RESOLUTION - pulse.properties.NumericPropertyKeyword
The resolution of linear search.
LinearAnisotropicPF - Class in pulse.problem.schemes.rte.dom
The linear-anisotropic scattering phase function.
LinearAnisotropicPF(ThermoOpticalProperties, Discretisation) - Constructor for class pulse.problem.schemes.rte.dom.LinearAnisotropicPF
 
LinearBaseline - Class in pulse.baseline
A linear Baseline which specifies the intercept and slope parameters.
LinearBaseline() - Constructor for class pulse.baseline.LinearBaseline
A primitive constructor, which initialises a CONSTANT baseline with zero intercept and slope.
LinearBaseline(double, double) - Constructor for class pulse.baseline.LinearBaseline
 
LinearBaseline(AdjustableBaseline) - Constructor for class pulse.baseline.LinearBaseline
 
linearExtrapolation(double[], double[], double) - Static method in class pulse.math.MathUtils
Performs linear extrapolation according to the rule y(xStar) = y1 + (xStar - x1)/(x2 - x1) * (y2 - y1)
LinearOptimiser - Class in pulse.search.linear
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.
LinearOptimiser() - Constructor for class pulse.search.linear.LinearOptimiser
 
linearStep(GeneralTask) - Method in class pulse.search.linear.GoldenSectionOptimiser
Let a and b be the start and end point of a Segment, initially defined by the super.domain(IndexedVector,Vector) method.
linearStep(GeneralTask) - Method in class pulse.search.linear.LinearOptimiser
Finds the minimum of the target function on the domain Segment.
linearStep(GeneralTask) - Method in class pulse.search.linear.WolfeOptimiser
This uses a combination of the Wolfe conditions for conducting an inexact line search with the domain partitioning using a random number generator.
listedKeywords() - Method in class pulse.AbstractData
Lists NUM_POINTS as an accessible property of this PropertyHolder.
listedKeywords() - Method in class pulse.baseline.AdjustableBaseline
Lists the intercept as accessible property for this FlatBaseline.
listedKeywords() - Method in class pulse.baseline.LinearBaseline
 
listedKeywords() - Method in class pulse.baseline.SinusoidalBaseline
 
listedKeywords() - Method in class pulse.HeatingCurve
 
listedKeywords() - Method in class pulse.input.Metadata
 
listedKeywords() - Method in class pulse.input.Range
Lists lower and upper bounds as properties.
listedKeywords() - Method in class pulse.math.FixedIntervalIntegrator
The listed property is INTEGRATION_SEGMENTS.
listedKeywords() - Method in class pulse.math.Harmonic
Listed properties include the frequency, amplitude, phase shift, and intercept.
listedKeywords() - Method in class pulse.problem.laser.ExponentiallyModifiedGaussian
 
listedKeywords() - Method in class pulse.problem.laser.TrapezoidalPulse
 
listedKeywords() - Method in class pulse.problem.schemes.CoupledImplicitScheme
 
listedKeywords() - Method in class pulse.problem.schemes.DifferenceScheme
The superclass only lists the TIME_LIMIT property.
listedKeywords() - Method in class pulse.problem.schemes.Grid
The listed properties include GRID_DENSITY and TAU_FACTOR.
listedKeywords() - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
listedKeywords() - Method in class pulse.problem.schemes.rte.dom.IterativeSolver
 
listedKeywords() - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
listedKeywords() - Method in class pulse.problem.schemes.rte.dom.SuccessiveOverrelaxation
 
listedKeywords() - Method in class pulse.problem.schemes.rte.exact.ChandrasekharsQuadrature
 
listedKeywords() - Method in class pulse.problem.schemes.rte.exact.NewtonCotesQuadrature
 
listedKeywords() - Method in class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
listedKeywords() - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
listedKeywords() - Method in class pulse.problem.schemes.solvers.MixedCoupledSolver
 
listedKeywords() - Method in class pulse.problem.statements.ClassicalProblem
 
listedKeywords() - Method in class pulse.problem.statements.model.AbsorptionModel
 
listedKeywords() - Method in class pulse.problem.statements.model.DiathermicProperties
 
listedKeywords() - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
listedKeywords() - Method in class pulse.problem.statements.model.Insulator
 
listedKeywords() - Method in class pulse.problem.statements.model.ThermalProperties
Listed parameters include: MAXTEMP, DIFFUSIVITY, THICKNESS, HEAT_LOSS_FRONT, HEAT_LOSS_REAR.
listedKeywords() - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
listedKeywords() - Method in class pulse.problem.statements.model.TwoTemperatureProperties
 
listedKeywords() - Method in class pulse.problem.statements.NonlinearProblem
 
listedKeywords() - Method in class pulse.problem.statements.ParticipatingMedium
 
listedKeywords() - Method in class pulse.problem.statements.PenetrationProblem
 
listedKeywords() - Method in class pulse.problem.statements.Problem
Listed parameters include: MAXTEMP, DIFFUSIVITY, THICKNESS, HEAT_LOSS_FRONT, HEAT_LOSS_REAR.
listedKeywords() - Method in class pulse.problem.statements.Pulse
The listed parameters for Pulse are: PulseShape, PULSE_WIDTH, SPOT_DIAMETER.
listedKeywords() - Method in class pulse.problem.statements.Pulse2D
 
listedKeywords() - Method in class pulse.search.direction.GradientBasedOptimiser
The types of the listed parameters for this class include: GRADIENT_RESOLUTION, ERROR_TOLERANCE, ITERATION_LIMIT.
listedKeywords() - Method in class pulse.search.direction.LMOptimiser
 
listedKeywords() - Method in class pulse.search.direction.PathOptimiser
The types of the listed parameters for this class include: ERROR_TOLERANCE, ITERATION_LIMIT.
listedKeywords() - Method in class pulse.search.linear.LinearOptimiser
The LINEAR_RESOLUTION is the single listed parameter for this class.
listedKeywords() - Method in class pulse.util.PropertyHolder
By default, this will search the children of this PropertyHolder to collect the types of their listed numeric parameters recursively.
listedTypes() - Method in class pulse.input.Metadata
The listed types include TEST_TEMPERATURE, THICKNESS, DIAMETER, PULSE_WIDTH, SPOT_DIAMETER, LASER_ENERGY, DETECTOR_GAIN, DETECTOR_IRIS, sample name and the types listed by the pulse descriptor.
listedTypes() - Method in class pulse.problem.schemes.RadiativeTransferCoupling
 
listedTypes() - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
listedTypes() - Method in class pulse.problem.schemes.rte.dom.Discretisation
 
listedTypes() - Method in class pulse.problem.schemes.rte.dom.ExplicitRungeKutta
 
listedTypes() - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
 
listedTypes() - Method in class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
listedTypes() - Method in class pulse.problem.statements.PenetrationProblem
 
listedTypes() - Method in class pulse.problem.statements.Problem
 
listedTypes() - Method in class pulse.problem.statements.Pulse
 
listedTypes() - Method in class pulse.problem.statements.TwoTemperatureModel
 
listedTypes() - Method in class pulse.search.direction.CompositePathOptimiser
 
listedTypes() - Method in class pulse.tasks.processing.Buffer
The BUFFER_SIZE is the single listed parameter for this class.
listedTypes() - Method in class pulse.util.PropertyHolder
By default, collects a list of default properties corresponding to types defined by listedKeywords().
LMOptimiser - Class in pulse.search.direction
Given an objective function equal to the sum of squared residuals, iteratively approaches the minimum of this function by applying the Levenberg-Marquardt formulas.
load(AbstractReader<T>, String, String) - Static method in class pulse.io.readers.ReaderManager
This method is specifically introduced to handle multiple files in a resources folder enclosed within the jar archive.
loadDataDialog() - Static method in class pulse.ui.components.DataLoader
Initiates a user dialog to load experimental time-temperature profiles.
loadDensity(File) - Static method in class pulse.ui.components.DataLoader
Uses the ReaderManager to create an InterpolationDataset from data stored in f and updates the associated properties of each task.
LoaderButton - Class in pulse.ui.components.buttons
 
LoaderButton(LoaderButton.DataType) - Constructor for class pulse.ui.components.buttons.LoaderButton
 
LoaderButton(LoaderButton.DataType, String) - Constructor for class pulse.ui.components.buttons.LoaderButton
 
LoaderButton.DataType - Enum in pulse.ui.components.buttons
 
loadIcon(String, int) - Static method in class pulse.util.ImageUtils
 
loadIcon(String, int, Color) - Static method in class pulse.util.ImageUtils
 
loadMetadataDialog() - Static method in class pulse.ui.components.DataLoader
Asks the user to select a single file containing the metadata, with the extension given by the MetaFilePopulator class.
loadPulseDialog() - Static method in class pulse.ui.components.DataLoader
 
loadSpecificHeat(File) - Static method in class pulse.ui.components.DataLoader
Uses the ReaderManager to create an InterpolationDataset from data stored in f and updates the associated properties of each task.
loadState(List<Flag>) - Static method in class pulse.search.direction.ActiveFlags
Loads the argument into the current list of flags.
Log - Class in pulse.tasks.logs
A Log is used to track changes for a specific SearchTask, such as changes of status and/or data collection events.
Log(SearchTask) - Constructor for class pulse.tasks.logs.Log
Creates a Log for this task that will automatically store TaskStatEvents and a list of DataLogEntries in thread-safe collections.
LOG - Static variable in class pulse.math.transforms.StandardTransformations
Logarithmic parameter transform.
LogChart - Class in pulse.ui.components
 
LogChart() - Constructor for class pulse.ui.components.LogChart
 
LogEntry - Class in pulse.tasks.logs
An abstract class for LogEntries created for a specific SearchTask.
LogEntry(SearchTask) - Constructor for class pulse.tasks.logs.LogEntry
Creates a LogEntry from this SearchTask.
LogEntryListener - Interface in pulse.tasks.listeners
 
LogExporter - Class in pulse.io.export
A singleton LogExporter works on Log objects to write html files containing the full contents of the Log.
LogFrame - Class in pulse.ui.frames
 
LogFrame() - Constructor for class pulse.ui.frames.LogFrame
 
LogListener - Interface in pulse.ui.components.listeners
 
LogToolbar - Class in pulse.ui.components.panels
 
LogToolbar() - Constructor for class pulse.ui.components.panels.LogToolbar
 
LOW - pulse.problem.statements.ProblemComplexity
 
LOWER_BOUND - pulse.properties.NumericPropertyKeyword
Lower calculation bound for optimiser.
LOWER_LIMIT - Static variable in class pulse.properties.NumericPropertyFormatter
Start using scientific notations for number whose absolute values are lower than 0.01.

M

main(String[]) - Static method in class pulse.ui.Launcher
Launches the application and creates a GUI.
MainGraphFrame - Class in pulse.ui.frames
 
MARGIN - Static variable in class pulse.ui.components.LogChart
 
MathUtils - Class in pulse.math
A utility class containing some common methods potentially enhancing the performance of standard mathematical operations.
Matrices - Class in pulse.math.linear
A static factory class used to create matrices.
MAX_FAILED_ATTEMPTS - Static variable in class pulse.search.direction.CompositePathOptimiser
Maximum number of consequent failed iterations that can be rejected.
MAX_FAILED_ATTEMPTS - Static variable in class pulse.search.direction.LMOptimiser
Up to 5 failed attempts are allowed.
MAX_HIGH_FREQ_WAVES - pulse.properties.NumericPropertyKeyword
Max.
MAX_ITERATIONS_REACHED - pulse.tasks.logs.Details
 
MAX_LOW_FREQ_WAVES - pulse.properties.NumericPropertyKeyword
Max.
maxAbsComponent() - Method in class pulse.math.linear.Vector
Determines the maximum absolute value of the vector components.
maxAdjustedSignal() - Method in class pulse.HeatingCurve
Retrieves the simple maximum (in arbitrary units) of the baseline-corrected temperature list.
maximumHeating(Pulse2D) - Method in class pulse.problem.statements.model.ThermalProperties
 
maxNp() - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
maxRadiationBiot() - Method in class pulse.problem.statements.model.ThermalProperties
Calculates the maximum Biot number at these conditions, which corresponds to an emissivity of unity.
MAXTEMP - pulse.properties.NumericPropertyKeyword
The maximum temperature, or the signal height -- if a relative temperature scale is used.
mean() - Method in class pulse.math.Segment
Calculates the middle point of this Segment.
mean(List<Double>) - Method in class pulse.baseline.AdjustableBaseline
 
meanFluxDerivative(int) - Method in interface pulse.problem.schemes.rte.DerivativeCalculator
Calculates the average value of the flux derivatives at the uIndex grid point on the current and previous timesteps.
meanFluxDerivative(int) - Method in class pulse.problem.schemes.rte.FluxesAndExplicitDerivatives
 
meanFluxDerivative(int) - Method in class pulse.problem.schemes.rte.FluxesAndImplicitDerivatives
 
meanFluxDerivativeFront() - Method in interface pulse.problem.schemes.rte.DerivativeCalculator
Calculates the average value of the flux derivatives at the first grid point on the current and previous timesteps.
meanFluxDerivativeFront() - Method in class pulse.problem.schemes.rte.FluxesAndExplicitDerivatives
 
meanFluxDerivativeFront() - Method in class pulse.problem.schemes.rte.FluxesAndImplicitDerivatives
 
meanFluxDerivativeRear() - Method in interface pulse.problem.schemes.rte.DerivativeCalculator
Calculates the average value of the flux derivatives at the last grid point on the current and previous timesteps.
meanFluxDerivativeRear() - Method in class pulse.problem.schemes.rte.FluxesAndExplicitDerivatives
 
meanFluxDerivativeRear() - Method in class pulse.problem.schemes.rte.FluxesAndImplicitDerivatives
 
memoryUsage() - Method in class pulse.util.ResourceMonitor
This will calculate the ratio totalMemory/maxMemory using the standard Runtime.
merge(double) - Method in class pulse.ui.components.models.ResultTableModel
Transforms the result model by merging individual results which: (a) correspond to test temperatures within a specified temperatureDelta (b) form a single sequence of measurements
Messages - Class in pulse.ui
 
Metadata - Class in pulse.input
Metadata is the information relating to a specific experiment, which can be used by a SearchTask to process an instance of ExperimentalData.
Metadata(NumericProperty, int) - Constructor for class pulse.input.Metadata
Creates a Metadata with the specified parameters and a default rectangular pulse shape.
MetadataExporter - Class in pulse.io.export
A singleton class used to export Metadata objects in a html format.
MetaFilePopulator - Class in pulse.io.readers
An AbstractPopulator capable of handling metafiles.
MidpointIntegrator - Class in pulse.math
Implements the midpoint integration scheme for the evaluation of definite integrals.
MidpointIntegrator(Segment) - Constructor for class pulse.math.MidpointIntegrator
 
MidpointIntegrator(Segment, NumericProperty) - Constructor for class pulse.math.MidpointIntegrator
 
MIN_BASELINE_POINTS - Static variable in class pulse.baseline.Baseline
 
MIN_BINS - Static variable in class pulse.math.filters.RunningAverage
 
MISSING_BUFFER - pulse.tasks.logs.Details
The buffer has not been created.
MISSING_DIFFERENCE_SCHEME - pulse.tasks.logs.Details
The DifferenceScheme for solving the Problem has not been specified by the user.
MISSING_HEATING_CURVE - pulse.tasks.logs.Details
A heating curve has not been set up for the DifferenceScheme.
MISSING_OPTIMISER - pulse.tasks.logs.Details
There is no information about the selected optimiser.
MISSING_PROBLEM_STATEMENT - pulse.tasks.logs.Details
The Problem has not been specified by the user.
MixedCoupledSolver - Class in pulse.problem.schemes.solvers
 
MixedCoupledSolver() - Constructor for class pulse.problem.schemes.solvers.MixedCoupledSolver
 
MixedCoupledSolver(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.MixedCoupledSolver
 
MixedCoupledSolverNL - Class in pulse.problem.schemes.solvers
 
MixedCoupledSolverNL() - Constructor for class pulse.problem.schemes.solvers.MixedCoupledSolverNL
 
MixedCoupledSolverNL(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.MixedCoupledSolverNL
 
MixedLinearisedSolver - Class in pulse.problem.schemes.solvers
Performs a fully-dimensionless calculation for the LinearisedProblem.
MixedLinearisedSolver() - Constructor for class pulse.problem.schemes.solvers.MixedLinearisedSolver
 
MixedLinearisedSolver(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.MixedLinearisedSolver
 
MixedLinearisedSolver(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.solvers.MixedLinearisedSolver
 
MixedScheme - Class in pulse.problem.schemes
An abstraction describing a weighted semi-implicit finite-difference scheme for solving the one-dimensional heat conduction problem.
MixedScheme() - Constructor for class pulse.problem.schemes.MixedScheme
Constructs a default semi-implicit scheme using the default values of GRID_DENSITY and TAU_FACTOR.
MixedScheme(NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.MixedScheme
Constructs a semi-implicit scheme on a one-dimensional grid that is specified by the values N and timeFactor.
MixedScheme(NumericProperty, NumericProperty, NumericProperty) - Constructor for class pulse.problem.schemes.MixedScheme
Constructs a semi-implicit scheme on a one-dimensional grid that is specified by the values N and timeFactor.
MODEL_COMPARISON - pulse.ui.frames.TaskControlFrame.Mode
 
MODEL_CRITERION - pulse.properties.NumericPropertyKeyword
Model selection criterion (AIC, BIC, etc.).
MODEL_STATISTIC_COLUMN - Static variable in class pulse.ui.components.models.StoredCalculationTableModel
 
MODEL_WEIGHT - pulse.properties.NumericPropertyKeyword
A weight indicating how good a calculation model is.
ModelSelectionCriterion - Class in pulse.search.statistics
An abstract superclass for the BIC and AIC statistics.
ModelSelectionCriterion(ModelSelectionCriterion) - Constructor for class pulse.search.statistics.ModelSelectionCriterion
 
ModelSelectionCriterion(OptimiserStatistic) - Constructor for class pulse.search.statistics.ModelSelectionCriterion
 
ModelSelectionFrame - Class in pulse.ui.frames
 
ModelSelectionFrame() - Constructor for class pulse.ui.frames.ModelSelectionFrame
 
ModelToolbar - Class in pulse.ui.components.panels
 
ModelToolbar() - Constructor for class pulse.ui.components.panels.ModelToolbar
 
MODERATE - pulse.problem.statements.ProblemComplexity
 
MouseOnMarkerListener - Class in pulse.ui.components.listeners
 
MouseOnMarkerListener(Chart, MovableValueMarker, MovableValueMarker, double) - Constructor for class pulse.ui.components.listeners.MouseOnMarkerListener
 
MovableValueMarker - Class in pulse.ui.components
 
MovableValueMarker(double) - Constructor for class pulse.ui.components.MovableValueMarker
 
MovableValueMarker.State - Enum in pulse.ui.components
 
moveParticles() - Method in class pulse.search.direction.pso.ParticleSwarmOptimiser
 
Mover - Interface in pulse.search.direction.pso
 
MOVING - pulse.ui.components.MovableValueMarker.State
 
multComponents(Vector) - Method in class pulse.math.linear.Vector
Component-wise vector multiplication
multiply(double) - Method in class pulse.math.linear.RectangularMatrix
Scales this Matrix by f, which results in element-wise multiplication by f.
multiply(double) - Method in class pulse.math.linear.Vector
Performs an element-wise multiplication by f.
multiply(RectangularMatrix) - Method in class pulse.math.linear.RectangularMatrix
Performs Matrix multiplication.
multiply(Vector) - Method in class pulse.math.linear.RectangularMatrix
Multiplies this Matrix by the vector v, which is represented by a n × 1 Matrix, where n is the dimension of v.

N

NEGATIVE - Static variable in class pulse.input.Range
 
NeighbourhoodTopology - Interface in pulse.search.direction.pso
 
neighbours(Particle, SwarmState) - Method in interface pulse.search.direction.pso.NeighbourhoodTopology
 
NetzschCSVReader - Class in pulse.io.readers
Reads the .CSV files exported from Proteus LFA Analysis software.
NetzschPulseCSVReader - Class in pulse.io.readers
Reads numeric pulse data generated by the Proteus LFA Analysis export tool.
NEW_STATE - pulse.tasks.listeners.TaskRepositoryEvent.State
A new state has been loaded.
newInstance(Class<K>, Object...) - Method in class pulse.util.InstanceDescriptor
 
NewtonCotesQuadrature - Class in pulse.problem.schemes.rte.exact
A class for evaluating the composition product using a simple Newton-Cotes quadrature with a cutoff.
NewtonCotesQuadrature() - Constructor for class pulse.problem.schemes.rte.exact.NewtonCotesQuadrature
Constructs a default NewtonCotesQuadrature with integration bounds spanning from 0 to 1.
NewtonCotesQuadrature(Segment) - Constructor for class pulse.problem.schemes.rte.exact.NewtonCotesQuadrature
Constructs a default NewtonCotesQuadrature whose integration bounds are specified by the argument.
NewtonCotesQuadrature(Segment, NumericProperty) - Constructor for class pulse.problem.schemes.rte.exact.NewtonCotesQuadrature
Constructs a custom NewtonCotesQuadrature with specified integration bounds and number of integration segments.
Nitrogen - Class in pulse.problem.statements.model
 
Nitrogen() - Constructor for class pulse.problem.statements.model.Nitrogen
 
NONE - pulse.tasks.logs.Details
 
NONE - Static variable in interface pulse.math.Window
 
NONLINEAR_PRECISION - pulse.properties.NumericPropertyKeyword
The precision parameter used to solve nonlinear problems.
NonlinearProblem - Class in pulse.problem.statements
 
NonlinearProblem() - Constructor for class pulse.problem.statements.NonlinearProblem
 
NonlinearProblem(NonlinearProblem) - Constructor for class pulse.problem.statements.NonlinearProblem
 
NonscatteringAnalyticalDerivatives - Class in pulse.problem.schemes.rte.exact
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.
NonscatteringAnalyticalDerivatives(ParticipatingMedium, Grid) - Constructor for class pulse.problem.schemes.rte.exact.NonscatteringAnalyticalDerivatives
 
NonscatteringDiscreteDerivatives - Class in pulse.problem.schemes.rte.exact
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.
NonscatteringDiscreteDerivatives(ParticipatingMedium, Grid) - Constructor for class pulse.problem.schemes.rte.exact.NonscatteringDiscreteDerivatives
 
NonscatteringRadiativeTransfer - Class in pulse.problem.schemes.rte.exact
 
NonscatteringRadiativeTransfer(ParticipatingMedium, Grid) - Constructor for class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
 
NORMAL - pulse.problem.schemes.rte.RTECalculationStatus
The current calculation step finished normally.
normalise() - Method in class pulse.math.linear.Vector
Performs normalisation, e.g.
NormalityTest - Class in pulse.search.statistics
A normality test is invoked after a task finishes, to validate its result.
NormalityTest() - Constructor for class pulse.search.statistics.NormalityTest
 
normalOperation() - Method in class pulse.problem.schemes.CoupledImplicitScheme
 
normalOperation() - Method in class pulse.problem.schemes.DifferenceScheme
 
normalOperation() - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
notifyClear() - Method in class pulse.ui.components.panels.TaskToolbar
 
notifyExit() - Method in class pulse.ui.components.PulseMainMenu
 
notifyGraph() - Method in class pulse.ui.components.panels.TaskToolbar
 
notifyListeners(TaskRepositoryEvent) - Method in class pulse.tasks.TaskManager
Notifies the TaskRepositoryListeners of the e
notifyPreview() - Method in class pulse.ui.frames.ResultFrame
 
notifyProblem() - Method in class pulse.ui.components.PulseMainMenu
 
notifyRemove() - Method in class pulse.ui.components.panels.TaskToolbar
 
notifyReset() - Method in class pulse.ui.components.panels.TaskToolbar
 
notifySearch() - Method in class pulse.ui.components.PulseMainMenu
 
NUM_PARTITIONS - Static variable in class pulse.math.FunctionWithInterpolation
 
NumberEditor - Class in pulse.ui.components.controllers
 
NumberEditor(NumericProperty) - Constructor for class pulse.ui.components.controllers.NumberEditor
 
numberFormat(NumericProperty) - Method in class pulse.properties.NumericPropertyFormatter
 
numberOfStages() - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
numberOfTasks() - Method in class pulse.tasks.TaskManager
Gets the current number of tasks in the repository.
numericData() - Method in class pulse.util.PropertyHolder
Lists all numeric data contained in this PropertyHolder.
numericProperties() - Method in class pulse.util.Accessible
Tries to access the property getter methods in this Accessible, which should be declared as no-argument methods with a specific return type.
NumericProperties - Class in pulse.properties
Default operations with NumericProperties
numericProperty(NumericPropertyKeyword) - Method in class pulse.input.Metadata
Searches the internal list of this class for a property with the key type.
numericProperty(NumericPropertyKeyword) - Method in class pulse.util.Accessible
Recursively searches for a NumericProperty from the unique set of numeric properties in this Accessible by comparing its NumericPropertyKeyword to type.
NumericProperty - Class in pulse.properties
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.
NumericProperty(Number, NumericProperty) - Constructor for class pulse.properties.NumericProperty
Creates a NumericProperty based on {
NumericProperty(NumericProperty) - Constructor for class pulse.properties.NumericProperty
A copy constructor for NumericProperty
NumericProperty(NumericPropertyKeyword, Number...) - Constructor for class pulse.properties.NumericProperty
Constructor used by XMLConverter to create a NumericProperty with fully specified set of parameters
NumericPropertyComparator - Class in pulse.ui.components.controllers
 
NumericPropertyComparator() - Constructor for class pulse.ui.components.controllers.NumericPropertyComparator
 
NumericPropertyFormatter - Class in pulse.properties
 
NumericPropertyFormatter(NumericProperty, boolean, boolean) - Constructor for class pulse.properties.NumericPropertyFormatter
 
NumericPropertyKeyword - Enum in pulse.properties
Contains a list of NumericProperty types recognised by the constituent modules of PULsE.
NumericPropertyRenderer - Class in pulse.ui.components.controllers
 
NumericPropertyRenderer() - Constructor for class pulse.ui.components.controllers.NumericPropertyRenderer
 
NumericPulse - Class in pulse.problem.laser
A numeric pulse is given by a set of discrete NumericPulseData measured independently using a pulse diode.
NumericPulse() - Constructor for class pulse.problem.laser.NumericPulse
 
NumericPulse(NumericPulse) - Constructor for class pulse.problem.laser.NumericPulse
Copy constructor
NumericPulseData - Class in pulse.problem.laser
An instance of the AbstractData class, which also declares an externalID.
NumericPulseData(int) - Constructor for class pulse.problem.laser.NumericPulseData
Stores id and calls super-constructor
NumericPulseData(NumericPulseData) - Constructor for class pulse.problem.laser.NumericPulseData
Copies everything, including the id number.
NUMPOINTS - pulse.properties.NumericPropertyKeyword
The number of points in the HeatingCurve.

O

OBJECTIVE_FUNCTION - pulse.properties.NumericPropertyKeyword
Value of objective function.
objectiveFunction() - Method in class pulse.search.GeneralTask
 
objectiveFunction(GeneralTask) - Method in interface pulse.Response
Calculates the value of the objective function used to identify the current state of the optimiser.
objectiveFunction(GeneralTask) - Method in class pulse.search.SimpleResponse
 
objectiveFunction(GeneralTask) - Method in class pulse.tasks.Calculation
This will use the current DifferenceScheme to solve the Problem for this SearchTask and calculate the SSR value showing how well (or bad) the calculated solution describes the ExperimentalData.
ODEIntegrator - Class in pulse.problem.schemes.rte.dom
 
ODEIntegrator(Discretisation) - Constructor for class pulse.problem.schemes.rte.dom.ODEIntegrator
 
onChildPropertyChanged(PropertyEvent) - Method in interface pulse.util.HierarchyListener
This is invoked by the UpwardsNavigable when an event resulting in a change of the child's property has occurred.
onClearRequest() - Method in interface pulse.ui.components.listeners.TaskActionListener
 
onConfirm() - Method in interface pulse.ui.components.controllers.ConfirmAction
 
onCurveEvent(CurveEvent) - Method in interface pulse.HeatingCurveListener
Signals that a CurveEvent has occurred.
onDataChanged(DataEvent) - Method in interface pulse.input.listeners.DataListener
Triggered when a certain DataEvent specified by its DataEventType is initiated from within the ExperimentalData object.
onDataCollected(LogEntry) - Method in interface pulse.tasks.listeners.DataCollectionListener
 
onDeleteRequest() - Method in interface pulse.ui.components.listeners.ResultRequestListener
 
onDensityDataLoaded() - Method in interface pulse.input.listeners.ExternalDatasetListener
 
onDescriptorChanged() - Method in interface pulse.util.DescriptorChangeListener
 
OneDimensionalScheme - Class in pulse.problem.schemes
 
OneDimensionalScheme() - Constructor for class pulse.problem.schemes.OneDimensionalScheme
 
OneDimensionalScheme(NumericProperty) - Constructor for class pulse.problem.schemes.OneDimensionalScheme
 
onExitRequested() - Method in interface pulse.ui.components.listeners.ExitRequestListener
 
onExportRequest() - Method in interface pulse.ui.components.listeners.ResultRequestListener
 
onFormatChanged(ResultFormatEvent) - Method in interface pulse.ui.components.listeners.ResultListener
 
onGraphRequest() - Method in interface pulse.ui.components.listeners.TaskActionListener
 
onLogExportRequest() - Method in interface pulse.ui.components.listeners.LogListener
 
onLogFinished(Log) - Method in interface pulse.tasks.listeners.LogEntryListener
 
onLogModeChanged(boolean) - Method in interface pulse.ui.components.listeners.LogListener
 
onMergeRequest() - Method in interface pulse.ui.components.listeners.ResultRequestListener
 
onNewEntry(LogEntry) - Method in interface pulse.tasks.listeners.LogEntryListener
 
onNewSessionLoaded() - Method in interface pulse.tasks.listeners.SessionListener
 
onPlotRequest() - Method in interface pulse.ui.components.listeners.PlotRequestListener
 
onPreviewFrameRequest() - Method in interface pulse.ui.components.listeners.PreviewFrameCreationListener
 
onPreviewRequest() - Method in interface pulse.ui.components.listeners.ResultRequestListener
 
onProblemSelected(ProblemSelectionEvent) - Method in interface pulse.ui.components.listeners.ProblemSelectionListener
 
onProblemStatementShowRequest() - Method in interface pulse.ui.components.listeners.FrameVisibilityRequestListener
 
onPropertyChanged(PropertyEvent) - Method in interface pulse.util.PropertyHolderListener
This event is triggered by any PropertyHolder, the properties of which have been changed.
onRemoveRequest() - Method in interface pulse.ui.components.listeners.TaskActionListener
 
onResetRequest() - Method in interface pulse.ui.components.listeners.TaskActionListener
 
onSearchSettingsShowRequest() - Method in interface pulse.ui.components.listeners.FrameVisibilityRequestListener
 
onSelectionChanged(TaskSelectionEvent) - Method in interface pulse.tasks.listeners.TaskSelectionListener
 
onSolverException(SolverException) - Method in class pulse.search.GeneralTask
Specifies what should be done when a solver exception is encountered.
onSolverException(SolverException) - Method in class pulse.tasks.SearchTask
 
onSpecificHeatDataLoaded() - Method in interface pulse.input.listeners.ExternalDatasetListener
 
onStatusChange(StateEntry) - Method in interface pulse.tasks.listeners.StatusChangeListener
 
onStatusUpdate(RTECalculationStatus) - Method in interface pulse.problem.schemes.rte.RTECalculationListener
Invoked when a sub-step of the RTE solution has finished.
onTaskListChanged(TaskRepositoryEvent) - Method in interface pulse.tasks.listeners.TaskRepositoryListener
 
onUndoRequest() - Method in interface pulse.ui.components.listeners.ResultRequestListener
 
onValueAssigned() - Method in interface pulse.math.filters.AssignmentListener
 
OpacitySlider - Class in pulse.ui.components.panels
 
OpacitySlider() - Constructor for class pulse.ui.components.panels.OpacitySlider
 
OPTICAL_THICKNESS - pulse.properties.NumericPropertyKeyword
The optical thickness of a material, equal to a product of its geometric thickness and the absorptivity.
opticalCoordinateAt(int) - Method in class pulse.problem.schemes.rte.RadiativeTransferSolver
Retrieves the optical coordinate corresponding to the grid index i
Optimisable - Interface in pulse.search
An interface for dealing with optimisation variables.
OptimisablePolyline - Class in pulse.math.filters
 
OptimisablePolyline(List<Point2D>) - Constructor for class pulse.math.filters.OptimisablePolyline
 
OPTIMISATION_ERROR - pulse.problem.schemes.solvers.SolverException.SolverExceptionType
 
OPTIMISATION_TIMEOUT - pulse.problem.schemes.solvers.SolverException.SolverExceptionType
 
optimisationVector(ParameterVector) - Method in class pulse.baseline.AdjustableBaseline
 
optimisationVector(ParameterVector) - Method in class pulse.baseline.LinearBaseline
 
optimisationVector(ParameterVector) - Method in class pulse.baseline.SinusoidalBaseline
 
optimisationVector(ParameterVector) - Method in class pulse.input.Range
The optimisation vector contain both the lower and upper bounds with the absolute constraints equal to a fourth of their values.
optimisationVector(ParameterVector) - Method in class pulse.math.filters.OptimisablePolyline
 
optimisationVector(ParameterVector) - Method in class pulse.math.Harmonic
The optimisation vector can include the amplitude, frequency and phase shift of a sinusoid, and a baseline intercept value of the superclass.
optimisationVector(ParameterVector) - Method in class pulse.problem.statements.ClassicalProblem
 
optimisationVector(ParameterVector) - Method in class pulse.problem.statements.ClassicalProblem2D
 
optimisationVector(ParameterVector) - Method in class pulse.problem.statements.DiathermicMedium
 
optimisationVector(ParameterVector) - Method in class pulse.problem.statements.model.AbsorptionModel
 
optimisationVector(ParameterVector) - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
optimisationVector(ParameterVector) - Method in class pulse.problem.statements.NonlinearProblem
Does the same as super-class method plus extracts the laser energy and stores it in the output, if needed.
optimisationVector(ParameterVector) - Method in class pulse.problem.statements.ParticipatingMedium
 
optimisationVector(ParameterVector) - Method in class pulse.problem.statements.PenetrationProblem
 
optimisationVector(ParameterVector) - Method in class pulse.problem.statements.Problem
Calculates the vector argument defined on Rn to the scalar objective function for this Problem.
optimisationVector(ParameterVector) - Method in class pulse.problem.statements.TwoTemperatureModel
 
optimisationVector(ParameterVector) - Method in interface pulse.search.Optimisable
Calculates the vector argument defined on Rn to the scalar objective function for this Optimisable.
OptimisedRunningAverage - Class in pulse.math.filters
 
OptimisedRunningAverage() - Constructor for class pulse.math.filters.OptimisedRunningAverage
 
OptimisedRunningAverage(int) - Constructor for class pulse.math.filters.OptimisedRunningAverage
 
OPTIMISER_STATISTIC - pulse.properties.NumericPropertyKeyword
Optimiser statistic (usually, RSS).
OPTIMISER_STATISTIC_COLUMN - Static variable in class pulse.ui.components.models.StoredCalculationTableModel
 
OptimiserStatistic - Class in pulse.search.statistics
An Optimiser statistic is simply the objective function that is calculated by the Optimiser.
OptimiserStatistic() - Constructor for class pulse.search.statistics.OptimiserStatistic
 
OptimiserStatistic(OptimiserStatistic) - Constructor for class pulse.search.statistics.OptimiserStatistic
 
OrdinateSet - Class in pulse.problem.schemes.rte.dom
A fixed set of discrete cosine nodes and weights for the angular discretisation of a radiative transfer equation.
OrdinateSet(String, double[], double[]) - Constructor for class pulse.problem.schemes.rte.dom.OrdinateSet
 
outerProduct(Vector, Vector) - Static method in class pulse.math.linear.SquareMatrix
Calculates the outer product of two vectors.

P

Parameter - Class in pulse.math
Parameter class
Parameter(Parameter) - Constructor for class pulse.math.Parameter
 
Parameter(ParameterIdentifier) - Constructor for class pulse.math.Parameter
 
Parameter(ParameterIdentifier, Transformable, Segment) - Constructor for class pulse.math.Parameter
 
PARAMETER_VALUES_NOT_SENSIBLE - pulse.tasks.logs.Details
 
ParameterIdentifier - Class in pulse.math
 
ParameterIdentifier(int) - Constructor for class pulse.math.ParameterIdentifier
 
ParameterIdentifier(NumericPropertyKeyword) - Constructor for class pulse.math.ParameterIdentifier
 
ParameterIdentifier(NumericPropertyKeyword, int) - Constructor for class pulse.math.ParameterIdentifier
 
parameterListChanged() - Method in class pulse.util.PropertyHolder
 
ParameterTableModel - Class in pulse.ui.components.models
 
ParameterTableModel(boolean) - Constructor for class pulse.ui.components.models.ParameterTableModel
 
ParameterVector - Class in pulse.math
A wrapper subclass that assigns ParameterIdentifiers to specific components of the vector.
ParameterVector(List<ParameterIdentifier>) - Constructor for class pulse.math.ParameterVector
Constructs an IndexedVector with the specified list of keywords.
ParameterVector(ParameterVector) - Constructor for class pulse.math.ParameterVector
Copy constructor
ParameterVector(ParameterVector, Vector) - Constructor for class pulse.math.ParameterVector
Constructs an IndexedVector based on v and a list of keyword indices
PARKERS_COEFFICIENT - Variable in class pulse.problem.statements.model.ThermalProperties
The corrected proportionality factor setting out the relation between the thermal diffusivity and the half-rise time of an ExperimentalData curve.
parse(String) - Static method in class pulse.tasks.Identifier
Seeks an Identifier from the list of available tasks in TaskManager that matches this string.
parse(String, ParsePosition) - Method in class pulse.properties.ScientificFormat
 
partial(int, double, double[], int, int) - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
partial(int, int, double, int, int) - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
partialSum(int, int, int, int) - Method in class pulse.problem.schemes.rte.dom.LinearAnisotropicPF
 
partialSum(int, int, int, int) - Method in class pulse.problem.schemes.rte.dom.PhaseFunction
 
ParticipatingMedium - Class in pulse.problem.statements
 
ParticipatingMedium() - Constructor for class pulse.problem.statements.ParticipatingMedium
 
ParticipatingMedium(ParticipatingMedium) - Constructor for class pulse.problem.statements.ParticipatingMedium
 
Particle - Class in pulse.search.direction.pso
Class defining a particle - the basic unit of a swarm.
Particle(ParticleState, int) - Constructor for class pulse.search.direction.pso.Particle
 
ParticleState - Class in pulse.search.direction.pso
 
ParticleState(ParameterVector) - Constructor for class pulse.search.direction.pso.ParticleState
 
ParticleState(ParameterVector, ParameterVector) - Constructor for class pulse.search.direction.pso.ParticleState
 
ParticleState(ParticleState) - Constructor for class pulse.search.direction.pso.ParticleState
 
ParticleSwarmOptimiser - Class in pulse.search.direction.pso
 
ParticleSwarmOptimiser() - Constructor for class pulse.search.direction.pso.ParticleSwarmOptimiser
 
PathOptimiser - Class in pulse.search.direction
An abstract class that defines the mathematical basis of solving the reverse heat conduction problem.
PathOptimiser() - Constructor for class pulse.search.direction.PathOptimiser
Abstract constructor that sets up the default ITERATION_LIMIT, ERROR_TOLERANCE and GRADIENT_RESOLUTION for this PathSolver.
PearsonCorrelation - Class in pulse.search.statistics
Wrapper CorrelationTest class for ApacheCommonsMath Pearson Correlation.
PearsonCorrelation() - Constructor for class pulse.search.statistics.PearsonCorrelation
 
penalisingTerm(int, int) - Method in class pulse.search.statistics.AICStatistic
 
penalisingTerm(int, int) - Method in class pulse.search.statistics.BICStatistic
 
penalisingTerm(int, int) - Method in class pulse.search.statistics.ModelSelectionCriterion
The penalising term, which is different depending on implementation.
PenetrationProblem - Class in pulse.problem.statements
 
PenetrationProblem() - Constructor for class pulse.problem.statements.PenetrationProblem
 
PenetrationProblem(PenetrationProblem) - Constructor for class pulse.problem.statements.PenetrationProblem
 
PeriodicTransform - Class in pulse.math.transforms
 
PeriodicTransform(Segment) - Constructor for class pulse.math.transforms.PeriodicTransform
Only the upper bound of the argument is used.
PhaseFunction - Class in pulse.problem.schemes.rte.dom
 
PhaseFunction(ThermoOpticalProperties, Discretisation) - Constructor for class pulse.problem.schemes.rte.dom.PhaseFunction
 
phi(int) - Method in class pulse.problem.schemes.ExplicitScheme
 
phi(int) - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
phi(int) - Method in class pulse.problem.schemes.solvers.ExplicitTranslucentSolver
 
phi(int) - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
PHI - Static variable in class pulse.search.linear.GoldenSectionOptimiser
The golden section φ, which is approximately equal to 0.618033989.
PLANCK_NUMBER - pulse.properties.NumericPropertyKeyword
The Planck number.
plot() - Method in class pulse.ui.frames.MainGraphFrame
 
plot(boolean) - Method in class pulse.ui.components.TaskPopupMenu
 
plot(ActionEvent) - Static method in class pulse.ui.components.panels.ProblemToolbar
 
plot(ResidualStatistic) - Method in class pulse.ui.components.ResidualsChart
 
plot(Calculation) - Method in class pulse.ui.components.PulseChart
 
plot(DataLogEntry, double) - Method in class pulse.ui.components.LogChart
 
plot(Log) - Method in class pulse.ui.components.LogChart
 
plot(SearchTask, boolean) - Method in class pulse.ui.components.Chart
 
plot(T) - Method in class pulse.ui.components.AuxPlotter
 
plot(T) - Method in class pulse.ui.frames.ExternalGraphFrame
 
plot(T) - Method in class pulse.ui.frames.InternalGraphFrame
 
PlotRequestListener - Interface in pulse.ui.components.listeners
 
plotSingle(HeatingCurve) - Method in class pulse.ui.components.Chart
 
points() - Method in class pulse.math.filters.OptimisablePolyline
 
poly(double) - Method in class pulse.math.LegendrePoly
Calculates the value of this Legendre polynomial at x
PolylineOptimiser - Class in pulse.math.filters
 
PolylineOptimiser(DiscreteInput, OptimisablePolyline) - Constructor for class pulse.math.filters.PolylineOptimiser
 
PolylineOptimiser.PolylineResponse - Class in pulse.math.filters
 
PolylineResponse(OptimiserStatistic) - Constructor for class pulse.math.filters.PolylineOptimiser.PolylineResponse
 
populate(File, Metadata) - Method in class pulse.io.readers.MetaFilePopulator
 
populate(File, T) - Method in interface pulse.io.readers.AbstractPopulator
Tries to populate t from data contained in f.
populate(AbstractData, BufferedReader) - Static method in class pulse.io.readers.NetzschCSVReader
 
populateWithAllProperties() - Method in class pulse.ui.components.models.ParameterTableModel
 
POSITIVE - Static variable in class pulse.input.Range
 
post(String) - Method in class pulse.tasks.logs.AbstractLogger
 
post(String) - Method in class pulse.ui.components.GraphicalLogPane
 
post(String) - Method in class pulse.ui.components.TextLogPane
 
post(LogEntry) - Method in class pulse.tasks.logs.AbstractLogger
 
post(LogEntry) - Method in class pulse.ui.components.GraphicalLogPane
 
post(LogEntry) - Method in class pulse.ui.components.TextLogPane
 
postAll() - Method in class pulse.tasks.logs.AbstractLogger
 
postAll() - Method in class pulse.ui.components.GraphicalLogPane
 
postProcessing() - Method in class pulse.search.GeneralTask
Override this to add post-processing checks e.g.
postProcessing() - Method in class pulse.tasks.SearchTask
 
powerAt(double) - Method in class pulse.problem.schemes.rte.BlackbodySpectrum
Calculates the emissive power at the given coordinate.
prepare(Problem) - Method in class pulse.problem.schemes.DifferenceScheme
Contains preparatory steps to ensure smooth running of the solver.This includes creating a DiscretePulseobject and adjusting the grid of this scheme to match the DiscretePulsecreated for this problem Finally, a heating curve is cleared from the previously calculated values.
prepare(Problem) - Method in class pulse.problem.schemes.ImplicitScheme
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.ADILinearisedSolver
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.ExplicitLinearisedSolver
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.ExplicitTranslucentSolver
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolver
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.ImplicitDiathermicSolver
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.ImplicitTranslucentSolver
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.MixedCoupledSolver
 
prepare(Problem) - Method in class pulse.problem.schemes.solvers.MixedLinearisedSolver
 
prepare(GeneralTask) - Method in class pulse.search.direction.BFGSOptimiser
Calculated the gradient at the end of this step.
prepare(GeneralTask) - Method in class pulse.search.direction.LMOptimiser
Calculates the Jacobian, if needed, evaluates the gradient and the Hessian matrix.
prepare(GeneralTask) - Method in class pulse.search.direction.PathOptimiser
Defines a set of procedures to be run at the end of the search iteration.
prepare(GeneralTask) - Method in class pulse.search.direction.pso.ParticleSwarmOptimiser
 
prepare(GeneralTask) - Method in class pulse.search.direction.pso.SwarmState
 
prepare(GeneralTask) - Method in class pulse.search.direction.SR1Optimiser
Calculated the gradient at the end of this step.
prepare(GeneralTask) - Method in class pulse.search.direction.SteepestDescentOptimiser
Calculates the gradient value at the end of each step.
prepareStep(int) - Method in class pulse.problem.schemes.ADIScheme
Contains only an empty statement, as the pulse needs to be calculated not only for the time step m but also accounting for the radial coordinate
prepareStep(int) - Method in class pulse.problem.schemes.DifferenceScheme
Do preparatory calculations that depend only on the time variable, e.g., calculate the pulse power.
preprocess() - Method in class pulse.input.ExperimentalData
 
PREVIEW - pulse.ui.frames.TaskControlFrame.Mode
 
PreviewFrame - Class in pulse.ui.frames
 
PreviewFrame() - Constructor for class pulse.ui.frames.PreviewFrame
 
PreviewFrameCreationListener - Interface in pulse.ui.components.listeners
 
printOrdinateSet() - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
printRangeAndNumber(NumericProperty, Number) - Static method in class pulse.properties.NumericProperties
 
printTableau() - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
printTimeTaken(Log) - Method in class pulse.tasks.logs.AbstractLogger
 
printTimeTaken(Log) - Method in class pulse.ui.components.GraphicalLogPane
 
printTimeTaken(Log) - Method in class pulse.ui.components.TextLogPane
 
printToStream(AbstractData, FileOutputStream, Extension) - Method in class pulse.io.export.CurveExporter
 
printToStream(ExperimentalData, FileOutputStream, Extension) - Method in class pulse.io.export.RawDataExporter
Invokes the printToStream(...) method of the HeatingCurveExporter instance.
printToStream(Metadata, FileOutputStream, Extension) - Method in class pulse.io.export.MetadataExporter
Prints the metadata content in html format in two columns, where the first column forms the description of the entry and the second column gives its value.
printToStream(ResidualStatistic, FileOutputStream, Extension) - Method in class pulse.io.export.ResidualStatisticExporter
Prints the residuals in a two-column format in a html or csv file (accepts both extensions).
printToStream(Log, FileOutputStream, Extension) - Method in class pulse.io.export.LogExporter
Prints all the data contained in this Log using fos.
printToStream(Result, FileOutputStream, Extension) - Method in class pulse.io.export.ResultExporter
Prints the data of this Result with fos either in a html or a csv file format.
printToStream(ResultTable, FileOutputStream, Extension) - Method in class pulse.io.export.ResultTableExporter
This will create a single file with the output.
printToStream(TextLogPane, FileOutputStream, Extension) - Method in class pulse.io.export.TextLogPaneExporter
This will write all contents of pane, which are accessed using an HTMLEditorKit directly to fos.
printToStream(T, FileOutputStream, Extension) - Method in interface pulse.io.export.Exporter
The interface method is implemented by the subclasses to define the exportable content in detail.
probability(List<ModelSelectionCriterion>) - Method in class pulse.search.statistics.ModelSelectionCriterion
Calculates the probability that this model is the best among all others.
Problem - Class in pulse.problem.statements
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 DifferenceSchemes.
Problem() - Constructor for class pulse.problem.statements.Problem
Creates a Problem with default parameters (as found in the .XML file).
Problem(Problem) - Constructor for class pulse.problem.statements.Problem
Copies all essential parameters from p, excluding the heating curve, which is created anew.
PROBLEM - pulse.ui.frames.TaskControlFrame.Mode
 
PROBLEM_COLUMN - Static variable in class pulse.ui.components.models.StoredCalculationTableModel
 
ProblemCellRenderer - Class in pulse.ui.components.controllers
 
ProblemCellRenderer() - Constructor for class pulse.ui.components.controllers.ProblemCellRenderer
 
ProblemComplexity - Enum in pulse.problem.statements
 
ProblemSelectionEvent - Class in pulse.ui.components.listeners
 
ProblemSelectionEvent(Problem, Object) - Constructor for class pulse.ui.components.listeners.ProblemSelectionEvent
 
ProblemSelectionListener - Interface in pulse.ui.components.listeners
 
ProblemStatementFrame - Class in pulse.ui.frames
 
ProblemStatementFrame() - Constructor for class pulse.ui.frames.ProblemStatementFrame
Create the frame.
ProblemToolbar - Class in pulse.ui.components.panels
 
ProblemToolbar() - Constructor for class pulse.ui.components.panels.ProblemToolbar
 
ProblemTree - Class in pulse.ui.components
 
ProblemTree(List<Problem>) - Constructor for class pulse.ui.components.ProblemTree
 
process() - Method in class pulse.tasks.Calculation
This will use the current DifferenceScheme to solve the Problem for this Calculation.
process(double[]) - Method in class pulse.math.ZScore
 
process(List<Point2D>) - Method in interface pulse.math.filters.Filter
 
process(List<Point2D>) - Method in class pulse.math.filters.Randomiser
 
process(List<Point2D>) - Method in class pulse.math.filters.RunningAverage
Constructs a deliberately crude representation of this heating curve by calculating a running average.
process(DiscreteInput) - Method in interface pulse.math.filters.Filter
 
process(DiscreteInput) - Method in class pulse.math.filters.OptimisedRunningAverage
 
ProgressDialog - Class in pulse.ui.frames.dialogs
 
ProgressDialog() - Constructor for class pulse.ui.frames.dialogs.ProgressDialog
 
ProgressDialog.ProgressWorker - Interface in pulse.ui.frames.dialogs
 
property(Property) - Method in class pulse.util.Accessible
Searches for a Property in this Accessible that looks similar to the argument.
Property - Interface in pulse.properties
The basic interface for properties.
propertyChange(PropertyChangeEvent) - Method in class pulse.ui.frames.dialogs.ProgressDialog
Invoked when task's progress property changes.
PropertyEvent - Class in pulse.util
An event which is created to signal about the changes with a PropertyHolder.
PropertyEvent(Object, PropertyHolder, Property) - Constructor for class pulse.util.PropertyEvent
Constructs an event that has happened because of source, resulting in an action taken on the property.
PropertyHolder - Class in pulse.util
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.
PropertyHolder() - Constructor for class pulse.util.PropertyHolder
 
PropertyHolderListener - Interface in pulse.util
A listener used by PropertyHolders to track changes with the associated Properties.
PropertyHolderTable - Class in pulse.ui.components
 
PropertyHolderTable(PropertyHolder) - Constructor for class pulse.ui.components.PropertyHolderTable
 
pulse - package pulse
Contains some of the most frequently used classes, which did not seem to fit in any other packages.
pulse(int) - Method in class pulse.problem.schemes.DifferenceScheme
 
pulse(int) - Method in class pulse.problem.schemes.solvers.MixedCoupledSolver
 
pulse(int) - Method in class pulse.problem.schemes.solvers.MixedLinearisedSolver
 
pulse(int, int) - Method in class pulse.problem.schemes.solvers.ADILinearisedSolver
 
Pulse - Class in pulse.problem.statements
A Pulse stores the parameters of the laser pulse, but does not provide the calculation facilities.
Pulse() - Constructor for class pulse.problem.statements.Pulse
Creates a Pulse with default values of pulse width and laser spot diameter (as per XML specification) and with a default pulse temporal shape (rectangular).
Pulse(Pulse) - Constructor for class pulse.problem.statements.Pulse
Copy constructor
PULSE_WIDTH - pulse.properties.NumericPropertyKeyword
Pulse width (time).
pulse.baseline - package pulse.baseline
Contains classes for describing and evaluating the baseline signal of a HeatingCurve or its subclasses.
pulse.input - package pulse.input
Introduces internal data structures that (a) are created as a result of parsing specific types of input files, such as: experimental heating curves, metadata, and property curves (e.g.
pulse.input.listeners - package pulse.input.listeners
Package contains listeners and event types which are used to track any runtime changes with the internal data structures defined in pulse and pulse.input.
pulse.io.export - package pulse.io.export
Package contains the PULsE export API, which currently consists of different exporter classes, an export manager, an XML converter and a MassExporter class.
pulse.io.readers - package pulse.io.readers
The main class of this package is ReaderManager.
pulse.math - package pulse.math
Provides general math functionality that is used when finding the direction (a Vector) of the minimum, including operations with vector and matrices.
pulse.math.filters - package pulse.math.filters
 
pulse.math.linear - package pulse.math.linear
A linear algebra package based mostly on the EJML library.
pulse.math.transforms - package pulse.math.transforms
 
pulse.problem.laser - package pulse.problem.laser
This package deals with discrete laser pulse representation and their various temporal shapes.
pulse.problem.schemes - package pulse.problem.schemes
This package deals with abstractions associated with finite differences in PULsE, including the definition of Grids, which determine the partitioning rules for space and time variables.
pulse.problem.schemes.rte - package pulse.problem.schemes.rte
Contains generic classes that act as a bridge between the specific implementation of radiative heat transfer and the heat problem solvers.
pulse.problem.schemes.rte.dom - package pulse.problem.schemes.rte.dom
Contains the implementation of the discrete ordinates method (DOM) for the solution of a anisotropic nonlinear radiative transfer equation.
pulse.problem.schemes.rte.exact - package pulse.problem.schemes.rte.exact
Contains classes for solving the radiative transfer equation in an absorbing-emitting medium (no scattering) using a semi-analytical approach.
pulse.problem.schemes.solvers - package pulse.problem.schemes.solvers
Contains various finite-difference solvers for the different problem statements available.
pulse.problem.statements - package pulse.problem.statements
Introduces various problem statements for the heat conduction problem in the laser flash experiment.
pulse.problem.statements.model - package pulse.problem.statements.model
 
pulse.properties - package pulse.properties
Properties is PULsE are low-level entities used by the different Accessibles or PropertyHolders, such as SearchTasks, Problems, etc.
pulse.search - package pulse.search
 
pulse.search.direction - package pulse.search.direction
Provides a list of PathSolvers and associated classes, which are used to determine the direction of the minimum of a specific SearchTask using an iterative approach.
pulse.search.direction.pso - package pulse.search.direction.pso
 
pulse.search.linear - package pulse.search.linear
Provides classes that are able to search for the minimum of a scalar function of a vector variable that is unimodal on a specific Segment.
pulse.search.statistics - package pulse.search.statistics
PULsE Statistical Kit.
pulse.tasks - package pulse.tasks
Introduces the SearchTask, which is the main actor in PULsE, and the TaskManager, a high-level class which among other functions manages loading and executing SearchTasks.
pulse.tasks.listeners - package pulse.tasks.listeners
Contains various listeners that deal with events associated with the individual SearchTasks, their statuses, logging and result generation, as well as with the task repository events generated by a TaskManager.
pulse.tasks.logs - package pulse.tasks.logs
Lists classes for logging, storing runtime information including statuses.
pulse.tasks.processing - package pulse.tasks.processing
Lists classes for storing runtime information, storing and ordering of final execution results, storing intermediate results of execution to check convergence.
pulse.ui - package pulse.ui
Includes the Launcher class, which is the entry-point to PULsE.
pulse.ui.components - package pulse.ui.components
This package contains all custom Swing-based components of the graphical user interface of PULsE that are used to interact with all other entities, such as PropertyHolders, etc.
pulse.ui.components.buttons - package pulse.ui.components.buttons
 
pulse.ui.components.controllers - package pulse.ui.components.controllers
 
pulse.ui.components.listeners - package pulse.ui.components.listeners
 
pulse.ui.components.models - package pulse.ui.components.models
 
pulse.ui.components.panels - package pulse.ui.components.panels
 
pulse.ui.frames - package pulse.ui.frames
Contains all JFrame classes that are used to create the graphical user interface of PULsE.
pulse.ui.frames.dialogs - package pulse.ui.frames.dialogs
 
pulse.util - package pulse.util
Contains abstract data and hierarchical structures that implement much of the Java Reflection API.
Pulse2D - Class in pulse.problem.statements
 
Pulse2D() - Constructor for class pulse.problem.statements.Pulse2D
Creates a Pulse with default values of pulse width and laser spot diameter (as per XML specification).
Pulse2D(Pulse) - Constructor for class pulse.problem.statements.Pulse2D
Copy constructor
PulseChart - Class in pulse.ui.components
 
PulseChart(String, String) - Constructor for class pulse.ui.components.PulseChart
 
PulseDataReader - Interface in pulse.io.readers
A reader for importing numeric pulse data -- if available.
PulseMainMenu - Class in pulse.ui.components
 
PulseMainMenu() - Constructor for class pulse.ui.components.PulseMainMenu
 
pulseReaders() - Static method in class pulse.io.readers.ReaderManager
 
PulseTemporalShape - Class in pulse.problem.laser
An abstract time-dependent pulse shape.
PulseTemporalShape() - Constructor for class pulse.problem.laser.PulseTemporalShape
 
PulseTemporalShape(PulseTemporalShape) - Constructor for class pulse.problem.laser.PulseTemporalShape
 
pulseWidth() - Method in class pulse.problem.laser.NumericPulseData
 
pulseWidthGrid() - Method in class pulse.problem.laser.DiscretePulse
Optimises the Grid parameters so that the timestep is sufficiently small to enable accurate pulse correction.

Q

QUADRATURE_POINTS - pulse.properties.NumericPropertyKeyword
Number of quadrature points (RTE).
QuadratureReader - Class in pulse.io.readers
A reader, which converts quad files into instances OrdinateSet.
QUEUED - pulse.tasks.logs.Status
Task has been queued and is waiting to be executed.

R

R - Static variable in class pulse.problem.statements.model.Gas
Universal gas constant.
RADIAL_COATING_THICKNESS - pulse.properties.NumericPropertyKeyword
Not implemented yet.
radiance(double) - Method in class pulse.problem.schemes.rte.BlackbodySpectrum
 
radianceAt(double) - Method in class pulse.problem.schemes.rte.BlackbodySpectrum
Calculates the spectral radiance, which is equal to the spectral power divided by π, at the given coordinate.
radiationBiot() - Method in class pulse.problem.statements.model.ThermalProperties
Calculates the radiative Biot number.
RadiativeTransferCoupling - Class in pulse.problem.schemes
 
RadiativeTransferCoupling() - Constructor for class pulse.problem.schemes.RadiativeTransferCoupling
 
RadiativeTransferSolver - Class in pulse.problem.schemes.rte
Manages processes to solve the radiative transfer equation and generate the input needed by the heat problem, i.e.
RadiativeTransferSolver() - Constructor for class pulse.problem.schemes.rte.RadiativeTransferSolver
Dummy constructor.
random(int) - Method in class pulse.ui.ColorGenerator
 
random(int, double, double) - Static method in class pulse.math.linear.Vector
Creates a vector with random coordinates confined within [min;max]
randomise(ParameterVector) - Method in class pulse.search.direction.pso.ParticleState
 
Randomiser - Class in pulse.math.filters
 
Randomiser(double) - Constructor for class pulse.math.filters.Randomiser
 
randomValue() - Method in class pulse.math.Segment
Calculates a random value confined in the interval between the two ends of this Segment.
Range - Class in pulse.input
The actual physical range defined as a Segment with minimum and maximum values.
Range(double, double) - Constructor for class pulse.input.Range
Constructs a new Range based on the segment specified by a and b
Range(List<Double>) - Constructor for class pulse.input.Range
Constructs a Range from the minimum and maximum values of data.
RANGE_CHANGED - pulse.input.listeners.DataEventType
The RANGE_CHANGED DataEventType indicates the range of the ExperimentalData has either been truncated or extended.
RangePenalisedLeastSquares - Class in pulse.search.statistics
This is an experimental feature.
RangePenalisedLeastSquares() - Constructor for class pulse.search.statistics.RangePenalisedLeastSquares
 
RangePenalisedLeastSquares(RangePenalisedLeastSquares) - Constructor for class pulse.search.statistics.RangePenalisedLeastSquares
 
RangeTextFields - Class in pulse.ui.components
Two JFormattedTextFields used to display the range of the currently selected task.
RangeTextFields() - Constructor for class pulse.ui.components.RangeTextFields
Creates textfield objects, which may be accessed with getters from this instance.
RawDataExporter - Class in pulse.io.export
A wrapper singleton class that is made specifically to handle export requests of ExperimentalData.
read(File) - Method in interface pulse.io.readers.AbstractReader
Reads f to translate its contents to one of the immutable structures of T.
read(File) - Method in class pulse.io.readers.ButcherTableauReader
Reads the Butcher tableau stored in file.
read(File) - Method in interface pulse.io.readers.CurveReader
Basic operation for reading the file and converting this to a List of ExperimentalData objects.
read(File) - Method in interface pulse.io.readers.DatasetReader
Creates an InterpolationDataset using the dataset stored in the file.
read(File) - Method in class pulse.io.readers.DATReader
This will return a single ExperimentalData, which stores all the information available in the file, wrapped in a List object with the size of unity.
read(File) - Method in class pulse.io.readers.LFRReader
Reads through the file, identifies the names of other files with individual heating curves, theirs external IDs and test temperatures (in degrees Celsius, later converted to Kelvin).
read(File) - Method in class pulse.io.readers.NetzschCSVReader
Reads file, assuming that it contains data generated by Proteus with the detector signal.
read(File) - Method in class pulse.io.readers.NetzschPulseCSVReader
This performs a basic check, finding the shot ID, which is then passed to a new NumericPulseData object.The latter is populated using the time-power sequence stored in this file.If the "Laser_pulse_data" keyword is not found, the method will display an error.
read(File) - Method in interface pulse.io.readers.PulseDataReader
Converts the ASCII file to a NumericPulseData object.
read(File) - Method in class pulse.io.readers.QuadratureReader
Reads an ordinate set.
read(File) - Method in class pulse.io.readers.TBLReader
Reads through a file with .tbl extension, converting each row into an ImmutableDataEntry<Double,Double>, which is then added to a newly created InterpolationDataset.
read(List<? extends AbstractReader<T>>, File) - Static method in class pulse.io.readers.ReaderManager
Attempts to find a DatasetReader for processing file.
readDefaultXML() - Static method in class pulse.io.export.XMLConverter
The default XML file is specific in the 'messages.properties' text file in the pulse.ui package
readDirectory(List<AbstractReader<T>>, File) - Static method in class pulse.io.readers.ReaderManager
Obtains a set of files in directory and attemps to convert each file to T using readers.
ReaderManager - Class in pulse.io.readers
A ReaderManager is a single class that manages most input operations.
readSingleCurve(File, Metadata) - Method in class pulse.io.readers.LFRReader
Creates a single ExperimentalData object with the time-temperature information retrieved from file and using the previously generated Metadata object, containing the external ID and the test temperature of this heating curve.
readSplineFunction(ObjectInputStream) - Static method in class pulse.util.FunctionSerializer
 
readVersion() - Static method in class pulse.io.readers.ReaderManager
 
readXML(InputStream) - Static method in class pulse.io.export.XMLConverter
Utility method used to read NumericProperty constants from xml files.
READY - pulse.tasks.logs.Status
Everything seems to be in order and the task can now be executed.
RectangularMatrix - Class in pulse.math.linear
 
RectangularMatrix(double[][]) - Constructor for class pulse.math.linear.RectangularMatrix
 
RectangularMatrix(double[], int) - Constructor for class pulse.math.linear.RectangularMatrix
 
RectangularPulse - Class in pulse.problem.laser
The simplest pulse shape defined as 0.5*(1 + sgn(tpulse - t)), where sgn(...) is the signum function, pulse is the pulse width.
RectangularPulse() - Constructor for class pulse.problem.laser.RectangularPulse
 
reduceStepSize() - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
REFLECTANCE - pulse.properties.NumericPropertyKeyword
Reflectance of the sample (0 < R ≤ 1).
Reflexive - Interface in pulse.util
An object is declared Reflexive if PULsE needs to know all its available subclasses.
ReflexiveFinder - Class in pulse.util
Provides utility methods for finding classes and instances of Reflexive in a PULsE package.
RegularisedLeastSquares - Class in pulse.search.statistics
This is an experimental feature.
RegularisedLeastSquares() - Constructor for class pulse.search.statistics.RegularisedLeastSquares
 
RegularisedLeastSquares(RegularisedLeastSquares) - Constructor for class pulse.search.statistics.RegularisedLeastSquares
 
RELATIVE_TIME_MARGIN - Static variable in class pulse.tasks.Calculation
 
RELAXATION_PARAMETER - pulse.properties.NumericPropertyKeyword
Relaxation parameter of iterative solver (RTE).
remove(int) - Method in class pulse.AbstractData
Removes a time-value pair that is present under the index i.
remove(int) - Method in class pulse.HeatingCurve
Removes an element with the index i from all three Lists (time, signal, and baseline-corrected signal).
remove(AbstractResult) - Method in class pulse.ui.components.models.ResultTableModel
 
removeAll(Identifier) - Method in class pulse.ui.components.models.ResultTableModel
 
removeAllListeners() - Method in class pulse.ui.components.PulseMainMenu
 
removeAllListeners() - Method in class pulse.ui.frames.ResultFrame
 
removeElement(NumericPropertyKeyword) - Method in class pulse.ui.components.models.SelectedKeysModel
 
removeHierarchyListener(HierarchyListener) - Method in class pulse.util.UpwardsNavigable
 
removeHierarchyListeners() - Method in class pulse.util.UpwardsNavigable
 
removeListeners() - Method in class pulse.HeatingCurve
 
removeListeners() - Static method in class pulse.tasks.processing.ResultFormat
 
removeListeners() - Method in class pulse.ui.components.models.ResultTableModel
 
removeListeners() - Method in class pulse.ui.components.panels.TaskToolbar
 
removeListeners() - Method in class pulse.util.PropertyHolder
 
removeSelectedRows() - Method in class pulse.ui.components.TaskTable
 
removeSelectionListeners() - Method in class pulse.tasks.TaskManager
 
removeSessionListeners() - Static method in class pulse.tasks.TaskManager
 
removeStatusChangeListeners() - Method in class pulse.tasks.SearchTask
 
removeTask(Identifier) - Method in class pulse.ui.components.models.TaskTableModel
 
removeTask(SearchTask) - Method in class pulse.tasks.TaskManager
If t is found in the local repository, removes it and triggers a TASK_REMOVED event.
removeTaskListeners() - Method in class pulse.tasks.SearchTask
 
removeTaskRepositoryListener(TaskRepositoryListener) - Method in class pulse.tasks.TaskManager
 
requireType(NumericProperty, NumericPropertyKeyword) - Static method in class pulse.properties.NumericProperty
 
RESCALED - pulse.input.listeners.CurveEventType
Indicates the curve signal values have been re-scaled.
reset() - Static method in class pulse.search.direction.ActiveFlags
 
reset() - Method in class pulse.search.direction.GradientBasedOptimiser
Resets the default ITERATION_LIMIT, ERROR_TOLERANCE and GRADIENT_RESOLUTION values for this PathSolver.
reset() - Method in class pulse.search.direction.IterativeState
 
reset() - Method in class pulse.search.direction.PathOptimiser
Resets the default ITERATION_LIMIT, ERROR_TOLERANCE and GRADIENT_RESOLUTION values for this PathSolver.
reset() - Method in class pulse.tasks.TaskManager
Clears any progress for all the tasks and resets everything.
reset() - Method in class pulse.ui.components.PulseMainMenu
 
reset(List<Double>) - Method in class pulse.input.IndexRange
Resets the index range by effectively treating the data list as bounded by its first and last elements, assuming that data is sorted in ascending order.
reset(IndexRange, List<Double>) - Method in class pulse.input.Range
Resets the minimum and maximum values of this range to those specified by the elements of data, the indices of which correspond to the lower and upper bound of the IndexRange.
resetFailedAttempts() - Method in class pulse.search.direction.IterativeState
 
resetRanges() - Method in class pulse.input.ExperimentalData
Calls reset for both the IndexRange and Range objects using the current time sequence.
resetSession() - Method in class pulse.ui.components.buttons.ExecutionButton
 
resetSession() - Method in class pulse.ui.components.models.ResultTableModel
 
resetSession() - Method in class pulse.ui.components.models.TaskTableModel
 
resetSession() - Method in class pulse.ui.components.panels.TaskToolbar
 
resetSession() - Method in class pulse.ui.components.ResultTable
 
resetSession() - Method in class pulse.ui.components.TaskTable
 
resetSession() - Method in class pulse.ui.frames.ModelSelectionFrame
 
resetSession() - Method in class pulse.ui.frames.ProblemStatementFrame
 
resetSession() - Method in class pulse.ui.frames.TaskControlFrame
 
resetSession() - Method in class pulse.ui.frames.TaskManagerFrame
 
residuals(Calculation) - Method in class pulse.ui.components.Chart
 
residualsArray() - Method in class pulse.search.statistics.ResidualStatistic
 
ResidualsChart - Class in pulse.ui.components
 
ResidualsChart(String, String) - Constructor for class pulse.ui.components.ResidualsChart
 
ResidualStatistic - Class in pulse.search.statistics
An abstract statistic (= a numeric value resulting from a statistical procedure) that operates with model residuals.
ResidualStatistic() - Constructor for class pulse.search.statistics.ResidualStatistic
 
ResidualStatistic(ResidualStatistic) - Constructor for class pulse.search.statistics.ResidualStatistic
 
ResidualStatisticExporter - Class in pulse.io.export
Exports the residuals, where each residual value refers to a specific point in time.
resolvedPulseWidthSeconds() - Method in class pulse.problem.laser.DiscretePulse
Gets the minimal resolved pulse width defined by the WIDTH_TOLERANCE_FACTOR and the characteristic time given by the getConversionFactor.
ResourceMonitor - Class in pulse.util
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 - Interface in pulse
 
Result - Class in pulse.tasks.processing
The individual Result that is associated with a SearchTask.
Result(Result) - Constructor for class pulse.tasks.processing.Result
 
Result(SearchTask, ResultFormat) - Constructor for class pulse.tasks.processing.Result
Creates an individual Result related to the current state of task using the specified format.
ResultChangeDialog - Class in pulse.ui.frames.dialogs
 
ResultChangeDialog() - Constructor for class pulse.ui.frames.dialogs.ResultChangeDialog
 
ResultExporter - Class in pulse.io.export
Provides export capabilities, for instances, of the Result class both in the csv and html formats.
ResultFormat - Class in pulse.tasks.processing
A singleton ResultFormat, which contains a list of NumericPropertyKeywords used for identification of NumericProperties.
resultFormatChanged(ResultFormatEvent) - Method in interface pulse.tasks.listeners.ResultFormatListener
 
ResultFormatEvent - Class in pulse.tasks.listeners
 
ResultFormatEvent(ResultFormat) - Constructor for class pulse.tasks.listeners.ResultFormatEvent
 
ResultFormatListener - Interface in pulse.tasks.listeners
 
ResultFrame - Class in pulse.ui.frames
 
ResultFrame() - Constructor for class pulse.ui.frames.ResultFrame
 
ResultListener - Interface in pulse.ui.components.listeners
 
ResultRequestListener - Interface in pulse.ui.components.listeners
 
ResultTable - Class in pulse.ui.components
 
ResultTable(ResultFormat) - Constructor for class pulse.ui.components.ResultTable
 
ResultTableExporter - Class in pulse.io.export
A singleton Exporter which can process the results table.
ResultTableModel - Class in pulse.ui.components.models
 
ResultTableModel(ResultFormat) - Constructor for class pulse.ui.components.models.ResultTableModel
 
ResultTableModel(ResultFormat, int) - Constructor for class pulse.ui.components.models.ResultTableModel
 
ResultToolbar - Class in pulse.ui.components.panels
 
ResultToolbar() - Constructor for class pulse.ui.components.panels.ResultToolbar
 
retrieveData(ExperimentalData) - Method in class pulse.problem.statements.NonlinearProblem
 
retrieveData(ExperimentalData) - Method in class pulse.problem.statements.Problem
This will use the data contained in c to estimate the detector signal span and the thermal diffusivity for this Problem.
RING - Static variable in class pulse.search.direction.pso.StaticTopologies
Ring topology (1D - lattice)
roots() - Method in class pulse.math.LegendrePoly
Uses a LaguerreSolver to calculate the roots of this polynomial.
RSquaredTest - Class in pulse.search.statistics
The coefficient of determination represents the goodness of fit that a HeatingCurve provides for the ExperimentalData
RSquaredTest() - Constructor for class pulse.search.statistics.RSquaredTest
 
RTE_INTEGRATION_TIMEOUT - pulse.properties.NumericPropertyKeyword
Maximum allowed time spent on integration (RTE).
RTE_MAX_ITERATIONS - pulse.properties.NumericPropertyKeyword
Iteration threshold for RTE calculations.
RTE_SOLVER_ERROR - pulse.problem.schemes.solvers.SolverException.SolverExceptionType
 
RTECalculationListener - Interface in pulse.problem.schemes.rte
Used to listed to status updates in RadiativeTransferSolver subclasses.
RTECalculationStatus - Enum in pulse.problem.schemes.rte
A measure of health for radiative transfer calculations.
RTOL - pulse.properties.NumericPropertyKeyword
Relative tolerance (atol) for RK calculations (RTE).
run() - Method in class pulse.search.GeneralTask
Runs this task if is either READY or QUEUED.
run() - Method in class pulse.search.SimpleOptimisationTask
 
run() - Method in class pulse.tasks.SearchTask
 
RunningAverage - Class in pulse.math.filters
 
RunningAverage() - Constructor for class pulse.math.filters.RunningAverage
 
RunningAverage(int) - Constructor for class pulse.math.filters.RunningAverage
 
runTimeSequence(Problem) - Method in class pulse.problem.schemes.DifferenceScheme
 
runTimeSequence(Problem, double, double) - Method in class pulse.problem.schemes.DifferenceScheme
 

S

sample(double) - Method in class pulse.ui.ColorGenerator
 
SampleName - Class in pulse.properties
 
SampleName(String) - Constructor for class pulse.properties.SampleName
 
sampling(double[]) - Method in class pulse.math.FFTTransformer
 
sanityCheck(RTECalculationStatus, int) - Method in class pulse.problem.schemes.rte.dom.IterativeSolver
 
scale(double) - Method in class pulse.HeatingCurve
Scales the temperature values by a factor of scale.
scaleSolution(Problem) - Method in class pulse.problem.schemes.DifferenceScheme
 
SCATTERING_ALBEDO - pulse.properties.NumericPropertyKeyword
Albedo of single scattering.
SCATTERING_ANISOTROPY - pulse.properties.NumericPropertyKeyword
Anisotropy coefficient for the phase function of scattering.
scheduleLogEvents() - Method in class pulse.ui.frames.LogFrame
 
SCHEME_WEIGHT - pulse.properties.NumericPropertyKeyword
Weight of the semi-implicit finite-difference scheme.
ScientificFormat - Class in pulse.properties
 
ScientificFormat(Number, Number) - Constructor for class pulse.properties.ScientificFormat
 
SEARCH - pulse.ui.frames.TaskControlFrame.Mode
 
SEARCH_STATISTIC_COLUMN - Static variable in class pulse.ui.components.models.TaskTableModel
 
SearchListRenderer - Class in pulse.ui.components.controllers
 
SearchListRenderer() - Constructor for class pulse.ui.components.controllers.SearchListRenderer
 
SearchOptionsFrame - Class in pulse.ui.frames
 
SearchOptionsFrame() - Constructor for class pulse.ui.frames.SearchOptionsFrame
Create the frame.
searchResolution - Static variable in class pulse.search.linear.LinearOptimiser
 
searchRow(Identifier) - Method in class pulse.ui.components.models.TaskTableModel
 
SearchTask - Class in pulse.tasks
A SearchTask is the most important class in PULsE.
SearchTask(ExperimentalData) - Constructor for class pulse.tasks.SearchTask
Creates a new SearchTask from curve.
searchVector() - Method in class pulse.math.filters.PolylineOptimiser
 
searchVector() - Method in class pulse.search.GeneralTask
Creates a search vector populated by parameters that are included in the optimisation routine.
searchVector() - Method in class pulse.search.SimpleOptimisationTask
Generates a search vector (= optimisation vector) using the search flags set by the PathSolver.
searchVector() - Method in class pulse.tasks.SearchTask
Generates a search vector (= optimisation vector) using the search flags set by the PathSolver.
Segment - Class in pulse.math
A Segment is simply a pair of values a and b such that a < b.
Segment(double, double) - Constructor for class pulse.math.Segment
Creates a Segment bounded by a and b.
Segment(Segment) - Constructor for class pulse.math.Segment
Copies segment
select(Result) - Method in class pulse.ui.components.ResultTable
 
select(SearchTask) - Method in class pulse.ui.components.ResultTable
 
selectActive(List<Flag>) - Static method in class pulse.properties.Flag
 
selectActiveAndListed(List<Flag>, PropertyHolder) - Static method in class pulse.search.direction.ActiveFlags
 
selectActiveTypes(List<Flag>) - Static method in class pulse.search.direction.ActiveFlags
 
SELECTED - pulse.ui.components.MovableValueMarker.State
 
SELECTED_STROKE - Static variable in class pulse.ui.components.MovableValueMarker
 
SelectedKeysModel - Class in pulse.ui.components.models
 
SelectedKeysModel(List<NumericPropertyKeyword>, NumericPropertyKeyword[]) - Constructor for class pulse.ui.components.models.SelectedKeysModel
 
selectedTask - Variable in class pulse.ui.components.models.TaskBoxModel
 
selectFirstTask() - Method in class pulse.tasks.TaskManager
 
selectTask(Identifier, Object) - Method in class pulse.tasks.TaskManager
Selects a SearchTask within this repository with the specified id (if present).
serialize() - Static method in class pulse.util.Serializer
 
serialize(File) - Static method in class pulse.util.Serializer
 
Serializer - Class in pulse.util
 
series(HeatingCurve, String, boolean) - Method in class pulse.ui.components.Chart
 
series(ExperimentalData, String, boolean) - Method in class pulse.ui.components.Chart
 
SessionListener - Interface in pulse.tasks.listeners
 
set(int, double) - Method in class pulse.math.linear.Vector
Sets the component of this Vector specified by index to value.
set(List<Double>, Range) - Method in class pulse.input.IndexRange
Sets the bounds of this index range using the minimum and maximum values of the segment specified in the range object.
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.AbstractData
Provides general setter accessibility for the number of points of this AbstractData.
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.baseline.AdjustableBaseline
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.baseline.LinearBaseline
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.baseline.SinusoidalBaseline
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.HeatingCurve
Calls super.set and provides write access to the TIME_SHIFT property.
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.input.Metadata
If type is listed by this Metadata, will attempt to either set a value to the property belonging to this Metadata and identified by type or add property to the internal repository of this Metadata.
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.input.Range
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.math.filters.OptimisablePolyline
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.math.FixedIntervalIntegrator
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.math.Harmonic
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.laser.ExponentiallyModifiedGaussian
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.laser.NumericPulse
Does not define any property.
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.laser.RectangularPulse
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.laser.TrapezoidalPulse
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.DifferenceScheme
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.Grid
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.RadiativeTransferCoupling
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.rte.dom.Discretisation
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.rte.dom.IterativeSolver
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.rte.dom.SuccessiveOverrelaxation
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.rte.exact.ChandrasekharsQuadrature
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.rte.exact.NewtonCotesQuadrature
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolverNL
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolverNL
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.solvers.MixedCoupledSolver
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.schemes.solvers.MixedCoupledSolverNL
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.statements.ClassicalProblem
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.statements.model.AbsorptionModel
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.statements.model.DiathermicProperties
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.statements.model.Insulator
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.statements.model.ThermalProperties
Used to change the parameter values of this Problem.
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.statements.model.TwoTemperatureProperties
Used to change the parameter values of this Problem.
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.statements.Problem
Used to change the parameter values of this Problem.
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.statements.Pulse
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.problem.statements.Pulse2D
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.search.direction.GradientBasedOptimiser
The accepted types are: GRADIENT_RESOLUTION, ERROR_TOLERANCE, ITERATION_LIMIT.
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.search.direction.LMOptimiser
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.search.direction.PathOptimiser
The accepted types are: ERROR_TOLERANCE, ITERATION_LIMIT.
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.search.linear.LinearOptimiser
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.search.SimpleOptimisationTask
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.search.statistics.CorrelationTest
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.search.statistics.ModelSelectionCriterion
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.search.statistics.NormalityTest
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.search.statistics.ResidualStatistic
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.tasks.Calculation
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.tasks.processing.Buffer
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.tasks.SearchTask
 
set(NumericPropertyKeyword, NumericProperty) - Method in class pulse.util.Accessible
An abstract method, which must be overriden to gain access over setting the values of all relevant (selected by the programmer) NumericProperties in subclasses of Accessible.
setAbbreviation(String) - Method in class pulse.properties.Flag
 
setAbbreviation(String) - Method in class pulse.properties.NumericProperty
 
setAbsoluteTolerance(NumericProperty) - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
setAbsorptionModel(AbsorptionModel) - Method in class pulse.problem.statements.PenetrationProblem
 
setAbsorptivity(SpectralRange, NumericProperty) - Method in class pulse.problem.statements.model.AbsorptionModel
 
setAlpha(int, double) - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
setAmplitude(NumericProperty) - Method in class pulse.math.Harmonic
 
setAutoUpdateFluxes(boolean) - Method in class pulse.problem.schemes.CoupledImplicitScheme
 
setAutoUpdateFluxes(boolean) - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
setAxisFontColor(Axis, Color) - Static method in class pulse.ui.components.Chart
 
setBaseline(Baseline) - Method in class pulse.problem.statements.Problem
Sets a new baseline.
setBestSoFar(ParticleState) - Method in class pulse.search.direction.pso.SwarmState
 
setBestSoFarIndex(int) - Method in class pulse.search.direction.pso.SwarmState
 
setBeta(int, double) - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
setBinCount(int) - Method in class pulse.ui.components.ResidualsChart
 
setBounds(Segment) - Method in class pulse.math.AbstractIntegrator
Simply sets the integration bounds to bounds
setBounds(Segment) - Method in class pulse.math.FixedIntervalIntegrator
Sets the bounds to the argument and re-evaluates the integration step size.
setBounds(Segment) - Method in class pulse.math.Parameter
 
setBounds(Segment) - Method in class pulse.math.transforms.BoundedParameterTransform
 
setButcherTableau(ButcherTableau) - Method in class pulse.problem.schemes.rte.dom.ExplicitRungeKutta
 
setC(Vector) - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
setCalculationStatus(RTECalculationStatus) - Method in class pulse.problem.schemes.CoupledImplicitScheme
 
setCalculationStatus(RTECalculationStatus) - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
setChart(JFreeChart) - Method in class pulse.ui.components.AuxPlotter
 
setClearEnabled(boolean) - Method in class pulse.ui.components.panels.TaskToolbar
 
setCoefA(double) - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
setCoefB(double) - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
setCoefC(double) - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
setCoefficients(double, double) - Method in class pulse.problem.schemes.rte.exact.CompositionProduct
 
setCombinedAbsorptivity(NumericProperty) - Method in class pulse.problem.statements.model.AbsorptionModel
 
setCombinedLosses(NumericProperty) - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
setComplexity(ProblemComplexity) - Method in class pulse.problem.statements.Problem
 
setConfirmAction(ConfirmAction) - Method in class pulse.ui.frames.dialogs.FormattedInputDialog
 
setConvectiveLosses(NumericProperty) - Method in class pulse.problem.statements.model.DiathermicProperties
 
setConvectiveLosses(NumericProperty) - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
setCost(double) - Method in class pulse.search.direction.IterativeState
 
setCoupling(RadiativeTransferCoupling) - Method in class pulse.problem.schemes.CoupledImplicitScheme
 
setCoupling(RadiativeTransferCoupling) - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
setCutoff(NumericProperty) - Method in class pulse.problem.schemes.rte.exact.NewtonCotesQuadrature
 
setDampingRatio(NumericProperty) - Method in class pulse.search.direction.LMOptimiser
 
setData(NumericPulseData) - Method in class pulse.problem.laser.NumericPulse
 
setDefaultLocale() - Method in class pulse.io.readers.NetzschCSVReader
 
setDefaultOptimiser() - Method in class pulse.math.filters.PolylineOptimiser
 
setDefaultOptimiser() - Method in class pulse.search.GeneralTask
 
setDefaultOptimiser() - Method in class pulse.search.SimpleOptimisationTask
 
setDefaultSearchVariable(boolean) - Method in class pulse.properties.NumericProperty
 
setDefaultSelection(String) - Method in class pulse.util.DiscreteSelector
 
setDeleteEnabled(boolean) - Method in class pulse.ui.components.panels.ResultToolbar
 
setDensity(NumericProperty) - Method in class pulse.problem.schemes.rte.Fluxes
 
setDensity(NumericProperty) - Method in class pulse.problem.statements.model.ThermalProperties
 
setDensityDataset(InterpolationDataset) - Method in class pulse.tasks.TaskManager
 
setDerivative(int, int, double) - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
setDescriptor(String) - Method in class pulse.properties.NumericProperty
 
setDetailedMessage(String) - Method in enum pulse.tasks.logs.Status
 
setDetails(Details) - Method in enum pulse.tasks.logs.Status
 
setDetailsHidden(boolean) - Static method in class pulse.problem.schemes.DifferenceScheme
Changes the policy of displaying a detailed information about this scheme.
setDetailsHidden(boolean) - Static method in class pulse.problem.statements.Problem
Allows to either hide or display all 'advanced' settings for this Problem.
setDiathermicCoefficient(NumericProperty) - Method in class pulse.problem.statements.model.DiathermicProperties
 
setDiffusivity(NumericProperty) - Method in class pulse.problem.statements.model.ThermalProperties
 
setDimensionFactor(Number) - Method in class pulse.properties.NumericProperty
 
setDirection(Vector) - Method in class pulse.search.direction.GradientGuidedPath
 
setDiscrete(boolean) - Method in class pulse.properties.NumericProperty
 
setDiscretisation(Discretisation) - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
setDomain(Number, Number) - Method in class pulse.properties.NumericProperty
Sets the definition domain for this NumericProperty.
setDrawSmooth(boolean) - Method in class pulse.ui.frames.PreviewFrame
 
setEmissionFunction(BlackbodySpectrum) - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
setEmissionFunction(BlackbodySpectrum) - Method in class pulse.problem.schemes.rte.exact.CompositionProduct
 
setEmissionFunction(BlackbodySpectrum) - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
 
setEmissivity(double) - Method in class pulse.problem.schemes.rte.dom.Discretisation
 
setEmissivity(NumericProperty) - Method in class pulse.problem.statements.model.ThermalProperties
 
setError(Number) - Method in class pulse.properties.NumericProperty
 
setErrorTolerance(NumericProperty) - Method in class pulse.search.direction.PathOptimiser
 
setEstimator(Vector) - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
setExcludeKeywords(NumericPropertyKeyword[]) - Method in class pulse.properties.NumericProperty
 
setExecEnabled(boolean) - Method in class pulse.ui.components.panels.TaskToolbar
 
setExecutionState(ExecutionButton.ExecutionState) - Method in class pulse.ui.components.buttons.ExecutionButton
 
setExperimentalCurve(ExperimentalData) - Method in class pulse.tasks.SearchTask
Adopts the curve by this SearchTask.
setExportEnabled(boolean) - Method in class pulse.ui.components.panels.ResultToolbar
 
setFirstRun(boolean) - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
setFitness(double) - Method in class pulse.search.direction.pso.ParticleState
 
setFlux(int, double) - Method in class pulse.problem.schemes.rte.Fluxes
Sets the flux at the i grid point
setFluxDerivative(int, double) - Method in class pulse.problem.schemes.rte.FluxesAndExplicitDerivatives
 
setFluxes(Fluxes) - Method in class pulse.problem.schemes.rte.RadiativeTransferSolver
 
setFonts() - Method in class pulse.ui.components.AuxPlotter
 
setFormat(ResultFormat) - Method in class pulse.tasks.processing.AbstractResult
 
setFOVInner(NumericProperty) - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
setFOVOuter(NumericProperty) - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
setFrequency(NumericProperty) - Method in class pulse.math.Harmonic
 
setGamma(int, double) - Method in class pulse.problem.schemes.BlockMatrixAlgorithm
 
setGas(Gas) - Method in class pulse.problem.statements.TwoTemperatureModel
 
setGasExchangeCoefficient(NumericProperty) - Method in class pulse.problem.statements.model.TwoTemperatureProperties
 
setGasHeatLoss(NumericProperty) - Method in class pulse.problem.statements.model.TwoTemperatureProperties
 
setGeometricFactor(NumericProperty) - Method in class pulse.problem.statements.ClassicalProblem
 
setGradient(Vector) - Method in class pulse.search.direction.GradientGuidedPath
 
setGradientResolution(NumericProperty) - Method in class pulse.search.direction.GradientBasedOptimiser
 
setGraphEnabled(boolean) - Method in class pulse.ui.components.panels.TaskToolbar
 
setGraphicalLog(boolean) - Static method in class pulse.tasks.logs.Log
Sets the verbose flag to verbose
setGrid(Grid) - Method in class pulse.problem.schemes.DifferenceScheme
Sets the grid and adopts it as its child.
setGrid(StretchedGrid) - Method in class pulse.problem.schemes.rte.dom.Discretisation
 
setGridDensity(NumericProperty) - Method in class pulse.problem.schemes.Grid
Sets the value of the gridDensity.
setGridDensity(NumericProperty) - Method in class pulse.problem.schemes.Grid2D
Sets the value of the gridDensity.
setGridDensityValue(int) - Method in class pulse.problem.schemes.Grid
 
setGridDensityValue(int) - Method in class pulse.problem.schemes.Grid2D
 
setGridScalingFactor(NumericProperty) - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
setHeatingCurve(HeatingCurve) - Method in class pulse.problem.statements.Problem
 
setHeatLoss(NumericProperty) - Method in class pulse.problem.statements.model.ThermalProperties
 
setHessian(SquareMatrix) - Method in class pulse.search.direction.ComplexPath
 
setHiFreqMax(NumericProperty) - Method in class pulse.baseline.SinusoidalBaseline
 
setInstance(PathOptimiser) - Static method in class pulse.search.direction.PathOptimiser
 
setIntegrationSegments(NumericProperty) - Method in class pulse.math.FixedIntervalIntegrator
Sets the number of integration segments and re-evaluates the integration step size.
setIntegrator(AdaptiveIntegrator) - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
setIntensity(int, int, double) - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
setIntercept(NumericProperty) - Method in class pulse.baseline.AdjustableBaseline
Checks whether intercept is a baseline intercept property and updates the respective value of this baseline.
setInterpolation(UnivariateFunction) - Method in class pulse.problem.schemes.rte.BlackbodySpectrum
Sets a new function for the spatial temperature profile.
setInterpolator(Vector) - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
setInverseHessian(SquareMatrix) - Method in class pulse.search.direction.ComplexPath
 
setIterationErrorTolerance(NumericProperty) - Method in class pulse.problem.schemes.rte.dom.IterativeSolver
 
setIterativeSolver(IterativeSolver) - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
setIterativeState(IterativeState) - Method in class pulse.search.GeneralTask
 
setLambda(double) - Method in class pulse.search.statistics.RangePenalisedLeastSquares
 
setLambda(double) - Method in class pulse.search.statistics.RegularisedLeastSquares
 
setLambda(NumericProperty) - Method in class pulse.problem.laser.ExponentiallyModifiedGaussian
Sets the SKEW_LAMBDA parameter
setLaserAbsorptivity(NumericProperty) - Method in class pulse.problem.statements.model.AbsorptionModel
 
setLaserEnergy(NumericProperty) - Method in class pulse.problem.statements.Pulse
 
setLinearResolution(NumericProperty) - Static method in class pulse.search.linear.LinearOptimiser
 
setLinearSolver(LinearOptimiser) - Method in class pulse.search.direction.CompositePathOptimiser
Assigns a LinearSolver to this PathSolver and sets this object as its parent.
setLinearStep(double) - Method in class pulse.search.direction.GradientGuidedPath
 
setLowerBound(List<Double>, double) - Method in class pulse.input.IndexRange
Sets the start index by conducting a primitive binary search using closest(...) to find an element in data either matching or being as close as possible to a (if a is non-negative) or zero.
setLowerBound(NumericProperty) - Method in class pulse.input.Range
Sets the lower bound and triggers firePropertyChanged.
setLowFreqMax(NumericProperty) - Method in class pulse.baseline.SinusoidalBaseline
 
setMatrix(SquareMatrix) - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
setMaximum(double) - Method in class pulse.math.Segment
Sets the maximum value to b.
setMaximumTemperature(NumericProperty) - Method in class pulse.problem.statements.model.ThermalProperties
 
setMaxIterations(NumericProperty) - Method in class pulse.problem.schemes.rte.dom.IterativeSolver
 
setMaxIterations(NumericProperty) - Method in class pulse.search.direction.PathOptimiser
 
setMergeEnabled(boolean) - Method in class pulse.ui.components.panels.ResultToolbar
 
setMetadata(Metadata) - Method in class pulse.input.ExperimentalData
Sets a new Metadata object for this ExperimentalData.
setMinimum(double) - Method in class pulse.math.Segment
Sets the minimum value to a.
setModelSelectionCriterion(ModelSelectionCriterion) - Method in class pulse.tasks.Calculation
 
setMu(NumericProperty) - Method in class pulse.problem.laser.ExponentiallyModifiedGaussian
Sets the SKEW_MU parameter
setName(String) - Method in class pulse.AbstractData
 
setName(String) - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
setNeighborhoodTopology(NeighbourhoodTopology) - Method in class pulse.search.direction.pso.SwarmState
 
setNonlinearPrecision(NumericProperty) - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolverNL
 
setNonlinearPrecision(NumericProperty) - Method in class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
setNonlinearPrecision(NumericProperty) - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolverNL
 
setNonlinearPrecision(NumericProperty) - Method in class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
setNonlinearPrecision(NumericProperty) - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
setNonlinearPrecision(NumericProperty) - Method in class pulse.problem.schemes.solvers.MixedCoupledSolverNL
 
setNumberOfBins(int) - Method in class pulse.math.filters.RunningAverage
 
setNumPoints(NumericProperty) - Method in class pulse.AbstractData
Sets the number of points for this baseline.
setOpacity(float) - Method in class pulse.ui.components.Chart
 
setOpticalThickness(NumericProperty) - Method in class pulse.problem.schemes.rte.Fluxes
 
setOpticalThickness(NumericProperty) - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
setOptimisable(boolean) - Method in class pulse.properties.NumericProperty
 
setOptimiser(PathOptimiser) - Method in class pulse.search.GeneralTask
 
setOptimiserStatistic(OptimiserStatistic) - Method in class pulse.search.SimpleResponse
 
setOptimiserStatistic(OptimiserStatistic) - Method in class pulse.search.statistics.ModelSelectionCriterion
 
setOptimiserStatistic(OptimiserStatistic) - Method in class pulse.tasks.Calculation
 
setOrder(int) - Method in class pulse.problem.schemes.rte.exact.CompositionProduct
Sets the integration order n.
setOrdinateSet(OrdinateSet) - Method in class pulse.problem.schemes.rte.dom.Discretisation
 
setParameterBounds(Segment) - Method in class pulse.math.FunctionWithInterpolation
Sets the parameter bounds to parameterBounds.
setParameters(ParameterVector) - Method in class pulse.search.direction.IterativeState
 
setParent(UpwardsNavigable) - Method in class pulse.util.UpwardsNavigable
Explicitly sets the parent of this UpwardsNavigable.
setParticles(Particle[]) - Method in class pulse.search.direction.pso.SwarmState
 
setPhaseFunction(PhaseFunction) - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
setPhaseShift(NumericProperty) - Method in class pulse.math.Harmonic
 
setPlanckNumber(NumericProperty) - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
setPlot(XYPlot) - Method in class pulse.ui.components.AuxPlotter
 
setPrefix(String) - Method in class pulse.util.PropertyHolder
 
setPreviewEnabled(boolean) - Method in class pulse.ui.components.panels.ResultToolbar
 
setProblem(Problem) - Method in class pulse.ui.components.listeners.ProblemSelectionEvent
 
setProblem(Problem, ExperimentalData) - Method in class pulse.tasks.Calculation
After setting and adopting the problem by this SearchTask, this will attempt to change the parameters of that problem in accordance with the loaded ExperimentalData for this SearchTask (if not null).Later, if any changes to the properties of that Problem occur and if the source of that event is either the Metadata or the PropertyHolderTable, they will be accounted for by altering the parameters of the problem accordingly -- immediately after the former take place.
setProperties(ThermalProperties) - Method in class pulse.problem.statements.Problem
 
setPropertyHolder(PropertyHolder) - Method in class pulse.ui.components.PropertyHolderTable
 
setPulse(Pulse) - Method in class pulse.problem.statements.Problem
Sets the pulse of this Problem and assigns this Problem as its parent.
setPulseData(NumericPulseData) - Method in class pulse.input.Metadata
 
setPulseDescriptor(InstanceDescriptor<? extends PulseTemporalShape>) - Method in class pulse.problem.statements.Pulse
 
setPulseShape(PulseTemporalShape) - Method in class pulse.problem.statements.Pulse
 
setPulseWidth(double) - Method in class pulse.problem.laser.PulseTemporalShape
 
setPulseWidth(NumericProperty) - Method in class pulse.problem.statements.Pulse
 
setQLast(int, double) - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
setQuadrature(CompositionProduct) - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
Sets the quadrature and updates its spectral function to that specified by this object.
setQuadraturePoints(NumericProperty) - Method in class pulse.problem.schemes.rte.exact.ChandrasekharsQuadrature
 
setRadiativeTransferEquation(RadiativeTransferSolver) - Method in class pulse.problem.schemes.RadiativeTransferCoupling
 
setRange(Range) - Method in class pulse.input.ExperimentalData
Sets the range, assigning this to its parent, and forcing changes to the indexRange.
setRank(int) - Method in class pulse.math.Harmonic
 
setReflectance(NumericProperty) - Method in class pulse.problem.statements.model.Insulator
 
setRelativeTolerance(NumericProperty) - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
setRelaxationParameter(NumericProperty) - Method in class pulse.problem.schemes.rte.dom.SuccessiveOverrelaxation
 
setRemoveEnabled(boolean) - Method in class pulse.ui.components.panels.TaskToolbar
 
setResetEnabled(boolean) - Method in class pulse.ui.components.panels.TaskToolbar
 
setResidualsShown(boolean) - Method in class pulse.ui.components.Chart
 
setResult(Result) - Method in class pulse.tasks.Calculation
 
setSampleDiameter(NumericProperty) - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
setSampleName(SampleName) - Method in class pulse.input.Metadata
Sets the sample name property.
setSampleThickness(NumericProperty) - Method in class pulse.problem.statements.model.ThermalProperties
 
setScatteringAlbedo(NumericProperty) - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
setScatteringAnisotropy(NumericProperty) - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
setScheme(DifferenceScheme, ExperimentalData) - Method in class pulse.tasks.Calculation
Adopts the scheme by this SearchTask and updates the time limit of scheme to match ExperimentalData.
setSelected(boolean) - Method in class pulse.ui.components.buttons.IconCheckBox
 
setSelectedDescriptor(String) - Method in class pulse.util.InstanceDescriptor
 
setSelectedItem(Object) - Method in class pulse.ui.components.models.TaskBoxModel
 
setSelectedOptimiserDescriptor(String) - Static method in class pulse.search.statistics.OptimiserStatistic
 
setSelectedProblem(Problem) - Method in class pulse.ui.components.ProblemTree
 
setSelectedTestDescriptor(String) - Static method in class pulse.search.statistics.NormalityTest
 
setSideLosses(NumericProperty) - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
setSigma(NumericProperty) - Method in class pulse.problem.laser.ExponentiallyModifiedGaussian
Sets the SKEW_SIGMA parameter
setSignalAt(int, double) - Method in class pulse.AbstractData
Sets the signal t at the position index of the signal List.
setSingleStatement(boolean) - Method in class pulse.tasks.TaskManager
Sets the flag to isolate or inter-connects changes in all instances of PropertyHolder
setSize(NumericProperty) - Static method in class pulse.tasks.processing.Buffer
Sets a new size for this Buffer.
setSlope(NumericProperty) - Method in class pulse.baseline.AdjustableBaseline
Checks whether slope is a baseline slope property and updates the respective value of this baseline.
setSolidExchangeCoefficient(NumericProperty) - Method in class pulse.problem.statements.model.TwoTemperatureProperties
 
setSolutionAt(int, double) - Method in class pulse.problem.schemes.OneDimensionalScheme
 
setSolver(DirectionSolver) - Method in class pulse.search.direction.PathOptimiser
 
setSource(Object) - Method in class pulse.tasks.listeners.TaskSelectionEvent
 
setSource(Object) - Method in class pulse.ui.components.listeners.ProblemSelectionEvent
 
setSpecificHeat(NumericProperty) - Method in class pulse.problem.statements.model.ThermalProperties
 
setSpecificHeatDataset(InterpolationDataset) - Method in class pulse.tasks.TaskManager
 
setSpotDiameter(NumericProperty) - Method in class pulse.problem.statements.Pulse2D
 
setState(MovableValueMarker.State) - Method in class pulse.ui.components.MovableValueMarker
 
setStatistic(NumericProperty) - Method in class pulse.search.statistics.ModelSelectionCriterion
 
setStatistic(NumericProperty) - Method in class pulse.search.statistics.NormalityTest
 
setStatistic(NumericProperty) - Method in class pulse.search.statistics.ResidualStatistic
 
setStatisticalSignificance(NumericProperty) - Static method in class pulse.search.statistics.NormalityTest
 
setStatus(Status) - Method in class pulse.tasks.Calculation
Attempts to set the status of this calculation to status.
setStatus(Status) - Method in class pulse.tasks.logs.StateEntry
 
setStatus(Status) - Method in class pulse.tasks.SearchTask
Will return true if status could be updated.
setStoredDerivative(int, int, double) - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
setStretchingFactor(NumericProperty) - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
setSumOfSquares(SumOfSquares) - Method in class pulse.search.statistics.RSquaredTest
 
setTestTemperature(NumericProperty) - Method in class pulse.problem.statements.model.ThermalProperties
 
setThermalAbsorptivity(NumericProperty) - Method in class pulse.problem.statements.model.AbsorptionModel
 
setThreshold(NumericProperty) - Static method in class pulse.search.statistics.CorrelationTest
 
setTimeAt(int, double) - Method in class pulse.AbstractData
Sets the time t at the position index of the time List.
setTimeFactor(NumericProperty) - Method in class pulse.problem.schemes.Grid
Sets the value of the tauFactor.
setTimeFactor(NumericProperty) - Method in class pulse.problem.schemes.Grid2D
 
setTimeInterval(int) - Method in class pulse.problem.schemes.DifferenceScheme
Sets the time interval to the argument of this method.
setTimeLimit(NumericProperty) - Method in class pulse.problem.schemes.DifferenceScheme
Sets the time limit (in units defined by the corresponding NumericProperty), which serves as the breakpoint for the calculations.
setTimeShift(NumericProperty) - Method in class pulse.HeatingCurve
Sets the time shift and triggers TIME_ORIGIN_CHANGED in CurveEvent.
setTimeStep(double) - Method in class pulse.problem.schemes.Grid
 
setTimeThreshold(NumericProperty) - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
SettingsToolBar - Class in pulse.ui.components.panels
 
SettingsToolBar(PropertyHolderTable...) - Constructor for class pulse.ui.components.panels.SettingsToolBar
 
setTransform(Transformable) - Method in class pulse.math.Parameter
 
setTrapezoidalFall(NumericProperty) - Method in class pulse.problem.laser.TrapezoidalPulse
 
setTrapezoidalRise(NumericProperty) - Method in class pulse.problem.laser.TrapezoidalPulse
 
setTridiagonalMatrixAlgorithm(TridiagonalMatrixAlgorithm) - Method in class pulse.problem.schemes.ImplicitScheme
 
setUndoEnabled(boolean) - Method in class pulse.ui.components.panels.ResultToolbar
 
setUpperBound(List<Double>, double) - Method in class pulse.input.IndexRange
Sets the end index by conducting a primitive binary search using closest(...) to find an element in data either matching or being as close as possible to b.
setUpperBound(NumericProperty) - Method in class pulse.input.Range
Sets the upper bound and triggers firePropertyChanged.
setValue(boolean) - Method in class pulse.properties.Flag
 
setValue(double) - Method in class pulse.math.Parameter
 
setValue(double, boolean) - Method in class pulse.math.Parameter
 
setValue(Number) - Method in class pulse.properties.NumericProperty
Sets the value of this NumericProperty -- if and only if the new value is confined within the definition domain for this NumericProperty.
setValues(Vector) - Method in class pulse.math.ParameterVector
 
setVisible(boolean) - Method in class pulse.ui.frames.dialogs.ResultChangeDialog
 
setVisibleByDefault(boolean) - Method in class pulse.properties.NumericProperty
 
setWeight(NumericProperty) - Method in class pulse.problem.schemes.solvers.MixedCoupledSolver
 
setXStep(double) - Method in class pulse.problem.schemes.Grid
Sets the value of the hx coordinate step.
setZeroApproximationShown(boolean) - Method in class pulse.ui.components.Chart
 
SHELL_GRID_DENSITY - pulse.properties.NumericPropertyKeyword
Not implemented yet.
SHUTDOWN - pulse.tasks.listeners.TaskRepositoryEvent.State
The repository has been shut down/
signal - Variable in class pulse.AbstractData
 
signal() - Method in class pulse.problem.schemes.DifferenceScheme
 
signal() - Method in class pulse.problem.schemes.OneDimensionalScheme
 
signal() - Method in class pulse.problem.schemes.solvers.ADILinearisedSolver
 
signal() - Method in class pulse.problem.schemes.solvers.ExplicitTranslucentSolver
 
signal() - Method in class pulse.problem.schemes.solvers.ImplicitTranslucentSolver
 
signal() - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
signalAt(int) - Method in class pulse.AbstractData
Retrieves the signal value corresponding to the index index.
signalAt(int) - Method in class pulse.HeatingCurve
Retrieves the baseline-corrected temperature corresponding to index in the respective List.
significance - Static variable in class pulse.search.statistics.NormalityTest
 
SIGNIFICANCE - pulse.properties.NumericPropertyKeyword
Statistical significance for calculating the critical value.
SIGNIFICANT_CORRELATION_BETWEEN_PARAMETERS - pulse.tasks.logs.Details
 
SIGNIFICANT_FIGURES - Static variable in class pulse.tasks.processing.AverageResult
 
simpleInstances(String) - Static method in class pulse.util.ReflexiveFinder
 
simpleInstances(String, Object...) - Static method in class pulse.util.ReflexiveFinder
Finds simple instances of Reflexive subclasses within pckgname.
SimpleOptimisationTask<T extends PropertyHolder & Optimisable> - Class in pulse.search
Generic optimisation class.
SimpleOptimisationTask(T, DiscreteInput) - Constructor for class pulse.search.SimpleOptimisationTask
 
SimpleResponse - Class in pulse.search
 
SimpleResponse(OptimiserStatistic) - Constructor for class pulse.search.SimpleResponse
 
SimpsonIntegrator - Class in pulse.math
Implements the Simpson's integration rule for the evaluation of definite integrals.
SimpsonIntegrator(Segment) - Constructor for class pulse.math.SimpsonIntegrator
 
SimpsonIntegrator(Segment, NumericProperty) - Constructor for class pulse.math.SimpsonIntegrator
 
SinusoidalBaseline - Class in pulse.baseline
A multiple-harmonic baseline.
SinusoidalBaseline() - Constructor for class pulse.baseline.SinusoidalBaseline
Creates a sinusoidal baseline with default properties.
size() - Method in class pulse.tasks.processing.ResultFormat
Calculates the length of the format string, which is the same as the size of the keyword list.
SKEW_LAMBDA - pulse.properties.NumericPropertyKeyword
λ parameter for skewed normal distribution.
SKEW_MU - pulse.properties.NumericPropertyKeyword
μ parameter for skewed normal distribution.
SKEW_SIGMA - pulse.properties.NumericPropertyKeyword
σ parameter for skewed normal distribution.
SOLID_EXCHANGE_COEFFICIENT - pulse.properties.NumericPropertyKeyword
Energy exchange coefficient in the two-temperature model (g).
solve(ClassicalProblem) - Method in class pulse.problem.schemes.solvers.ExplicitLinearisedSolver
 
solve(ClassicalProblem) - Method in class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
solve(ClassicalProblem) - Method in class pulse.problem.schemes.solvers.MixedLinearisedSolver
 
solve(ClassicalProblem2D) - Method in class pulse.problem.schemes.solvers.ADILinearisedSolver
 
solve(DiathermicMedium) - Method in class pulse.problem.schemes.solvers.ImplicitDiathermicSolver
 
solve(NonlinearProblem) - Method in class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
solve(NonlinearProblem) - Method in class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
solve(ParticipatingMedium) - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
solve(ParticipatingMedium) - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolver
 
solve(ParticipatingMedium) - Method in class pulse.problem.schemes.solvers.MixedCoupledSolver
 
solve(PenetrationProblem) - Method in class pulse.problem.schemes.solvers.ExplicitTranslucentSolver
 
solve(PenetrationProblem) - Method in class pulse.problem.schemes.solvers.ImplicitTranslucentSolver
 
solve(TwoTemperatureModel) - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
solve(ComplexPath, Vector) - Static method in interface pulse.search.direction.HessianDirectionSolver
 
solve(T) - Method in interface pulse.problem.schemes.solvers.Solver
Calculates the solution of the t and stores it in the respective HeatingCurve.
Solver<T extends Problem> - Interface in pulse.problem.schemes.solvers
A solver interface which provides the capability to use the solve method on a Problem.
SOLVER_ERROR - pulse.tasks.logs.Details
 
SolverException - Exception in pulse.problem.schemes.solvers
 
SolverException(String, SolverException.SolverExceptionType) - Constructor for exception pulse.problem.schemes.solvers.SolverException
 
SolverException(SolverException.SolverExceptionType) - Constructor for exception pulse.problem.schemes.solvers.SolverException
 
SolverException.SolverExceptionType - Enum in pulse.problem.schemes.solvers
 
sort(List<ExperimentalData>) - Static method in interface pulse.io.readers.CurveReader
Sorts the List of ExperimentalData according to their external IDs (if any).
source(int, double[], double[], double, int, int) - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
source(int, int, double, double) - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
SOURCE_GEOMETRIC_FACTOR - pulse.properties.NumericPropertyKeyword
Determines how much weight is attributed to the front-face light source compared to rear face.
SpearmansCorrelationTest - Class in pulse.search.statistics
Wrapper CorrelationTest class for ApacheCommonsMath Spearmans Correlation.
SpearmansCorrelationTest() - Constructor for class pulse.search.statistics.SpearmansCorrelationTest
 
SPECIFIC_HEAT - pulse.properties.NumericPropertyKeyword
Specific heat (Cp).
specificAncestor(Class<? extends UpwardsNavigable>) - Method in class pulse.util.UpwardsNavigable
Finds an ancestor that looks similar to aClass by recursively calling getParent().
SpectralRange - Enum in pulse.problem.statements.model
 
SPOT_DIAMETER - pulse.properties.NumericPropertyKeyword
Laser spot diameter.
SQRT - Static variable in class pulse.math.transforms.StandardTransformations
 
SQUARE - Static variable in class pulse.search.direction.pso.StaticTopologies
Von Neumann topology (square lattice) Condition: if( ( ps.length & (ps.length - 1) ) != 0) throw new IllegalArgumentException("Number of particles: " + ps.length + " is not power of 2");
SquareMatrix - Class in pulse.math.linear
The matrix class.
SquareMatrix(double[][]) - Constructor for class pulse.math.linear.SquareMatrix
Constructs a Matrix with the elements copied from args.
SR1Optimiser - Class in pulse.search.direction
 
StandardTransformations - Class in pulse.math.transforms
A utility class containing standard mathematical transforms and their inverses for non-bounded parameters.
StateEntry - Class in pulse.tasks.logs
 
StateEntry(SearchTask, Status) - Constructor for class pulse.tasks.logs.StateEntry
 
StaticTopologies - Class in pulse.search.direction.pso
 
Statistic - Class in pulse.search.statistics
A statistic is an abstract class that hosts the evaluate method to validate the results of a SearchTask.
Statistic() - Constructor for class pulse.search.statistics.Statistic
 
Status - Enum in pulse.tasks.logs
An enum that represents the different states in which a SearchTask can be.
STATUS_COLUMN - Static variable in class pulse.ui.components.models.StoredCalculationTableModel
 
STATUS_COLUMN - Static variable in class pulse.ui.components.models.TaskTableModel
 
StatusChangeListener - Interface in pulse.tasks.listeners
 
SteepestDescentOptimiser - Class in pulse.search.direction
The simplest possible PathSolver, which assumes that the minimum direction coincides with the inverted gradient.
STEFAN_BOTLZMAN - Static variable in class pulse.problem.statements.model.ThermalProperties
 
step(int, double) - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
step(int, double) - Method in class pulse.problem.schemes.rte.dom.ExplicitRungeKutta
 
step(int, double) - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
step(int, double) - Method in class pulse.problem.schemes.rte.dom.TRBDF2
Performs a TRBDF2 step.
stepLeft(int) - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
stepRight(int) - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
stepSize() - Method in class pulse.math.FixedIntervalIntegrator
Retrieves the step size equal to the integration range length divided by the number of integration segments.
StickTransform - Class in pulse.math.transforms
A simple bounded transform which makes the parameter stick to the boundaries upon reaching them.
StickTransform(Segment) - Constructor for class pulse.math.transforms.StickTransform
Only the upper bound of the argument is used.
STOP - pulse.ui.components.buttons.ExecutionButton.ExecutionState
 
stopCellEditing() - Method in class pulse.ui.components.controllers.NumberEditor
 
store() - Method in class pulse.problem.schemes.rte.dom.DiscreteQuantities
 
store() - Method in class pulse.problem.schemes.rte.Fluxes
Stores all currently calculated fluxes in a separate array.
store() - Method in class pulse.problem.schemes.rte.FluxesAndExplicitDerivatives
 
storeCalculation() - Method in class pulse.tasks.SearchTask
 
StoredCalculationTableModel - Class in pulse.ui.components.models
 
StoredCalculationTableModel() - Constructor for class pulse.ui.components.models.StoredCalculationTableModel
 
storeState() - Static method in class pulse.search.direction.ActiveFlags
Creates a deep copy of the flags collection.
storeState() - Method in class pulse.search.GeneralTask
Update the best state.
StretchedGrid - Class in pulse.problem.schemes.rte.dom
 
StretchedGrid(double) - Constructor for class pulse.problem.schemes.rte.dom.StretchedGrid
Constructs a uniform grid where the dimension is set to the argument.
StretchedGrid(NumericProperty, double) - Constructor for class pulse.problem.schemes.rte.dom.StretchedGrid
Constructs a non-uniform grid where the dimension and the grid density are specified by the arguments.
StretchedGrid(NumericProperty, double, NumericProperty, boolean) - Constructor for class pulse.problem.schemes.rte.dom.StretchedGrid
 
stringToValue(String) - Method in class pulse.properties.NumericPropertyFormatter
 
subgroups() - Method in class pulse.baseline.SinusoidalBaseline
 
subgroups() - Method in class pulse.util.Group
Tries to access getter methods to retrieve all Accessible instances belonging to this object.
subtract(RectangularMatrix) - Method in class pulse.math.linear.RectangularMatrix
Performs an element-wise subtraction of m from this if these matrices have matching dimensions.
subtract(Vector) - Method in class pulse.math.linear.Vector
Performs an element-wise subtraction of v from this.
SuccessiveOverrelaxation - Class in pulse.problem.schemes.rte.dom
 
SuccessiveOverrelaxation() - Constructor for class pulse.problem.schemes.rte.dom.SuccessiveOverrelaxation
 
sum(RectangularMatrix) - Method in class pulse.math.linear.RectangularMatrix
Performs an element-wise summation if this and m have matching dimensions.
sum(Vector) - Method in class pulse.math.linear.Vector
Performs an element-wise summation of this and v.
sumExcludingIndex(int, int, int) - Method in class pulse.problem.schemes.rte.dom.PhaseFunction
 
SumOfSquares - Class in pulse.search.statistics
The standard optimality criterion of the L2 norm condition, or simply ordinary least squares.
SumOfSquares() - Constructor for class pulse.search.statistics.SumOfSquares
 
SumOfSquares(SumOfSquares) - Constructor for class pulse.search.statistics.SumOfSquares
 
SwarmState - Class in pulse.search.direction.pso
 
SwarmState() - Constructor for class pulse.search.direction.pso.SwarmState
 
SwarmState(int, NeighbourhoodTopology) - Constructor for class pulse.search.direction.pso.SwarmState
 
sweep(double[]) - Method in class pulse.problem.schemes.BlockMatrixAlgorithm
 
sweep(double[]) - Method in class pulse.problem.schemes.TridiagonalMatrixAlgorithm
Calculates the solution V using the tridiagonal matrix algorithm.
switchTo(Calculation) - Method in class pulse.tasks.SearchTask
 
switchToBestModel() - Method in class pulse.tasks.SearchTask
 
SystemPanel - Class in pulse.ui.components.panels
 
SystemPanel() - Constructor for class pulse.ui.components.panels.SystemPanel
 

T

tanh(double, double) - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
target() - Method in class pulse.io.export.CurveExporter
 
target() - Method in interface pulse.io.export.Exporter
Defines the class, instances of which can be fed into the exporter to produce a result.
target() - Method in class pulse.io.export.LogExporter
 
target() - Method in class pulse.io.export.MetadataExporter
 
target() - Method in class pulse.io.export.RawDataExporter
 
target() - Method in class pulse.io.export.ResidualStatisticExporter
 
target() - Method in class pulse.io.export.ResultExporter
 
target() - Method in class pulse.io.export.ResultTableExporter
 
target() - Method in class pulse.io.export.TextLogPaneExporter
 
TASK - pulse.ui.frames.TaskControlFrame.Mode
 
TASK_ADDED - pulse.tasks.listeners.TaskRepositoryEvent.State
Indicates a task has been added to the repository.
TASK_BROWSING_REQUEST - pulse.tasks.listeners.TaskRepositoryEvent.State
An external request has been received to browse previous calculations.
TASK_CRITERION_SWITCH - pulse.tasks.listeners.TaskRepositoryEvent.State
The task changed its selection criterion.
TASK_FINISHED - pulse.tasks.listeners.TaskRepositoryEvent.State
A task has finished executing.
TASK_MODEL_SWITCH - pulse.tasks.listeners.TaskRepositoryEvent.State
The task has switched to a new model.
TASK_REMOVED - pulse.tasks.listeners.TaskRepositoryEvent.State
A task has been removed from the repository.
TASK_RESET - pulse.tasks.listeners.TaskRepositoryEvent.State
A task has been reset.
TASK_SUBMITTED - pulse.tasks.listeners.TaskRepositoryEvent.State
A task has been submitted for execution.
TaskActionListener - Interface in pulse.ui.components.listeners
 
TaskBox - Class in pulse.ui.components
 
TaskBox() - Constructor for class pulse.ui.components.TaskBox
 
TaskBoxModel - Class in pulse.ui.components.models
 
TaskBoxModel() - Constructor for class pulse.ui.components.models.TaskBoxModel
 
TaskControlFrame - Class in pulse.ui.frames
 
TaskControlFrame.Mode - Enum in pulse.ui.frames
 
TaskManager - Class in pulse.tasks
The TaskManager is a high-level class for dealing with operations of creation, removal, storage, and execution of SearchTasks, as well as with the associated Results and InterpolationDatasets.
TaskManagerFrame - Class in pulse.ui.frames
 
TaskManagerFrame() - Constructor for class pulse.ui.frames.TaskManagerFrame
 
TaskPopupMenu - Class in pulse.ui.components
 
TaskPopupMenu() - Constructor for class pulse.ui.components.TaskPopupMenu
 
TaskRepositoryEvent - Class in pulse.tasks.listeners
 
TaskRepositoryEvent(TaskRepositoryEvent.State, Identifier) - Constructor for class pulse.tasks.listeners.TaskRepositoryEvent
 
TaskRepositoryEvent.State - Enum in pulse.tasks.listeners
 
TaskRepositoryListener - Interface in pulse.tasks.listeners
 
TaskSelectionEvent - Class in pulse.tasks.listeners
 
TaskSelectionEvent(Object) - Constructor for class pulse.tasks.listeners.TaskSelectionEvent
 
TaskSelectionListener - Interface in pulse.tasks.listeners
 
TaskTable - Class in pulse.ui.components
 
TaskTable() - Constructor for class pulse.ui.components.TaskTable
 
TaskTableModel - Class in pulse.ui.components.models
 
TaskTableModel() - Constructor for class pulse.ui.components.models.TaskTableModel
 
TaskTableRenderer - Class in pulse.ui.components.controllers
 
TaskTableRenderer() - Constructor for class pulse.ui.components.controllers.TaskTableRenderer
 
TaskToolbar - Class in pulse.ui.components.panels
 
TaskToolbar() - Constructor for class pulse.ui.components.panels.TaskToolbar
 
tau - Variable in class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
TAU_FACTOR - pulse.properties.NumericPropertyKeyword
The factor used to convert squared grid spacing to time step.
TBLReader - Class in pulse.io.readers
A DatasetReader capable of reading .tbl files.
tellParent(PropertyEvent) - Method in class pulse.util.UpwardsNavigable
Recursively informs the parent, the parent of its parent, etc.
terminate() - Method in class pulse.tasks.SearchTask
If the current task is either IN_PROGRESS, QUEUED, or READY, terminates it by setting its status to TERMINATED.
TERMINATED - pulse.tasks.logs.Status
Task terminated
test(GeneralTask) - Method in class pulse.search.statistics.AndersonDarlingTest
This uses the SSJ statistical library to calculate the Anderson-Darling test with the input parameters formed by the task residuals and a normal distribution with zero mean and variance equal to the residuals variance.
test(GeneralTask) - Method in class pulse.search.statistics.EmptyTest
Always returns true
test(GeneralTask) - Method in class pulse.search.statistics.KSTest
 
test(GeneralTask) - Method in class pulse.search.statistics.NormalityTest
 
test(GeneralTask) - Method in class pulse.search.statistics.RSquaredTest
 
test(CorrelationTest) - Method in class pulse.tasks.processing.CorrelationBuffer
 
test(Calculation, Calculation) - Static method in class pulse.search.statistics.FTest
Tests two models to see which one is better according to the F-test
TEST_STATISTIC - pulse.properties.NumericPropertyKeyword
Test statistic (e.g.
TEST_STATISTIC_COLUMN - Static variable in class pulse.ui.components.models.TaskTableModel
 
TEST_TEMPERATURE - pulse.properties.NumericPropertyKeyword
Test temperature, at which the laser was fired at the sample.
TextLogPane - Class in pulse.ui.components
 
TextLogPane() - Constructor for class pulse.ui.components.TextLogPane
 
TextLogPaneExporter - Class in pulse.io.export
Similar to a LogExporter, except that it works only on the contents of a LogPane currently being displayed to the user.
THERMAL - pulse.problem.statements.model.SpectralRange
 
THERMAL_ABSORPTIVITY - pulse.properties.NumericPropertyKeyword
Dimensionless coefficient of thermal radiation absorption.
thermalConductivity() - Method in class pulse.problem.statements.model.ThermalProperties
 
thermalConductivity(double) - Method in class pulse.problem.statements.model.Gas
 
thermalConductivity(double) - Method in class pulse.problem.statements.model.Helium
 
thermalConductivity(double) - Method in class pulse.problem.statements.model.Nitrogen
 
thermalDiffusivity() - Method in class pulse.problem.statements.model.Gas
 
ThermalProperties - Class in pulse.problem.statements.model
 
ThermalProperties() - Constructor for class pulse.problem.statements.model.ThermalProperties
 
ThermalProperties(ThermalProperties) - Constructor for class pulse.problem.statements.model.ThermalProperties
 
ThermoOpticalProperties - Class in pulse.problem.statements.model
 
ThermoOpticalProperties() - Constructor for class pulse.problem.statements.model.ThermoOpticalProperties
 
ThermoOpticalProperties(ThermalProperties) - Constructor for class pulse.problem.statements.model.ThermoOpticalProperties
 
ThermoOpticalProperties(ThermoOpticalProperties) - Constructor for class pulse.problem.statements.model.ThermoOpticalProperties
 
THICKNESS - pulse.properties.NumericPropertyKeyword
Sample thickness.
threadsAvailable() - Method in class pulse.util.ResourceMonitor
Finds the number of threads available for calculation.
time - Variable in class pulse.AbstractData
 
TIME_LIMIT - pulse.properties.NumericPropertyKeyword
Calculation time limit.
TIME_ORIGIN_CHANGED - pulse.input.listeners.CurveEventType
Indicates a new time shift is introduced between the time sequences of a HeatingCurve and its linked ExperimentalData.
TIME_SHIFT - pulse.properties.NumericPropertyKeyword
Time shift (pulse sync).
timeAt(int) - Method in class pulse.AbstractData
Retrieves an element from the time List specified by index
timeAt(int) - Method in class pulse.HeatingCurve
Retrieves the time from the stored list of values, adding the value of startTime to the result.
timeLimit() - Method in class pulse.AbstractData
Retrieves the last element of the time List.
timeLimit() - Method in class pulse.input.ExperimentalData
Retrieves the time limit.
TIMEOUT - pulse.tasks.logs.Status
The iteration limit has been reached and the task aborted.
timeStep(int) - Method in class pulse.problem.schemes.DifferenceScheme
 
timeStep(int) - Method in class pulse.problem.schemes.ImplicitScheme
Calculates the solution at the boundaries using the boundary conditions specific to the problem statement and runs the tridiagonal matrix algorithm to evaluate solution at the intermediate grid points.
timeStep(int) - Method in class pulse.problem.schemes.solvers.ADILinearisedSolver
 
timeStep(int) - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
 
timeStep(int) - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolverNL
 
timeStep(int) - Method in class pulse.problem.schemes.solvers.ExplicitLinearisedSolver
 
timeStep(int) - Method in class pulse.problem.schemes.solvers.ExplicitNonlinearSolver
 
timeStep(int) - Method in class pulse.problem.schemes.solvers.ExplicitTranslucentSolver
 
timeStep(int) - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolverNL
 
timeStep(int) - Method in class pulse.problem.schemes.solvers.ImplicitNonlinearSolver
 
timeStep(int) - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
 
timeStep(int) - Method in class pulse.problem.schemes.solvers.MixedCoupledSolverNL
 
timeTaken() - Method in class pulse.tasks.logs.Log
Time taken where the first array element contains seconds [0] and the second contains milliseconds [1].
TO_SECONDS - Static variable in class pulse.io.readers.NetzschCSVReader
 
toString() - Method in class pulse.AbstractData
 
toString() - Method in class pulse.baseline.FlatBaseline
 
toString() - Method in class pulse.baseline.LinearBaseline
 
toString() - Method in class pulse.baseline.SinusoidalBaseline
 
toString() - Method in class pulse.input.ExperimentalData
 
toString() - Method in class pulse.input.IndexRange
 
toString() - Method in class pulse.input.Metadata
 
toString() - Method in class pulse.input.Range
 
toString() - Method in enum pulse.io.export.Extension
This will return the lower-case string with the name of the extension (e.g., html or csv).
toString() - Method in class pulse.math.FixedIntervalIntegrator
 
toString() - Method in class pulse.math.Harmonic
 
toString() - Method in class pulse.math.linear.RectangularMatrix
Prints out matrix dimensions and all the elements contained in it.
toString() - Method in class pulse.math.linear.Vector
Defines the string representation of the current instance of the class.
toString() - Method in class pulse.math.ParameterIdentifier
 
toString() - Method in class pulse.math.ParameterVector
 
toString() - Method in class pulse.math.Segment
 
toString() - Method in class pulse.problem.laser.PulseTemporalShape
 
toString() - Method in class pulse.problem.schemes.ADIScheme
Prints out the description of this problem type.
toString() - Method in class pulse.problem.schemes.DifferenceScheme
 
toString() - Method in class pulse.problem.schemes.ExplicitScheme
Prints out the description of this problem type.
toString() - Method in class pulse.problem.schemes.Grid
 
toString() - Method in class pulse.problem.schemes.ImplicitScheme
Prints out the description of this problem type.
toString() - Method in class pulse.problem.schemes.MixedScheme
Prints out the description of this problem type.
toString() - Method in class pulse.problem.schemes.RadiativeTransferCoupling
 
toString() - Method in class pulse.problem.schemes.rte.BlackbodySpectrum
 
toString() - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
toString() - Method in class pulse.problem.schemes.rte.dom.ButcherTableau
 
toString() - Method in class pulse.problem.schemes.rte.dom.DiscreteOrdinatesMethod
 
toString() - Method in class pulse.problem.schemes.rte.dom.Discretisation
 
toString() - Method in class pulse.problem.schemes.rte.dom.ExplicitRungeKutta
 
toString() - Method in class pulse.problem.schemes.rte.dom.HermiteInterpolator
 
toString() - Method in class pulse.problem.schemes.rte.dom.IterativeSolver
 
toString() - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
toString() - Method in class pulse.problem.schemes.rte.dom.OrdinateSet
 
toString() - Method in class pulse.problem.schemes.rte.dom.PhaseFunction
 
toString() - Method in class pulse.problem.schemes.rte.dom.StretchedGrid
 
toString() - Method in class pulse.problem.schemes.rte.dom.SuccessiveOverrelaxation
 
toString() - Method in class pulse.problem.schemes.rte.exact.ChandrasekharsQuadrature
 
toString() - Method in class pulse.problem.schemes.rte.exact.NewtonCotesQuadrature
 
toString() - Method in class pulse.problem.schemes.rte.exact.NonscatteringRadiativeTransfer
 
toString() - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolver
Prints out the description of this problem type.
toString() - Method in class pulse.problem.schemes.solvers.ExplicitCoupledSolverNL
 
toString() - Method in class pulse.problem.schemes.solvers.ExplicitTranslucentSolver
Prints out the description of this problem type.
toString() - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolver
 
toString() - Method in class pulse.problem.schemes.solvers.ImplicitCoupledSolverNL
 
toString() - Method in class pulse.problem.schemes.solvers.ImplicitTranslucentSolver
Prints out the description of this problem type.
toString() - Method in class pulse.problem.schemes.solvers.ImplicitTwoTemperatureSolver
Prints out the description of this problem type.
toString() - Method in class pulse.problem.schemes.solvers.MixedCoupledSolverNL
 
toString() - Method in class pulse.problem.statements.ClassicalProblem
 
toString() - Method in class pulse.problem.statements.ClassicalProblem2D
 
toString() - Method in class pulse.problem.statements.DiathermicMedium
 
toString() - Method in class pulse.problem.statements.model.AbsorptionModel
 
toString() - Method in class pulse.problem.statements.model.Gas
 
toString() - Method in enum pulse.problem.statements.model.SpectralRange
 
toString() - Method in class pulse.problem.statements.model.ThermalProperties
 
toString() - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 
toString() - Method in class pulse.problem.statements.NonlinearProblem
 
toString() - Method in class pulse.problem.statements.ParticipatingMedium
 
toString() - Method in class pulse.problem.statements.PenetrationProblem
 
toString() - Method in class pulse.problem.statements.Problem
 
toString() - Method in class pulse.problem.statements.Pulse
 
toString() - Method in class pulse.problem.statements.Pulse2D
 
toString() - Method in class pulse.problem.statements.TwoTemperatureModel
 
toString() - Method in class pulse.properties.Flag
 
toString() - Method in class pulse.properties.NumericProperty
Prints out the type and value of this NumericProperty.
toString() - Method in class pulse.properties.SampleName
 
toString() - Method in class pulse.search.direction.BFGSOptimiser
 
toString() - Method in class pulse.search.direction.LMOptimiser
 
toString() - Method in class pulse.search.direction.PathOptimiser
 
toString() - Method in class pulse.search.direction.SR1Optimiser
 
toString() - Method in class pulse.search.direction.SteepestDescentOptimiser
 
toString() - Method in class pulse.search.linear.GoldenSectionOptimiser
 
toString() - Method in class pulse.search.linear.LinearOptimiser
 
toString() - Method in class pulse.search.linear.WolfeOptimiser
 
toString() - Method in class pulse.tasks.Identifier
 
toString() - Method in class pulse.tasks.logs.CorrelationLogEntry
 
toString() - Method in class pulse.tasks.logs.DataLogEntry
This String will be displayed by the LogPane if the verbose log option is enabled.
toString() - Method in enum pulse.tasks.logs.Details
 
toString() - Method in class pulse.tasks.logs.Log
Outputs all log entries consecutively.
toString() - Method in class pulse.tasks.logs.StateEntry
 
toString() - Method in enum pulse.tasks.logs.Status
 
toString() - Method in class pulse.tasks.processing.AbstractResult
This will print out all the properties according to the ResultFormat.
toString() - Method in class pulse.tasks.SearchTask
 
toString() - Method in class pulse.ui.Version
 
toString() - Method in class pulse.util.DiscreteSelector
 
toString() - Method in class pulse.util.ImmutableDataEntry
 
toString() - Method in class pulse.util.InstanceDescriptor
 
toString() - Method in class pulse.util.PropertyEvent
 
totalEnergy() - Method in class pulse.problem.laser.DiscretePulse
Calculates the total pulse energy using a numerical integrator.The normalisation factor is then equal to the inverse total energy.
toVector() - Method in class pulse.math.ParameterVector
 
trackProgress(int) - Method in class pulse.ui.frames.dialogs.ProgressDialog
 
transform() - Method in class pulse.math.FFTTransformer
 
transform(double) - Method in class pulse.math.transforms.AtanhTransform
 
transform(double) - Method in class pulse.math.transforms.InvDiamTransform
 
transform(double) - Method in class pulse.math.transforms.PeriodicTransform
 
transform(double) - Method in class pulse.math.transforms.StickTransform
 
transform(double) - Method in interface pulse.math.transforms.Transformable
Performs the selected transform with value
Transformable - Interface in pulse.math.transforms
An interface for performing reversible one-to-one mapping of the model parameters.
transpose() - Method in class pulse.math.linear.RectangularMatrix
Transposes this Matrix, i.e.
TRAPEZOIDAL_FALL_PERCENTAGE - pulse.properties.NumericPropertyKeyword
Percentage of final (fall) segment of the pulse trapezoid.
TRAPEZOIDAL_RISE_PERCENTAGE - pulse.properties.NumericPropertyKeyword
Percentage of initial (rise) segment of the pulse trapezoid.
TrapezoidalPulse - Class in pulse.problem.laser
A trapezoidal pulse shape, which combines a rise segment, a constant-power segment, and a fall segment.
TrapezoidalPulse() - Constructor for class pulse.problem.laser.TrapezoidalPulse
Constructs a trapezoidal pulse using a default segmentation principle.
TrapezoidalPulse(TrapezoidalPulse) - Constructor for class pulse.problem.laser.TrapezoidalPulse
 
TRBDF2 - Class in pulse.problem.schemes.rte.dom
TRBDF2 (Trapezoidal Backward Differencing Second Order) Scheme for the solution of one-dimensional radiative transfer problems.
TRBDF2(Discretisation) - Constructor for class pulse.problem.schemes.rte.dom.TRBDF2
 
treatZeroIndex() - Method in class pulse.problem.schemes.rte.dom.ODEIntegrator
 
TridiagonalMatrixAlgorithm - Class in pulse.problem.schemes
Implements the tridiagonal matrix algorithm (Thomas algorithms) for solving systems of linear equations.
TridiagonalMatrixAlgorithm(Grid) - Constructor for class pulse.problem.schemes.TridiagonalMatrixAlgorithm
 
troubleshoot(SolverException) - Static method in enum pulse.tasks.logs.Status
 
truncate() - Method in class pulse.input.ExperimentalData
Truncates the range and indexRange of this ExperimentalData above a certain threshold, NOT removing any data elements.
TUKEY - Static variable in interface pulse.math.Window
 
TwoTemperatureModel - Class in pulse.problem.statements
 
TwoTemperatureModel() - Constructor for class pulse.problem.statements.TwoTemperatureModel
 
TwoTemperatureModel(TwoTemperatureModel) - Constructor for class pulse.problem.statements.TwoTemperatureModel
 
TwoTemperatureProperties - Class in pulse.problem.statements.model
 
TwoTemperatureProperties() - Constructor for class pulse.problem.statements.model.TwoTemperatureProperties
 
TwoTemperatureProperties(ThermalProperties) - Constructor for class pulse.problem.statements.model.TwoTemperatureProperties
 
typeOfAbsorption() - Method in enum pulse.problem.statements.model.SpectralRange
 

U

UNBOUNDED - Static variable in class pulse.math.Segment
 
undo() - Method in class pulse.ui.components.ResultTable
 
UNLIMITED - Static variable in class pulse.input.Range
 
update() - Method in class pulse.tasks.logs.AbstractLogger
 
update() - Method in class pulse.ui.components.models.SelectedKeysModel
 
update() - Method in class pulse.ui.frames.ProblemStatementFrame
 
update() - Method in class pulse.ui.frames.SearchOptionsFrame
 
update() - Method in class pulse.util.ResourceMonitor
 
update(List<NumericPropertyKeyword>) - Method in class pulse.ui.components.models.SelectedKeysModel
 
update(OptimisablePolyline) - Method in class pulse.math.filters.PolylineOptimiser.PolylineResponse
 
update(NumericProperty) - Method in class pulse.util.Accessible
Set a NumericProperty contained in this Accessible or any of its accessible childern, using the NumericPropertyKeyword of the argument as identifier and its value.
update(Property) - Method in class pulse.search.direction.PathOptimiser
Finds a Flag equivalent to flag in the originalList and substitutes its value with flag.getValue.
update(Property) - Method in class pulse.util.Accessible
Runs recursive search for a property in this Accessible object with the same identifier as property and sets its value to the value of the property parameter.If property is a NumericProperty, uses its NumericPropertyKeyword for identification.
update(ResultFormat, double[][][]) - Method in class pulse.ui.frames.PreviewFrame
 
update(SearchTask) - Method in class pulse.ui.components.CalculationTable
 
update(SearchTask) - Method in class pulse.ui.components.models.StoredCalculationTableModel
 
updateMinimum(NumericProperty) - Method in class pulse.input.Range
Updates the lower bound of this range using the information contained in p.
updateProperties(Object, PropertyHolder) - Method in class pulse.util.PropertyHolder
This method will update this PropertyHolder with all properties that are contained in a different propertyHolder, if they also are present in the former.
updateProperty(Object, Property) - Method in class pulse.util.PropertyHolder
Attempts to update an updatedProperty similar to one found in this PropertyHolder.
updateTable() - Method in class pulse.ui.components.PropertyHolderTable
 
UPPER_BOUND - pulse.properties.NumericPropertyKeyword
Upper calculation bound for optimiser.
UPPER_LIMIT - Static variable in class pulse.properties.NumericPropertyFormatter
Start using scientific notations for number whose absolute values are larger than 10000.0.
UpwardsNavigable - Class in pulse.util
An UpwardsNavigable provides a two-way connection with the other Describable in an asymmetric (upwards-oriented) manner (hence its name).
UpwardsNavigable() - Constructor for class pulse.util.UpwardsNavigable
 
userSaysRevert() - Method in class pulse.ui.components.controllers.NumberEditor
Lets the user know that the text they entered is bad.
useTheoreticalEstimates(ExperimentalData) - Method in class pulse.problem.statements.model.ExtendedThermalProperties
 
useTheoreticalEstimates(ExperimentalData) - Method in class pulse.problem.statements.model.ThermalProperties
Calculates the half-rise time t1/2 of c and uses it to estimate the thermal diffusivity of this problem: a=0.1388*l2/t1/2.
useTheoreticalEstimates(ExperimentalData) - Method in class pulse.problem.statements.model.ThermoOpticalProperties
 

V

validate() - Method in class pulse.properties.NumericProperty
 
value() - Method in class pulse.ui.frames.dialogs.FormattedInputDialog
 
valueAt(double) - Method in class pulse.baseline.AdjustableBaseline
Calculates the linear function g(x) = intercept + slope*time
valueAt(double) - Method in class pulse.baseline.Baseline
Calculates the baseline at the given position.
valueAt(double) - Method in class pulse.baseline.SinusoidalBaseline
 
valueAt(double) - Method in class pulse.math.FunctionWithInterpolation
Uses the stored interpolation function to calculate values at any t within the parameter bounds.
valueAt(double) - Method in class pulse.math.Harmonic
Amplitude form of the Fourier harmonic
valueInCurrentUnits() - Method in class pulse.properties.NumericProperty
 
valueOf(String) - Static method in enum pulse.input.listeners.CurveEventType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.input.listeners.DataEventType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.io.export.Extension
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.problem.schemes.rte.RTECalculationStatus
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.problem.schemes.solvers.SolverException.SolverExceptionType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.problem.statements.model.SpectralRange
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.problem.statements.ProblemComplexity
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.properties.NumericPropertyKeyword
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.tasks.listeners.TaskRepositoryEvent.State
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.tasks.logs.Details
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.tasks.logs.Status
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.ui.components.buttons.ExecutionButton.ExecutionState
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.ui.components.buttons.LoaderButton.DataType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.ui.components.MovableValueMarker.State
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum pulse.ui.frames.TaskControlFrame.Mode
Returns the enum constant of this type with the specified name.
values() - Static method in enum pulse.input.listeners.CurveEventType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.input.listeners.DataEventType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.io.export.Extension
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.problem.schemes.rte.RTECalculationStatus
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.problem.schemes.solvers.SolverException.SolverExceptionType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.problem.statements.model.SpectralRange
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.problem.statements.ProblemComplexity
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.properties.NumericPropertyKeyword
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.tasks.listeners.TaskRepositoryEvent.State
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.tasks.logs.Details
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.tasks.logs.Status
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.ui.components.buttons.ExecutionButton.ExecutionState
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.ui.components.buttons.LoaderButton.DataType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.ui.components.MovableValueMarker.State
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum pulse.ui.frames.TaskControlFrame.Mode
Returns an array containing the constants of this enum type, in the order they are declared.
valueToString(Object) - Method in class pulse.properties.NumericPropertyFormatter
Used to print out a nice value for GUI applications and for exporting.
variance() - Method in class pulse.search.statistics.AbsoluteDeviations
 
variance() - Method in class pulse.search.statistics.OptimiserStatistic
 
variance() - Method in class pulse.search.statistics.SumOfSquares
 
variance(NumericPropertyKeyword) - Method in class pulse.tasks.processing.Buffer
Calculates the variance for the index -- if the respective NumericProperty is contained in the IndexedVector data of this Buffer.
Vector - Class in pulse.math.linear
This is a general class for Vector operations useful for optimisers and ODE solvers.
Vector(double[]) - Constructor for class pulse.math.linear.Vector
Constructs a new vector specified by the argument array
Vector(int) - Constructor for class pulse.math.linear.Vector
Creates a zero Vector.
Vector(Vector) - Constructor for class pulse.math.linear.Vector
Copy constructor.
Version - Class in pulse.ui
 
Version(String, long) - Constructor for class pulse.ui.Version
 

W

wasRescaled() - Method in class pulse.problem.schemes.rte.dom.AdaptiveIntegrator
 
weight(List<ModelSelectionCriterion>) - Method in class pulse.search.statistics.ModelSelectionCriterion
Calculates the weight (in the Akaike sense) when comparing the model associated with this statistic with other models represented by statistics of the same type.
weight(List<Calculation>) - Method in class pulse.tasks.Calculation
 
WEIGHT_COLUMN - Static variable in class pulse.ui.components.models.StoredCalculationTableModel
 
Window - Interface in pulse.math
 
WINDOW - pulse.properties.NumericPropertyKeyword
Averaging window.
WolfeOptimiser - Class in pulse.search.linear
This is the implementation of the strong Wolfe conditions for performing inexact linear search.
work() - Method in interface pulse.ui.frames.dialogs.ProgressDialog.ProgressWorker
 
writeSplineFunction(PolynomialSplineFunction, ObjectOutputStream) - Static method in class pulse.util.FunctionSerializer
 
writeXML() - Static method in class pulse.io.export.XMLConverter
Utility method that creates an .xml file listing all public final static instances of NumericProperty found in the NumericProperty class.

X

x - Variable in class pulse.math.linear.RectangularMatrix
 
xCoord(MouseEvent) - Method in class pulse.ui.components.Chart
 
XMLConverter - Class in pulse.io.export
Used to read and write XML files containing information about the default NumericProperties.

Y

y0 - Variable in class pulse.problem.schemes.rte.dom.HermiteInterpolator
 
y1 - Variable in class pulse.problem.schemes.rte.dom.HermiteInterpolator
 

Z

ZScore - Class in pulse.math
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.
ZScore() - Constructor for class pulse.math.ZScore
 
ZScore(int, double, double) - Constructor for class pulse.math.ZScore
 

_

_2HTAU - Variable in class pulse.problem.schemes.solvers.ImplicitLinearisedSolver
 
A B C D E F G H I J K L M N O P Q R S T U V W X Y Z _ 
All Classes All Packages